Rediscover is an R package to identify mutually exclusive genomic events. It reimplements a privious R package (Discover) whose main contribution is a statistical analysis based on the Poisson-Binomial distribution that takes into account that some samples are more mutated than others. Rediscover is much faster than the  discover  implementation. 
Rediscover can be installed from CRAN repository:
install.packages("Rediscover")The package library has two main parts:
Figure 1. Flow diagram of Rediscover.
Figure 1 is a flowchart that depicts Rediscover pipeline. Given a binary matrix of genes x samples where a 1 will appear if gene i is mutated in sample j and 0 otherwise, getPM function estimates the probabilities \(p_{ij}\) of the gene i being mutated in sample j. The input matrix could be matrix or Matrix class. Usually, mutations stored in Matrix class are a sparse object and therefore, require less memory to store them.
The second step is the estimation of the p-values using these probabilities and the number of samples where two genes are co-altered. Rediscover offers different functions depending on the desired study:
getMutex if the user wants to evaluate if genes are mutually exclusive.getMutexAB if the user wants to evaluate if genes are mutually exclusive with respect to another event (amplifications, deletions, etc…)getMutexGroup will be used when the user wants to obtain the probability that a certain group of genes being mutually exclusive. Unlike the getMutex function, in this case the users introduces the set of genes of interest.Rediscover also provides a function to integrate its usage with  maftools and TCGAbiolinks. Specifically, we added to the function somaticInteractions from maftools our analyses based on the Poisson-Binomial distribution resulting in a new function called discoversomaticInteractions.
Given a binary matrix A with the mutation information, getPM estimates the probabilities \(p_{ij}\) of the gene i being mutated in sample j. To make the package more memory efficient, we created an S4 class object called PMatrix that gives access to the values of the resulting probability matrix.
The required input for this function is:
The following code chunk shows an example of how to perform this function:
data("A_example")
PMA <- getPM(A_example)
PMA[1:4,1:4]##           [,1]      [,2]      [,3]      [,4]
## [1,] 0.4813047 0.4853081 0.4743055 0.4673148
## [2,] 0.5133379 0.5173420 0.5063276 0.4993132
## [3,] 0.4993267 0.5033346 0.4923142 0.4853031
## [4,] 0.5093353 0.5133411 0.5023232 0.4953086As already mentioned, getPM allows matrices of class matrix as depicted on previous example. But this functions also supports matrices of type Matrix. The following code chunk shows the same example but using a matrix of class Matrix.
data("A_Matrix")
class(A_Matrix)## [1] "dgCMatrix"
## attr(,"package")
## [1] "Matrix"PMA <- getPM(A_Matrix)
PMA[1:4,1:4]##           [,1]      [,2]      [,3]      [,4]
## [1,] 0.4813047 0.4853081 0.4743055 0.4673148
## [2,] 0.5133379 0.5173420 0.5063276 0.4993132
## [3,] 0.4993267 0.5033346 0.4923142 0.4853031
## [4,] 0.5093353 0.5133411 0.5023232 0.4953086Finally, the next code chunk shows an example of applying this function to a real case. Specifically, information available in The Cancer Genome Atlas Program (TCGA) on colon adenocarcinoma (COAD) has been used.
data("TCGA_COAD")
PM_COAD <- getPM(TCGA_COAD)From the probability matrix and the number of samples in which two genes are co-mutated, p-values can be estimated using the Poisson-Binomial distribution. That is, the probability of two genes being mutually exclusive is obtained. The p-values obtained are stored in a Matrix class in order to be memory efficient.
Rediscover offers different functions depending on the desired study: Using a single matrix (getMutex function), using two matrices (getMutexAB function), using a specific group of genes (getMutexGroup function).
As explained below, the p-values can be estimated using the Poisson-Binomial distribution.
Both functions getMutex and getMutexAB have four different approaches to estimate the
Poisson-Binomial distribution:
PoissonBinomial Rpackage based on the work from (Biscarri, Zhao, & Brunner, 2018).We can perform the mutual exclusivity test for all pairs of genes of a single matrix using the getMutex function.
The inputs of getMutex are:
getPM. By default is equal to getPM(A).The following code chunk shows an example of how to perform this function:
data("A_example")
PMA <- getPM(A_example)
mymutex <- getMutex(A=A_example,PM=PMA)As in the previous case, an example is shown when using matrices of class Matrix.
data("A_Matrix")
PMA_Matrix <- getPM(A_Matrix)
mymutex <- getMutex(A=A_Matrix,PM=PMA_Matrix)Finally, as in the previous case, an example of how to apply this function to a real case has been carried out. Specifically, information available in The Cancer Genome Atlas Program (TCGA) on colon adenocarcinoma (COAD) has been used. We applied to the top 100 most mutated genes.
data("TCGA_COAD")
data("PM_COAD")
COAD_mutex <- getMutex(TCGA_COAD[1:100,], PM_COAD[1:100,])Moreover, there are some extra inputs that if user want to use the exact formula of the Poison-Binomial distribution:
By default, the mixed parameter is set to TRUE and the exact p-value is computed for p-values lower that the upper threshold (the parameter th, which default value is 0.05). I.e. if mixed option is selected and th is set to 1, all the p-values are computed with the exact formula. The following code chunk shows performs the previous test but applying the exact method for p-values lower than 0.001.
data("TCGA_COAD")
data("PM_COAD")
COAD_mutex_exact <- getMutex(TCGA_COAD[1:100,], PM_COAD[1:100,],mixed = TRUE,th = 0.001)If the mixed parameter is set to FALSE all the p-values are computed with the approximation selected. The following code chunk show an example of how to performe the previous test but applying the Binomial approximation for all the p-values:
data("TCGA_COAD")
data("PM_COAD")
COAD_mutex_exact <- getMutex(TCGA_COAD[1:100,], PM_COAD[1:100,],mixed = FALSE,method = "Binomial")The second option is using two matrices. As in the first case, it is also necessary to enter the previously obtained probability matrix in addition to the initial matrix. But, unlike the previous case, an extra matrix B is used which has the same shape as matrix A, but may contain additional information, such as gene amplifications i in samples j. In this way, it will be necessary to enter both probability matrices in addition to the initial matrices. In the case where this function is applied directly, getMutex allows not to enter the probability matrices, since it would be calculated internally in order to use this function.
Therefore, the inputs required by getMutexAB are:
getPM. By default is equal to getPM(A).getPM. By default is equal to getPM(B).In addition, in this case there are also some extra possible entries that have been previously defined, but could be modified by the user:
Continuing with the example, in this case the result will not be a matrix with the probability that genes being mutually exclusive, but rather a matrix with the probability that genes being amplified. The following code chunk shows an example of how to perform this function with the default parameters.
data("A_example")
data("B_example")
PMA <- getPM(A_example)
PMB <- getPM(B_example)
mismutex <- getMutexAB(A=A_example, PM=PMA, B=B_example, PMB = PMB)As in the previous cases, the following code chunk shows an example when using matrices of class Matrix.
data("A_Matrix")
data("B_Matrix")
PMA <- getPM(A_Matrix)
PMB <- getPM(B_Matrix)
mismutex <- getMutexAB(A=A_Matrix, PM=PMA, B=B_Matrix, PMB = PMB)Finally, the next code chunk shows an example of how to apply this function to a real case. Specifically, information available in The Cancer Genome Atlas Program (TCGA) on colon adenocarcinoma (COAD) has been used. In this case, the TCGA_COAD_AMP matrix correspond to the most 1000 mutated genes, and the extra matrix AMP_COAD provides information about the amplifications over 1000 genes. The example run getMutexAB with the default parameters.
data("TCGA_COAD_AMP")
data("AMP_COAD")
data("PM_TCGA_COAD_AMP")
data("PM_AMP_COAD")
mismutex <- getMutexAB(A=TCGA_COAD_AMP, PMA=PM_TCGA_COAD_AMP, 
                       B=AMP_COAD, PMB = PM_AMP_COAD)In the previous example, TCGA_COAD_AMP and AMP_COAD share the same number of rown, but this is not needed. The following code chunk show the sample analysis but with the 100 most mutated genes and 50 amplificated genes.
data("TCGA_COAD_AMP")
data("AMP_COAD")
data("PM_TCGA_COAD_AMP")
data("PM_AMP_COAD")
mismutex <- getMutexAB(A=TCGA_COAD_AMP[1:100,], PMA=PM_TCGA_COAD_AMP[1:100,], 
                       B=AMP_COAD[1:50,], PMB = PM_AMP_COAD[1:50,])Finally, the last option requires, as in the first case, a single matrix and the obtained probability matrix. As explained before, in this case a reduced version of the original matrix is introduced, i.e., starting from the original matrix, a specific group of genes and samples are selected. On the other hand, the probability matrix required for this study will be taken from the global probability matrix, i.e., the global probability matrix is first calculated by introducing the original matrix with all genes and all samples and then only the probabilities of the specifically selected genes and samples are chosen. Therefore, a matrix will be introduced that will contain a series of genes and samples from the original matrix, with their corresponding probabilities obtained from the global probability matrix.
In addition, unlike the other functions, this one allows to determine:
Therefore, the inputs required by getMutexGroup are:
getPM.Furthermore, there is also an extra possible entry that has been previously defined, but could be modified by the user:
The following code chunk shows an example of how to perform this function:
data("A_example")
A2 <- A_example[,1:40]
A2[1,1:10] <- 1
A2[2,1:10] <- 0
A2[3,1:10] <- 0
A2[1,11:20] <- 0
A2[2,11:20] <- 1
A2[3,11:20] <- 0
A2[1,21:30] <- 0
A2[2,21:30] <- 0
A2[3,21:30] <- 1
PM2 <- getPM(A2)
A <- A2[1:3,]
PM <- PM2[1:3,]The next figure is a graphical representation of A, showing a matrix of 3 genes with mutations in some of samples (black areas).
Following, getMutexGroup function has been used introducing the generated A matrix and performing three different studies; first one analyses the impurity, second one the coverage and last one the exclusivity.
getMutexGroup(A, PM, "Impurity")## [1] 0.02459048getMutexGroup(A, PM, "Coverage")## [1] 2.245149e-05getMutexGroup(A, PM, "Exclusivity")## [1] 5.444509e-07Among the possible applications of Rediscover stands up the possibility of representing graphically the results obtained by applying discoverSomaticInteractions function. In this case, maftools has been used in Colon Adenocarcinoma (COAD) and different plots have been performed to study the results obtained, which has allowed the study of co-ocurring and mutually exclusive genes.
coad.maf <- GDCquery_Maf("COAD", pipelines = "muse") %>% read.mafFigure 3 shows the mutations contained in genes in each sample, with missesense mutations being the most common, although, nonsense mutations are noteworthy, as 54% of the samples are mutated in APC, which contains a large percentage of nonsense mutations.
oncoplot(coad.maf, top = 35)Figure 3. Oncoplot of Colon Adenocarcinoma.
Analyzing Figure 3, it can be seen that there are samples with a high number of mutations, which indicates the presence of hypermutated samples. Specifically, there are samples with more than 7000 mutations, and focusing on them, it can be seen that there are three samples in particular with a large number of mutations, but, even though they are hypermutated, not all genes contain a mutation in that sample. In particular, looking at the second and third peaks, it is observed that most of genes are mutated, but there are a few that are not, which makes them very interesting. Specifically, TP53, which has 47% mutations, is not mutated in two of the most hypermutated samples.
Furthermore, looking at the pattern of mutations, it could be predicted that APC, TP53 and TTN and KRAS are mutually exclusive, as it is observed that there are areas in which one of the genes is mutated but the rest are not.
Next, to further deepen the analysis obtained from the oncoplot, Somatic Interactions plots were made, which determines the co-occurrence and mutual exclusivity between genes. Specifically, two plots have been carried out the first one using the function provided by the discover package, i.e. somaticInteractions, an the second one using the last of the functions created in Rediscover package; discoversomaticInteractions.
Figure 4 shows the result when applying somaticInteractions function and it can be seen that most of genes are co-occurrent.
somaticInteractions(maf = coad.maf, top = 35, pvalue = c(1e-2, 2e-3))Figure 4. Somatic Interactions plot of Colon Adenocarcinoma using somaticInteractions function*.
However, Figure 5 shows the result when applying discoversomaticInteractions function. It is observed that the result is very different from the previous one, as in this case more mutually exclusive genes appear.
The discoversomaticInteractions internally calls the getMutex function. Therefore, it has some extra parameter in order to set the parameters of getMutex, that are:
getMutex function (by default “ShiftedBinomial”)getMutex function (by default TRUE)The following code chunk show an example of how to apply this function:
discoversomaticInteractions(maf = coad.maf, top = 35, pvalue = c(1e-2, 2e-3),getMutexMixed=FALSE)Figure 5. Somatic Interactions plot of Colon Adenocarcinoma using discoversomaticInteractions function.
The reason why this difference exists is because, as mentioned, there are samples that are hypermutated, so most genes are mutated, and therefore they are all co-ocurring with each other, when in fact they are not.
Analyzing Figure 5, it can be seen that:
somaticInteractions function where the significance was minimal and practically nil.Finally, analyzing the similarities between the two Somatic Interaction figures at the same time, the following conclusions can be drawn:
Therefore, analyzing all these conclusions, it is obtained that, as predicted by the oncoplot analysis, APC, TP53, TTN and KRAS are mutually exclusive. But, genes that seem co-occurrent when applying somaticInteractions, in reality are not and that is demonstrated when applying discoversomaticInteractions.
There are several methods for calculating the corrected p-values (q-values). The following example shows how to calculate the q-values using the qvalue library:
data("TCGA_COAD")
data("PM_COAD")
COAD_mutex <- getMutex(TCGA_COAD[1:100,], PM_COAD[1:100,])
COAD_mutex_qvalue <- COAD_mutex
COAD_mutex_qvalue@x <- qvalue::qvalue(COAD_mutex_qvalue@x)$qvalueFerrer-Bonsoms Juan A., Jareno Laura, and Rubio Angel ‘Rediscover: an R package to identify mutually exclusive mutations.’ submitted.
Canisius, Sander, John WM Martens, and Lodewyk FA Wessels. “A novel independence test for somatic alterations in cancer shows that biology drives mutual exclusivity but chance explains most co-occurrence.” Genome biology 17.1 (2016): 1-17.
Antonio Colaprico, Tiago Chedraoui Silva, Catharina Olsen, Luciano Garofano, Claudia Cava, Davide Garolini, Thais Sabedot, Tathiane Malta, Stefano M. Pagnotta, Isabella Castiglioni,Michele Ceccarelli, Gianluca Bontempi Houtan Noushmehr. TCGAbiolinks: An R/Bioconductor package for integrative analysis of TCGA data Nucleic Acids Research (05 May 2016) 44 (8): e71.
Silva, Tiago C., et al. “TCGA Workflow: Analyze cancer genomics and epigenomics data using Bioconductor packages.” F1000Research 5 (2016).
Mounir, Mohamed, et al. “New functionalities in the TCGAbiolinks package for the study and integration of cancer data from GDC and GTEx.” PLoS computational biology 15.3 (2019): e1006701.
Mayakonda A, Lin DC, Assenov Y, Plass C, Koeffler HP. 2018. Maftools: efficient and comprehensive analysis of somatic variants in cancer. Genome Research. http://dx.doi.org/10.1101/gr.239244.118
sessionInfo()## R version 4.0.3 (2020-10-10)
## Platform: x86_64-apple-darwin17.0 (64-bit)
## Running under: macOS Catalina 10.15.2
## 
## Matrix products: default
## BLAS:   /Library/Frameworks/R.framework/Versions/4.0/Resources/lib/libRblas.dylib
## LAPACK: /Library/Frameworks/R.framework/Versions/4.0/Resources/lib/libRlapack.dylib
## 
## locale:
## [1] C/es_ES.UTF-8/es_ES.UTF-8/C/es_ES.UTF-8/es_ES.UTF-8
## 
## attached base packages:
## [1] parallel  stats     graphics  grDevices utils     datasets  methods  
## [8] base     
## 
## other attached packages:
##  [1] qvalue_2.22.0         TCGAbiolinks_2.18.0   maftools_2.6.05      
##  [4] kableExtra_1.3.1      dplyr_1.0.2           Rediscover_0.2.0     
##  [7] PoissonBinomial_1.2.1 speedglm_0.3-2        MASS_7.3-53          
## [10] Matrix_1.2-18         knitr_1.30            BiocStyle_2.18.1     
## 
## loaded via a namespace (and not attached):
##  [1] bitops_1.0-6                matrixStats_0.57.0         
##  [3] bit64_4.0.5                 webshot_0.5.2              
##  [5] RColorBrewer_1.1-2          progress_1.2.2             
##  [7] httr_1.4.2                  GenomeInfoDb_1.26.0        
##  [9] tools_4.0.3                 R6_2.5.0                   
## [11] DBI_1.1.0                   BiocGenerics_0.36.0        
## [13] colorspace_2.0-0            tidyselect_1.1.0           
## [15] prettyunits_1.1.1           bit_4.0.4                  
## [17] curl_4.3                    compiler_4.0.3             
## [19] rvest_0.3.6                 Biobase_2.50.0             
## [21] xml2_1.3.2                  DelayedArray_0.16.0        
## [23] bookdown_0.21               scales_1.1.1               
## [25] readr_1.4.0                 askpass_1.1                
## [27] rappdirs_0.3.1              stringr_1.4.0              
## [29] digest_0.6.27               rmarkdown_2.5              
## [31] R.utils_2.10.1              XVector_0.30.0             
## [33] pkgconfig_2.0.3             htmltools_0.5.0            
## [35] MatrixGenerics_1.2.0        dbplyr_2.0.0               
## [37] rlang_0.4.8                 rstudioapi_0.13            
## [39] RSQLite_2.2.1               generics_0.1.0             
## [41] jsonlite_1.7.1              R.oo_1.24.0                
## [43] RCurl_1.98-1.2              magrittr_1.5               
## [45] GenomeInfoDbData_1.2.4      Rcpp_1.0.5                 
## [47] munsell_0.5.0               S4Vectors_0.28.0           
## [49] lifecycle_0.2.0             R.methodsS3_1.8.1          
## [51] stringi_1.5.3               yaml_2.2.1                 
## [53] SummarizedExperiment_1.20.0 zlibbioc_1.36.0            
## [55] plyr_1.8.6                  BiocFileCache_1.14.0       
## [57] grid_4.0.3                  blob_1.2.1                 
## [59] crayon_1.3.4                lattice_0.20-41            
## [61] splines_4.0.3               hms_0.5.3                  
## [63] magick_2.7.1                pillar_1.4.6               
## [65] GenomicRanges_1.42.0        TCGAbiolinksGUI.data_1.10.0
## [67] reshape2_1.4.4              biomaRt_2.46.0             
## [69] stats4_4.0.3                XML_3.99-0.5               
## [71] glue_1.4.2                  evaluate_0.14              
## [73] downloader_0.4              data.table_1.13.2          
## [75] BiocManager_1.30.10         vctrs_0.3.4                
## [77] tidyr_1.1.2                 gtable_0.3.0               
## [79] openssl_1.4.3               purrr_0.3.4                
## [81] assertthat_0.2.1            ggplot2_3.3.2              
## [83] xfun_0.19                   survival_3.2-7             
## [85] viridisLite_0.3.0           tibble_3.0.4               
## [87] AnnotationDbi_1.52.0        memoise_1.1.0              
## [89] IRanges_2.24.0              ellipsis_0.3.1