A Snakemake workflow for automatic processing and quality control of protein mass spectrometry data.
This workflow is a best-practice workflow for the automated analysis of mass spectrometry proteomics data. It currently supports automated analysis of data-dependent acquisition (DDA) data with label-free quantification. An extension by different wokflows (DIA, isotope labeling) is planned in the future. The workflow is mainly a wrapper for the excellent tools fragpipe and MSstats, with additional modules that supply and check the required input files, and generate reports. The workflow is built using snakemake and processes MS data using the following steps:
- Prepare
workflow
file (python
script) - check user-supplied sample sheet (
python
script) - Fetch protein database from NCBI or use user-supplied fasta file (
python
, NCBI Datasets) - Generate decoy proteins (DecoyPyrat)
- Import raw files, search protein database (fragpipe)
- Align feature maps using IonQuant (fragpipe)
- Import quantified features, infer and quantify proteins (R MSstats)
- Compare different biological conditions, export results (R MSstats)
- Generate HTML report with embedded QC plots (R markdown)
- Generate PDF report from HTML weasyprint
- Send out report by email (
python
script) - Clean up temporary files after workflow execution (
bash
script)
If you want to contribute, report issues, or suggest features, please get in touch on github.
Step 1: Install snakemake with conda
, mamba
, micromamba
(or any another conda
flavor). This step generates a new conda environment called snakemake-ms-proteomics
, which will be used for all further installations.
conda create -c conda-forge -c bioconda -n snakemake-ms-proteomics snakemake
Step 2: Activate conda environment with snakemake
source /path/to/conda/bin/activate
conda activate snakemake-ms-proteomics
Alternatively, install snakemake
using pip:
pip install snakemake
Or install snakemake
globally from linux archives:
sudo apt install snakemake
Fragpipe is not available on conda
or other package archives. However, to make the workflow as user-friendly as possible, the latest fragpipe release from github (currently v22.0) is automatically installed to the respective conda
environment when using the workflow the first time. After installation, the GUI (graphical user interface) will pop up and ask to you to finish the installation by downloading the missing modules MSFragger, IonQuant, and Philosopher. This step is necessary to abide to license restrictions. From then on, fragpipe will run in headless
mode through command line only.
All other dependencies for the workflow are automatically pulled as conda
environments by snakemake.
The workflow requires the following input files:
- mass spectrometry data, such as Thermo
*.raw
or*.mzML
files - an (organism) database in
*.fasta
format OR a NCBI Refseq ID. Decoys (rev_
prefix) will be added if necessary - a sample sheet in tab-separated format (aka
manifest
file) - a
workflow
file for fragpipe (seeresources
dir)
The samplesheet file has the following structure with four mandatory columns and no header (example file: test/input/samplesheet/samplesheet.tsv
).
sample
: names/paths to raw filescondition
: experimental group, treatmentsreplicate
: replicate number, consecutively numbered. Repeating numbers (e.g. 1,2,1,2) will be treated as paired samples!type
: the type of MS data, will be used to determine the workflowcontrol
: reference condition for testing differential abudandance
sample | condition | replicate | type | control |
---|---|---|---|---|
sample_1 | condition_1 | 1 | DDA | condition_1 |
sample_2 | condition_1 | 2 | DDA | condition_1 |
sample_3 | condition_2 | 3 | DDA | condition_1 |
sample_4 | condition_2 | 4 | DDA | condition_1 |
To run the workflow from command line, change the working directory.
cd /path/to/snakemake-ms-proteomics
Adjust options in the default config file config/config.yml
.
Before running the entire workflow, you can perform a dry run using:
snakemake --dry-run
To run the complete workflow with test files using conda
, execute the following command. The definition of the number of compute cores is mandatory.
snakemake --cores 10 --use-conda --directory .test
To supply options that override the defaults, run the workflow like this:
snakemake --cores 10 --use-conda --directory .test \
--configfile 'config/config.yml' \
--config \
samplesheet='my/sample_sheet.tsv'
This table lists all global parameters to the workflow.
parameter | type | details | example |
---|---|---|---|
samplesheet | *.tsv |
tab-separated file | test/input/config/samplesheet.tsv |
database | *.fasta OR refseq ID |
plain text | test/input/database/database.fasta , GCF_000009045.1 |
workflow | *.workflow OR string |
a fragpipe workflow | workflows/LFQ-MBR.workflow , from_samplesheet |
This table lists all module-specific parameters and their default values, as included in the config.yml
file.
module | parameter | default | details |
---|---|---|---|
decoypyrat | cleavage_sites |
KR |
amino acids residues used for decoy peptide generation |
decoy_prefix |
rev |
decoy prefix appended to proteins names | |
fragpipe | target_dir |
share |
default path in conda env to store fragpipe |
executable |
fragpipe/bin/fragpipe |
path to fragpipe executable | |
download |
FragPipe-22.0 (see config) | downlowd link to Fragpipe Github repo | |
msstats | logTrans |
2 |
base for log fold change transformation |
normalization |
equalizeMedians |
normalization strategy for feature intensity, see MSstats manual | |
featureSubset |
all |
which features to use for quantification | |
summaryMethod |
TMP |
how to calculate protein from feature intensity | |
MBimpute |
True |
Imputes missing values with Accelerated failure time model | |
report | html |
True |
Generate HTLM report |
pdf |
True |
Generate PDF report | |
send |
False |
whether reports should send out by email | |
port |
0 |
default port for email server | |
smtp_server |
smtp.example.com |
smtp server address | |
smtp_user |
user |
smtp server user name | |
smtp_pw |
password |
smtp server user password | |
from |
[email protected] |
sender's email address | |
to |
["[email protected]"] |
receiver's email address(es), a list | |
subject |
"Results MS proteomics workflow" |
subject line for email |
- missing value imputation happens at different stages
- first, the default strategy for
fragpipe
is to use "match between runs", i.e. non-identified features in the MS1 spectra are cross-compared with other runs of the same experiment where MS2 identification is available - this reduces the number of missing feature quantifications
- this strategy is based on actual quantification data
- second,
MSstats
imputes two kinds of missing values where absolutely no feature quantification is available - missing values at random: removed during summarization
- missing values due to low abundance: imputed at the feature level via accelerated failure time model
- missing value treatment can be controlled through
MSstats
parametersMBimpute
and others - see
MSstats
manual for more information
The workflow generates the following output from its modules:
samplesheet
samplesheet.tsv
: Samplesheet after checking file paths and optionslog.txt
: Log file for this module
workflow
workflow.txt
: Configuration file forfragpipe
, determined from samplesheet.log.txt
: Log file for this module
database
database.fasta
: The downloaded or user-supplied.fasta
file. In the latter case, the file is identical to the input.log.txt
: Log file for this module
decoypyrat
decoy_database.fasta
: Original.fasta
file supplemented with randomized protein sequences.log.txt
: Log file for this module
fragpipe
[sample_name]/
: Directory containing sample specific output files for each runcombined_ion.tsv
: Quantification of ion intensity per peptidecombined_modified_peptide.tsv
: Quantification of peptide modificationscombined_peptide.tsv
: Quantification of peptides/featurescombined_protein.tsv
: Quantification of proteins from petide, inferred byfragpipe
MSstats.csv
: Qunatification of petides/features, output from fragpipe served inMSstats
friendly format- other files such as logs, file lists, etc.
log.txt
: Log file for this module
msstats
comparison_result.csv
: Main table with results about the comparison between different experimental conditionsfeature_level_data.csv
: Feature-level quantification data processed by MSstatsmodel_qc.csv
: Table with data about the fitted quantification models from MSstatsprotein_level_data.csv
: Protein-level quantification data processed by MSstatsuniprot.csv
: Optionally downloaded table with protein annotation from Uniprotlog.txt
: Log file for this module
report
report.html
: Report with figures and tablesreport.pdf
: Report with figures and tables in PDF format. Converted from HTMLlog.txt
: Log file for this module
log.txt
: Log file for this module
clean_up
log.txt
: Log file for this module
- Dr. Michael Jahn
- Affiliation: Max-Planck-Unit for the Science of Pathogens (MPUSP), Berlin, Germany
- ORCID profile: https://orcid.org/0000-0002-3913-153X
- github page: https://github.com/m-jahn
- the contents of this repository are licensed under a free for academic use license; this means
- you may use the workflow for scientific purposes free of charge
- you may modify the contents and create derivative work for you own scientific purposes
- all contents come with absolutely no warranty to work for your or any other purposes
- all third party dependencies are licensed under their own terms and not covered by this license
- Essential tools are linked in the top section of this document
- The core of this workflow are the two external packages fragpipe and MSstats
fragpipe
- Kong, A. T., Leprevost, F. V., Avtonomov, D. M., Mellacheruvu, D., & Nesvizhskii, A. I. (2017). MSFragger: ultrafast and comprehensive peptide identification in mass spectrometry–based proteomics. Nature Methods, 14(5), 513-520.
- da Veiga Leprevost, F., Haynes, S. E., Avtonomov, D. M., Chang, H. Y., Shanmugam, A. K., Mellacheruvu, D., Kong, A. T., & Nesvizhskii, A. I. (2020). Philosopher: a versatile toolkit for shotgun proteomics data analysis. Nature Methods, 17(9), 869-870.
- Yu, F., Haynes, S. E., & Nesvizhskii, A. I. (2021). IonQuant enables accurate and sensitive label-free quantification with FDR-controlled match-between-runs. Molecular & Cellular Proteomics, 20.
MSstats
- Choi M (2014). MSstats: an R package for statistical analysis of quantitative mass spectrometry-based proteomic experiments. Bioinformatics, 30.