MCbiclust 1.3.3 Report issues on https://github.com/rbentham/MCbiclust/issues
MCbiclust is a R package for running massively correlating biclustering analysis. MCbiclust aims to find large scale biclusters with selected features being highly correlated with each other over a subset of samples. MCbiclust was particularly designed for the application of studying gene expression data, finding and understanding biclusters that are related to large scale co-regulation of genes.
Report issues on https://github.com/rbentham/MCbiclust/issues
Once installed MCbiclust can be loaded with the following command:
library(MCbiclust)MCbiclust also makes sure that the packages BiocParallel, cluster, stats, GGally, ggplot2 and scales are all installed. It is also advised that the packages ggplot2 and gplots are separately installed and loaded.
library(ggplot2)
library(gplots)
library(dplyr)
library(gProfileR)
library(MASS)
library(devtools)For this example analysis we will be seeking to find biclusters related to mitochondrial function in the cancer cell line encyclopedia (Barretina et al. (2012)). For this two datasets are needed, both of which are available on the MCbiclust package. The first in CCLE_small that contains a subset of the gene expression values found in the entire CCLE data set (the full dataset is avaliable at https://portals.broadinstitute.org/ccle/home), the second, Mitochondrial_genes, is a list of mitochondrial genes that can be found from MitoCarta1.0 (Pagliarini et al. (2008)).
data(CCLE_small)
data(Mitochondrial_genes)It is a simple procedure to create a new matrix CCLE.mito only containing the mitochondrial genes. While there are \(1023\) known mitochondrial genes, not all of these are measured in CCLE_data.
mito.loc <- which(row.names(CCLE_small) %in% Mitochondrial_genes)
CCLE.mito <- CCLE_small[mito.loc,]The first step in using MCbiclust is to find a subset of samples that have the most highly correlating genes in the chosen gene expression matrix. This is done by, calculating the associated correlation matrix and then calculating the absolute mean of the correlations, as a correlation score.
Mathematically for a gene expression dataset measuring multiple gene probes across multiple samples, let \[\begin{equation} X = \textrm{Set of all probes, } Y = \textrm{Set of all samples} \end{equation}\] Then define two subsets of \(X\) and \(Y\), \(I\) and \(J\) repectively \[\begin{equation} I \subset X \textrm{ and } J \subset Y \end{equation}\] Subsets \(I\) and \(J\) form a bicluster on sets \(X\) and \(Y\), and the strength of this bicluster measured is based on measuring the correlations between pairs of probes in set \(I\) across all samples in set \(J\). The correlation between a probe \(i \in I\) to a probe \(k \in I\) across the samples in \(J\) is denoted as \(C_{i,k}^J\). Then the strength of the bicluster is measured as having a score \(\alpha\) based on these correlations, defined as: \[\begin{equation} \alpha_I^J= \frac{1}{|I|^2}\sum_{i \in I} \sum_{k \in I} abs(C_{i,k}^J) \end{equation}\] where the function \(abs()\) refers to the absolute value. In words the score \(\alpha\) is the average of the absolute values of the gene-gene correlation matrix for gene-probe set \(I\) across the samples in sample set \(J\).
A high \(\alpha_I^J\) value indicates that the probes in set \(I\) are being strongly co-regulated across the samples in set \(J\). As \(\alpha_I^J\) is calculating using the absolute values of \(C_{i,k}^J\), these probes could be in either in correlation or anti-correlation with each other.
MCbiclust main aim is therefore to find sets of samples and genes that have a high \(\alpha_I^J\) value. This is achieved by first finding a small sample “seed” containing relatively few samples but a very high \(\alpha_I^J\) value,
This is achieved with function FindSeed, initially a random subset of samples is chosen and then at each iteration one sample is removed and replaced and if this results in a higher \(\alpha_I^J\) value than this new subset is chosen. In this function the argument gem stands for gene expression matrix, seed.size indicates the size of the subset of samples that is sought. iterations indicates how many iterations of the algorithm to carry out before stopping. In general the higher the iterations the more optimal the solution in terms of maximising the strength of the correlation.
For reproducibility set.seed has been used to set R’s pseudo-random number generator. It should also be noted that the for gem the data matrix can not contain all the genes, since FindSeed involves the calculation of correlation matrices which are not computationally efficient to compute if they involve greater than ~1000 genes.
set.seed(102)
CCLE.seed <- FindSeed(gem = CCLE.mito,
                      seed.size = 10,
                      iterations = 10000,
                      messages = 1000)FindSeed has one more additional options, initial.seed allows the user to specify the initial subsample to be tested, by default the initial sample subset is randomly chosen.
There is a function CorScoreCalc that can calculate the correlation score \(\alpha_I^J\) directly, in general however you should not need to use it, unless you wish to manually check the chosen seed is an improvement on one that is randomly generated.
set.seed(103)
random.seed <- sample(seq(length = dim(CCLE.mito)[2]), 10)
CorScoreCalc(CCLE.mito,random.seed)## [1] 0.2901273CorScoreCalc(CCLE.mito,CCLE.seed)## [1] 0.5781261The results of FindSeed can also be visualised by examining the associated correlation matrix, and viewing the result as a heatmap. Again it is easy to see the difference between the random subsample and the one outputted from FindSeed.
CCLE.random.cor <- cor(t(CCLE.mito[,random.seed]))
heatmap.2(CCLE.random.cor,trace = "none")CCLE.mito.cor <- cor(t(CCLE.mito[,CCLE.seed]))
heatmap.2(CCLE.mito.cor,trace = "none")Note that when the genes are represented as the rows in a matrix, that matrix needs to be transposed before the calculation of the correlation matrix.
heatmap.2 is a function from the gplots R package.
In this example a distinct correlation pattern was found. However this was only examined for genes involved in mitochondrial function. Non-mitochondrial genes are likely also involved in this pattern and it is important to identify them.
All genes can be measured by how they match to this pattern by calculating what is called a correlation vector (CV). This is done in two steps:
The pattern is summarised by finding a subset of genes which all strongly correlate with each other, and calculating their average expression value. This is done by clustering the genes using hierarchical clustering and selecting the best group judged by that groups correlation score multiplied by the square root of the number of genes. This multiplication is done to remove the bias of selecting a group containing very few genes.
The correlation vector is calculated by finding the correlation of every gene to the average expression value of the chosen best group.
This process is all encapsulated in the function CVEval which takes 4 arguements. gem.part is the gene expression matrix for the chosen gene set of interest, e.g. mitochondrial genes, gem.all is the entire gene expression matrix, seed is the output from FindSeed and splits is the number of groups to split the chosen gene set into in order to select the best group.
CCLE.cor.vec <- CVEval(gem.part = CCLE.mito,
                        gem.all = CCLE_small,
                        seed = CCLE.seed, splits = 10)Using the calculated correlation vector, it is a relatively simple task to perform gene set enrichment. This can be done on any platform (e.g. DAVID, gprofiler, etc.) but MCbiclust comes with an inbuilt function for calculating GO enrichment values using the Mann-Whitney non-parametric test.
This is achieved with the GOEnrichmentAnalysis function which takes three inputs:
gene.names: The names of the genes in standard format.
gene.values: The correlation vector.
sig.rate: The value below which adjusted p-values are decided to be significant.
The output is a table with 7 columns:
GOID: ID for GO term.
TERM: Name of GO term.
num.genes: Number of genes in GO term.
g.in.genelist: Number of genes in GO term that were measured in the gene expression matrix.
adj.p.value: Adjusted p-value from Mann-Whitney test.
CV.av.value: Average value of CV for genes in GO term.
phenotype: +1 if CV.av.value is greater than the overall CV average, -1 if the CV.av.value is less then the overall CV average.
GSE.MW <- GOEnrichmentAnalysis(gene.names = row.names(CCLE_small),
                               gene.values = CCLE.cor.vec,
                               sig.rate = 0.05)There are 76 significant terms and the top 10 most significant can be viewed below:
row.names(GSE.MW) <- NULL
pander::pandoc.table(GSE.MW[1:10,],row.names = FALSE)| GOID | TERM | ONTOLOGY | num.genes | 
|---|---|---|---|
| GO:0030529 | intracellular ribonucleoprotein complex | CC | 964 | 
| GO:1990904 | ribonucleoprotein complex | CC | 965 | 
| GO:0007005 | mitochondrion organization | BP | 819 | 
| GO:0006414 | translational elongation | BP | 139 | 
| GO:0005840 | ribosome | CC | 286 | 
| GO:0032543 | mitochondrial translation | BP | 151 | 
| GO:0070125 | mitochondrial translational elongation | BP | 86 | 
| GO:0005743 | mitochondrial inner membrane | CC | 629 | 
| GO:0019866 | organelle inner membrane | CC | 686 | 
| GO:0003723 | RNA binding | MF | 2029 | 
| g.in.genelist | adj.p.value | CV.av.value | phenotype | 
|---|---|---|---|
| 66 | 2.917e-08 | 0.796 | 1 | 
| 66 | 2.917e-08 | 0.796 | 1 | 
| 144 | 6.14e-07 | 0.6753 | 1 | 
| 46 | 1.675e-06 | 0.8433 | 1 | 
| 44 | 2.292e-06 | 0.8447 | 1 | 
| 50 | 5.694e-06 | 0.824 | 1 | 
| 42 | 6.354e-06 | 0.8417 | 1 | 
| 211 | 8.329e-06 | 0.619 | 1 | 
| 213 | 9.259e-06 | 0.6154 | 1 | 
| 111 | 1.01e-05 | 0.6448 | 1 | 
Since CCLE_small is half made up of mitochondrial genes and we were seeking for mitochondrial related biclusters it is not surprising that mitochondrial terms dominate the gene set enrichment. If MCbiclust was run on the full CCLE gene expression data set it would be expected to see many more significant non-mitochondrial related terms.
An alternative to using the GOEnrichmentAnalysis function would be to use a separate gene set enrichment method such as gprofiler, this can be done by for instance selecting the top 200 genes with positive CV values:
top200 <- row.names(CCLE_small)[order(CCLE.cor.vec,
                                             decreasing = TRUE)[seq(200)]]
# top200.gprof <- gprofiler(top200)
# dim(top200.gprof)# pander::pandoc.table(top200.gprof[seq(10),-c(1,2,7,8,11,14)],
#                     row.names = FALSE)Already all the genes in the data set have had the correlation calculated to the pattern found. One more task that can be readily done is to order the samples according to the strength of correlation. Function FindSeed found the initial \(n\) samples that had a very strong correlation with the gene set of interest, the \(n+1\) sample is to be selected as that sample which best maintains the correlation strength, this process can be simply repeated until all or the desired number of samples are ordered.
SampleSort is the function in MCbiclust that completes this procedure, it has \(4\) main inputs:
gem: the gene expression matrix with all the samples and the gene set of interest.
seed: the initial subsample found with FindSeed.
num.cores: Used for setting the number of cores used in calculation, default value is to use one core.
sort.length: Sets the number of samples to be ordered.
CCLE.samp.sort <- SampleSort(CCLE.mito[as.numeric(CCLE.hicor.genes),],
                             seed = CCLE.seed)Note as before that these are long calculations, and may take some time.
Note that SampleSort is a very computationally expensive function and requires time to run. For a large dataset such as the CCLE data it is advisable to either calculate a partial ordering, which can be done with the sort.length arguement or submit the job of sorting the samples to a high performance computing facility.
Once the samples have been sorted it is possible to summarise the correlation pattern found using principal component analysis (PCA).
PCA is a method of dimensional reduction, and converts a data set to a new set of variables known as the principal components. These are designed to be completely uncorrelated or orthogonal to each other. In this way the principal components are new variables that capture the correlations between the old variables, and are in fact a linear combination of the old variables. The first principal component (PC1) is calculated as the one that explains the highest variance within the data, the second than is that which has the highest variance but is completely uncorrelated or orthogonal to the previous principal component. In this way additional principal components are calculated until all the variance in the data set is explained.
PC1 captures the highest variance within the data, so if PCA is run on the found bicluster with very strong correlations between the genes, PC1 will be a variable that summarises this correlation.
PC1VecFun is a function that calculates the PC1 values for all sorted samples. It takes three inputs:
1.top.gem is the gene expression matrix with only the most highly correlated genes but with all the sample data.
seed.sort is the sorting of the data samples found with function SampleSort
n is the number of samples used for initially calculating the weighting of PC1. If set to \(10\), the first \(10\) samples are used to calculate the weighting of PC1 and then the value of PC1 is calculated for all samples in the ordering.
top.mat <- CCLE.mito[as.numeric(CCLE.hicor.genes),]
pc1.vec <- PC1VecFun(top.gem = top.mat,
                     seed.sort = CCLE.samp.sort, n = 10)So far MCbiclust outputs a ranked list of genes and samples. In many cases it is however necessary to determine which genes and samples are within the bicluster and which are not. This is done with the ThresholdBic function, which takes \(4\) arguements:
cor.vec: The correlation vector, output of CVeval.
sort.order: The sorted samples, output of SampleSort.
pc1: The PC1 vector, output of PC1VecFun
samp.sig: A numeric value between 0 and 1 that detemines the number of samples in the bicluster.
The genes in the bicluster are determined using kmeans clustering, and dividing the genes into two clusters based on the absolute value of the correlation vector, choosing one correlated and one uncorrelated groups.
The samples are however chosen based on the last 10% of the ranked samples, these samples are assumed to not belong to the bicluster and the first sample with a PC1 value between the \(0 + samp.sig/2\) and \(1 - samp.sig/2\) quantiles, and every sample after that is not in the bicluster.
CCLE.bic <- ThresholdBic(cor.vec = CCLE.cor.vec,
                         sort.order = CCLE.samp.sort,
                         pc1 = pc1.vec, samp.sig = 0.05)Once this thresholded bicluster has been found it is important to properly align the PC1 vector and the correlation vector such that samples with a high PC1 values are those samples with up-regulated genes that have positive CV values. This is not strictly necessary to do, but makes the interpretation of MCbiclust simpler.
This is done with function PC1Align which if necessary times the pc1.vec by -1 to ensure that the correlation vector and PC1 vector are “aligned”.
pc1.vec <- PC1Align(gem = CCLE_small, pc1 = pc1.vec,
                    sort.order = CCLE.samp.sort,
                    cor.vec = CCLE.cor.vec, bic = CCLE.bic)As an alternative to calculating PC1, the user may want to calculate the average expression value of certain gene sets. This gives a better idea of the type of regulation occurring in the correlation pattern, as an abstract notion of a principal component does not have to be understood.
av.genes.group1 <- colMeans(CCLE.mito[CCLE.groups[[1]],
                                      CCLE.samp.sort])
av.genes.group2 <- colMeans(CCLE.mito[CCLE.groups[[2]],
                                      CCLE.samp.sort])Once the samples have been ordered and PC1 and the average gene sets calculated it is a simple procedure to produce plots of these against the ordered samples.
One final additional thing that can be done is to classify the samples into belonging to the bicluster or not, and additionally whether a sample belongs to the Upper or Lower fork. This can be done with the function ForkClassifier
To produce the plots of the forks the ggplot2 package is used.
CCLE.names <- colnames(CCLE_small)[CCLE.samp.sort]
fork.status <- ForkClassifier(pc1.vec, samp.num = length(CCLE.bic[[2]]))
CCLE.df <- data.frame(CCLE.name = CCLE.names,
                      PC1 = pc1.vec,
                      Fork = fork.status,
                      Average.Group1 = av.genes.group1,
                      Average.Group2 = av.genes.group2,
                      Order = seq(length = length(pc1.vec)))
ggplot(CCLE.df, aes(Order,PC1)) +
  geom_point(aes(colour = Fork)) + ylab("PC1")ggplot(CCLE.df, aes(Order,Average.Group1)) +
  geom_point(aes(colour = Fork)) + ylab("Average Group 1")ggplot(CCLE.df, aes(Order,Average.Group2)) +
  geom_point(aes(colour = Fork)) + ylab("Average Group 2")This by itself however is not particularly enlightening and to get additional information out of these plots supplementary information needs to be examined.
This section will deal with an addition data sets both of which are available in the MCbiclust package.
This section is meant as an example of the type of analysis that can be done with additional data set. Each new data set may have different additional data available with it and may be in formats that need some extra work to become compatible with the results from the MCbiclust analysis.
This data set is available within the MCbiclust package.
data(CCLE_samples)In this case some samples have an additional “X” not present in some CCLE_samples data so it is necessary to add it for consistency.
CCLE.samples.names <- as.character(CCLE_samples[,1])
CCLE.samples.names[c(1:15)] <- paste("X",CCLE.samples.names[c(1:15)],
                                     sep="")
CCLE_samples$CCLE.name <- CCLE.samples.namesThe first step is to compare the column names of both data sets and to make sure we are dealing with the same correctly labeled samples.
rownames(CCLE_samples) <- as.character(CCLE_samples[,1])
CCLE.data.names <- colnames(CCLE_small)
CCLE_small_samples <- CCLE_samples[CCLE.data.names,]Using the dplyr library, it is possible to join this new data set to the one we made for plotting the values of PC1 in the previous section. This can be easily done as both datasets share a column - the name of the samples. Once this is done, it is again simple to produce additional plots.
CCLE.df.samples <- inner_join(CCLE.df,CCLE_samples,by="CCLE.name")
ggplot(CCLE.df.samples, aes(Order,PC1)) +
  geom_point(aes(colour=factor(Site.Primary))) + ylab("PC1")In this case the figure is slightly confusing due to the number of factors. We can however rename factors that appear less than 30 times in total as “Other”.
rare.sites <- names(which(summary(CCLE.df.samples$Site.Primary) < 15))
CCLE.df.samples$Site.Primary2 <- as.character(CCLE.df.samples$Site.Primary)
rare.sites.loc <- which(CCLE.df.samples$Site.Primary2 %in% rare.sites)
CCLE.df.samples$Site.Primary2[rare.sites.loc] <- "Other"
ggplot(CCLE.df.samples, aes(Order,PC1)) +
  geom_point(aes(colour=factor(Site.Primary2))) + ylab("PC1")ggplot(CCLE.df.samples, aes(Order,PC1)) +
  geom_point(aes(colour=factor(Gender))) + ylab("PC1")Since in this case the data is categorical, it can be tested for significance using Pearson’s chi squared test.
library(MASS)
# create contingency tables
ctable.site <- table(CCLE.df.samples$Fork,
                     CCLE.df.samples$Site.Primary)
ctable.gender <- table(CCLE.df.samples$Fork,
                       CCLE.df.samples$Gender,
                       exclude = "U")
chisq.test(ctable.site)## Warning in chisq.test(ctable.site): Chi-squared approximation may be incorrect## 
##  Pearson's Chi-squared test
## 
## data:  ctable.site
## X-squared = 202.27, df = 46, p-value < 2.2e-16chisq.test(ctable.gender)## Warning in chisq.test(ctable.gender): Chi-squared approximation may be incorrect## 
##  Pearson's Chi-squared test
## 
## data:  ctable.gender
## X-squared = 6.3603, df = 4, p-value = 0.1738As was easily apparent from examining the plots, the primary site the cell line is derived from is highly significant, while gender is not.
MCbiclust is a stochastic method so for best results it needs to be run multiple times, in practice this means using high-performance computing the run the algorithm on a computer cluster which will be dealt with in a later section. Here however the task of dealing with the results will be looked at. The algorithm will be run \(100\) times with only \(500\) iterations each. Typically more iterations are required, but for this demonstration it will be sufficient.
CCLE.multi.seed <- list()
initial.seed1 <- list()
for(i in seq(100)){
  set.seed(i)
  initial.seed1[[i]] <- sample(seq(length = dim(CCLE_small)[2]),10)
  CCLE.multi.seed[[i]] <- FindSeed(gem = CCLE_small[c(501:1000), ],
                                   seed.size = 10,
                                   iterations = 500,
                                   initial.seed = initial.seed1[[i]])
}The associated correlation vector must also be calculated for each run and these correlation vectors can be put into a matrix.
CCLE.cor.vec.multi <- list()
for(i in seq(100)){
  CCLE.cor.vec.multi[[i]] <- CVEval(gem.part = CCLE_small[c(501:1000), ],
                                    gem.all = CCLE_small,
                                    seed = CCLE.multi.seed[[i]],
                                    splits = 10)
                                      
}len.a <- length(CCLE.cor.vec.multi[[1]])
len.b <- length(CCLE.cor.vec.multi)
multi.run.cor.vec.mat <- matrix(0,len.a,len.b)
for(i in 1:100){
  multi.run.cor.vec.mat[,i] <- CCLE.cor.vec.multi[[i]]
}
rm(CCLE.cor.vec.multi)A correlation matrix can be formed from the correlation vectors, and in this way they can be viewed as a heatmap.
CV.cor.mat1 <- abs(cor((multi.run.cor.vec.mat)))
cor.dist <- function(c){as.dist(1 - abs(c))}
routput.corvec.matrix.cor.heat <- heatmap.2(CV.cor.mat1,
                                            trace="none",
                                            distfun = cor.dist)It needs to be known how many distinct patterns have been found, this is done with clustering and particular silhouette coefficients to judge what number of clusters is optimum within the data. Function SilhouetteClustGroups achieves this and uses hierarchical clustering to split the patterns into clusters, for comparison a randomly generated correlation vector is also added to allow for the possibility that all patterns found are best grouped into a single cluster.
multi.clust.groups <- SilhouetteClustGroups(multi.run.cor.vec.mat,
                                            max.clusters = 20,
                                            plots = TRUE,rand.vec = FALSE)## NULL## NULLHere two clusters were found, and we can visualise this pattern (and any additional others found) with the function CVPlot, which highlights a chosen gene set, in this case the mitochondrial genes.
gene.names <- row.names(CCLE_small)
av.corvec.fun <- function(x) rowMeans(multi.run.cor.vec.mat[,x])
average.corvec <- lapply(X = multi.clust.groups,
                         FUN = av.corvec.fun)
CVPlot(cv.df = as.data.frame(average.corvec),
        geneset.loc = mito.loc,
        geneset.name = "Mitochondrial",
        alpha1 = 0.1)As before can also calculate the gene set enrichment.
GOfun <- function(x) GOEnrichmentAnalysis(gene.names = gene.names,
                                          gene.values = x,
                                          sig.rate = 0.05)corvec.gsea <- lapply(X = average.corvec,
                      FUN = GOfun)Before using SampleSort a special prep function, MultiSampleSortPrep is used to generate the gene expression matrix and top seed for each found bicluster. The gene expression matrix is composed of the top \(n\) genes in the correlation vector, and the seed is chosen as the calculated seed that has the maximum correlation score.
CCLE.samp.multi.sort <- list()
multi.prep <- MultiSampleSortPrep(gem = CCLE_small,
                                  av.corvec = average.corvec,
                                  top.genes.num = 750,
                                  groups = multi.clust.groups,
                                  initial.seeds =  CCLE.multi.seed)CCLE.samp.multi.sort[[1]] <- SampleSort(gem = multi.prep[[1]][[1]],
                                        seed = multi.prep[[2]][[1]])
CCLE.samp.multi.sort[[2]] <- SampleSort(gem = multi.prep[[1]][[2]],
                                        seed = multi.prep[[2]][[2]])     Note as before that these are long calculations.
These two biclusters can now be analysed in the same way as the single bicluster before.
To calculate the PC1 values:
pc1.vec.multi <- list()
 
pc1.vec.multi[[1]] <- PC1VecFun(top.gem =  multi.prep[[1]][[1]],
                     seed.sort = CCLE.samp.multi.sort[[1]], n = 10)
pc1.vec.multi[[2]] <- PC1VecFun(top.gem =  multi.prep[[1]][[2]],
                     seed.sort = CCLE.samp.multi.sort[[2]], n = 10)These new biclusters can also be thresholded as follows:
CCLE.bic.multi <- list()
CCLE.bic.multi[[1]] <- ThresholdBic(cor.vec = average.corvec[[1]],
                         sort.order = CCLE.samp.multi.sort[[1]],
                         pc1 = pc1.vec.multi[[1]], samp.sig = 0.05)
CCLE.bic.multi[[2]] <- ThresholdBic(cor.vec = average.corvec[[2]],
                         sort.order = CCLE.samp.multi.sort[[2]],
                         pc1 = pc1.vec.multi[[2]], samp.sig = 0.05)
pc1.vec.multi[[1]] <- PC1Align(gem = CCLE_small, pc1 = pc1.vec.multi[[1]],
                    sort.order = CCLE.samp.multi.sort[[1]],
                    cor.vec = average.corvec[[1]], bic = CCLE.bic.multi[[1]])
pc1.vec.multi[[2]] <- PC1Align(gem = CCLE_small, pc1 = pc1.vec.multi[[2]],
                    sort.order = CCLE.samp.multi.sort[[2]],
                    cor.vec = average.corvec[[2]], bic = CCLE.bic.multi[[2]])In a similar way to before the forks for these new biclusters can be plotted:
CCLE.multi.df <- data.frame(CCLE.name = colnames(CCLE_small),
           Bic1.order = order(CCLE.samp.multi.sort[[1]]),
           Bic2.order = order(CCLE.samp.multi.sort[[2]]),
           Bic1.PC1 = pc1.vec.multi[[1]][order(CCLE.samp.multi.sort[[1]])],
           Bic2.PC1 = pc1.vec.multi[[2]][order(CCLE.samp.multi.sort[[2]])])
CCLE.multi.df.samples <- inner_join(CCLE.multi.df,CCLE_samples,by="CCLE.name")
rare.sites <- names(which(summary(CCLE.multi.df.samples$Site.Primary) < 15))
CCLE.multi.df.samples$Site.Primary2 <- as.character(CCLE.multi.df.samples$Site.Primary)
rare.sites.loc <- which(CCLE.multi.df.samples$Site.Primary2 %in% rare.sites)
CCLE.multi.df.samples $Site.Primary2[rare.sites.loc] <- "Other"
ggplot(CCLE.multi.df.samples, aes(Bic1.order,Bic1.PC1)) +
  geom_point(aes(colour=factor(Site.Primary2))) + ylab("Bic1 PC1")ggplot(CCLE.multi.df.samples, aes(Bic2.order,Bic2.PC1)) +
  geom_point(aes(colour=factor(Site.Primary2))) + ylab("Bic2 PC1")One final thing that can be done is to compare all 3 correlation vectors found
cv.df <- as.data.frame(average.corvec)
cv.df$Mito1 <- CCLE.cor.vec
CVPlot(cv.df,cnames = c("R1","R2","M1"),
        geneset.loc = mito.loc,
        geneset.name = "Mitochondrial",
        alpha1 = 0.1)It is immediately apparent that the one of the biclusters found from the random gene set is very similar to that of the mitochondrial based bicluster.
devtools::session_info()## ─ Session info ───────────────────────────────────────────────────────────────
##  setting  value                       
##  version  R version 4.1.1 (2021-08-10)
##  os       Ubuntu 20.04.3 LTS          
##  system   x86_64, linux-gnu           
##  ui       X11                         
##  language (EN)                        
##  collate  C                           
##  ctype    en_US.UTF-8                 
##  tz       America/New_York            
##  date     2021-10-26                  
## 
## ─ Packages ───────────────────────────────────────────────────────────────────
##  package              * version  date       lib source        
##  annotate               1.72.0   2021-10-26 [2] Bioconductor  
##  AnnotationDbi          1.56.0   2021-10-26 [2] Bioconductor  
##  assertthat             0.2.1    2019-03-21 [2] CRAN (R 4.1.1)
##  backports              1.2.1    2020-12-09 [2] CRAN (R 4.1.1)
##  base64enc              0.1-3    2015-07-28 [2] CRAN (R 4.1.1)
##  beachmat               2.10.0   2021-10-26 [2] Bioconductor  
##  Biobase                2.54.0   2021-10-26 [2] Bioconductor  
##  BiocGenerics           0.40.0   2021-10-26 [2] Bioconductor  
##  BiocManager            1.30.16  2021-06-15 [2] CRAN (R 4.1.1)
##  BiocParallel           1.28.0   2021-10-26 [2] Bioconductor  
##  BiocSingular           1.10.0   2021-10-26 [2] Bioconductor  
##  BiocStyle            * 2.22.0   2021-10-26 [2] Bioconductor  
##  Biostrings             2.62.0   2021-10-26 [2] Bioconductor  
##  bit                    4.0.4    2020-08-04 [2] CRAN (R 4.1.1)
##  bit64                  4.0.5    2020-08-30 [2] CRAN (R 4.1.1)
##  bitops                 1.0-7    2021-04-24 [2] CRAN (R 4.1.1)
##  blob                   1.2.2    2021-07-23 [2] CRAN (R 4.1.1)
##  bookdown               0.24     2021-09-02 [2] CRAN (R 4.1.1)
##  bslib                  0.3.1    2021-10-06 [2] CRAN (R 4.1.1)
##  cachem                 1.0.6    2021-08-19 [2] CRAN (R 4.1.1)
##  callr                  3.7.0    2021-04-20 [2] CRAN (R 4.1.1)
##  caTools                1.18.2   2021-03-28 [2] CRAN (R 4.1.1)
##  checkmate              2.0.0    2020-02-06 [2] CRAN (R 4.1.1)
##  cli                    3.0.1    2021-07-17 [2] CRAN (R 4.1.1)
##  cluster                2.1.2    2021-04-17 [2] CRAN (R 4.1.1)
##  codetools              0.2-18   2020-11-04 [2] CRAN (R 4.1.1)
##  colorspace             2.0-2    2021-06-24 [2] CRAN (R 4.1.1)
##  crayon                 1.4.1    2021-02-08 [2] CRAN (R 4.1.1)
##  data.table             1.14.2   2021-09-27 [2] CRAN (R 4.1.1)
##  DBI                    1.1.1    2021-01-15 [2] CRAN (R 4.1.1)
##  DelayedArray           0.20.0   2021-10-26 [2] Bioconductor  
##  DelayedMatrixStats     1.16.0   2021-10-26 [2] Bioconductor  
##  desc                   1.4.0    2021-09-28 [2] CRAN (R 4.1.1)
##  devtools             * 2.4.2    2021-06-07 [2] CRAN (R 4.1.1)
##  digest                 0.6.28   2021-09-23 [2] CRAN (R 4.1.1)
##  doParallel             1.0.16   2020-10-16 [2] CRAN (R 4.1.1)
##  dplyr                * 1.0.7    2021-06-18 [2] CRAN (R 4.1.1)
##  dynamicTreeCut         1.63-1   2016-03-11 [2] CRAN (R 4.1.1)
##  ellipsis               0.3.2    2021-04-29 [2] CRAN (R 4.1.1)
##  evaluate               0.14     2019-05-28 [2] CRAN (R 4.1.1)
##  fansi                  0.5.0    2021-05-25 [2] CRAN (R 4.1.1)
##  farver                 2.1.0    2021-02-28 [2] CRAN (R 4.1.1)
##  fastcluster            1.2.3    2021-05-24 [2] CRAN (R 4.1.1)
##  fastmap                1.1.0    2021-01-25 [2] CRAN (R 4.1.1)
##  foreach                1.5.1    2020-10-15 [2] CRAN (R 4.1.1)
##  foreign                0.8-81   2020-12-22 [2] CRAN (R 4.1.1)
##  Formula                1.2-4    2020-10-16 [2] CRAN (R 4.1.1)
##  fs                     1.5.0    2020-07-31 [2] CRAN (R 4.1.1)
##  generics               0.1.1    2021-10-25 [2] CRAN (R 4.1.1)
##  GenomeInfoDb           1.30.0   2021-10-26 [2] Bioconductor  
##  GenomeInfoDbData       1.2.7    2021-09-23 [2] Bioconductor  
##  GenomicRanges          1.46.0   2021-10-26 [2] Bioconductor  
##  GGally                 2.1.2    2021-06-21 [2] CRAN (R 4.1.1)
##  ggplot2              * 3.3.5    2021-06-25 [2] CRAN (R 4.1.1)
##  glue                   1.4.2    2020-08-27 [2] CRAN (R 4.1.1)
##  GO.db                  3.14.0   2021-09-23 [2] Bioconductor  
##  gplots               * 3.1.1    2020-11-28 [2] CRAN (R 4.1.1)
##  gProfileR            * 0.7.0    2019-11-04 [2] CRAN (R 4.1.1)
##  graph                  1.72.0   2021-10-26 [2] Bioconductor  
##  gridExtra              2.3      2017-09-09 [2] CRAN (R 4.1.1)
##  GSEABase               1.56.0   2021-10-26 [2] Bioconductor  
##  GSVA                 * 1.42.0   2021-10-26 [2] Bioconductor  
##  gtable                 0.3.0    2019-03-25 [2] CRAN (R 4.1.1)
##  gtools                 3.9.2    2021-06-06 [2] CRAN (R 4.1.1)
##  HDF5Array              1.22.0   2021-10-26 [2] Bioconductor  
##  highr                  0.9      2021-04-16 [2] CRAN (R 4.1.1)
##  Hmisc                  4.6-0    2021-10-07 [2] CRAN (R 4.1.1)
##  htmlTable              2.3.0    2021-10-12 [2] CRAN (R 4.1.1)
##  htmltools              0.5.2    2021-08-25 [2] CRAN (R 4.1.1)
##  htmlwidgets            1.5.4    2021-09-08 [2] CRAN (R 4.1.1)
##  httr                   1.4.2    2020-07-20 [2] CRAN (R 4.1.1)
##  impute                 1.68.0   2021-10-26 [2] Bioconductor  
##  IRanges                2.28.0   2021-10-26 [2] Bioconductor  
##  irlba                  2.3.3    2019-02-05 [2] CRAN (R 4.1.1)
##  iterators              1.0.13   2020-10-15 [2] CRAN (R 4.1.1)
##  jpeg                   0.1-9    2021-07-24 [2] CRAN (R 4.1.1)
##  jquerylib              0.1.4    2021-04-26 [2] CRAN (R 4.1.1)
##  jsonlite               1.7.2    2020-12-09 [2] CRAN (R 4.1.1)
##  KEGGREST               1.34.0   2021-10-26 [2] Bioconductor  
##  KernSmooth             2.23-20  2021-05-03 [2] CRAN (R 4.1.1)
##  knitr                  1.36     2021-09-29 [2] CRAN (R 4.1.1)
##  labeling               0.4.2    2020-10-20 [2] CRAN (R 4.1.1)
##  lattice                0.20-45  2021-09-22 [2] CRAN (R 4.1.1)
##  latticeExtra           0.6-29   2019-12-19 [2] CRAN (R 4.1.1)
##  lifecycle              1.0.1    2021-09-24 [2] CRAN (R 4.1.1)
##  magick                 2.7.3    2021-08-18 [2] CRAN (R 4.1.1)
##  magrittr               2.0.1    2020-11-17 [2] CRAN (R 4.1.1)
##  MASS                 * 7.3-54   2021-05-03 [2] CRAN (R 4.1.1)
##  Matrix                 1.3-4    2021-06-01 [2] CRAN (R 4.1.1)
##  MatrixGenerics         1.6.0    2021-10-26 [2] Bioconductor  
##  matrixStats            0.61.0   2021-09-17 [2] CRAN (R 4.1.1)
##  MCbiclust            * 1.18.0   2021-10-26 [1] Bioconductor  
##  memoise                2.0.0    2021-01-26 [2] CRAN (R 4.1.1)
##  munsell                0.5.0    2018-06-12 [2] CRAN (R 4.1.1)
##  nnet                   7.3-16   2021-05-03 [2] CRAN (R 4.1.1)
##  org.Hs.eg.db           3.14.0   2021-09-23 [2] Bioconductor  
##  pander                 0.6.4    2021-06-13 [2] CRAN (R 4.1.1)
##  pillar                 1.6.4    2021-10-18 [2] CRAN (R 4.1.1)
##  pkgbuild               1.2.0    2020-12-15 [2] CRAN (R 4.1.1)
##  pkgconfig              2.0.3    2019-09-22 [2] CRAN (R 4.1.1)
##  pkgload                1.2.3    2021-10-13 [2] CRAN (R 4.1.1)
##  plyr                   1.8.6    2020-03-03 [2] CRAN (R 4.1.1)
##  png                    0.1-7    2013-12-03 [2] CRAN (R 4.1.1)
##  preprocessCore         1.56.0   2021-10-26 [2] Bioconductor  
##  prettyunits            1.1.1    2020-01-24 [2] CRAN (R 4.1.1)
##  processx               3.5.2    2021-04-30 [2] CRAN (R 4.1.1)
##  ps                     1.6.0    2021-02-28 [2] CRAN (R 4.1.1)
##  purrr                  0.3.4    2020-04-17 [2] CRAN (R 4.1.1)
##  R6                     2.5.1    2021-08-19 [2] CRAN (R 4.1.1)
##  RColorBrewer           1.1-2    2014-12-07 [2] CRAN (R 4.1.1)
##  Rcpp                   1.0.7    2021-07-07 [2] CRAN (R 4.1.1)
##  RCurl                  1.98-1.5 2021-09-17 [2] CRAN (R 4.1.1)
##  remotes                2.4.1    2021-09-29 [2] CRAN (R 4.1.1)
##  reshape                0.8.8    2018-10-23 [2] CRAN (R 4.1.1)
##  rhdf5                  2.38.0   2021-10-26 [2] Bioconductor  
##  rhdf5filters           1.6.0    2021-10-26 [2] Bioconductor  
##  Rhdf5lib               1.16.0   2021-10-26 [2] Bioconductor  
##  rlang                  0.4.12   2021-10-18 [2] CRAN (R 4.1.1)
##  rmarkdown              2.11     2021-09-14 [2] CRAN (R 4.1.1)
##  rpart                  4.1-15   2019-04-12 [2] CRAN (R 4.1.1)
##  rprojroot              2.0.2    2020-11-15 [2] CRAN (R 4.1.1)
##  RSQLite                2.2.8    2021-08-21 [2] CRAN (R 4.1.1)
##  rstudioapi             0.13     2020-11-12 [2] CRAN (R 4.1.1)
##  rsvd                   1.0.5    2021-04-16 [2] CRAN (R 4.1.1)
##  S4Vectors              0.32.0   2021-10-26 [2] Bioconductor  
##  sass                   0.4.0    2021-05-12 [2] CRAN (R 4.1.1)
##  ScaledMatrix           1.2.0    2021-10-26 [2] Bioconductor  
##  scales                 1.1.1    2020-05-11 [2] CRAN (R 4.1.1)
##  sessioninfo            1.1.1    2018-11-05 [2] CRAN (R 4.1.1)
##  SingleCellExperiment   1.16.0   2021-10-26 [2] Bioconductor  
##  sparseMatrixStats      1.6.0    2021-10-26 [2] Bioconductor  
##  stringi                1.7.5    2021-10-04 [2] CRAN (R 4.1.1)
##  stringr                1.4.0    2019-02-10 [2] CRAN (R 4.1.1)
##  SummarizedExperiment   1.24.0   2021-10-26 [2] Bioconductor  
##  survival               3.2-13   2021-08-24 [2] CRAN (R 4.1.1)
##  testthat               3.1.0    2021-10-04 [2] CRAN (R 4.1.1)
##  tibble                 3.1.5    2021-09-30 [2] CRAN (R 4.1.1)
##  tidyselect             1.1.1    2021-04-30 [2] CRAN (R 4.1.1)
##  usethis              * 2.1.2    2021-10-25 [2] CRAN (R 4.1.1)
##  utf8                   1.2.2    2021-07-24 [2] CRAN (R 4.1.1)
##  vctrs                  0.3.8    2021-04-29 [2] CRAN (R 4.1.1)
##  WGCNA                  1.70-3   2021-02-28 [2] CRAN (R 4.1.1)
##  withr                  2.4.2    2021-04-18 [2] CRAN (R 4.1.1)
##  xfun                   0.27     2021-10-18 [2] CRAN (R 4.1.1)
##  XML                    3.99-0.8 2021-09-17 [2] CRAN (R 4.1.1)
##  xtable                 1.8-4    2019-04-21 [2] CRAN (R 4.1.1)
##  XVector                0.34.0   2021-10-26 [2] Bioconductor  
##  yaml                   2.2.1    2020-02-01 [2] CRAN (R 4.1.1)
##  zlibbioc               1.40.0   2021-10-26 [2] Bioconductor  
## 
## [1] /tmp/RtmpG2EWUq/Rinst13e896bb4aad
## [2] /home/biocbuild/bbs-3.14-bioc/R/libraryBarbie, David A, Pablo Tamayo, Jesse S Boehm, So Young Kim, Susan E Moody, Ian F Dunn, Anna C Schinzel, et al. 2009. “Systematic Rna Interference Reveals That Oncogenic Kras-Driven Cancers Require Tbk1.” Nature 462 (7269): 108.
Barretina, Jordi, Giordano Caponigro, Nicolas Stransky, Kavitha Venkatesan, Adam A Margolin, Sungjoon Kim, Christopher J Wilson, et al. 2012. “The Cancer Cell Line Encyclopedia Enables Predictive Modelling of Anticancer Drug Sensitivity.” Nature 483 (7391): 603–7.
Hänzelmann, Sonja, Robert Castelo, and Justin Guinney. 2013. “GSVA: Gene Set Variation Analysis for Microarray and Rna-Seq Data.” BMC Bioinformatics 14 (1): 7.
Pagliarini, David J, Sarah E Calvo, Betty Chang, Sunil A Sheth, Scott B Vafai, Shao-En Ong, Geoffrey A Walford, et al. 2008. “A Mitochondrial Protein Compendium Elucidates Complex I Disease Biology.” Cell 134 (1): 112–23.