1 Overview

The mumosa package implements a variety of utilities for analyses of single-cell data with multiple modalities. This usually refers to single-cell RNA-seq experiments with proteomics, epigenomics or other data collected from the same cells. The aim is to investigate how different modalities relate to each other via analyses of correlations, and to combine data together from multiple modalities for integrated downstream analyses. The actual analyses of each individual modality are deferred to other packages; the scope of mumosa is limited to the sharing of information across modalities.

2 Setting up the dataset

To demonstrate the functionalities of this package, we will use a subset of a CITE-seq experiment from the scRNAseq package. The main Experiment contains the RNA-seq counts while the adt alternative Experiment contains the CITE-seq counts - see the SingleCellExperiment package documentation for more details.

library(scater)
library(scran)
library(scRNAseq)
sce <- KotliarovPBMCData()
sce <- sce[,1:1000] # subset for speed.
sce
## class: SingleCellExperiment 
## dim: 32738 1000 
## metadata(0):
## assays(1): counts
## rownames(32738): MIR1302-10 FAM138A ... AC002321.2 AC002321.1
## rowData names(0):
## colnames(1000): AAACCTGAGAGCCCAA_H1B1ln1 AAACCTGAGGCGTACA_H1B1ln1 ...
##   ATAACGCGTTTGGGCC_H1B1ln1 ATAACGCTCAACGCTA_H1B1ln1
## colData names(24): nGene nUMI ... dmx_hto_match timepoint
## reducedDimNames(0):
## mainExpName: NULL
## altExpNames(1): adt

We perform some cursory analyses on the RNA component:

stats <- perCellQCMetrics(sce, subsets=list(Mito=grep("^MT-", rownames(sce))))
filter <- quickPerCellQC(stats, sub.fields="subsets_Mito_percent")
sce <- sce[,!filter$discard]
sce <- logNormCounts(sce)
dec <- modelGeneVar(sce)
set.seed(10000)
sce <- runPCA(sce, ncomponents=25, subset_row=getTopHVGs(dec, n=5000))

And again on the protein component.

# TODO: sync this with the book.
sceA <- altExp(sce)
statsA <- perCellQCMetrics(sceA)
keep <- statsA$detected > 50 
sceA <- sceA[,keep]

library(DropletUtils)
amb <- inferAmbience(assay(sceA))
sceA <- computeMedianFactors(sceA, reference=amb)
sceA <- logNormCounts(sceA)

set.seed(10000)
sceA <- runPCA(sceA, ncomponents=15)

Finally, we put everything back into the same object, only considering the cells passing QC in both modalities.

sce2 <- sce[,keep]
altExp(sce2) <- sceA

3 Rescaling by neighbors

The easiest way to combine data for the same set of cells is to simply cbind their matrices together prior to downstream analyses like clustering. However, this requires some rescaling to adjust for the differences in the number of features and variation of each modality; otherwise, the modality with more features or stronger (technical) variation would just dominate later calculations. rescaleByNeighbors() quantifies the “noise” of each modality using on the median distance to the \(k\)-th nearest neighbor, and then rescales each expression/PC matrix by that distance to equalize the noise across modalities.

library(mumosa)
output <- rescaleByNeighbors(list(reducedDim(sce2), reducedDim(altExp(sce2))))
dim(output)
## [1] 911  40

The result is a cbinded matrix that can be used directly in downstream analyses like clustering and dimensionality reduction.

set.seed(100001)
library(bluster)
sce2$combined.clustering <- clusterRows(output, NNGraphParam())

reducedDim(sce2, "combined") <- output
sce2 <- runTSNE(sce2, dimred="combined")
plotTSNE(sce2, colour_by="combined.clustering")

Advanced users can also adjust the weight given to each modality via the weights= argument; a modality assigned a weight of 2 will mean that the rescaled distance is twice that of a modality with a weight of 1.

4 Intersecting clusters

In other situations, we may already have a clustering for each modality. For example, we might have one clustering for each of the gene expression and ADT PCs:

g.rna <- buildSNNGraph(sce2, use.dimred="PCA")
rna.clusters <- igraph::cluster_walktrap(g.rna)$membership
table(rna.clusters)
## rna.clusters
##   1   2   3   4   5   6   7 
## 115 158 314  24  84  92 124
g.adt <- buildSNNGraph(altExp(sce2), use.dimred='PCA')
adt.clusters <- igraph::cluster_walktrap(g.adt)$membership
table(adt.clusters)
## adt.clusters
##   1   2   3   4   5   6   7   8 
## 111 191 122 181 122  82  20  82

We can naively “intersect” these clusters by concatenating their identities, as shown below. Cells are only assigned to the same intersected clusters if they belong to the same per-modality clusters. In practice, this often creates a large number of irrelevant clusters with small numbers of cells.

intersected <- paste0(adt.clusters, ".", rna.clusters)
table(intersected)
## intersected
## 1.2 1.5 1.6 2.2 2.3 2.6 3.7 4.3 4.5 5.1 5.3 5.4 6.2 6.3 7.4 7.7 8.5 8.6 
##  39   2  70 108  63  20 122 179   2 115   1   6  11  71  18   2  80   2

A more refined approach is implemented in the intersectClusters() function. This performs the intersection as described but then performs a series of pairwise merges to eliminate the small clusters. It will stop merging when the within-cluster sum of squares exceeds that of the original clustering in any modality; this ensures that any within-modality structure captured by the original clustering is preserved.

intersected2 <- intersectClusters(list(rna.clusters, adt.clusters),
    list(reducedDim(sce2), reducedDim(altExp(sce2))))
table(intersected2)
## intersected2
##   1   2   3   4   5   6   7   8   9 
## 171 124  92  39  82  84 115  24 180

5 Multi-metric UMAP

Another approach is to take advantage of UMAP’s ability to combine information on different scales. This is achieved by - roughly speaking - creating nearest-neighbor graphs within each modality, and then “intersecting” the graphs such that cells are only considered to be neighbors if they are neighbors in each modality. In this manner, we incorporate locality information from all modalities without explicitly comparing distances. We apply this strategy using the calculateMultiUMAP() function, increasing the number of components to avoid loss of information.

set.seed(100002)
umap.out <- calculateMultiUMAP(list(reducedDim(sce2), reducedDim(altExp(sce2))), 
    n_components=20)
dim(umap.out)
## [1] 911  20

Again, we can use this in downstream analyses like clustering:

library(bluster)
sce2$umap.clustering <- clusterRows(umap.out, NNGraphParam())

And also visualization, though perhaps it is more natural to just compute the UMAP on two dimensions for this purpose. runMultiMap() is just a wrapper around calculateMultiUMAP() that conveniently stores the output in the reducedDims of the input SingleCellExperiment.

set.seed(100002)
sce2 <- runMultiUMAP(sce2, dimred="PCA", extras=list(reducedDim(altExp(sce2))))
plotReducedDim(sce2, "MultiUMAP", colour_by="umap.clustering")

6 Intersecting graphs

Inspired by the UMAP approach, we can perform intersections on arbitrary graphs with the intersectGraphs() function. This is relevant in cases where we have nearest-neighbor graphs constructed separately for each modality, e.g., for graph-based clustering. We intersect these graphs by setting the weights of edges to the product of the edge weights from each individual graph.

g.com <- intersectGraphs(g.rna, g.adt)

Two cells will only be connected by a high-weighted edge if that edge is of high weight in each original graph, i.e., cells must be nearest neighbors in all modalities to be considered as nearest neighbors in the intersection. We can then use this graph for clustering, which hopefully gives us clusters where cells are similar across all modalities.

com.clusters <- igraph::cluster_walktrap(g.com)$membership
table(com.clusters)
## com.clusters
##   1   2   3   4   5   6   7   8   9  10 
## 123 124 118 169 178  70  21  22  84   2

7 Correlation analyses

Given two modalities, we may be interested in knowing which features in one modality are correlated to the features in another modality. The computeCorrelations() function does exactly this:

cor.all <- computeCorrelations(sce2, altExp(sce2)[1:5,])
cor.all[order(cor.all$p.value),]
## DataFrame with 163690 rows and 5 columns
##           feature1      feature2       rho     p.value         FDR
##        <character>   <character> <numeric>   <numeric>   <numeric>
## 1            CD79A     BTLA_PROT  0.443223 4.01052e-45 2.89580e-40
## 2         HLA-DRB1    CD123_PROT  0.430457 2.17126e-42 7.83878e-38
## 3          HLA-DRA    CD123_PROT  0.403383 5.75021e-37 1.38398e-32
## 4             FCN1     CD13_PROT  0.397864 6.38599e-36 1.15275e-31
## 5            TCL1A     BTLA_PROT  0.383289 2.97413e-33 4.29495e-29
## ...            ...           ...       ...         ...         ...
## 163686      snoU13 AnnexinV_PROT       NaN          NA          NA
## 163687      snoU13     BTLA_PROT       NaN          NA          NA
## 163688      snoU13    CD117_PROT       NaN          NA          NA
## 163689      snoU13    CD123_PROT       NaN          NA          NA
## 163690      snoU13     CD13_PROT       NaN          NA          NA

For multi-batch experiments, we can specify blocking factors to avoid being confounded by the batch effect. Each batch receives equal weight when averaging correlations and in computing the final combined \(p\)-value.

b <- rep(1:3, length.out=ncol(sce2))
cor.all.batch <- computeCorrelations(sce2, altExp(sce2)[1:5,], block=b)

However, this approach can be very slow when dealing with large numbers of features; indeed, one may note the subsetting to the first 5 features in the code above. Users can enable parallelization via BPPARAM= to speed up the process but this will only go so far.

An alternative approach is to, for each feature in one modality, perform an approximate search for the top most-correlated features in another modality. This assumes that only the strongest correlations (positive or negative) are of actual interest, while the bulk of weak correlations can be ignored. We use the findTopCorrelations() function with a specified number of top features to extract:

set.seed(100001) # for IRLBA.
top.cor <- findTopCorrelations(sce2[1:100,], y=altExp(sce2), number=10)
top.cor
## List of length 2
## names(2): positive negative
top.cor$positive
## DataFrame with 530 rows and 5 columns
##         feature1              feature2        rho   p.value       FDR
##      <character>           <character>  <numeric> <numeric> <numeric>
## 1   RP11-34P13.7 RatIgG2bkIsotype_PROT  0.0550420 0.0484271         1
## 2   RP11-34P13.7            CD194_PROT  0.0519342 0.0586247         1
## 3   RP11-34P13.7             CD19_PROT  0.0310772 0.1743962         1
## 4   RP11-34P13.7             CD34_PROT  0.0301584 0.1816169         1
## 5   RP11-34P13.7             CD1c_PROT  0.0300619 0.1823858         1
## ...          ...                   ...        ...       ...       ...
## 526     C1orf222             CD19_PROT 0.03895679  0.120066         1
## 527     C1orf222            CD141_PROT 0.03693348  0.132724         1
## 528     C1orf222             CD10_PROT 0.02722832  0.205866         1
## 529     C1orf222            CD184_PROT 0.00819402  0.402461         1
## 530     C1orf222            CD273_PROT 0.00572678  0.431477         1

This returns the top 10 features in the CITE-seq data (y) for each feature in the main RNA-seq data. As the search is approximate, some features may not be ranked as highly as they would be under an exact search - the approximation quality can be modified by increasing the number of PCs (d) used for data compression. Blocking is also supported with block=, in which case correlations are only computed within each level of the blocking factor.

Session information

sessionInfo()
## R version 4.3.1 (2023-06-16)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 22.04.3 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.18-bioc/R/lib/libRblas.so 
## LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.10.0
## 
## locale:
##  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
##  [3] LC_TIME=en_GB              LC_COLLATE=C              
##  [5] LC_MONETARY=en_US.UTF-8    LC_MESSAGES=en_US.UTF-8   
##  [7] LC_PAPER=en_US.UTF-8       LC_NAME=C                 
##  [9] LC_ADDRESS=C               LC_TELEPHONE=C            
## [11] LC_MEASUREMENT=en_US.UTF-8 LC_IDENTIFICATION=C       
## 
## time zone: America/New_York
## tzcode source: system (glibc)
## 
## attached base packages:
## [1] stats4    stats     graphics  grDevices utils     datasets  methods  
## [8] base     
## 
## other attached packages:
##  [1] bluster_1.12.0              mumosa_1.10.0              
##  [3] DropletUtils_1.22.0         Matrix_1.6-1.1             
##  [5] scRNAseq_2.15.0             scran_1.30.0               
##  [7] scater_1.30.0               ggplot2_3.4.4              
##  [9] scuttle_1.12.0              SingleCellExperiment_1.24.0
## [11] SummarizedExperiment_1.32.0 Biobase_2.62.0             
## [13] GenomicRanges_1.54.0        GenomeInfoDb_1.38.0        
## [15] IRanges_2.36.0              S4Vectors_0.40.0           
## [17] BiocGenerics_0.48.0         MatrixGenerics_1.14.0      
## [19] matrixStats_1.0.0           knitr_1.44                 
## [21] BiocStyle_2.30.0           
## 
## loaded via a namespace (and not attached):
##   [1] later_1.3.1                   batchelor_1.18.0             
##   [3] BiocIO_1.12.0                 bitops_1.0-7                 
##   [5] filelock_1.0.2                tibble_3.2.1                 
##   [7] R.oo_1.25.0                   XML_3.99-0.14                
##   [9] lifecycle_1.0.3               edgeR_4.0.0                  
##  [11] lattice_0.22-5                ensembldb_2.26.0             
##  [13] magrittr_2.0.3                limma_3.58.0                 
##  [15] sass_0.4.7                    rmarkdown_2.25               
##  [17] jquerylib_0.1.4               yaml_2.3.7                   
##  [19] metapod_1.10.0                httpuv_1.6.12                
##  [21] cowplot_1.1.1                 DBI_1.1.3                    
##  [23] ResidualMatrix_1.12.0         abind_1.4-5                  
##  [25] zlibbioc_1.48.0               Rtsne_0.16                   
##  [27] purrr_1.0.2                   R.utils_2.12.2               
##  [29] AnnotationFilter_1.26.0       RCurl_1.98-1.12              
##  [31] rappdirs_0.3.3                GenomeInfoDbData_1.2.11      
##  [33] ggrepel_0.9.4                 irlba_2.3.5.1                
##  [35] dqrng_0.3.1                   DelayedMatrixStats_1.24.0    
##  [37] codetools_0.2-19              DelayedArray_0.28.0          
##  [39] xml2_1.3.5                    tidyselect_1.2.0             
##  [41] farver_2.1.1                  ScaledMatrix_1.10.0          
##  [43] viridis_0.6.4                 BiocFileCache_2.10.0         
##  [45] GenomicAlignments_1.38.0      jsonlite_1.8.7               
##  [47] BiocNeighbors_1.20.0          ellipsis_0.3.2               
##  [49] tools_4.3.1                   progress_1.2.2               
##  [51] Rcpp_1.0.11                   glue_1.6.2                   
##  [53] gridExtra_2.3                 SparseArray_1.2.0            
##  [55] xfun_0.40                     dplyr_1.1.3                  
##  [57] HDF5Array_1.30.0              withr_2.5.1                  
##  [59] BiocManager_1.30.22           fastmap_1.1.1                
##  [61] rhdf5filters_1.14.0           fansi_1.0.5                  
##  [63] digest_0.6.33                 rsvd_1.0.5                   
##  [65] R6_2.5.1                      mime_0.12                    
##  [67] colorspace_2.1-0              biomaRt_2.58.0               
##  [69] RSQLite_2.3.1                 R.methodsS3_1.8.2            
##  [71] utf8_1.2.4                    generics_0.1.3               
##  [73] FNN_1.1.3.2                   rtracklayer_1.62.0           
##  [75] prettyunits_1.2.0             httr_1.4.7                   
##  [77] S4Arrays_1.2.0                uwot_0.1.16                  
##  [79] pkgconfig_2.0.3               gtable_0.3.4                 
##  [81] blob_1.2.4                    XVector_0.42.0               
##  [83] htmltools_0.5.6.1             bookdown_0.36                
##  [85] ProtGenerics_1.34.0           scales_1.2.1                 
##  [87] png_0.1-8                     rjson_0.2.21                 
##  [89] curl_5.1.0                    cachem_1.0.8                 
##  [91] rhdf5_2.46.0                  stringr_1.5.0                
##  [93] BiocVersion_3.18.0            parallel_4.3.1               
##  [95] vipor_0.4.5                   AnnotationDbi_1.64.0         
##  [97] restfulr_0.0.15               pillar_1.9.0                 
##  [99] grid_4.3.1                    vctrs_0.6.4                  
## [101] promises_1.2.1                BiocSingular_1.18.0          
## [103] dbplyr_2.3.4                  beachmat_2.18.0              
## [105] xtable_1.8-4                  cluster_2.1.4                
## [107] beeswarm_0.4.0                evaluate_0.22                
## [109] magick_2.8.1                  GenomicFeatures_1.54.0       
## [111] cli_3.6.1                     locfit_1.5-9.8               
## [113] compiler_4.3.1                Rsamtools_2.18.0             
## [115] rlang_1.1.1                   crayon_1.5.2                 
## [117] labeling_0.4.3                ggbeeswarm_0.7.2             
## [119] stringi_1.7.12                viridisLite_0.4.2            
## [121] BiocParallel_1.36.0           munsell_0.5.0                
## [123] Biostrings_2.70.0             lazyeval_0.2.2               
## [125] ExperimentHub_2.10.0          hms_1.1.3                    
## [127] sparseMatrixStats_1.14.0      bit64_4.0.5                  
## [129] Rhdf5lib_1.24.0               KEGGREST_1.42.0              
## [131] statmod_1.5.0                 shiny_1.7.5.1                
## [133] interactiveDisplayBase_1.40.0 AnnotationHub_3.10.0         
## [135] igraph_1.5.1                  memoise_2.0.1                
## [137] bslib_0.5.1                   bit_4.0.5