iBAQ (Intensity-Based Absolute Quantification) determines the abundance of a protein by dividing the total precursor intensities by the number of theoretically observable peptides of the protein manuscript here. ibaqpy is a Python package that computes iBAQ values starting from a feature parquet from quantmsio and a SDRF file. In addition, the package computes other ibaq values including rIBAQ, log2, and ppb.
ibaqpy also allows computing the TPA value (Total Protein Approach). TPA is determined by summing peptide intensities of each protein and then dividing by the molecular mass to determine the relative concentration of each protein. By using ProteomicRuler, it is possible to calculate the protein copy number and absolute concentration. The OpenMS tool was used to calculate the theoretical molecular mass of each protein. Similar to the calculation of IBAQ, the TPA value of protein-group was the sum of its intensity divided by the sum of the theoretical molecular mass.
As mentioned before, ibaq values are calculated by dividing the total precursor intensities by the number of theoretically observable peptides of the protein. We use the following steps to calculate the iBAQ values:
Observable peptides, the protein sequence is digested in silico using a specific enzyme. The current version of this tool uses OpenMS method to load fasta file, and use ProteaseDigestion to enzyme digestion of protein sequences, and finally get the theoretical peptide number of each protein.
Total precursor intensities, the total intensity of a protein is calculated by summing the intensity of all peptides that belong to the protein. The intensity values are obtained from the feature parquet file in quantms.io.
Note: If protein-group exists in the peptide intensity dataframe, the intensity of all proteins in the protein-group is summed based on the above steps, and then divided by the number of proteins in the protein-group.
IbaqNorm
- normalize the ibaq values using the total ibaq of the sample ibaq / sum(ibaq)
, the sum is applied for proteins in the same sample + condition.
IbaqLog
- The ibaq log is calculated as 10 + log10(IbaqNorm)
. This normalized ibaq value was developed by ProteomicsDB Team.
IbaqPpb
- The resulted IbaqNorm is multiplied by 100M IbaqNorm * 100'000'000
. This method was developed originally by PRIDE Team.
The output of quantms is converted into quantms.io feature file. A feature in quantms.io is the combination of the following columns:
ProteinName
: Protein namePeptidoform
: Peptide sequence including post-translation modifications (e.g. .(Acetyl)ASPDWGYDDKN(Deamidated)GPEQWSK)
PrecursorCharge
: Precursor chargeIsotopeLabelType
: Isotope label typeCondition
: Condition label (e.g. heart)
BioReplicate
: Biological replicate index (e.g. 1)
Run
: Run index (e.g. 1)
Fraction
: Fraction index (e.g. 1)
Intensity
: Peptide intensitySampleID
: Sample ID (e.g. PXD003947-Sample-3)
StudyID
: Study ID (e.g. PXD003947)
. In most of the cases, the study ID is the same as the ProteomeXchange ID.In summary, each feature is the unique combination of a peptide sequence including modifications (peptidoform), precursor charge state, condition, biological replicate, run, fraction, isotopic label type, and a given intensity. In order to go from these features into protein ibaq values, the package does the following:
In this sectionfeatures2peptides
, ibaqpy will do:
--min_unique
parameter.DECOY, CONTAMINANT, ENTRAPMENT
could be removed, by default, the filter is not applied. If users want to remove these proteins, they can use the --remove_decoy_contaminants
parameter.--remove_ids
parameter. The remove ids parameters will remove proteins from the analysis that could be potential to influence the intensity normalization. For example, ALBU_HUMAN could be over expressed in human tissues, and that is why we may want to remove it when analyzing tissue data.MS runs > 1
in the sample, the mean
of all average(mean
, median
or iqr
) in each MS run is calculated(SampleMean)globalMedian
: A global median that adjusts the median of all samples.conditionMedian
: All samples under the same conditions were adjusted to the median value under the current conditions.sample number > 1
: This parameter is applied always unless the user specifies the --remove_low_frequency_peptides
parameter. The default value is 20% of the samples. If users want to change this threshold, they can use the --remove_low_frequency_peptides
parameter.PeptideSequence(Modifications) + Charge + BioReplicate + Fraction
(among other features), and a peptide is a combination of a PeptideSequence(Canonical) + BioReplicate
. ibaqpy will do:
sum
of the intensity values of the peptidoforms.--log2
parameter to transform the peptide intensity values to log2 before normalization.Note: At the moment, ibaqpy computes the ibaq values only based on unique peptides. Shared peptides are discarded. However, if a group of proteins share the same unique peptides (e.g., Pep1 -> Prot1;Prot2 and Pep2 -> Prot1;Prot2), the intensity of the proteins is summed and divided by the number of proteins in the group.
First, peptide intensity dataframe was grouped according to protein name, sample name and condition. The protein intensity of each group was summed. Due to the experimental type, the same protein may exhibit missing peptides in different samples, resulting in variations in the number of peptides detected for the protein across different samples. To handle this difference, normalization within the same group can be achieved by using the formula sum(peptides) / n
(n represents the number of detected peptide segments). Finally, the normalized intensity of the protein is divided by the number of theoretical peptides.See details in peptides2proteins
.
Note: In all scripts and result files, uniprot accession is used as the protein identifier.
Ibaqpy is available in PyPI and can be installed using pip:
pip install ibaqpy
You can install the package from code:
>$ git clone https://github.com/bigbio/ibaqpy
>$ cd ibaqpy
>$ mamba env create -f conda-environment.yaml
>$ python setup.py install
Absolute quantification files have been stored in the following url:
http://ftp.pride.ebi.ac.uk/pub/databases/pride/resources/proteomes/absolute-expression/quantms-data/
Inside each project reanalysis folder, the folder proteomicslfq contains the msstats input file with the structure {Name of the project}.{Random uuid}.feature.parquet
.
ibaqpy features2peptides -p tests/PXD003947/PXD003947-featrue.parquet -s tests/PXD003947/PXD003947.sdrf.tsv --remove_ids data/contaminants_ids.tsv --remove_decoy_contaminants --remove_low_frequency_peptides --output tests/PXD003947/PXD003947-peptides-norm.csv
Usage: features2peptides.py [OPTIONS]
Options:
-p, --parquet TEXT Parquet file import generated by quantms.io
-s, --sdrf TEXT SDRF file import generated by quantms
--min_aa INTEGER Minimum number of amino acids to filter
peptides
--min_unique INTEGER Minimum number of unique peptides to filter
proteins
--remove_ids TEXT Remove specific protein ids from the
analysis using a file with one id per line
--remove_decoy_contaminants Remove decoy and contaminants proteins from
the analysis
--remove_low_frequency_peptides
Remove peptides that are present in less
than 20% of the samples
--output TEXT Peptide intensity file including other all
properties for normalization
--skip_normalization Skip normalization step
--nmethod TEXT Normalization method used to normalize
feature intensities for tec
(options: mean, median, iqr, none)
--pnmethod TEXT Normalization method used to normalize
peptides intensities for all samples
(options: globalMedian,conditionMedian,none)
--log2 Transform to log2 the peptide intensity
values before normalization
--save_parquet Save normalized peptides to parquet
--help Show this message and exit.
ibaqpy peptides2proteins --fasta tests/PXD003947/Homo-sapiens-uniprot-reviewed-contaminants-decoy-202210.fasta --peptides tests/PXD003947/PXD003947-peptides-norm.csv --enzyme Trypsin --output tests/PXD003947/PXD003947-ibaq-norm.csv --normalize --verbose
The command provides an additional flag
for normalize IBAQ values.
Usage: peptides2proteins [OPTIONS]
Options:
-f, --fasta TEXT Protein database to compute IBAQ values
-p, --peptides TEXT Peptide identifications with intensities following the
peptide intensity output
-e, --enzyme TEXT Enzyme used during the analysis of the dataset
(default: Trypsin)
-n, --normalize Normalize IBAQ values using by using the total IBAQ of
the experiment
--min_aa INTEGER Minimum number of amino acids to consider a peptide
--max_aa INTEGER Maximum number of amino acids to consider a peptide
-o, --output TEXT Output file with the proteins and ibaq values
--verbose Print addition information about the distributions of
the intensities, number of peptides remove after
normalization, etc.
--qc_report TEXT PDF file to store multiple QC images
--help Show this message and exit.
python compute_tpa --fasta Homo-sapiens-uniprot-reviewed-contaminants-decoy-202210.fasta --organism 'human' --peptides PXD003947-peptides.csv --ruler --ploidy 2 --cpc 200 --output PXD003947-tpa.tsv --verbose
ibaqpyc tpa --help
Usage: tpa [OPTIONS]
Compute the protein copy numbers and concentrations according to a file output of peptides with the
format described in peptide_normalization.py.
:param fasta: Fasta file used to perform the peptide identification
:param peptides: Peptide intensity file
:param organism: Organism source of the data
:param ruler: Whether to compute protein copy number, weight and concentration.
:param ploidy: Ploidy number
:param cpc: Cellular protein concentration(g/L)
:param output: Output format containing the TPA values, protein copy numbers and concentrations
:param verbose: Print addition information about the distributions of the intensities,
number of peptides remove after normalization, etc.
:param qc_report: PDF file to store multiple QC images
Options:
-f, --fasta TEXT Protein database to compute IBAQ values [required]
-p, --peptides TEXT Peptide identifications with intensities following the peptide intensity output [required]
-m, --organism Organism source of the data.
-r, --ruler Calculate protein copy number and concentration according to ProteomicRuler
-n, --ploidy Ploidy number (default: 2)
-c, --cpc Cellular protein concentration(g/L) (default: 200)
-o, --output TEXT Output format containing the TPA values, protein copy numbers and concentrations
--verbose Print addition information about the distributions of the intensities,
number of peptides remove after normalization, etc.
--qc_report PDF file to store multiple QC images (default: "TPA-QCprofile.pdf")
--help Show this message and exit.
The protein copy calculation follows the following formula:
protein copies per cell = protein MS-signal * (avogadro / molecular mass) * (DNA mass / histone MS-signal)
For cellular protein copy number calculation, the uniprot accession of histones was obtained from species first, and the molecular mass of DNA was calculated. Then the dataframe was grouped according to different conditions, and the copy number, molar number and mass of proteins were calculated. In the calculation of protein concentration, the volume is calculated according to the cell protein concentration first, and then the protein mass is divided by the volume to calculate the intracellular protein concentration.
Wang H, Dai C, Pfeuffer J, Sachsenberg T, Sanchez A, Bai M, Perez-Riverol Y. Tissue-based absolute quantification using large-scale TMT and LFQ experiments. Proteomics. 2023 Oct;23(20):e2300188. doi: 10.1002/pmic.202300188. Epub 2023 Jul 24. PMID: 37488995.