This is part of the online course Proteomics Data Analysis (PDA)
library(tidyverse)
library(limma)
library(QFeatures)
library(msqrob2)
library(plotly)
library(gridExtra)
<- "https://raw.githubusercontent.com/statOmics/PDA22GTPB/data/quantification/mouseTcell/peptidesRCB.txt"
peptidesFile <- "https://raw.githubusercontent.com/statOmics/PDA22GTPB/data/quantification/mouseTcell/peptidesCRD.txt"
peptidesFile2 <- "https://raw.githubusercontent.com/statOmics/PDA22GTPB/data/quantification/mouseTcell/peptides.txt"
peptidesFile3
<- grep("Intensity\\.", names(read.delim(peptidesFile)))
ecols <- readQFeatures(
pe table = peptidesFile,
fnames = 1,
ecol = ecols,
name = "peptideRaw", sep="\t")
<- grep("Intensity\\.", names(read.delim(peptidesFile2)))
ecols2 <- readQFeatures(
pe2 table = peptidesFile2,
fnames = 1,
ecol = ecols2,
name = "peptideRaw", sep="\t")
<- grep("Intensity\\.", names(read.delim(peptidesFile3)))
ecols3 <- readQFeatures(
pe3 table = peptidesFile3,
fnames = 1,
ecol = ecols3,
name = "peptideRaw", sep="\t")
### Design
colData(pe)$celltype <- substr(
colnames(pe[["peptideRaw"]]),
11,
14) %>%
%>%
unlist
as.factor
colData(pe)$mouse <- pe[[1]] %>%
%>%
colnames strsplit(split="[.]") %>%
sapply(function(x) x[3]) %>%
as.factor
colData(pe2)$celltype <- substr(
colnames(pe2[["peptideRaw"]]),
11,
14) %>%
%>%
unlist
as.factor
colData(pe2)$mouse <- pe2[[1]] %>%
%>%
colnames strsplit(split="[.]") %>%
sapply(function(x) x[3]) %>%
as.factor
colData(pe3)$celltype <- substr(
colnames(pe3[["peptideRaw"]]),
11,
14) %>%
%>%
unlist
as.factor
colData(pe3)$mouse <- pe3[[1]] %>%
%>%
colnames strsplit(split="[.]") %>%
sapply(function(x) x[3]) %>%
as.factor
rowData(pe[["peptideRaw"]])$nNonZero <- rowSums(assay(pe[["peptideRaw"]]) > 0)
rowData(pe2[["peptideRaw"]])$nNonZero <- rowSums(assay(pe2[["peptideRaw"]]) > 0)
rowData(pe3[["peptideRaw"]])$nNonZero <- rowSums(assay(pe3[["peptideRaw"]]) > 0)
NA
value rather than 0
.<- zeroIsNA(pe, "peptideRaw") # convert 0 to NA
pe
<- zeroIsNA(pe2, "peptideRaw") # convert 0 to NA
pe2
<- zeroIsNA(pe3, "peptideRaw") # convert 0 to NA pe3
<- logTransform(pe, base = 2, i = "peptideRaw", name = "peptideLog")
pe
<- logTransform(pe2, base = 2, i = "peptideRaw", name = "peptideLog")
pe2
<- logTransform(pe3, base = 2, i = "peptideRaw", name = "peptideLog") pe3
In our approach a peptide can map to multiple proteins, as long as there is none of these proteins present in a smaller subgroup.
<- filterFeatures(pe, ~ Proteins %in% smallestUniqueGroups(rowData(pe[["peptideLog"]])$Proteins))
pe
<- filterFeatures(pe2, ~ Proteins %in% smallestUniqueGroups(rowData(pe2[["peptideLog"]])$Proteins))
pe2
<- filterFeatures(pe3, ~ Proteins %in% smallestUniqueGroups(rowData(pe3[["peptideLog"]])$Proteins)) pe3
We now remove the contaminants, peptides that map to decoy sequences, and proteins which were only identified by peptides with modifications.
<- filterFeatures(pe,~Reverse != "+")
pe <- filterFeatures(pe,~ Potential.contaminant != "+")
pe
<- filterFeatures(pe2,~Reverse != "+")
pe2 <- filterFeatures(pe2,~ Potential.contaminant != "+")
pe2
<- filterFeatures(pe3,~Reverse != "+")
pe3 <- filterFeatures(pe3,~ Potential.contaminant != "+") pe3
We keep peptides that were observed at last twice.
<- filterFeatures(pe,~ nNonZero >=2)
pe <- filterFeatures(pe2,~ nNonZero >=2)
pe2 <- filterFeatures(pe3,~ nNonZero >=2) pe3
<- normalize(pe,
pe i = "peptideLog",
name = "peptideNorm",
method = "center.median")
<- normalize(pe2,
pe2 i = "peptideLog",
name = "peptideNorm",
method = "center.median")
<- normalize(pe3,
pe3 i = "peptideLog",
name = "peptideNorm",
method = "center.median")
<- aggregateFeatures(pe,
pe i = "peptideNorm",
fcol = "Proteins",
na.rm = TRUE,
name = "protein")
## Your quantitative and row data contain missing values. Please read the
## relevant section(s) in the aggregateFeatures manual page regarding the
## effects of missing values on data aggregation.
<- aggregateFeatures(pe2,
pe2 i = "peptideNorm",
fcol = "Proteins",
na.rm = TRUE,
name = "protein")
## Your quantitative and row data contain missing values. Please read the
## relevant section(s) in the aggregateFeatures manual page regarding the
## effects of missing values on data aggregation.
<- aggregateFeatures(pe3,
pe3 i = "peptideNorm",
fcol = "Proteins",
na.rm = TRUE,
name = "protein")
## Your quantitative and row data contain missing values. Please read the
## relevant section(s) in the aggregateFeatures manual page regarding the
## effects of missing values on data aggregation.
levels(colData(pe3)$mouse) <- paste0("m",1:7)
<- plotMDS(assay(pe3[["protein"]]), plot = FALSE)
mdsObj3 <- colData(pe3) %>%
mdsOrig %>%
as.data.frame mutate(mds1 = mdsObj3$x,
mds2 = mdsObj3$y,
lab = paste(mouse,celltype,sep="_")) %>%
ggplot(aes(x = mds1, y = mds2, label = lab, color = celltype, group = mouse)) +
geom_text(show.legend = FALSE) +
geom_point(shape = 21) +
geom_line(color = "black", linetype = "dashed") +
xlab(
paste0(
$axislabel,
mdsObj3" ",
1,
" (",
paste0(
round(mdsObj3$var.explained[1] *100,0),
"%"
),")"
)+
) ylab(
paste0(
$axislabel,
mdsObj3" ",
2,
" (",
paste0(
round(mdsObj3$var.explained[2] *100,0),
"%"
),")"
)+
) ggtitle("Original (RCB)")
levels(colData(pe)$mouse) <- paste0("m",1:4)
<- plotMDS(assay(pe[["protein"]]), plot = FALSE)
mdsObj <- colData(pe) %>%
mdsRCB %>%
as.data.frame mutate(mds1 = mdsObj$x,
mds2 = mdsObj$y,
lab = paste(mouse,celltype,sep="_")) %>%
ggplot(aes(x = mds1, y = mds2, label = lab, color = celltype, group = mouse)) +
geom_text(show.legend = FALSE) +
geom_point(shape = 21) +
geom_line(color = "black", linetype = "dashed") +
xlab(
paste0(
$axislabel,
mdsObj" ",
1,
" (",
paste0(
round(mdsObj$var.explained[1] *100,0),
"%"
),")"
)+
) ylab(
paste0(
$axislabel,
mdsObj" ",
2,
" (",
paste0(
round(mdsObj$var.explained[2] *100,0),
"%"
),")"
)+
) ggtitle("Randomized Complete Block (RCB)")
levels(colData(pe2)$mouse) <- paste0("m",1:8)
<- plotMDS(assay(pe2[["protein"]]), plot = FALSE)
mdsObj2 <- colData(pe2) %>%
mdsCRD %>%
as.data.frame mutate(mds1 = mdsObj2$x,
mds2 = mdsObj2$y,
lab = paste(mouse,celltype,sep="_")) %>%
ggplot(aes(x = mds1, y = mds2, label = lab, color = celltype, group = mouse)) +
geom_text(show.legend = FALSE) +
geom_point(shape = 21) +
xlab(
paste0(
$axislabel,
mdsObj" ",
1,
" (",
paste0(
round(mdsObj2$var.explained[1] *100,0),
"%"
),")"
)+
) ylab(
paste0(
$axislabel,
mdsObj" ",
2,
" (",
paste0(
round(mdsObj2$var.explained[2] *100,0),
"%"
),")"
)+
) ggtitle("Completely Randomized Design (CRD)")
mdsOrig
mdsRCB
mdsCRD
<- msqrob(
pe object = pe,
i = "protein",
formula = ~ celltype + mouse)
<- msqrob(
pe object = pe,
i = "protein",
formula = ~ celltype, modelColumnName = "wrongModel")
<- msqrob(
pe2 object = pe2,
i = "protein",
formula = ~ celltype)
library(ExploreModelMatrix)
VisualizeDesign(colData(pe),~ celltype + mouse)$plotlist
## [[1]]
VisualizeDesign(colData(pe2),~ celltype)$plotlist
## [[1]]
<- makeContrast("celltypeTreg = 0", parameterNames = c("celltypeTreg"))
L <- hypothesisTest(object = pe, i = "protein", contrast = L)
pe <- hypothesisTest(object = pe, i = "protein", contrast = L, modelColumn = "wrongModel", resultsColumnNamePrefix="wrong")
pe <- hypothesisTest(object = pe2, i = "protein", contrast = L) pe2
<- ggplot(
volcanoRCB rowData(pe[["protein"]])$celltypeTreg,
aes(x = logFC, y = -log10(pval), color = adjPval < 0.05)
+
) geom_point(cex = 2.5) +
scale_color_manual(values = alpha(c("black", "red"), 0.5)) +
theme_minimal() +
ggtitle(paste0("RCB: \n",
sum(rowData(pe[["protein"]])$celltypeTreg$adjPval<0.05,na.rm=TRUE),
" significant"))
<- ggplot(
volcanoRCBwrong rowData(pe[["protein"]])$wrongcelltypeTreg,
aes(x = logFC, y = -log10(pval), color = adjPval < 0.05)
+
) geom_point(cex = 2.5) +
scale_color_manual(values = alpha(c("black", "red"), 0.5)) +
theme_minimal() +
ggtitle(paste0("RCB wrong: \n",
sum(rowData(pe[["protein"]])$wrongcelltypeTreg$adjPval<0.05,na.rm=TRUE),
" significant"))
<- ggplot(
volcanoCRD rowData(pe2[["protein"]])$celltypeTreg,
aes(x = logFC, y = -log10(pval), color = adjPval < 0.05)
+
) geom_point(cex = 2.5) +
scale_color_manual(values = alpha(c("black", "red"), 0.5)) +
theme_minimal() +
ggtitle(paste0("CRD: \n",
sum(rowData(pe2[["protein"]])$celltypeTreg$adjPval<0.05,na.rm=TRUE),
" significant"))
grid.arrange(volcanoRCB,volcanoCRD, volcanoRCBwrong,ncol=2)
## Warning: Removed 777 rows containing missing values (geom_point).
## Warning: Removed 382 rows containing missing values (geom_point).
## Warning: Removed 262 rows containing missing values (geom_point).
Disclaimer: the Anova analysis is only for didactical purposes. In practice we assess the hypotheses using msqrob2.
We illustrate the power gain of blocking using an Anova analysis on 1 protein.
Note, that msqrob2 will perform a similar analysis, but, it uses robust regression and it uses an empirical Bayes estimator for the variance.
<- "Q7TPR4"
prot <- colData(pe) %>%
dataHlp %>%
as.data.frame mutate(intensity=assay(pe[["protein"]])[prot,],
intensityCRD=assay(pe2[["protein"]])[prot,])
anova(lm(intensity~ celltype + mouse, dataHlp))
anova(lm(intensity~ celltype,dataHlp))
anova(lm(intensityCRD~ celltype,dataHlp))
<- rownames(pe[["protein"]])[rownames(pe[["protein"]])%in%rownames(pe2[["protein"]])]
accessions <- data.frame(
dat sigmaRBC = sapply(rowData(pe[["protein"]])$msqrobModels[accessions], getSigmaPosterior),
sigmaRBCwrong = sapply(rowData(pe[["protein"]])$wrongModel[accessions], getSigmaPosterior),
<- sapply(rowData(pe2[["protein"]])$msqrobModels[accessions], getSigmaPosterior)
sigmaCRD
)
<- ggplot(data = dat, aes(sigmaRBC, sigmaRBCwrong)) +
plotRBCvsWrong geom_point(alpha = 0.1, shape = 20) +
scale_x_log10() +
scale_y_log10() +
geom_abline(intercept=0,slope=1)
<- ggplot(data = dat, aes(sigmaCRD, sigmaRBCwrong)) +
plotCRDvsWrong geom_point(alpha = 0.1, shape = 20) +
scale_x_log10() +
scale_y_log10() +
geom_abline(intercept=0,slope=1)
<- ggplot(data = dat, aes(sigmaRBC, sigmaCRD)) +
plotRBCvsCRD geom_point(alpha = 0.1, shape = 20) +
scale_x_log10() +
scale_y_log10() +
geom_abline(intercept=0,slope=1)
grid.arrange(
plotRBCvsWrong,
plotCRDvsWrong,
plotRBCvsCRD,nrow=2)
## Warning: Removed 730 rows containing missing values (geom_point).
## Warning: Removed 397 rows containing missing values (geom_point).
## Warning: Removed 743 rows containing missing values (geom_point).
We clearly observe that the standard deviation of the protein expression in the RCB is smaller for the majority of the proteins than that obtained with the CRD
The standard deviation of the protein expression RCB where we perform a wrong analysis without considering the blocking factor according to mouse is much larger for the marjority of the proteins than that obtained with the correct analysis.
Indeed, when we ignore the blocking factor in the RCB design we do not remove the variability according to mouse from the analysis and the mouse effect is absorbed in the error term. The standard deviation than becomes very comparable to that observed in the completely randomised design where we could not remove the mouse effect from the analysis.
Why are some of the standard deviations for the RCB with the correct analysis larger than than of the RCB with the incorrect analysis that ignored the mouse blocking factor?
Can you think of a reason why it would not be useful to block on a particular factor?