This vignette complements the more basic vignette ‘Getting started with wrProteo’ also from this package (wrProteo) and shows in more detail how UPS1_spike-in_ experiments may be analyzed, using this package (wrProteo).
Furthermore, wrMisc, wrGraph and RColorBrewer from CRAN as well as the Bioconductor package limma (for it’s moderated statistical testing) will be used internally.
So, to get started on a fresh session of R, you might have to install the following packages:
## This is R code, you can run this to redo all analysis presented here.
install.packages("wrMisc")
## These packages are used for the graphics
install.packages("wrGraph")
install.packages("RColorBrewer")
if(!requireNamespace("knitr", quietly=TRUE)) install.packages("knitr")
## Installation of limma from Bioconductor
if(!requireNamespace("BiocManager", quietly=TRUE)) install.packages("BiocManager")
BiocManager::install("limma")
## now all dependecies are installed...
install.packages("wrProteo")
## You cat also see all vignettes for this package by typing :
browseVignettes("wrProteo")    #  ... and the select the html outputAs you will see in the interactive window from browseVignettes(), this package has 2 vignettes, a more general introductory vignette (mentioned above) and this UPS1 dedicated vignette.
Now let’s load the packages needed :
## Let's assume this is a fresh R-session
library(knitr)
library(wrMisc)
library(wrGraph)
library(wrProteo)
# Version number for wrProteo :
packageVersion("wrProteo")
#> [1] '1.13.3'The main aim of the experimental setup using heterologous spike-in experiments is to provide a framework to test identification and quantitation procedures in proteomics. The overall idea is based on providing samples where the amount of a few proteins vary in a very controlled way, ie it is exactely known in advance which proteins vary how much. The easiest way to obtain samples consists in taking of advantage that proteins from different species vary many times enough so that mass spectrometry experiments can distinguish the species origin.
The exeriment reanalyzed here used a base (‘matrix’) of yeast protein extract constant in all samples. Then, varying amounts of a commerical collection of 48 purified human proteins were added in different well documented amounts to the constant yeast protein extract. For this purpose the UPS1 preparation, commerically available from Sigma-Aldrich (www.sigmaaldrich.com), is frequently used.
In terms of ROC curves (see also ROC on Wikipedia) the spike-in proteins are expected to show up as true positives (TP). In contrast, since all yeast proteins were added in the same quantity to the same samples, they should be observed as constant, ie as true negatives (TN) when looking for proteins changing abundance.
The specific dataset used here (seen also next section Ramus Data Set) is not so recent and better performing mass spectrometers have gotten availabale in the meantime. Thus, for addressing scientific questions concerning comparison and choice of quantification software it is suggetsed to perform similar comparisons on more recent datasets. The main aim of this vignette is to show the possibilities of how such comparisons can be performed using wrProteo.
The data used in this vignette was published with the article : Ramus et al 2016 “Benchmarking quantitative label-free LC-MS data processing workflows using a complex spiked proteomic standard dataset” in J Proteomics 2016 Jan 30;132:51-62.
This dataset is available on PRIDE as PXD001819 (and on ProteomeXchange).
Briefly, this experiment aims to evaluate and compare various quantification appoaches of the heterologous spike-in UPS1 (available from Sigma-Aldrich) in yeast protein extracts as constant matrix. 9 different concentrations of the heterologous spike-in (UPS1) were run in triplicates. The proteins were initially digested by Trypsin and then analyzed by LC-MS/MS in DDA mode.
As described in more detail in the reference, this dataset was generated using a LTQ-Orbitrap, in the meantime more powerful and precises mass-spectrometers have become avialable. Thus, scientific questions about the comparison and choice of quantification software may be better addressed using more recent datasets.
The project Proteomics Sample Metadata Format aims to provide a framework of providing a uniform format for documenting experimental meta-data (sdrf-format). The meta-data for experiments already integrated can be directly read/accessed from wrProteo.
Either you download the meta-data as file ‘sdrf.tsv’ from Pride/PXD001819, or you may read file ‘PXD001819.sdrf.tsv’ directly from github/bigbio.
## Read meta-data from  github.com/bigbio/proteomics-metadata-standard/
pxd001819meta <- readSdrf("PXD001819")
#> readSdrf : Successfully read 24 annotation columns for 27 samples
## The concentration of the UPS1 spike-in proteins in the samples
if(length(pxd001819meta) >0) {
  UPSconc <- sort(unique(as.numeric(wrMisc::trimRedundText(pxd001819meta$characteristics.spiked.compound.))))  # trim to get to 'essential' info
} else {
  UPSconc <- c(50, 125, 250, 500, 2500, 5000, 12500, 25000, 50000)       # in case access to github failed
}The import-functions used later in this vignette can directly download the spike-in metadata if the associated PXD-accession-number is provided.
## A few elements and functions we'll need lateron
methNa <- c("ProteomeDiscoverer","MaxQuant","Proline")
names(methNa) <- c("PD","MQ","PL")In this project the old version for the accession-number of UBB (which has been withdrown by the database in the meantime) and protein-sequence as originally cited by Sigma-Aldrich (www.sigmaaldrich.com/) has been used. Se we’ll ‘retrograde’ the output from ‘getUPS1acc()’.
spikeType <- "UPS1"            ## information about spike used 
matrixType <- "Saccharomyces cerevisiae"   ## information about matrix used  (user-provided)
matrixType2 <- wrProteo::inspectSpeciesIndic(matrixType)               # check & make uniform
sdrfNa <- "PXD001819"                     # name of sdrf to use
## The accession numbers for the UPS1 proteins
UPS1 <- getUPS1acc(updated=FALSE)
## global information about what could be contaminants
contaInf <- c("Bos tauris|Gallus", MQ="CON_|LYSC_CHICK")
  ## additional functions
replSpecType <- function(x, annCol="SpecType", replBy=cbind(old=c("mainSpe","species2"), new=c("Yeast","UPS1")), silent=TRUE) {
  ## rename $annot[,"SpecType"] to more specific names
  fxNa <- "replSpecType"
  chCol <- annCol[1] %in% colnames(x$annot)
  if(chCol) { chCol <- which(colnames(x$annot)==annCol[1])
    chIt <- replBy[,1] %in% unique(x$annot[,chCol])    # check items to replace if present
    if(any(chIt)) for(i in which(chIt)) {useLi <- which(x$annot[,chCol] %in% replBy[i,1]); cat("useLi",head(useLi),"\n"); x$annot[useLi,chCol] <- replBy[i,2]}
  } else if(!silent) message(fxNa," 'annCol' not found in x$annot !")
  x }
plotConcHist <- function(mat, ref, refColumn=3:4, matCluNa="cluNo", lev=NULL, ylab=NULL, tit=NULL) {
  ## plot histogram like counts of UPS1 concentrations
  if(is.null(tit)) tit <- "Frequency of UPS1 Concentrations Appearing in Cluster"
  gr <- unique(mat[,matCluNa])
  ref <- ref[,refColumn]
  if(length(lev) <2) lev <- sort(unique(as.numeric(as.matrix(ref))))
  if(length(ylab) !=1) ylab <- "Frequency"
  tbl <- table(factor( as.numeric(ref[which(rownames(ref) %in% rownames(mat)),]), levels=lev))
  graphics::barplot(tbl, las=1, beside=TRUE, main=paste(tit,gr), col=grDevices::gray(0.8), ylab=ylab)
}
plotMultRegrPar <- function(dat, methInd, tit=NULL, useColumn=c("logp","slope","medAbund","startFr"), lineGuide=list(v=c(-12,-10),h=c(0.7,0.75),col="grey"), xlim=NULL,ylim=NULL,subTit=NULL) {
  ## scatter plot logp (x) vs slope (y) for all UPS proteins, symbol by useColumn[4], color by hist of useColumn[3]
  ## dat (array) UPS1 data
  ## useColumn (character) 1st as 'logp', 2nd as 'slope', 3rd as median abundance, 4th as starting best regression from this point
  fxNa <- "plotMultRegrPar"
   #fxNa <- wrMisc::.composeCallName(callFrom,newNa="plotMultRegrPar")
  if(length(dim(dat)) !=3) stop("invalid input, expecting as 'dat' array with 3 dimensions (proteins,Softw,regrPar)")
  if(any(length(methInd) >1, methInd > dim(dat)[2], !is.numeric(methInd))) stop("invalid 'methInd'")
  chCol <- useColumn %in% dimnames(dat)[[3]]
  if(any(!chCol)) stop("argument 'useColumn' does not fit to 3rd dim dimnames of 'dat'")
  useCol <- colorAccording2(dat[,methInd,useColumn[3]], gradTy="rainbow", revCol=TRUE, nEndOmit=14)
  graphics::plot(dat[,methInd,useColumn[1:2]], main=tit, type="n",xlim=xlim,ylim=ylim)   #col=1, bg.col=useCol, pch=20+lmPDsum[,"startFr"],
  graphics::points(dat[,methInd,useColumn[1:2]], col=1, bg=useCol, pch=20+dat[,methInd,useColumn[4]],)
  graphics::legend("topright",paste("best starting from ",1:5), text.col=1, pch=21:25, col=1, pt.bg="white", cex=0.9, xjust=0.5, yjust=0.5)
  if(length(subTit)==1) graphics::mtext(subTit,cex=0.9)
  if(is.list(lineGuide) & length(lineGuide) >0) {if(length(lineGuide$v) >0) graphics::abline(v=lineGuide$v,lty=2,col=lineGuide$col)
    if(length(lineGuide$h) >0) graphics::abline(h=lineGuide$h,lty=2,col=lineGuide$col)}
  hi1 <- graphics::hist(dat[,methInd,useColumn[3]], plot=FALSE)
  wrGraph::legendHist(sort(dat[,methInd,useColumn[3]]), colRamp=useCol[order(dat[,methInd,useColumn[3]])][cumsum(hi1$counts)],
    cex=0.5, location="bottomleft", legTit="median raw abundance")  #
}Multiple algorithms and software implementations have been developed for quantitation label-free proteomics experiments, in particular for extracted ion chromatograms (XIC). For background information you may look at Wikipedia labell-free Proteomics. Here, the use of the output for 3 such implementations for extracting peptide/protein quantifications is shown. These 3 software implementations were run individually using equivalent settings, ie identifcation based on the same fasta-database, starting at a single peptide with 1% FDR, MS mass tolerance for ion precursors at 0.7 ppm, oxidation of methionins and N-terminal acetylation as fixed as well as carbamidomethylation of cysteins as variable modifications.
Since in this context it is crucial to recognize all UPS1 proteins as such (see also this data-set), the import-functions make use of the specPref argument, allowing to define custom tags. Most additional arguments to the various import-functions have been kept common for conventient use and for generating output structured the same way. Indeed, simply separating proteins by their species origin is not sufficient since common contaminants like human Keratin might get considered by error as UPS1.
MaxQuant is free software provided by the Max-Planck-Institute, see also Tyanova et al 2016. Later in this document data from MaxQuant will by frequently abbreviated as MQ.
Typically MaxQuant exports quantitation data on level of consensus-proteins by default to a folder called txt with a file called “proteinGroups.txt” . So in a standard case (when the file name has not been changed manually) it is sufficient to provide the path to this file. Of course, you can explicitely point to a specific file, as shown below. The data presented here were processed using MaxQuant version 1.6.10. Files compressed as .gz can be read, too (like in the example below).
path1 <- system.file("extdata", package="wrProteo")
fiNaMQ <- "proteinGroups.txt.gz"
## We need to define the setup of species
specPrefMQ <- list(conta=contaInf[2], matrix=paste0("OS=",matrixType2), spike=spikeType, sampleNames="sdrf") #fasta=fastaFi, 
dataMQ <- readMaxQuantFile(file=fiNaMQ, path=path1, refLi="mainSpe", specPref=specPrefMQ, 
  sdrf=c(sdrfNa,"max",sdrfOrder=TRUE), suplAnnotFile=TRUE, plotGraph=FALSE, silent=TRUE)   # , refLi=useRefLi
The data were imported, log2-transformed and median-normalized, the protein annotation was parsed to automatically extract IDs, protein-names and species information. The species anotation was extracted out of the fasta-headers, as given in the specPref argument (MaxQuant specific setting). As explained in more detail in the general vignette wrProteoVignette1, In this example we use only proteins annotated as Homo sapiens for determining the normalization-factors via the argument refLi.
If you wish to inspect the graphs for the distribution of abundance values for each sample before and after median-normalization, please set the argument plotGraph=TRUE (default). Please note, that in the example above we directly added information about the experimental setup from the sdrf repository and we asked for arranging the order of samples as they appear in the sdrf.
## The number of lines and colums
dim(dataMQ$quant)
#> [1] 1104   27
## A quick summary of some columns of quantitation data
summary(dataMQ$quant[,1:7])                # the first 8 cols
#>   12500amol_1     12500amol_2     12500amol_3      125amol_1    
#>  Min.   :17.52   Min.   :15.65   Min.   :14.91   Min.   :15.20  
#>  1st Qu.:22.49   1st Qu.:22.47   1st Qu.:22.48   1st Qu.:22.40  
#>  Median :23.45   Median :23.45   Median :23.45   Median :23.45  
#>  Mean   :23.67   Mean   :23.64   Mean   :23.65   Mean   :23.62  
#>  3rd Qu.:24.80   3rd Qu.:24.74   3rd Qu.:24.75   3rd Qu.:24.84  
#>  Max.   :30.27   Max.   :30.25   Max.   :30.30   Max.   :30.27  
#>  NA's   :98      NA's   :100     NA's   :104     NA's   :114    
#>    125amol_2       125amol_3      25000amol_1   
#>  Min.   :14.88   Min.   :14.94   Min.   :15.74  
#>  1st Qu.:22.39   1st Qu.:22.41   1st Qu.:22.44  
#>  Median :23.45   Median :23.45   Median :23.45  
#>  Mean   :23.62   Mean   :23.63   Mean   :23.65  
#>  3rd Qu.:24.84   3rd Qu.:24.80   3rd Qu.:24.86  
#>  Max.   :30.28   Max.   :30.30   Max.   :30.19  
#>  NA's   :106     NA's   :114     NA's   :109
table(dataMQ$annot[,"SpecType"], useNA="always")
#> 
#> mainSpecies       spike        <NA> 
#>        1047          48           9
table(dataMQ$annot[,"Species"], useNA="always")
#> 
#>            Gallus gallus             Homo sapiens             Mus musculus 
#>                        1                       49                        1 
#> Saccharomyces cerevisiae               Sus scrofa                     <NA> 
#>                     1047                        1                        5Now we can summarize the presence of UPS1 proteins after treatment by MaxQuant : In sum, 47 UPS1 proteins were found, 1 is/are missing.
ProteomeDiscoverer is commercial software from ThermoFisher (www.thermofisher.com). Later in this document data from ProteomeDiscoverer will by frequently abbreviated as PD.
With the data (see also this data-set) used here, the identification was performed using the XCalibur module of ProteomeDiscoverer version 2.4 . Quantitation data at the level of consensus-proteins can be exported to tabulated text files, which can be treated by the function shown below. The resultant data were export in tablulated format and the file automatically named ‘_Proteins.txt_’ by ProteomeDiscoverer (the option R-headers was checked, however this option is not mandatory). Files compressed as .gz can be read, too (like in the example below).
Note, since ProteomeDiscoverer frequently does not provide customized column-names we’ll use the information from the sdrf-file (see argument sdrf=…). However, in this case the 1st suitable column of the sdrf doesn’t allow either to extract useful names we’ll tell the import-function to skip this 1st column of the sdrf when looking for a column indicating a maximum number of groups. Since the order of samples may appear different in various quantification-software we’ll also ask the import-function to adjust the order of samples to the sdrf (see argument sdrf=c(sdrfNa,“max”,sdrfOrder=TRUE,skipCol=1)).
path1 <- system.file("extdata", package="wrProteo")
fiNaPd <- "pxd001819_PD24_Proteins.txt.gz"
## Next, we define the setup of species
specPrefPD <- list(conta=contaInf[1], mainSpecies=matrixType2, spike=spikeType, sampleNames="sdrf", lowNumberOfGroups=FALSE)   # fasta=fastaFi,
dataPD <- readProteomeDiscovererFile(file=fiNaPd, path=path1,  refLi="mainSpe", specPref=specPrefPD, sdrf=c(sdrfNa,"max",sdrfOrder=TRUE,skipCol=1), suplAnnotFile=TRUE, plotGraph=FALSE, silent=TRUE)   # refLi=useRefLiThe data were imported, log2-transformed and median-normalized, the protein annotation was parsed to automatically extract IDs, protein-names and species information. Please note, that quantitation data exported from ProteomeDiscoverer frequently have very generic column-names (increasing numbers). When calling the import-function they can be replaced by more meaningful names either using the argument sampNa, or from reading the default annotation in the file ‘InputFiles.txt’ or, finally, from the sdrf-annotation. In the example below both the default annotation as file ‘InputFiles.txt’ and sdrf annotation are available and were integrated to object produced by the import-function.
The species anotation was extracted out as given in the specPref argument. In this example we use only proteins annotated as Homo sapiens for determining the normalization-factors via the argument refLi.
If you wish to inspect the graphs for the distribution of abundance values for each sample before and after median-normalization, please set the argument plotGraph=TRUE (default).
## The number of lines and colums
dim(dataPD$quant)
#> [1] 1296   27
## A quick summary of some columns of quantitation data
summary(dataPD$quant[,1:7])        # the first 8 cols
#>      run 1           run 2           run 3           run 4      
#>  Min.   :10.86   Min.   :11.33   Min.   :11.57   Min.   :10.90  
#>  1st Qu.:18.32   1st Qu.:18.31   1st Qu.:18.31   1st Qu.:18.22  
#>  Median :19.48   Median :19.46   Median :19.45   Median :19.37  
#>  Mean   :19.62   Mean   :19.62   Mean   :19.60   Mean   :19.52  
#>  3rd Qu.:20.84   3rd Qu.:20.83   3rd Qu.:20.80   3rd Qu.:20.84  
#>  Max.   :26.36   Max.   :26.36   Max.   :26.39   Max.   :26.43  
#>  NA's   :69      NA's   :59      NA's   :67      NA's   :88     
#>      run 5           run 6           run 7      
#>  Min.   :10.48   Min.   :11.16   Min.   :11.55  
#>  1st Qu.:18.20   1st Qu.:18.20   1st Qu.:18.35  
#>  Median :19.40   Median :19.40   Median :19.53  
#>  Mean   :19.51   Mean   :19.53   Mean   :19.67  
#>  3rd Qu.:20.82   3rd Qu.:20.83   3rd Qu.:21.01  
#>  Max.   :26.39   Max.   :26.46   Max.   :26.40  
#>  NA's   :99      NA's   :86      NA's   :64
table(dataPD$annot[,"SpecType"], useNA="always")
#> 
#> mainSpecies       spike        <NA> 
#>        1239          48           9
table(dataPD$annot[,"Species"], useNA="always")
#> 
#>            Gallus gallus             Homo sapiens Saccharomyces cerevisiae 
#>                        1                       44                     1239 
#>                     <NA> 
#>                       12Confirming the presence of UPS1 proteins by ProteomeDiscoverer:
Now we can summarize the presence of UPS1 proteins after treatment by ProteomeDiscoverer : In sum, 47 UPS1 proteins were found, 1 is/are missing.
Proline is open-source software provided by the Profi-consortium (see also proline-core on github), published by Bouyssie et al 2020. Later in this document data from Proline will by frequently abbreviated as PL.
Protein identification in Proline gets performed by SearchGUI, see also Vaudel et al 2015. In this case X!Tandem (see also Duncan et al 2005) was used as search engine.
Quantitation data at the level of consensus-proteins can be exported from Proline as .xlsx or tabulated text files, both formats can be treated by the import-functions shown below. Here, Proline version 1.6.1 was used with addition of Percolator (via MS-Angel from the same authors).
path1 <- system.file("extdata", package="wrProteo")
fiNaPl <- "pxd001819_PL.xlsx"
specPrefPL <- list(conta=contaInf[1], mainSpecies=matrixType2, spike=spikeType, sampleNames="sdrf")   # fasta=fastaFi,    # same as PL
dataPL <- readProlineFile(file=fiNaPl, path=path1, specPref=specPrefPL, sdrf=c(sdrfNa,"max",sdrfOrder=TRUE), suplAnnotFile=TRUE, plotGraph=FALSE, silent=TRUE)   # refLi=useRefLi
The (log2-transformed) data were imported and median-normalized, the protein annotation was parsed to automatically extract IDs, protein-names and species information. The species anotation was extracted out of protein annotation columns, as specified with the specPref argument. As explained in more detail in the general vignette wrProteoVignette1, In this example we use only proteins annotated as Homo sapiens for determining the normalization-factors via the argument refLi.
If you wish to inspect the graphs for the distribution of abundance values for each sample before and after median-normalization, please set the argument plotGraph=TRUE (default). Please note, that in the example above we directly added information about the experimental setup from the sdrf repository.
## The number of lines and colums
dim(dataPL$quant)
#> [1] 1186   27
## A quick summary of some columns of quantitation data
summary(dataPL$quant[,1:8])        # the first 8 cols
#>   12500amol_R1    12500amol_R2    12500amol_R3     125amol_R1   
#>  Min.   :14.17   Min.   :14.03   Min.   :13.16   Min.   :14.49  
#>  1st Qu.:19.90   1st Qu.:19.90   1st Qu.:19.90   1st Qu.:19.81  
#>  Median :21.70   Median :21.70   Median :21.70   Median :21.70  
#>  Mean   :21.76   Mean   :21.77   Mean   :21.74   Mean   :21.80  
#>  3rd Qu.:23.59   3rd Qu.:23.59   3rd Qu.:23.57   3rd Qu.:23.75  
#>  Max.   :29.38   Max.   :29.39   Max.   :29.35   Max.   :29.53  
#>  NA's   :43      NA's   :43      NA's   :45      NA's   :46     
#>    125amol_R2      125amol_R3     25000amol_R1    25000amol_R2  
#>  Min.   :13.61   Min.   :14.82   Min.   :14.03   Min.   :14.70  
#>  1st Qu.:19.83   1st Qu.:19.82   1st Qu.:19.87   1st Qu.:19.82  
#>  Median :21.70   Median :21.70   Median :21.70   Median :21.70  
#>  Mean   :21.80   Mean   :21.78   Mean   :21.75   Mean   :21.72  
#>  3rd Qu.:23.75   3rd Qu.:23.70   3rd Qu.:23.59   3rd Qu.:23.57  
#>  Max.   :29.54   Max.   :29.47   Max.   :29.30   Max.   :29.32  
#>  NA's   :46      NA's   :48      NA's   :49      NA's   :48
table(dataPL$annot[,"SpecType"], useNA="always")
#> 
#> mainSpecies       spike        <NA> 
#>        1137          48           1
table(dataPL$annot[,"Species"], useNA="always")
#> 
#>             Homo sapiens Saccharomyces cerevisiae               Sus scrofa 
#>                       48                     1137                        1 
#>                     <NA> 
#>                        0Now we can summarize the presence of UPS1 proteins after treatment by Proline : In sum, 47 UPS1 proteins were found, 1 is/are missing.
For easy and proper comparisons we need to make sure all columns are in the same order, since we have forced to use the initial order of the Sdrf, this is already the case.
Next, we’ll replace some missing protein-names:
## Need to address missing ProteinNames (UPS1) due to missing tags in Fasta
dataPD <- replMissingProtNames(dataPD)
#> replreplMissingProtNames :  ..trying to replace 1296 'EntryName'
dataMQ <- replMissingProtNames(dataMQ)
#> replreplMissingProtNames :  ..trying to replace 5 'EntryName'
dataPL <- replMissingProtNames(dataPL)
    table(dataMQ$annot[,"SpecType"])
#> 
#> mainSpecies       spike 
#>        1047          48
    table(dataPD$annot[,"SpecType"])
#> 
#> mainSpecies       spike 
#>        1239          48
    table(dataPL$annot[,"SpecType"])
#> 
#> mainSpecies       spike 
#>        1137          48
## synchronize order of groups
(grp9 <- dataMQ$sampleSetup$level)
#> 12500 12500 12500   125   125   125 25000 25000 25000  2500  2500  2500   250 
#>     7     7     7     2     2     2     8     8     8     5     5     5     3 
#>   250   250 50000 50000 50000  5000  5000  5000   500   500   500    50    50 
#>     3     3     9     9     9     6     6     6     4     4     4     1     1 
#>    50 
#>     1
names(grp9) <- paste0(names(grp9),"amol")
#dataPL$sampleSetup$groups <- dataMQ$sampleSetup$groups <- dataPD$sampleSetup$groups <- grp9  # synchronize order of groups## extract names of quantified UPS1-proteins
NamesUpsPD <- dataPD$annot[which(dataPD$annot[,"SpecType"]=="spike"), "Accession"]
NamesUpsMQ <- dataMQ$annot[which(dataMQ$annot[,"SpecType"]=="spike"), "Accession"]
NamesUpsPL <- dataPL$annot[which(dataPL$annot[,"SpecType"]=="spike"), "Accession"]tabS <- mergeVectors(PD=table(dataPD$annot[,"SpecType"]), MQ=table(dataMQ$annot[,"SpecType"]), PL=table(dataPL$annot[,"SpecType"]))
tabT <- mergeVectors(PD=table(dataPD$annot[,"Species"]), MQ=table(dataMQ$annot[,"Species"]), PL=table(dataPL$annot[,"Species"]))
tabS[which(is.na(tabS))] <- 0
tabT[which(is.na(tabT))] <- 0
kable(cbind(tabS[,2:1], tabT), caption="Number of proteins identified, by custom tags, species and software")| spike | mainSpecies | Gallus gallus | Homo sapiens | Mus musculus | Saccharomyces cerevisiae | Sus scrofa | |
|---|---|---|---|---|---|---|---|
| PD | 48 | 1239 | 1 | 44 | 0 | 1239 | 0 | 
| MQ | 48 | 1047 | 1 | 49 | 1 | 1047 | 1 | 
| PL | 48 | 1137 | 0 | 48 | 0 | 1137 | 1 | 
The initial fasta file also contained the yeast strain number, this has been stripped off when using default parameters.
The global structure of experiments can be provided as sdrf-file and/or from meta-data stored with the experimental data read. For convenience, this information about the groups of replicates was already deduced and can be found (for example) in dataMQ $ sampleSetup $ sdrf. Below, a few columns of the sdrf are shown.
kable(cbind(dataMQ$sampleSetup$sdrfDat[,c(23,7,19,22)], groups=dataMQ$sampleSetup$groups))| comment.data.file. | characteristics.spiked.compound. | comment.modification.parameters..2 | comment.file.uri. | groups | 
|---|---|---|---|---|
| UPS1_12500amol_R1.raw | CT=mixture;QY=12500 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_12500amol_R1.raw | 12500amol | 
| UPS1_12500amol_R2.raw | CT=mixture;QY=12500 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_12500amol_R2.raw | 12500amol | 
| UPS1_12500amol_R3.raw | CT=mixture;QY=12500 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_12500amol_R3.raw | 12500amol | 
| UPS1_125amol_R1.raw | CT=mixture;QY=125 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_125amol_R1.raw | 125amol | 
| UPS1_125amol_R2.raw | CT=mixture;QY=125 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_125amol_R2.raw | 125amol | 
| UPS1_125amol_R3.raw | CT=mixture;QY=125 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_125amol_R3.raw | 125amol | 
| UPS1_25000amol_R1.raw | CT=mixture;QY=25000 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_25000amol_R1.raw | 25000amol | 
| UPS1_25000amol_R2.raw | CT=mixture;QY=25000 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_25000amol_R2.raw | 25000amol | 
| UPS1_25000amol_R3.raw | CT=mixture;QY=25000 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_25000amol_R3.raw | 25000amol | 
| UPS1_2500amol_R1.raw | CT=mixture;QY=2500 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_2500amol_R1.raw | 2500amol | 
| UPS1_2500amol_R2.raw | CT=mixture;QY=2500 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_2500amol_R2.raw | 2500amol | 
| UPS1_2500amol_R3.raw | CT=mixture;QY=2500 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_2500amol_R3.raw | 2500amol | 
| UPS1_250amol_R1.raw | CT=mixture;QY=250 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_250amol_R1.raw | 250amol | 
| UPS1_250amol_R2.raw | CT=mixture;QY=250 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_250amol_R2.raw | 250amol | 
| UPS1_250amol_R3.raw | CT=mixture;QY=250 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_250amol_R3.raw | 250amol | 
| UPS1_50000amol_R1.raw | CT=mixture;QY=50000 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_50000amol_R1.raw | 50000amol | 
| UPS1_50000amol_R2.raw | CT=mixture;QY=50000 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_50000amol_R2.raw | 50000amol | 
| UPS1_50000amol_R3.raw | CT=mixture;QY=50000 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_50000amol_R3.raw | 50000amol | 
| UPS1_5000amol_R1.raw | CT=mixture;QY=5000 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_5000amol_R1.raw | 5000amol | 
| UPS1_5000amol_R2.raw | CT=mixture;QY=5000 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_5000amol_R2.raw | 5000amol | 
| UPS1_5000amol_R3.raw | CT=mixture;QY=5000 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_5000amol_R3.raw | 5000amol | 
| UPS1_500amol_R1.raw | CT=mixture;QY=500 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_500amol_R1.raw | 500amol | 
| UPS1_500amol_R2.raw | CT=mixture;QY=500 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_500amol_R2.raw | 500amol | 
| UPS1_500amol_R3.raw | CT=mixture;QY=500 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_500amol_R3.raw | 500amol | 
| UPS1_50amol_R1.raw | CT=mixture;QY=50 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_50amol_R1.raw | 50amol | 
| UPS1_50amol_R2.raw | CT=mixture;QY=50 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_50amol_R2.raw | 50amol | 
| UPS1_50amol_R3.raw | CT=mixture;QY=50 amol;CN=UPS1;CV=Standards Research Group | NT=Acetyl;AC=UNIMOD:67;PP=Protein N-term;MT=variable | https://ftp.pride.ebi.ac.uk/pride/data/archive/2015/12/PXD001819/UPS1_50amol_R3.raw | 50amol | 
To get more general information about normalization, please refer also to the vignette “Getting started with wrProteo” from this package.
No additional normalization is needed with this particular data-set. All data were already median normalized directly at import to the host proteins (ie Saccharomyces cerevisiae) after importing the initial quantification-output using ‘readMaxQuantFile()’, ‘readProlineFile()’ and ‘readProteomeDiscovererFile()’.
As mentioned in the general vignette of this package, ‘wrProteoVignette1’, it is important to investigate the nature of NA-values. In particular, checking the hypothesis that NA-values originate from very low abundance instances is very important for deciding how to treat NA-values furtheron.
## Let's inspect NA values from ProteomeDiscoverer as graphic
matrixNAinspect(dataPD$quant, gr=grp9, tit="ProteomeDiscoverer")
#> stableMode : Method='density',  length of x =976, 'bandw' has been set to 44## Let's inspect NA values from MaxQuant as graphic
matrixNAinspect(dataMQ$quant, gr=grp9, tit="MaxQuant")
#> stableMode : Method='density',  length of x =1142, 'bandw' has been set to 47## Let's inspect NA values from Proline as graphic
matrixNAinspect(dataPL$quant, gr=grp9, tit="Proline")
#> stableMode : Method='density',  length of x =413, 'bandw' has been set to 28A key element to understand the nature of NA-value is to investigate their NA-neighbours. If a given protein has for just one of the 3 replicates an NA, the other two valid quantifications can be considered as NA-neighbours. In the figures above all NA-neighbours are shown in the histogram and their mode is marked by an arrow. One can see, that NA-neighbours are predominantely (but not exclusively) part of the lower quantitation values. This supports the hypothesis that NAs occur most frequently with low abundance proteins.
NA-values represent a challange for statistical testing. In addition, techniques like PCA don’t allow NAs, neither.
The number of NAs varies between samples : Indeed, very low concentrations of UPS1 are difficult to get detected and contribute largely to the NAs (as we will see later in more detail). Since the amout of yeast proteins (ie the matrix in this setup) stays constant across all samples, yeast proteins should always get detected the same way.
## Let's look at the number of NAs. Is there an accumulated number in lower UPS1 samples ?
tabSumNA <- rbind(PD=sumNAperGroup(dataPD$raw, grp9), MQ=sumNAperGroup(dataMQ$raw, grp9), PL=sumNAperGroup(dataPL$raw, grp9) )
kable(tabSumNA, caption="Number of NAs per group of samples", align="r")| 7 | 2 | 8 | 5 | 3 | 9 | 6 | 4 | 1 | |
|---|---|---|---|---|---|---|---|---|---|
| PD | 195 | 273 | 209 | 205 | 257 | 220 | 207 | 234 | 272 | 
| MQ | 302 | 334 | 330 | 282 | 323 | 322 | 297 | 337 | 318 | 
| PL | 131 | 140 | 141 | 137 | 157 | 131 | 139 | 140 | 124 | 
In the section above we investigated the circumstances of NA-instances and provided evidence that NA-values typically represent proteins with low abundance which frequently ended up as non-detectable (NA). Thus, we hypothesize that (in most cases) NA-values might also have been detected in quantities like their NA-neighbours. In consequence, we will model a normal distribution based on the NA-neighbours and use for substituting.
The function testRobustToNAimputation() from this
package (wrProteo) allows to perform NA-imputation and subsequent
statistical testing (after repeated imputation) between all groups of
samples (see also the general vignette). One of the advantages of this
implementation, is that multiple rounds of imputation are run, so that
final results (including pair-wise testing) get stabilized to (rare)
stochastic effects. For this reason one may also speak of stabilized
NA-imputations.
The statistical tests used underneith make use of the shrinkage-procedure provided from the empirical Bayes procedure as implemented to the Bioconductor package limma, see also Ritchie et al 2015. In addition, various formats of multiple testing correction can be added to the results : Benjamini-Hochberg FDR (lateron referred to as BH or BH-FDR, see FDR on Wikipedia, see also Benjamini and Hochberg 1995), local false discovery rate (lfdr, using the package fdrtool, see Strimmer 2008), or modified testing by ROTS, etc … In this vignette we will make use of the BH-FDR.
We are ready to launch the NA-imputation and testing for data from ProteomeDiscoverer. Please note, that the procedure including repetive NA-imputations may take a several seconds.
testPD <- testRobustToNAimputation(dataPD, imputMethod="informed")     # ProteomeDiscoverer.
Then for MaxQuant …
testMQ <- testRobustToNAimputation(dataMQ, imputMethod="informed")      # MaxQuant , okAnd finally for Proline :
testPL <- testRobustToNAimputation(dataPL, imputMethod="informed")      # ProlineFrom these results we’ll use i) the NA-imputed version of our datasets for plotting principal components (PCA) and ii) the (stabilized) testing results for counting TP, FP, etc and to construct ROC curves.
Let’s add the NA-imputed data to our main object :
dataPD$datImp <- testPD$datImp       # recuperate imputeded data to main data-object
dataMQ$datImp <- testMQ$datImp
dataPL$datImp <- testPL$datImpIn this section we’ll consider all proteins identified and quantified in a pair-wise fashion, using the t-tests already run in the previous section. As mentioned, the experimental setup is very special, since all proteins that are truly changing are known in advance (the UPS1 spike-in proteins). Tables get constructed by counting based on various thresholds for considering given protein abundances as differential or not. A traditional 5 percent FDR cut-off is used for Volcano-plots, while ROC-curves allow inspecting the entire range of potential cut-off values.
A very universal and simple way to analyze data is by checking as several pairwise comparisons, in particular, if the experimental setup does not include complete multifactorial plans.
This UPS1 spike-in experiment (see also Experimental Setup) has 27 samples organized (according to meta-information) as 9 groups. Thus, one obtains in total 36 pair-wise comparisons which will make comparisons very crowded. The original publication by Ramus et al 2016 focussed on 3 pairwise comparisons only. In this vignette it is shown how all of them can get considered.
Now, we’ll construct a table showing all possible pairwise-comparisons. Using the function numPairDeColNames() we can easily extract the UPS1 concentrations as numeric content and show the (log-)ratio of the pairwise comparisons (column ‘log2rat’), the final concentrations (columns ‘conc1’ and ‘conc2’, in amol) and the number of differentially abundant proteins passing 5% FDR (using classical Benjamini-Hochberg FDR (columns ‘sig.xx.BH’) or lfdr (Strimmer 2008, columns ‘sig._xx_.lfdr’ ).
## The number of differentially abundant proteins passing 5% FDR (ProteomeDiscoverer and MaxQuant)
signCount <- cbind( sig.PD.BH=colSums(testPD$BH < 0.05, na.rm=TRUE), sig.PD.lfdr=if("lfdr" %in% names(testPD)) colSums(testPD$lfdr < 0.05, na.rm=TRUE),
  sig.MQ.BH=colSums(testMQ$BH < 0.05, na.rm=TRUE), sig.MQ.lfdr=if("lfdr" %in% names(testMQ)) colSums(testMQ$lfdr < 0.05, na.rm=TRUE),
  sig.PL.BH=colSums(testPL$BH < 0.05, na.rm=TRUE), sig.PL.lfdr=if("lfdr" %in% names(testPL)) colSums(testPL$lfdr < 0.05, na.rm=TRUE)  )
  
  
table1 <- numPairDeColNames(testPD$BH, stripTxt="amol", sortByAbsRatio=TRUE)
table1 <- cbind(table1, signCount[table1[,1],])
rownames(table1) <- colnames(testMQ$BH)[table1[,1]]
kable(table1, caption="All pairwise comparisons and number of significant proteins", align="c")| index | log2rat | conc1 | conc2 | sig.PD.BH | sig.PD.lfdr | sig.MQ.BH | sig.MQ.lfdr | sig.PL.BH | sig.PL.lfdr | |
|---|---|---|---|---|---|---|---|---|---|---|
| 50000amol-50amol | 34 | 9.966 | 50 | 50000 | 547 | 503 | 438 | 388 | 738 | 659 | 
| 250amol-50000amol | 15 | 8.966 | 50 | 25000 | 601 | 539 | 412 | 343 | 685 | 625 | 
| 12500amol-50amol | 29 | 8.644 | 125 | 50000 | 370 | 286 | 321 | 242 | 605 | 548 | 
| 125amol-50000amol | 12 | 7.966 | 50 | 12500 | 531 | 490 | 374 | 329 | 715 | 646 | 
| 12500amol-250amol | 7 | 7.644 | 125 | 25000 | 365 | 304 | 107 | 89 | 409 | 380 | 
| 25000amol-50amol | 31 | 7.644 | 250 | 50000 | 348 | 284 | 434 | 383 | 724 | 666 | 
| 12500amol-125amol | 1 | 6.644 | 125 | 12500 | 240 | 195 | 120 | 96 | 534 | 477 | 
| 25000amol-250amol | 9 | 6.644 | 250 | 25000 | 235 | 178 | 368 | 322 | 615 | 559 | 
| 50000amol-500amol | 27 | 6.644 | 50 | 5000 | 593 | 529 | 426 | 395 | 708 | 642 | 
| 5000amol-50amol | 35 | 6.644 | 500 | 50000 | 333 | 278 | 338 | 292 | 541 | 462 | 
| 125amol-25000amol | 3 | 5.644 | 250 | 12500 | 137 | 97 | 346 | 283 | 689 | 638 | 
| 2500amol-50000amol | 14 | 5.644 | 50 | 2500 | 571 | 544 | 511 | 478 | 706 | 624 | 
| 250amol-5000amol | 20 | 5.644 | 500 | 25000 | 250 | 178 | 41 | 29 | 137 | 104 | 
| 12500amol-500amol | 22 | 5.322 | 125 | 5000 | 290 | 257 | 109 | 61 | 426 | 416 | 
| 125amol-5000amol | 17 | 4.644 | 500 | 12500 | 159 | 102 | 97 | 70 | 286 | 246 | 
| 12500amol-2500amol | 4 | 4.322 | 125 | 2500 | 240 | 203 | 124 | 149 | 343 | 383 | 
| 25000amol-500amol | 24 | 4.322 | 250 | 5000 | 181 | 115 | 379 | 346 | 641 | 584 | 
| 2500amol-50amol | 32 | 4.322 | 2500 | 50000 | 295 | 215 | 322 | 260 | 483 | 418 | 
| 25000amol-2500amol | 6 | 3.322 | 250 | 2500 | 125 | 94 | 497 | 435 | 606 | 539 | 
| 2500amol-250amol | 10 | 3.322 | 2500 | 25000 | 62 | 45 | 29 | 25 | 86 | 60 | 
| 50000amol-5000amol | 21 | 3.322 | 50 | 500 | 436 | 370 | 463 | 439 | 614 | 557 | 
| 5000amol-500amol | 28 | 3.322 | 500 | 5000 | 159 | 118 | 58 | 31 | 137 | 98 | 
| 500amol-50amol | 36 | 3.322 | 5000 | 50000 | 270 | 203 | 228 | 178 | 366 | 317 | 
| 125amol-2500amol | 5 | 2.322 | 2500 | 12500 | 26 | 16 | 97 | 79 | 161 | 111 | 
| 25000amol-50000amol | 13 | 2.322 | 50 | 250 | 362 | 273 | 98 | 87 | 93 | 67 | 
| 2500amol-5000amol | 19 | 2.322 | 500 | 2500 | 138 | 94 | 11 | 9 | 19 | 10 | 
| 250amol-500amol | 26 | 2.322 | 5000 | 25000 | 39 | 26 | 1 | 0 | 3 | 2 | 
| 12500amol-5000amol | 16 | 2.000 | 125 | 500 | 30 | 23 | 66 | 60 | 121 | 169 | 
| 125amol-50amol | 30 | 2.000 | 12500 | 50000 | 212 | 139 | 140 | 113 | 202 | 174 | 
| 12500amol-50000amol | 11 | 1.322 | 50 | 125 | 289 | 244 | 266 | 201 | 357 | 305 | 
| 125amol-500amol | 23 | 1.322 | 5000 | 12500 | 20 | 10 | 5 | 2 | 23 | 7 | 
| 12500amol-25000amol | 2 | 1.000 | 125 | 250 | 19 | 13 | 100 | 85 | 89 | 86 | 
| 125amol-250amol | 8 | 1.000 | 12500 | 25000 | 12 | 10 | 1 | 0 | 3 | 2 | 
| 25000amol-5000amol | 18 | 1.000 | 250 | 500 | 6 | 2 | 434 | 440 | 459 | 405 | 
| 2500amol-500amol | 25 | 1.000 | 2500 | 5000 | 14 | 11 | 44 | 28 | 99 | 66 | 
| 250amol-50amol | 33 | 1.000 | 25000 | 50000 | 135 | 83 | 192 | 132 | 305 | 249 | 
resMQ1 <- extractTestingResults(testMQ, compNo=1, thrsh=0.05, FCthrs=2)
resPD1 <- extractTestingResults(testPD, compNo=1, thrsh=0.05, FCthrs=2)
resPL1 <- extractTestingResults(testPL, compNo=1, thrsh=0.05, FCthrs=2)You can see that in numerous cases much more than the 48 UPS1 proteins showed up significant, ie yeast proteins supposed to remain constant also showed up in part as ‘sigificantly changing’. However, some proteins with enthousiastic FDR values have very low log-FC amplitude and will be removed by filtering in the following steps.
par(mar=c(5.5, 4.7, 4, 1))
imageW(table1[,c("sig.PD.BH","sig.MQ.BH","sig.PL.BH" )], col=(RColorBrewer::brewer.pal(9,"YlOrRd")),
  transp=FALSE, tit="Number of BH.FDR passing proteins by the quantification approaches")
mtext("Dark red for high number signif proteins", cex=0.75)In the original Ramus et al 2016 et al paper only 3 pairwise comparisons were further analyzed :
## Selection in Ramus paper
kable(table1[which(rownames(table1) %in% colnames(testPD$BH)[c(2,21,27)]),], caption="Selected pairwise comparisons (as in Ramus et al)", align="c")| index | log2rat | conc1 | conc2 | sig.PD.BH | sig.PD.lfdr | sig.MQ.BH | sig.MQ.lfdr | sig.PL.BH | sig.PL.lfdr | 
|---|
Here we’ll consider all possible pairwise comparisons, as shown below.
Volcano-plots offer additional insight in how statistical test results relate to log-fold-change of pair-wise comparisons. In addition, we can mark the different protein-groups (or species) by different symbols, see also the general vignette ‘wrProteoVignette1’ (from this package) and the vignette to the package wrGraph. Counting the number of proteins passing a classical threshold for differential expression combined with a filter for minimum log-fold-change is a good way to start.
As mentioned, the dataset from Ramus et al 2016
contains 9 different levels of UPS1 concentrations (Ramus Data Set),
in consequence 36 pair-wise comparisons are possible. Again, plotting
all possible Volcano plots would make way too crowded plots, instead
we’ll try to summarize (see ROC curves), cluster into groups and finally
plot only a few representative ones.
Receiver Operator Curves (ROC) curves display sensitivity (True Positive Rate) versus 1-Specificity (False Positive Rate). They are typically used as illustrate and compare the discriminiative capacity of a yes/no decision system (here: differential abundance or not), see eg also the original publication Hand and Till 2001.
The data get constructed by sliding through a panel of threshold-values for the statistical tests instead of just using 0.05. Due to the experimental setup we know that all yeast proteins should stay constant and only UPS1 proteins (see also Experimental Setup) are expected to change. For each of these threshold values one counts the number of true positives (TP), false positives (FP) etc, allowing then to calculate sensitivity and specificity.
In the case of bechmarking quantitation efforts, ROC curves are used to judge how well heterologous spikes UPS1 proteins can be recognized as differentially abundant while constant yeast matrix proteins should not get classified as differential. Finally, ROC curves let us also gain some additional insights in the question which cutoff may be optimal or if the commonly used 5-percent FDR threshld cutoff allows getting the best out of the testing system.
The next step consists in calculating the area under the curve (AUC) for the individual profiles of each pairwise comparison. Below, these calculations of summarizeForROC() are run in batch.
## calulate  AUC for each ROC
layout(1)
  #aaa <- summarizeForROC(testPD, useComp=table1[1,1], annotCol="SpecType", spec=c("mainSpecies","spike"), tyThr="BH", plotROC=FALSE,debug=TRUE)
rocPD <- lapply(table1[,1], function(x) summarizeForROC(testPD, useComp=x, annotCol="SpecType", 
  spec=c("mainSpecies","spike"), tyThr="BH", plotROC=FALSE,silent=TRUE))
rocMQ <- lapply(table1[,1], function(x) summarizeForROC(testMQ, useComp=x, annotCol="SpecType", 
  spec=c("mainSpecies","spike"), tyThr="BH", plotROC=FALSE,silent=TRUE))
rocPL <- lapply(table1[,1], function(x) summarizeForROC(testPL, useComp=x, annotCol="SpecType", 
  spec=c("mainSpecies","spike"), tyThr="BH", plotROC=FALSE,silent=TRUE))
# we still need to add the names for the pair-wise groups:
names(rocPD) <- names(rocMQ) <- names(rocPL) <- rownames(table1)AucAll <- cbind(ind=table1[match(names(rocPD), rownames(table1)),"index"], clu=NA,
  PD=sapply(rocPD, AucROC), MQ=sapply(rocMQ, AucROC), PL=sapply(rocPL, AucROC) )To provide a quick overview, the clustered AUC values are displayed as PCA :
try(biplot(prcomp(AucAll[,names(methNa)]), cex=0.7, main="PCA of AUC from ROC Curves"))On this PCA one can see the three software types in red. We can see that AUC values from MaxQuant correlate somehow less to Proline and ProteomeDiscoverer (red arrows). The pair-wise ratios constructed from the different rations are shown in black. They form a compact area with mostly wide ratios (one rather high and one low concentration of UPS1 proteins). Besides, there is a number of disperse points, typically containig the point of 125 and/or 250 fmol. These disperse points do not replicate well and follow their own characteristics captured by PC2.
Now we are ready to inspect the 5 clusters in detail :
As mentioned, there are too many pair-wise combinations available for plotting and inspecting all ROC-curves. So we can try to group similar pairwise comparison AUC values into clusters and then easily display representative examples for each cluster/group. Again, we (pre)define that we want to obtain 5 groups (like customer-ratings from 5 to 1 stars), a k-Means clustering approach was chosen.
## number of groups for clustering
nGr <- 5
## K-Means clustering
kMAx <- stats::kmeans(standardW(AucAll[,c("PD","MQ","PL")]), nGr)$cluster
   table(kMAx)
#> kMAx
#>  1  2  3  4  5 
#>  4 20  6  5  1
AucAll[,"clu"] <- kMAxAucAll <- reorgByCluNo(AucAll, cluNo=kMAx, useColumn=c("PD","MQ","PL"))
AucAll <- cbind(AucAll, iniInd=table1[match(rownames(AucAll), rownames(table1)), "index"])
colnames(AucAll)[1:(which(colnames(AucAll)=="index")-1)] <- paste("Auc",colnames(AucAll)[1:(which(colnames(AucAll)=="index")-1)], sep=".")
AucAll[,"cluNo"] <- rep(nGr:1, table(AucAll[,"cluNo"]))        # make cluNo descending
kMAx <- AucAll[,"cluNo"]      # update
  table(AucAll[,"cluNo"])
#> 
#>  1  2  3  4  5 
#>  1  5  6  4 20
 ## note : column 'index' is relative to table1, iniInd to ordering inside objects from clusteringTo graphically summarize the AUC values, the clustered AUC values are plotted accompagnied by the geometric mean:
try(profileAsClu(AucAll[,c(1:length(methNa),(length(methNa)+2:3))], clu="cluNo", meanD="geoMean", tit="Pairwise Comparisons as Clustered AUC from ROC Curves",
  xlab="Comparison number", ylab="AUC", meLty=1, meLwd=3))From this figure we can see clearly that there are some pairwise comparisons where all initial analysis-software results yield high AUC values, while other pairwise comparisons less discriminative power.
Again, now we can select a representative pairwise-comparison for each cluster (from the center of each cluster):
AucRep <- table(AucAll[,"cluNo"])[rank(unique(AucAll[,"cluNo"]))]   # representative for each cluster
AucRep <- round(cumsum(AucRep) -AucRep/2 +0.1)
## select representative for each cluster
kable(round(AucAll[AucRep,c("Auc.PD","Auc.MQ","Auc.PL","cluNo")], 3), caption="Selected representative for each cluster ", align="c")| Auc.PD | Auc.MQ | Auc.PL | cluNo | |
|---|---|---|---|---|
| 50000amol-50amol | 0.963 | 0.994 | 0.950 | 5 | 
| 125amol-2500amol | 0.941 | 0.788 | 0.935 | 4 | 
| 50000amol-5000amol | 0.456 | 0.993 | 0.941 | 3 | 
| 125amol-250amol | 0.848 | 0.699 | 0.482 | 2 | 
| 125amol-500amol | 0.845 | 0.395 | 0.730 | 1 | 
Now we can check if some experimental UPS1 log-fold-change have a bias for some clusters.
ratTab <- sapply(5:1, function(x) { y <- table1[match(rownames(AucAll),rownames(table1)),]
  table(factor(signif(y[which(AucAll[,"cluNo"]==x),"log2rat"],1), levels=unique(signif(table1[,"log2rat"],1))) )})
colnames(ratTab) <- paste0("\nclu",5:1,"\nn=",rev(table(kMAx)))
layout(1)
imageW(ratTab, tit="Frequency of rounded log2FC in the 5 clusters", xLab="log2FC (rounded)", 
  yLab="log2 Fold-Change", col=c("grey95", RColorBrewer::brewer.pal(8,"YlOrRd")), las=1)
mtext("Dark red for enrichment of given pair-wise ratio", cex=0.7)We can see, that the cluster of best ROC-curves (cluster 5) covers practically all UPS1 log-ratios from this experiment without being restricted just to the high ratios.
colPanel <- 2:5
gr <- 5
j <- match(rownames(AucAll)[AucRep[6-gr]], colnames(testPD$t))
## table of all proteins in cluster
useLi <- which(AucAll[,"cluNo"]==gr)
tmp <- cbind(round(as.data.frame(AucAll)[useLi,c("cluNo","Auc.PD","Auc.MQ","Auc.PL")],3),
  as.data.frame(table1)[match(names(useLi),rownames(table1)), c(2,5,7,9)])
kable(tmp, caption="AUC details for best pairwise-comparisons ", align="c")| cluNo | Auc.PD | Auc.MQ | Auc.PL | log2rat | sig.PD.BH | sig.MQ.BH | sig.PL.BH | |
|---|---|---|---|---|---|---|---|---|
| 12500amol-250amol | 5 | 0.976 | 0.996 | 0.983 | 7.644 | 365 | 107 | 409 | 
| 250amol-50000amol | 5 | 0.973 | 0.998 | 0.979 | 8.966 | 601 | 412 | 685 | 
| 25000amol-250amol | 5 | 0.978 | 0.994 | 0.975 | 6.644 | 235 | 368 | 615 | 
| 250amol-5000amol | 5 | 0.978 | 0.977 | 0.990 | 5.644 | 250 | 41 | 137 | 
| 12500amol-50amol | 5 | 0.977 | 0.986 | 0.965 | 8.644 | 370 | 321 | 605 | 
| 25000amol-500amol | 5 | 0.965 | 0.994 | 0.968 | 4.322 | 181 | 379 | 641 | 
| 125amol-25000amol | 5 | 0.971 | 0.981 | 0.958 | 5.644 | 137 | 346 | 689 | 
| 5000amol-500amol | 5 | 0.955 | 0.968 | 0.986 | 3.322 | 159 | 58 | 137 | 
| 25000amol-50amol | 5 | 0.979 | 0.978 | 0.952 | 7.644 | 348 | 434 | 724 | 
| 50000amol-50amol | 5 | 0.963 | 0.994 | 0.950 | 9.966 | 547 | 438 | 738 | 
| 125amol-50000amol | 5 | 0.935 | 0.996 | 0.970 | 7.966 | 531 | 374 | 715 | 
| 12500amol-500amol | 5 | 0.930 | 0.994 | 0.973 | 5.322 | 290 | 109 | 426 | 
| 50000amol-500amol | 5 | 0.917 | 0.998 | 0.976 | 6.644 | 593 | 426 | 708 | 
| 5000amol-50amol | 5 | 0.980 | 0.938 | 0.951 | 6.644 | 333 | 338 | 541 | 
| 12500amol-125amol | 5 | 0.921 | 0.976 | 0.964 | 6.644 | 240 | 120 | 534 | 
| 125amol-5000amol | 5 | 0.963 | 0.904 | 0.957 | 4.644 | 159 | 97 | 286 | 
| 25000amol-2500amol | 5 | 0.913 | 0.994 | 0.918 | 3.322 | 125 | 497 | 606 | 
| 12500amol-2500amol | 5 | 0.858 | 0.997 | 0.922 | 4.322 | 240 | 124 | 343 | 
| 2500amol-50000amol | 5 | 0.822 | 0.998 | 0.950 | 5.644 | 571 | 511 | 706 | 
| 2500amol-5000amol | 5 | 0.890 | 0.927 | 0.898 | 2.322 | 138 | 11 | 19 | 
## frequent concentrations :
layout(matrix(1:2), heights=c(1,2.5))
plotConcHist(mat=tmp, ref=table1)
## representative ROC
jR <- match(rownames(AucAll)[AucRep[6-gr]], names(rocPD))
plotROC(rocPD[[jR]], rocMQ[[jR]], rocPL[[jR]], col=colPanel, methNames=methNa, pointSi=0.8, xlim=c(0,0.45),
  txtLoc=c(0.12,0.1,0.033), tit=paste("Cluster",gr," Example: ",names(rocPD)[jR]), legCex=1)## This required package 'wrGraph' at version 1.2.5 (or higher)
if(packageVersion("wrGraph")  >= "1.2.5") {
  layout(matrix(1:4,ncol=2))
  try(VolcanoPlotW(testPD, useComp=j, FCthrs=1.5, FdrThrs=0.05, annColor=c(4,2,3), ProjNa=methNa[1], expFCarrow=TRUE, silent=TRUE),silent=TRUE)
  try(VolcanoPlotW(testMQ, useComp=j, FCthrs=1.5, FdrThrs=0.05, annColor=c(4,2,3), ProjNa=methNa[2], expFCarrow=TRUE, silent=TRUE),silent=TRUE)
  try(VolcanoPlotW(testPL, useComp=j, FCthrs=1.5, FdrThrs=0.05, annColor=c(4,2,3), ProjNa=methNa[3], expFCarrow=TRUE, silent=TRUE),silent=TRUE)}gr <- 4
j <- match(rownames(AucAll)[AucRep[6-gr]], colnames(testPD$t))
## table of all proteins in cluster
useLi <- which(AucAll[,"cluNo"]==gr)
tmp <- cbind(round(as.data.frame(AucAll)[useLi,c("cluNo","Auc.PD","Auc.MQ","Auc.PL")],3),
  as.data.frame(table1)[match(names(useLi),rownames(table1)), c(2,5,7,9)])
kable(tmp, caption="AUC details for cluster '++++' pairwise-comparisons ", align="c")| cluNo | Auc.PD | Auc.MQ | Auc.PL | log2rat | sig.PD.BH | sig.MQ.BH | sig.PL.BH | |
|---|---|---|---|---|---|---|---|---|
| 2500amol-250amol | 4 | 0.976 | 0.808 | 0.979 | 3.322 | 62 | 29 | 86 | 
| 125amol-2500amol | 4 | 0.941 | 0.788 | 0.935 | 2.322 | 26 | 97 | 161 | 
| 2500amol-500amol | 4 | 0.810 | 0.853 | 0.964 | 1.000 | 14 | 44 | 99 | 
| 2500amol-50amol | 4 | 0.977 | 0.694 | 0.896 | 4.322 | 295 | 322 | 483 | 
## frequent concentrations :
layout(matrix(1:2), heights=c(1,2.5))
plotConcHist(mat=tmp, ref=table1)
## representative ROC
jR <- match(rownames(AucAll)[AucRep[6-gr]], names(rocPD))
plotROC(rocPD[[jR]], rocMQ[[jR]], rocPL[[jR]], col=colPanel, methNames=methNa, pointSi=0.8, xlim=c(0,0.45),
  txtLoc=c(0.12,0.1,0.033), tit=paste("Cluster",gr," Example: ",names(rocPD)[jR]), legCex=1)if(packageVersion("wrGraph")  >= "1.2.5"){
  layout(matrix(1:4,ncol=2))
  try(VolcanoPlotW(testPD, useComp=j, FCthrs=1.5, FdrThrs=0.05, annColor=c(4,2,3), ProjNa=methNa[1], expFCarrow=TRUE, silent=TRUE),silent=TRUE)
  try(VolcanoPlotW(testMQ, useComp=j, FCthrs=1.5, FdrThrs=0.05, annColor=c(4,2,3), ProjNa=methNa[2], expFCarrow=TRUE, silent=TRUE),silent=TRUE)
  try(VolcanoPlotW(testPL, useComp=j, FCthrs=1.5, FdrThrs=0.05, annColor=c(4,2,3), ProjNa=methNa[3], expFCarrow=TRUE, silent=TRUE),silent=TRUE)}gr <- 3
j <- match(rownames(AucAll)[AucRep[6-gr]], colnames(testPD$t))
## table of all proteins in cluster
useLi <- which(AucAll[,"cluNo"]==gr)
tmp <- cbind(round(as.data.frame(AucAll)[useLi,c("cluNo","Auc.PD","Auc.MQ","Auc.PL")],3),
  as.data.frame(table1)[match(names(useLi),rownames(table1)), c(2,5,7,9)])
kable(tmp, caption="AUC details for cluster '+++' pairwise-comparisons ", align="c")| cluNo | Auc.PD | Auc.MQ | Auc.PL | log2rat | sig.PD.BH | sig.MQ.BH | sig.PL.BH | |
|---|---|---|---|---|---|---|---|---|
| 25000amol-5000amol | 3 | 0.598 | 0.971 | 0.890 | 1.000 | 6 | 434 | 459 | 
| 12500amol-5000amol | 3 | 0.590 | 0.970 | 0.871 | 2.000 | 30 | 66 | 121 | 
| 50000amol-5000amol | 3 | 0.456 | 0.993 | 0.941 | 3.322 | 436 | 463 | 614 | 
| 12500amol-50000amol | 3 | 0.412 | 0.969 | 0.946 | 1.322 | 289 | 266 | 357 | 
| 12500amol-25000amol | 3 | 0.572 | 0.795 | 0.825 | 1.000 | 19 | 100 | 89 | 
| 25000amol-50000amol | 3 | 0.368 | 0.932 | 0.925 | 2.322 | 362 | 98 | 93 | 
## frequent concentrations :
layout(matrix(1:2), heights=c(1,2.5))
plotConcHist(mat=tmp, ref=table1)
## representative ROC
jR <- match(rownames(AucAll)[AucRep[6-gr]], names(rocPD))
plotROC(rocPD[[jR]],rocMQ[[jR]],rocPL[[jR]], col=colPanel, methNames=methNa, pointSi=0.8, xlim=c(0,0.45),
  txtLoc=c(0.12,0.1,0.033), tit=paste("Cluster",gr," Example: ",names(rocPD)[jR]), legCex=1)if(packageVersion("wrGraph")  >= "1.2.5"){
  layout(matrix(1:4,ncol=2))
  try(VolcanoPlotW(testPD, useComp=j, FCthrs=1.5, FdrThrs=0.05, annColor=c(4,2,3), ProjNa=methNa[1], expFCarrow=TRUE, silent=TRUE),silent=TRUE)
  try(VolcanoPlotW(testMQ, useComp=j, FCthrs=1.5, FdrThrs=0.05, annColor=c(4,2,3), ProjNa=methNa[2], expFCarrow=TRUE, silent=TRUE),silent=TRUE)
  try(VolcanoPlotW(testPL, useComp=j, FCthrs=1.5, FdrThrs=0.05, annColor=c(4,2,3), ProjNa=methNa[3], expFCarrow=TRUE, silent=TRUE),silent=TRUE)}gr <- 2
j <- match(rownames(AucAll)[AucRep[6-gr]], colnames(testPD$t))
## table of all proteins in cluster
useLi <- which(AucAll[,"cluNo"]==gr)
tmp <- cbind(round(as.data.frame(AucAll)[useLi,c("cluNo","Auc.PD","Auc.MQ","Auc.PL")],3),
  as.data.frame(table1)[match(names(useLi),rownames(table1)), c(2,5,7,9)])
kable(tmp, caption="AUC details for cluster '++' pairwise-comparisons ", align="c")| cluNo | Auc.PD | Auc.MQ | Auc.PL | log2rat | sig.PD.BH | sig.MQ.BH | sig.PL.BH | |
|---|---|---|---|---|---|---|---|---|
| 250amol-500amol | 2 | 0.919 | 0.688 | 0.601 | 2.322 | 39 | 1 | 3 | 
| 500amol-50amol | 2 | 0.958 | 0.651 | 0.527 | 3.322 | 270 | 228 | 366 | 
| 125amol-250amol | 2 | 0.848 | 0.699 | 0.482 | 1.000 | 12 | 1 | 3 | 
| 125amol-50amol | 2 | 0.922 | 0.573 | 0.472 | 2.000 | 212 | 140 | 202 | 
| 250amol-50amol | 2 | 0.878 | 0.582 | 0.427 | 1.000 | 135 | 192 | 305 | 
## frequent concentrations :
layout(matrix(1:2), heights=c(1,2.5))
plotConcHist(mat=tmp, ref=table1)
## representative ROC
jR <- match(rownames(AucAll)[AucRep[6-gr]], names(rocPD))
plotROC(rocPD[[jR]], rocMQ[[jR]], rocPL[[jR]], col=colPanel, methNames=methNa, pointSi=0.8, xlim=c(0,0.45),
  txtLoc=c(0.12,0.1,0.033), tit=paste("Cluster",gr," Example: ",names(rocPD)[jR]), legCex=1)if(packageVersion("wrGraph")  >= "1.2.5"){
  layout(matrix(1:4,ncol=2))
  try(VolcanoPlotW(testPD, useComp=j, FCthrs=1.5, FdrThrs=0.05, annColor=c(4,2,3), ProjNa=methNa[1], expFCarrow=TRUE, silent=TRUE),silent=TRUE)
  try(VolcanoPlotW(testMQ, useComp=j, FCthrs=1.5, FdrThrs=0.05, annColor=c(4,2,3), ProjNa=methNa[2], expFCarrow=TRUE, silent=TRUE),silent=TRUE)
  try(VolcanoPlotW(testPL, useComp=j, FCthrs=1.5, FdrThrs=0.05, annColor=c(4,2,3), ProjNa=methNa[3], expFCarrow=TRUE, silent=TRUE),silent=TRUE)}gr <- 1
j <- match(rownames(AucAll)[AucRep[6-gr]], colnames(testPD$t))
## table of all proteins in cluster
useLi <- which(AucAll[,"cluNo"]==gr)
tmp <- cbind(round(as.data.frame(AucAll)[useLi,c("cluNo","Auc.PD","Auc.MQ","Auc.PL")],3),
  as.data.frame(table1)[match(names(useLi),rownames(table1)), c(2,5,7,9)])
kable(tmp, caption="AUC details for cluster '+' pairwise-comparisons ", align="c")| cluNo | Auc.PD | Auc.MQ | Auc.PL | log2rat | sig.PD.BH | sig.MQ.BH | sig.PL.BH | |
|---|---|---|---|---|---|---|---|---|
| 125amol-500amol | 1 | 0.845 | 0.395 | 0.73 | 1.322 | 20 | 5 | 23 | 
## frequent concentrations :
layout(matrix(1:2, ncol=1), heights=c(1,2.5))
plotConcHist(mat=tmp, ref=table1)
## representative ROC
jR <- match(rownames(AucAll)[AucRep[6-gr]], names(rocPD))
plotROC(rocPD[[jR]], rocMQ[[jR]], rocPL[[jR]], col=colPanel, methNames=methNa, pointSi=0.8, xlim=c(0,0.45),
  txtLoc=c(0.12,0.1,0.033), tit=paste("Cluster",gr," Example: ",names(rocPD)[jR]), legCex=1)if(packageVersion("wrGraph")  >= "1.2.5"){
  layout(matrix(1:4,ncol=2))
  try(VolcanoPlotW(testPD, useComp=j, FCthrs=1.5, FdrThrs=0.05, annColor=c(4,2,3), ProjNa=methNa[1], expFCarrow=TRUE, silent=TRUE),silent=TRUE)
  try(VolcanoPlotW(testMQ, useComp=j, FCthrs=1.5, FdrThrs=0.05, annColor=c(4,2,3), ProjNa=methNa[2], expFCarrow=TRUE, silent=TRUE),silent=TRUE)
  try(VolcanoPlotW(testPL, useComp=j, FCthrs=1.5, FdrThrs=0.05, annColor=c(4,2,3), ProjNa=methNa[3], expFCarrow=TRUE, silent=TRUE),silent=TRUE)}We know from the experimental setup that there were 48 UPS1 proteins (see also Experimental Setup). present in the commercial mix added to a constant background of yeast-proteins. The lowest concentrations are extremely challenging and it is no surprise that many of them were not detected at the lowest concentration(s). In order to choose among the various concentrations of UPS1, let’s look how many NAs are in each group of replicates (ie before NA-imputation), and in particular, the number of NAs among the UPS1 proteins.
Previsouly we’ve looked at the total number of NAs, now let’s focus just on the UPS1 proteins. Obviously, instances of non-quantified UPS1 proteins make the following comparisons using these samples rather insecure, since NA-imputation is just an ‘educated guess’.
tab1 <- rbind(PD=sumNAperGroup(dataPD$raw[which(dataPD$annot[,"SpecType"]=="spike"),], grp9),
  MQ=sumNAperGroup(dataMQ$raw[which(dataMQ$annot[,"SpecType"]=="spike"),], grp9),
  PL= sumNAperGroup(dataPL$raw[which(dataPL$annot[,"SpecType"]=="spike"),], grp9)  )
kable(tab1, caption="The number of NAs in the UPS1 proteins", align="c")| 7 | 2 | 8 | 5 | 3 | 9 | 6 | 4 | 1 | |
|---|---|---|---|---|---|---|---|---|---|
| PD | 0 | 73 | 0 | 1 | 69 | 0 | 0 | 43 | 79 | 
| MQ | 3 | 113 | 4 | 19 | 109 | 1 | 10 | 98 | 112 | 
| PL | 0 | 32 | 0 | 0 | 34 | 0 | 0 | 20 | 27 | 
One can see that starting the 5th level of UPS1 concentrations almost all UPS1 proteins were found in nearly all samples. In consequence we’ll avoid using all of them at all times, but this should be made depending on the very protein and quantification method.
Let’s look graphically at the number of NAs in each of the UPS1 proteins along the quantification methods :
countRawNA <- function(dat, newOrd=UPS1$ac, relative=FALSE) {  # count number of NAs per UPS protein and order as UPS
  out <- rowSums(is.na(dat$raw[match(newOrd,rownames(dat$raw)),]))
  if(relative) out/nrow(dat$raw) else out }
sumNAperMeth <- cbind(PD=countRawNA(dataPD), MQ=countRawNA(dataMQ), PL=countRawNA(dataPL) )
UPS1na <- sub("_UPS","", dataPL$annot[(rownames(dataPL$annot) %in% UPS1$acFull),"EntryName"])
par(mar=c(6.8, 3.5, 4, 1))
#imageW(sumNAperMeth, rowNa=UPS1na, tit="Number of NAs in UPS  proteins", xLab="", yLab="",
imageW(sumNAperMeth, tit="Number of NAs in UPS  proteins", xLab="", yLab="",
  transp=FALSE, col=RColorBrewer::brewer.pal(9,"YlOrRd"))
mtext("Dark red for high number of NAs",cex=0.7)Typically the number of NAs is similar when comparing the different quantitation approaches, it tends to be a bit higher with MaxQuant. This means that some UPS1 proteins which are easier to (detect and) quantify than others. We can conclude, the capacity to successfully quantify a given protein depends on its abundance and its composition.
Plotting the principal components (PCA) typically allows to gain an overview on how samples are related to each other. This type of experiment is special for the fact that the majority of proteins is expected to remain constant (yeast matrix), while only the UPS1 proteins (see also Experimental Setup) vary. Since we are primarily intereseted in the UPS1 proteins, the regular plots of PCA are not shown here, but PCA of the lines identified as UPS1.
Principal
component analysis (PCA) cannot handle NA-values. Either all lines
with any NAs have to be excluded, or data after NA-imputation have to be
used. Here, the option of plotting data after NA-imputation was chosen
(in the context of filtering UPS1 lines only one whould loose too many
lines, ie proteins). Below plots are be made using the function
plotPCAw() from the package wrGraph. Via
indexing we choose only the lines./proteins with the annoation ‘spike’
(ie UPS1).
try(plotPCAw(testPD$datImp[which(testPD$annot[,"SpecType"]=="spike"),], sampleGrp=grp9, tit="PCA on ProteomeDiscoverer, UPS1 only (NAs imputed)", rowTyName="proteins", useSymb2=0, silent=TRUE), silent=TRUE)try(plotPCAw(testMQ$datImp[which(testMQ$annot[,"SpecType"]=="spike"),], sampleGrp=grp9, tit="PCA on MaxQuant, UPS1 only (NAs imputed)", rowTyName="proteins", useSymb2=0, silent=TRUE), silent=TRUE)try(plotPCAw(testPL$datImp[which(testPL$annot[,"SpecType"]=="spike"),], sampleGrp=grp9, tit="PCA on Proline, UPS1 only (NAs imputed)", rowTyName="proteins", useSymb2=0, silent=TRUE), silent=TRUE)Based on PCA plots one can see that the concentrations 125 - 500 aMol are very much alike and detecting differences may perform better when not combining them, as also confirmed by ROC part later. In the Screeplot we can see that the first principal component captures almost all variability. Thus, displaying the 3rd principal component (as done above) finally has no importance.
In order to have more data available for linear regression modelling it was decided to use UPS1 abundance values after NA-Imputation for linear regressions. Previously it was shown that NA values originate predominantly from absent or very low abundance quantitations, which justified relplacing NA values by low abundance values in a shrinkage like fashion.
As general indicator for data-quality and -usability let’s look at the intra-replicate variability. Here we plot all intra-group CVs (defined by UPS1-concentration), either the CVs for all quantified proteins or the UPS1 proteins only.
In the figure below the complete series (including yeast) is shown on the left side, the human UPS1 proteins only on the right side. Briefly, vioplots show a kernel-estimate for the distribution, in addition, a box-plot is also integrated (see vignette to package wrGraph).
## combined plot : all data (left), Ups1 (right)
layout(1:3)
sumNAinPD <- list(length=18)
sumNAinPD[2*(1:length(unique(grp9))) -1] <- as.list(as.data.frame(log2(rowGrpCV(testPD$datImp, grp9))))
sumNAinPD[2*(1:length(unique(grp9))) ] <- as.list(as.data.frame(log2(rowGrpCV(testPD$datImp[which(testPD$annot[,"SpecType"]=="spike"),], grp9))))
names(sumNAinPD)[2*(1:length(unique(grp9))) -1] <-  sub("amol","",unique(grp9))
names(sumNAinPD)[2*(1:length(unique(grp9))) ] <- paste(sub("amol","",unique(grp9)),"Ups",sep=".")
try(vioplotW(sumNAinPD, halfViolin="pairwise", tit="CV Intra Replicate, ProteomeDiscoverer", cexNameSer=0.6))
mtext("left part : all data\nright part: UPS1",adj=0,cex=0.8)
sumNAinMQ <- list(length=18)
sumNAinMQ[2*(1:length(unique(grp9))) -1] <- as.list(as.data.frame(log2(rowGrpCV(testMQ$datImp, grp9))))
sumNAinMQ[2*(1:length(unique(grp9))) ] <- as.list(as.data.frame(log2(rowGrpCV(testMQ$datImp[which(testMQ$annot[,"SpecType"]=="spike"),], grp9))))
names(sumNAinMQ)[2*(1:length(unique(grp9))) -1] <- sub("amol","",unique(grp9))                        # paste(unique(grp9),"all",sep=".")
names(sumNAinMQ)[2*(1:length(unique(grp9))) ] <- paste(sub("amol","",unique(grp9)),"Ups",sep=".")      #paste(unique(grp9),"Ups1",sep=".")
try(vioplotW(sumNAinMQ, halfViolin="pairwise", tit="CV intra replicate, MaxQuant",cexNameSer=0.6))
mtext("left part : all data\nright part: UPS1",adj=0,cex=0.8)
sumNAinPL <- list(length=18)
sumNAinPL[2*(1:length(unique(grp9))) -1] <- as.list(as.data.frame(log2(rowGrpCV(testPL$datImp, grp9))))
sumNAinPL[2*(1:length(unique(grp9))) ] <- as.list(as.data.frame(log2(rowGrpCV(testPL$datImp[which(testPL$annot[,"SpecType"]=="spike"),], grp9))))
names(sumNAinPL)[2*(1:length(unique(grp9))) -1] <-  sub("amol","",unique(grp9))
names(sumNAinPL)[2*(1:length(unique(grp9))) ] <- paste(sub("amol","",unique(grp9)),"Ups",sep=".")
try(vioplotW(sumNAinPL, halfViolin="pairwise", tit="CV Intra Replicate, Proline", cexNameSer=0.6))
mtext("left part : all data\nright part: UPS1",adj=0,cex=0.8)The distribution of intra-group CV-values showed (without major surprise) that the highest UPS1 concentrations replicated best. This phenomenon also correlates with the content of NAs in the original data. When imputing NA-values it is a challange to respect the variability of the respective data (NA-neighbours) before NA-imputation. Many NA-values can be observed when looking at very low UPS1-doses and too few initial quantitations values may remain for meaningful comparisons. Of course, with an elevanted content of NAs the mechanism of NA-substitution will also contribute to masking (in part) the true variability.
In consequence pair-wise comparisons using one of the higher UPS1-concentrations group are expected to have a decent chance to rather specifically reveil a high number of UPS1 proteins.
Once can see that lower concentrations of UPS1 usually have worse CV (coefficient of variance) in the respective samples,
First, we construct a container for storing various measures and results which we will look at lateron.
## prepare object for storing all results
datUPS1 <- array(NA, dim=c(length(UPS1$ac),length(methNa),7), dimnames=list(UPS1$ac,c("PD","MQ","PL"),
  c("sco","nPep","medAbund", "logp","slope","startFr","cluNo")))Now we’ll calculate the linear models, extract slope & pval for each UPS1 protein. The functions used also allow plotting the resulting regression results, but plotting each UPS1 protein would make very crowded figures. Instead, we’ll plot representative examples only after clustering the regression-results.
lmPD <- list(length=length(NamesUpsPD))
doPl <- FALSE
lmPD[1:length(NamesUpsPD)] <- lapply(NamesUpsPD[1:length(NamesUpsPD)], wrMisc::linModelSelect, dat=dataPD,
  expect=names(grp9), startLev=1:5, cexXAxis=0.7, logExpect=TRUE, plotGraph=doPl, silent=TRUE)
names(lmPD) <- NamesUpsPD## We make a little summary of regression-results (ProteomeDiscoverer)
tmp <- cbind(log10(sapply(lmPD, function(x) x$coef[2,4])), sapply(lmPD, function(x) x$coef[2,1]), sapply(lmPD, function(x) x$startLev))
datUPS1[,1,c("logp","slope","startFr")] <- tmp[match(rownames(datUPS1), names(lmPD)), ]
datUPS1[,1,"medAbund"] <- apply(wrMisc::.scale01(dataPD$datImp)[match(UPS1$ac, rownames(dataPD$datImp)),], 1,median,na.rm=TRUE)lmMQ <- list(length=length(NamesUpsMQ))
lmMQ[1:length(NamesUpsMQ)] <- lapply(NamesUpsMQ[1:length(NamesUpsMQ)], linModelSelect, dat=dataMQ,
  expect=names(grp9), startLev=1:5, cexXAxis=0.7, logExpect=TRUE, plotGraph=doPl, silent=TRUE)
names(lmMQ) <- NamesUpsMQ## We make a little summary of regression-results (MaxQuant)
tmp <- cbind(log10(sapply(lmMQ, function(x) x$coef[2,4])), sapply(lmMQ, function(x) x$coef[2,1]), sapply(lmMQ, function(x) x$startLev))
datUPS1[,2,c("logp","slope","startFr")] <- tmp[match(rownames(datUPS1), names(lmMQ)), ]
datUPS1[,2,"medAbund"] <- apply(wrMisc::.scale01(dataMQ$datImp)[match(UPS1$ac,rownames(dataMQ$datImp)),],1,median,na.rm=TRUE)lmPL <- list(length=length(NamesUpsPL))
lmPL[1:length(NamesUpsPL)] <- lapply(NamesUpsPL[1:length(NamesUpsPL)], linModelSelect, dat=dataPL,
  expect=names(grp9), startLev=1:5, cexXAxis=0.7, logExpect=TRUE, plotGraph=doPl, silent=TRUE)
names(lmPL) <- NamesUpsPLtmp <- cbind(log10(sapply(lmPL, function(x) x$coef[2,4])), sapply(lmPL, function(x) x$coef[2,1]), sapply(lmPL, function(x) x$startLev))
datUPS1[,3,c("logp","slope","startFr")] <- tmp[match(rownames(datUPS1), names(lmPL)), ]
datUPS1[,3,"medAbund"] <- apply(wrMisc::.scale01(dataPL$datImp)[match(UPS1$ac,rownames(dataPL$datImp)),],1,median,na.rm=TRUE)To get a general view, let’s look where regressions typically have their best starting-site (ie how many low concentrations points are usually better omitted):
## at which concentration of UPS1 did the best regression start ?
stTab <- sapply(1:5, function(x) apply(datUPS1[,,"startFr"], 2, function(y) sum(x==y, na.rm=TRUE)))
colnames(stTab) <- paste("lev", 1:5, sep="_")
kable(stTab, caption = "Frequency of starting levels for regression")| lev_1 | lev_2 | lev_3 | lev_4 | lev_5 | |
|---|---|---|---|---|---|
| PD | 4 | 19 | 11 | 3 | 10 | 
| MQ | 9 | 11 | 7 | 6 | 14 | 
| PL | 7 | 14 | 12 | 7 | 7 | 
Next, we’ll inspect the relation between regression-slopes and p-values (for H0: slope=0) :
layout(matrix(1:4,ncol=2))
subTi <- "fill according to median abundance (blue=low - green - red=high)"
xyRa <- apply(datUPS1[,,4:5], 3, range, na.rm=TRUE)
plotMultRegrPar(datUPS1, 1, xlim=xyRa[,1], ylim=xyRa[,2],tit="ProteomeDiscoverer UPS1, p-value vs slope",subTit=subTi)    # adj wr 9jan23
plotMultRegrPar(datUPS1, 2, xlim=xyRa[,1], ylim=xyRa[,2],tit="MaxQuant UPS1, p-value vs slope",subTit=subTi)
plotMultRegrPar(datUPS1, 3, xlim=xyRa[,1], ylim=xyRa[,2],tit="Proline UPS1, p-value vs slope",subTit=subTi)We can observe, that sope and (log)p-value of the resultant regressions do not necessarily correlate well. Thus, considering only one of these resultant values may not be sufficient.
When judging results for individual spike-in proteins both the value of the slope as well as the p-value (for H0: slope=0) are important to consider. For example, there are some cases where the quantitations line up well giving a good p-value, however with slopes < 0.4, although a slope=1.0 is expected. This is definitely not the type of dose-response characteristics we are looking for.
In order to consider both characteristics (slope and p-value) at the same time, we’ll introduce a penalized objective score using slope and p-value for easier consideration of both elements at once : The overal model is :
score = sqrt ( | log_pValue | + lambda * | slope - 1 | )
In our case lambda is set to -5 .
for(i in 1:(dim(datUPS1)[2])) datUPS1[,i,"sco"] <- sqrt(abs(datUPS1[,i,"logp"])) - 5*abs(datUPS1[,i,"slope"] -1)    # Next, let’s bring together all linear-model scores, the number of peptides and meadian protein abundance for each of UPS1 proteins in one object to facilite further steps.
datUPS1[,1,2] <- rowSums(dataPD$counts[match(UPS1$ac,dataPD$annot[,1]),,1], na.rm=TRUE)
datUPS1[,2,2] <- rowSums(dataMQ$counts[match(UPS1$ac,dataMQ$annot[,1]),,1], na.rm=TRUE)
datUPS1[,3,2] <- rowSums(dataPL$counts[match(UPS1$ac,dataPL$annot[,1]),], na.rm=TRUE)
nNApGrp <- array(dim=c(length(UPS1$ac), length(methNa), length(unique(grp9))), dimnames=list(UPS1$ac, names(methNa), unique(names(grp9)[order(grp9)])))
nNApGrp[,1,] <- wrMisc::rowGrpNA(dataPD$raw[match(UPS1$ac,dataPD$annot[,1]),], grp9)
nNApGrp[,2,] <- wrMisc::rowGrpNA(dataMQ$raw[match(UPS1$ac,dataMQ$annot[,1]),], grp9)
nNApGrp[,3,] <- wrMisc::rowGrpNA(dataPL$raw[match(UPS1$ac,dataPL$annot[,1]),], grp9)
layout(matrix(1:length(methNa), nrow=1))
for(i in 1:length(methNa )) { wrGraph::imageW(nNApGrp[,i,], tit=paste(names(methNa)[i],": Number Of NAs /Group"))
  mtext("Blue for low, dark red for high number of NAs", cex=0.75, adj=0)  }Now we can explore the regression score and its context to other parameters, below it’s done graphically.
layout(matrix(1:4, ncol=2))
par(mar=c(5.5, 2.2, 4, 0.4))
col1 <- RColorBrewer::brewer.pal(9,"YlOrRd")
imageW(datUPS1[,,1], col=col1, tit="Linear regression score", xLab="",yLab="",transp=FALSE)
mtext("Drak red for elevated", cex=0.75)
imageW(log(datUPS1[,,2]), tit="Number of peptides", xLab="",yLab="", col=col1, transp=FALSE)
mtext("Dark red for high number of peptides", cex=0.75)
## ratio : regression score vs no of peptides
imageW(datUPS1[,,1]/log(datUPS1[,,2]), col=rev(col1), tit="Regression score / Number of peptides", xLab="",yLab="", transp=FALSE)
mtext("Dark red for high lmScore/peptide ratio)", cex=0.75)
## score vs abundance
imageW(datUPS1[,,1]/datUPS1[,,3], col=rev(col1), tit="Regression score / median Abundance", xLab="",yLab="", transp=FALSE)
mtext("Dark red for high lmScore/abundance ratio)", cex=0.75)From the heatmap-like plots we can see that some proteins are rather consistently quantified by any of the methods. Some of the varaibility may be explained by the number of peptides (in case of MaxQuant ‘razor-peptides’ were used), see plot of ‘regression score / number of peptides’. In contrast, UPS-protein median abundance does not correlate or explain this phenomenon (see last plot ‘regression score / median abundance’). So we cannot support the hypothesis that highly abundant proteins get quantified better.
Using the linear regression score defined above we can rank UPS1 proteins and display representative ones in order to avoid crowded and repetitive figures.
Now, we can try to group the regression scores into groups and easily display representative examples for each group. Here, we (pre)define that we want to obtain 5 groups (like ratings from 1 -5 starts), a k-Means clustering approach was chosen.
## number of groups for clustering
nGr <- 5
chFin <- is.finite(datUPS1[,,"sco"])
if(any(!chFin)) datUPS1[,,"sco"][which(!chFin)] <- -1      # just in case..
## clustering using kMeans
kMx <- stats::kmeans(standardW(datUPS1[,,"sco"], byColumn=FALSE), nGr)$cluster
datUPS1[,,"cluNo"] <- matrix(rep(kMx, dim(datUPS1)[2]), nrow=length(kMx))
geoM <- apply(datUPS1[,,"sco"], 1, function(x) prod(x)^(1/length(x)))        # geometric mean across analysis soft
geoM2 <- lrbind(by(cbind(geoM,datUPS1[,,"sco"], clu=kMx), kMx, function(x) x[order(x[,1],decreasing=TRUE),]))  # organize by clusters
tmp <- tapply(geoM2[,"geoM"], geoM2[,"clu"], median)
geoM2[,"clu"] <- rep(rank(tmp, ties.method="first"), table(kMx))
geoM2 <- geoM2[order(geoM2[,"clu"],geoM2[,"geoM"],decreasing=TRUE),]         # order as decreasing median.per.cluster
geoM2[,"clu"] <- rep(1:max(kMx), table(geoM2[,"clu"])[rank(unique(geoM2[,"clu"]))])    # replace cluster-names to increasing
try(profileAsClu(geoM2[,2:4], geoM2[,"clu"], tit="Clustered Regression Results for UPS1 Proteins", ylab="Linear regression score"))datUPS1 <- datUPS1[match(rownames(geoM2), rownames(datUPS1)),,]               # bring in new order
datUPS1[,,"cluNo"] <- geoM2[,"clu"]                                          # update cluster-names
### prepare annotation of UPS proteins
annUPS1 <- dataPL$annot[match(rownames(datUPS1), dataPL$annot[,1]), c(1,3)]
annUPS1[,2] <- substr(sub("_UPS","",sub("generic_ups\\|[[:alnum:]]+-{0,1}[[:digit:]]\\|","",annUPS1[,2])),1,42)## index of representative for each cluster  (median position inside cluster)
UPSrep <- tapply(geoM2[,"geoM"], geoM2[,"clu"], function(x) ceiling(length(x)/2)) + c(0, cumsum(table(geoM2[,"clu"]))[-nGr])Previously we organized all UPS1 proteins according to their regression characteristics into 5 clusters and each cluster was ordered for descending scores. Now we can use the median position within each cluster as representative example for this cluster.
gr <- 5
useLi <- which(datUPS1[,1,"cluNo"]==gr)
colNa <- c("Protein",paste(colnames(datUPS1), rep(c("slope","logp"), each=ncol(datUPS1)), sep=" "))
try(kable(cbind(annUPS1[useLi,2], signif(datUPS1[useLi,,"slope"],3), signif(datUPS1[useLi,,"logp"],3)),
  caption=paste("Regression details for cluster of the",length(useLi),"best UPS1 proteins "), col.names=colNa, align="l"),silent=TRUE)| Protein | PD slope | MQ slope | PL slope | PD logp | MQ logp | PL logp | |
|---|---|---|---|---|---|---|---|
| P00918 | Carbonic anhydrase 2 (Chain 2-260) | 1.17 | 1.28 | 0.813 | -18.2 | -16.7 | -18.1 | 
| P06732 | Creatine kinase M-type (Chain 1-381) | 1.15 | 1.41 | 0.854 | -18.3 | -18 | -18.6 | 
| P62937 | Peptidyl-prolyl cis-trans isomerase A (Cha | 0.98 | 1.21 | 0.74 | -18.3 | -12 | -15.6 | 
| P04040 | Catalase (Chain 2-527) | 0.993 | 1.34 | 0.725 | -13.5 | -17.2 | -18.7 | 
| P12081 | Histidyl-tRNA synthetase, cytoplasmic (Cha | 0.889 | 1.23 | 0.814 | -16.6 | -14.7 | -13.3 | 
| P02768 | Serum albumin (Chain 26-609) | 1.01 | 1.45 | 0.778 | -16.5 | -15.3 | -20.2 | 
| P63279 | SUMO-conjugating enzyme UBC9 (Chain 1-158) | 0.859 | 1.03 | 0.839 | -12.9 | -8.23 | -11.7 | 
| P61626 | Lysozyme C (Chain 19-148) | 1.18 | 0.657 | 1.13 | -17.4 | -11.9 | -17.6 | 
| Q06830 | Peroxiredoxin 1 (Chain 2-199) | 0.782 | 0.879 | 0.668 | -14.9 | -12.5 | -16.8 | 
| P02787 | Serotransferrin (Chain 20-698) | 1.1 | 1.45 | 0.764 | -22.6 | -17.1 | -12.1 | 
| P01127 | Platelet-derived growth factor B chain (Ch | 1.1 | 1.43 | 1.02 | -16.5 | -10.9 | -20.6 | 
| Q15843 | NEDD8 (Chain 1-81) | 1.17 | 0.794 | 0.955 | -12.7 | -6.92 | -13.6 | 
| P61769 | Beta-2-microglobulin (Chain 21-119) | 1.16 | 0.603 | 1.03 | -17.2 | -8.55 | -16.7 | 
| P02788 | Lactotransferrin (Chain 20-710) | 1.31 | 1.46 | 0.659 | -16.2 | -17.9 | -16.4 | 
| P01112 | GTPase HRas (Chain 1-189) | 0.807 | 0.692 | 0.687 | -12.8 | -11.5 | -14.6 | 
| P68871 | Hemoglobin subunit beta (Chain 2-147) | 1.06 | 1.49 | 0.593 | -13.4 | -14 | -14.5 | 
| P63165 | Small ubiquitin-related modifier 1 (Chain | 1.3 | 0.839 | 0.675 | -9.1 | -11.3 | -13.2 | 
## Plotting the best regressions, this required package wrGraph version 1.2.5 (or higher)
if(packageVersion("wrGraph")  >= "1.2.5"){
  layout(matrix(1:4, ncol=2))
  tit <- paste0(methNa,", ",annUPS1[UPSrep[gr],1])
  try(tm <- linModelSelect(annUPS1[UPSrep[gr],1], dat=dataPD, tit=tit[1], expect=names(grp9), startLev=1:5, cexXAxis=0.7, logExpect=TRUE, plotGraph=TRUE, silent=TRUE),silent=TRUE)
  try(tm <- linModelSelect(annUPS1[UPSrep[gr],1], dat=dataMQ, tit=tit[2], expect=names(grp9), startLev=1:5, cexXAxis=0.7, logExpect=TRUE, plotGraph=TRUE, silent=TRUE),silent=TRUE)
  try(tm <- linModelSelect(annUPS1[UPSrep[gr],1], dat=dataPL, tit=tit[3], expect=names(grp9), startLev=1:5, cexXAxis=0.7, logExpect=TRUE, plotGraph=TRUE, silent=TRUE),silent=TRUE) }gr <- 4
useLi <- which(datUPS1[,1,"cluNo"]==gr)
try(kable(cbind(annUPS1[useLi,2], signif(datUPS1[useLi,,"slope"],3), signif(datUPS1[useLi,,"logp"],3)),
  caption=paste("Regression details for cluster of the",length(useLi),"2nd best UPS1 proteins "), col.names=colNa, align="l"),silent=TRUE)| Protein | PD slope | MQ slope | PL slope | PD logp | MQ logp | PL logp | |
|---|---|---|---|---|---|---|---|
| P55957 | BH3-interacting domain death agonist (Chai | 1.08 | 1.04 | 1.01 | -19.8 | -17.8 | -18.3 | 
| P01375 | Tumor necrosis factor, soluble form (Chain | 1.16 | 0.927 | 1.11 | -22.8 | -15.8 | -20.1 | 
| P41159 | Leptin (Chain 22-167) | 1.22 | 1.1 | 0.987 | -21.4 | -19.2 | -17.6 | 
| P00167 | Cytochrome b5 (Chain 1-134, N-terminal His | 1.06 | 1.17 | 0.937 | -22.3 | -17.4 | -16.6 | 
| P00709 | Alpha-lactalbumin (Chain 20-142) | 0.996 | 1.18 | 0.966 | -19.7 | -16.1 | -16.5 | 
| P00915 | Carbonic anhydrase 1 (Chain 2-261) | 1.07 | 1.37 | 0.991 | -23.6 | -17.4 | -23.3 | 
| P01344 | Insulin-like growth factor II (Chain 25-91 | 1 | 0.844 | 0.853 | -17.9 | -17 | -16.5 | 
| P01579 | Interferon Gamma (Chain 23-166) | 1.07 | 1 | 0.801 | -17.9 | -12.9 | -19 | 
| P05413 | Fatty acid-binding protein, heart (Chain 2 | 1.07 | 1.19 | 0.839 | -18.2 | -17.6 | -19.3 | 
| P01133 | Pro-Epidermal growth factor (EGF) (Chain 9 | 0.983 | 1.01 | 0.84 | -17 | -13.8 | -12.3 | 
| O00762 | Ubiquitin-conjugating enzyme E2 C (Chain 1 | 1.08 | 1.15 | 0.868 | -18.2 | -12.4 | -17.6 | 
| P01008 | Antithrombin-III (Chain 33-464) | 0.961 | 1.24 | 0.834 | -17.2 | -16.6 | -16.3 | 
| P08758 | Annexin A5 (Chain 2-320) | 1.1 | 1.16 | 0.671 | -19.8 | -17.2 | -16.5 | 
if(packageVersion("wrGraph")  >= "1.2.5"){
  layout(matrix(1:4, ncol=2))
  tit <- paste0(methNa,", ",annUPS1[UPSrep[gr],1])
  try(tm <- linModelSelect(annUPS1[UPSrep[gr],1], dat=dataPD, tit=tit[1], expect=names(grp9), startLev=1:5, cexXAxis=0.7, logExpect=TRUE, plotGraph=TRUE, silent=TRUE),silent=TRUE)
  try(tm <- linModelSelect(annUPS1[UPSrep[gr],1], dat=dataMQ, tit=tit[2], expect=names(grp9), startLev=1:5, cexXAxis=0.7, logExpect=TRUE, plotGraph=TRUE, silent=TRUE),silent=TRUE)
  try(tm <- linModelSelect(annUPS1[UPSrep[gr],1], dat=dataPL, tit=tit[3], expect=names(grp9), startLev=1:5, cexXAxis=0.7, logExpect=TRUE, plotGraph=TRUE, silent=TRUE),silent=TRUE) }gr <- 3
useLi <- which(datUPS1[,1,"cluNo"]==gr)
try(kable(cbind(annUPS1[useLi,2], signif(datUPS1[useLi,,"slope"],3), signif(datUPS1[useLi,,"logp"],3)),
  caption="Regression details for 3rd cluster UPS1 proteins ", col.names=colNa, align="l"),silent=TRUE)| Protein | PD slope | MQ slope | PL slope | PD logp | MQ logp | PL logp | |
|---|---|---|---|---|---|---|---|
| O76070 | Gamma-synuclein (Chain 1-127) | 1.06 | 1.03 | 0.668 | -16.6 | -15.5 | -11.9 | 
| P02144 | Myoglobin (Chain 2-154) | 1.18 | 1.2 | 0.55 | -18.1 | -18.6 | -14 | 
| P51965 | Ubiquitin-conjugating enzyme E2 E1 (Chain | 1.01 | 1.11 | 0.442 | -18.5 | -11.4 | -14 | 
| P06396 | Gelsolin (Chain 28-782) | 1.12 | 1.39 | 0.376 | -21.7 | -18.5 | -13.2 | 
| P62988 | Ubiquitin (Chain 1-76, N-terminal His tag) | 0.864 | 1.01 | 0.0383 | -13.2 | -11.7 | -10.3 | 
if(packageVersion("wrGraph")  >= "1.2.5"){
  layout(matrix(1:4, ncol=2))
  tit <- paste0(methNa,", ",annUPS1[UPSrep[gr],1])
  try(tm <- linModelSelect(annUPS1[UPSrep[gr],1], dat=dataPD, tit=tit[1], expect=names(grp9), startLev=1:5, cexXAxis=0.7, logExpect=TRUE, plotGraph=TRUE, silent=TRUE),silent=TRUE)
  try(tm <- linModelSelect(annUPS1[UPSrep[gr],1], dat=dataMQ, tit=tit[2], expect=names(grp9), startLev=1:5, cexXAxis=0.7, logExpect=TRUE, plotGraph=TRUE, silent=TRUE),silent=TRUE)
  try(tm <- linModelSelect(annUPS1[UPSrep[gr],1], dat=dataPL, tit=tit[3], expect=names(grp9), startLev=1:5, cexXAxis=0.7, logExpect=TRUE, plotGraph=TRUE, silent=TRUE),silent=TRUE) }gr <- 2
useLi <- which(datUPS1[,1,"cluNo"]==gr)
try(kable(cbind(annUPS1[useLi,2], signif(datUPS1[useLi,,"slope"],3), signif(datUPS1[useLi,,"logp"],3)),
  caption="Regression details for 3rd cluster UPS1 proteins ", col.names=colNa, align="l"),silent=TRUE)| Protein | PD slope | MQ slope | PL slope | PD logp | MQ logp | PL logp | |
|---|---|---|---|---|---|---|---|
| P16083 | Ribosyldihydronicotinamide dehydrogenase [ | 1.24 | 1.74 | 0.858 | -13.6 | -15.8 | -16.1 | 
| P10145 | Interleukin-8, IL-8 (Chain 28-99) | 0.882 | 0.446 | 0.786 | -10.8 | -8.31 | -15.4 | 
| P00441 | Superoxide dismutase [Cu-Zn] (Chain 2-154) | 0.759 | 0.471 | 0.475 | -11.5 | -7.38 | -10.3 | 
| P01031 | Complement C5 (C5a anaphylatoxin) (Chain 6 | 0.463 | 0.416 | 1.14 | -8.02 | -6.21 | -15.5 | 
| P69905 | Hemoglobin subunit alpha (Chain 2-142) | 0.508 | 0.0774 | 0.965 | -9.15 | -1.43 | -8.49 | 
| P10599 | Thioredoxin (Chain 2-105, N-terminal His | 0.943 | 0.327 | 0.946 | -15.4 | -5.23 | -20.6 | 
if(packageVersion("wrGraph")  >= "1.2.5"){
  layout(matrix(1:4, ncol=2))
  tit <- paste0(methNa,", ",annUPS1[UPSrep[gr],1])
  try(tm <- linModelSelect(annUPS1[UPSrep[gr],1], dat=dataPD, tit=tit[1], expect=names(grp9), startLev=1:5, cexXAxis=0.7, logExpect=TRUE, plotGraph=TRUE, silent=TRUE),silent=TRUE)
  try(tm <- linModelSelect(annUPS1[UPSrep[gr],1], dat=dataMQ, tit=tit[2], expect=names(grp9), startLev=1:5, cexXAxis=0.7, logExpect=TRUE, plotGraph=TRUE, silent=TRUE),silent=TRUE)
  try(tm <- linModelSelect(annUPS1[UPSrep[gr],1], dat=dataPL, tit=tit[3], expect=names(grp9), startLev=1:5, cexXAxis=0.7, logExpect=TRUE, plotGraph=TRUE, silent=TRUE),silent=TRUE) }gr <- 1
useLi <- which(datUPS1[,1,"cluNo"]==gr)
try(kable(cbind(annUPS1[useLi,2], signif(datUPS1[useLi,,"slope"],3), signif(datUPS1[useLi,,"logp"],3)),
  caption="Regression details for 5th cluster UPS1 proteins ", col.names=colNa, align="l"),silent=TRUE)| Protein | PD slope | MQ slope | PL slope | PD logp | MQ logp | PL logp | |
|---|---|---|---|---|---|---|---|
| P15559 | NAD(P)H dehydrogenase [quinone] 1 (Chain 2 | 0.0754 | 0.998 | 0.088 | -11.5 | -13.8 | -10 | 
| P09211 | Glutathione S-transferase P (Chain 2-210) | 0.618 | 0.772 | 0.594 | -10.4 | -11 | -12 | 
| P99999 | Cytochrome c (Chain 2-105) | 0.523 | 1.27 | 0.415 | -12 | -13 | -12.1 | 
| P02753 | Retinol-binding protein 4 (Chain 19-201) | 0.33 | 0.537 | 0.607 | -10.4 | -9.59 | -16 | 
| P08263 | Glutathione S-transferase A1 (Chain 2-222) | 0.405 | 1.1 | 0.187 | -10.2 | -17.2 | -9.93 | 
| P02741 | C-reactive protein (Chain 19-224) | 0.266 | 0.983 | 0.674 | -12.1 | -7.03 | -11.1 | 
| NA | NA | NA | NA | NA | NA | NA | NA | 
if(packageVersion("wrGraph")  >= "1.2.5"){
  layout(matrix(1:4, ncol=2))
  tit <- paste0(methNa,", ",annUPS1[UPSrep[gr],1])
  try(tm <- linModelSelect(annUPS1[UPSrep[gr],1], dat=dataPD, tit=tit[1], expect=names(grp9), startLev=1:5, cexXAxis=0.7, logExpect=TRUE, plotGraph=TRUE, silent=TRUE),silent=TRUE)
  try(tm <- linModelSelect(annUPS1[UPSrep[gr],1], dat=dataMQ, tit=tit[2], expect=names(grp9), startLev=1:5, cexXAxis=0.7, logExpect=TRUE, plotGraph=TRUE, silent=TRUE),silent=TRUE)
  try(tm <- linModelSelect(annUPS1[UPSrep[gr],1], dat=dataPL, tit=tit[3], expect=names(grp9), startLev=1:5, cexXAxis=0.7, logExpect=TRUE, plotGraph=TRUE, silent=TRUE),silent=TRUE) }In some (less frequent) cases on can recognize unexpected characteristics of regression lines. This illustrates that not all proteins are quantified as perfectly as obtention of initial quantitation data may suggest.
The choice of the ‘best suited’ approach to quantify and compare proteomics data is not trivial at all. Particular attention has to be given to the choice of the numerous ‘small’ parameters which may have a very strong impact on the final outcome, as it has been experienced when preparing the data for this vignette or at other places (eg Chawade et al 2015). Thus, knowing and understanding well the software/tools one has chosen is of prime importance ! Of course, this also concerns the protein-identifcation part/software.
The total number of proteins identified varies considerably between methods, this information may be very important to the user in real-world settings but is only taken in consideration in part in the comparisons presented here.
ROC curves allow us to gain more insight on the impact of cutoff values (alpha) for statistical testing. Frequently the ideal threshold maximizing sensitivity and specificity lies quite distant to the common 5-percent threshold. This indicates that many times the common 5-percent threshold may not be the ‘optimal’ compromise for calling differential abundant proteins. However, the optimal point varies very much between data-sets and in a real world setting with unknown samples this type of analysis is not possible.
As mentioned before, the dataset used in this vignette is not very recent, much better performing mass-spectrometers have been introduced since then. The main aim of this vignette consists in showing how to use wrProteo with a smaller example (allowing to limit file-size of this package). Thus, for rather scientific conclusions the user is encouraged to run the same procedure using data run on more recent mass-spectrometers.
The author wants to acknowledge the support by the IGBMC (CNRS UMR 7104, Inserm U 1258, UdS), CNRS, Université de Strasbourg and Inserm and of course all collegues from the IGBMC proteomics platform. The author wishes to thank the CRAN -staff for all their help with new entries and their efforts in maintaining this repository of R-packages. Furthermore, many very fruitful discussions with colleages on national and international level have helped to formulate ideas and improve the tools presented here.
Thank you for you interest. This package is constantly evolving, new featues/functions may get added to the next version of this package.
For completeness :
#> R version 4.5.1 (2025-06-13 ucrt)
#> Platform: x86_64-w64-mingw32/x64
#> Running under: Windows 11 x64 (build 26100)
#> 
#> Matrix products: default
#>   LAPACK version 3.12.1
#> 
#> locale:
#> [1] LC_COLLATE=C                   LC_CTYPE=French_France.utf8   
#> [3] LC_MONETARY=French_France.utf8 LC_NUMERIC=C                  
#> [5] LC_TIME=French_France.utf8    
#> 
#> time zone: Europe/Paris
#> tzcode source: internal
#> 
#> attached base packages:
#> [1] stats     graphics  grDevices utils     datasets  methods   base     
#> 
#> other attached packages:
#> [1] rmarkdown_2.29  knitr_1.50      wrGraph_1.3.11  wrProteo_1.13.3
#> [5] wrMisc_1.15.4  
#> 
#> loaded via a namespace (and not attached):
#>  [1] gtable_0.3.6       limma_3.64.1       jsonlite_2.0.0     dplyr_1.1.4       
#>  [5] compiler_4.5.1     Rcpp_1.1.0         tidyselect_1.2.1   stringr_1.5.1     
#>  [9] jquerylib_0.1.4    splines_4.5.1      scales_1.4.0       readxl_1.4.5      
#> [13] yaml_2.3.10        fastmap_1.2.0      statmod_1.5.0      plyr_1.8.9        
#> [17] ggplot2_3.5.2      R6_2.6.1           generics_0.1.4     fdrtool_1.2.18    
#> [21] tibble_3.3.0       sm_2.2-6.0         bslib_0.9.0        pillar_1.11.0     
#> [25] RColorBrewer_1.1-3 R.utils_2.13.0     rlang_1.1.6        stringi_1.8.7     
#> [29] cachem_1.1.0       xfun_0.52          sass_0.4.10        cli_3.6.5         
#> [33] magrittr_2.0.3     digest_0.6.37      grid_4.5.1         lifecycle_1.0.4   
#> [37] R.oo_1.27.1        R.methodsS3_1.8.2  vctrs_0.6.5        qvalue_2.40.0     
#> [41] evaluate_1.0.4     glue_1.8.0         cellranger_1.1.0   farver_2.1.2      
#> [45] reshape2_1.4.4     tools_4.5.1        pkgconfig_2.0.3    htmltools_0.5.8.1