Contents

0.1 Introducrtion

The accumulation of single-cell RNA-seq (scRNA-seq) studies highlights the potential benefits of integrating multiple data sets. By augmenting sample sizes and enhancing analytical robustness, integration can lead to more insightful biological conclusions. However, challenges arise due to the inherent diversity and batch discrepancies within and across studies. SCIntRuler, a novel R package, addresses these challenges by guiding the integration of multiple scRNA-seq data sets. SCIntRuler is an R package developed for single-cell RNA-seq analysis. It was designed using the Seurat framework, and offers existing and novel single-cell analytic work flows.

Integrating scRNA-seq data sets can be complex due to various factors, including batch effects and sample diversity. Key decisions – whether to integrate data sets, which method to choose for integration, and how to best handle inherent data discrepancies – are crucial. SCIntRuler offers a statistical metric to aid in these decisions, ensuring more robust and accurate analyses.

0.2 1. Installation

To install the package, you need to install the batchelor and MatrixGenerics package from Bioconductor.


# Check if BioManager is installed, install if not
if (!requireNamespace("BiocManager", quietly = TRUE))
    install.packages("BiocManager")

# Check if 'batchelor' is installed, install if not
if (!requireNamespace("batchelor", quietly = TRUE))
    BiocManager::install("batchelor")

# Check if 'MatrixGenerics' is installed, install if not
if (!requireNamespace("MatrixGenerics", quietly = TRUE))
    BiocManager::install("MatrixGenerics")

The SCIntRuler can be installed by the following commands, the source code can be found at GitHub.

BiocManager::install("SCIntRuler") 

After the installation, the package can be loaded with

library(SCIntRuler)
library(Seurat)
library(dplyr)
library(ggplot2)

0.3 2. Explore with an example data

Let’s start with an example data. We conducted a series of simulation studies to assess the efficacy of SCIntRuler in guiding the integration selection under different scenarios with varying degrees of shared information among data sets. We generated the simulation data based on a real Peripheral Blood Mononuclear Cells (PBMC) scRNA-seq dataset.

0.3.1 Overview of the data

This dataset is a subset of what we used in our Simulation 2, where we have three studies. In each study, we randomly drew different numbers of CD4 T helper cells, B cells, CD14 monocytes, and CD56 NK cells to mimic four real-world scenarios with three data sources Simulation 2 introduces a moderate overlap, with 20.3% cells sharing the same cell type identity. There are 2000 B cells and 400 CD4T cells in the first study, 700 CD14Mono cells and 400 CD4T cells in the second study, 2000 CD56NK cells and 400 CD4T cells in the third study. This data is already in Seurat format and can be found under /data. There are 32738 genes and 5900 cells in simulation 2. Here, we subset 800 cells with 3000 genes.

data("sim_data_sce", package = "SCIntRuler")
sim_data <- as.Seurat(sim_data_sce)
head(sim_data[[]])
#>                     orig.ident nCount_RNA nFeature_RNA CellType  Study
#> AATTACGAATCGGT-1 SeuratProject       1035          365    Bcell Study1
#> AGAGCGGAGTCCTC-1 SeuratProject       1157          448    Bcell Study1
#> TTCTTACTGGTACT-1 SeuratProject       2824          884    Bcell Study1
#> TGACGCCTACACCA-1 SeuratProject       1801          644    Bcell Study1
#> ATTTGCACCTATGG-1 SeuratProject       2501          749    Bcell Study1
#> AGAACAGATGGAGG-1 SeuratProject       1113          391    Bcell Study1
#>                  RNA_snn_res.0.5 seurat_clusters ident
#> AATTACGAATCGGT-1               0               0     0
#> AGAGCGGAGTCCTC-1               0               0     0
#> TTCTTACTGGTACT-1               0               0     0
#> TGACGCCTACACCA-1               0               0     0
#> ATTTGCACCTATGG-1               0               0     0
#> AGAACAGATGGAGG-1               0               0     0

0.3.2 Data pre-process and visulization with Seurat

Followed by the tutorial of Seurat, we first pre-processed the data by the functions NormalizeData, FindVariableFeature, ScaleData, RunPCA, FindNeighbors, FinsClusters and RunUMAP from Seurat and then draw the UMAP by using DimPlot stratified by Study and Cell Type.

# Normalize the data
sim_data <- NormalizeData(sim_data)
# Identify highly variable features
sim_data <- FindVariableFeatures(sim_data, selection.method = "vst", nfeatures = 2000)
# Scale the data
all.genes <- rownames(sim_data)
sim_data <- ScaleData(sim_data, features = all.genes)
# Perform linear dimensional reduction
sim_data <- RunPCA(sim_data, features = VariableFeatures(object = sim_data))
# Cluster the cells
sim_data <- FindNeighbors(sim_data, dims = 1:20)
sim_data <- FindClusters(sim_data, resolution = 0.5)
#> Modularity Optimizer version 1.3.0 by Ludo Waltman and Nees Jan van Eck
#> 
#> Number of nodes: 800
#> Number of edges: 46490
#> 
#> Running Louvain algorithm...
#> Maximum modularity in 10 random starts: 0.7653
#> Number of communities: 4
#> Elapsed time: 0 seconds
sim_data <- RunUMAP(sim_data, dims = 1:20)

0.3.2.1 UMAP separated by Study

p1 <- DimPlot(sim_data, reduction = "umap", label = FALSE, pt.size = .5, group.by = "Study", repel = TRUE)
p1

0.3.2.2 UMAP separated by cell type


p2 <- DimPlot(sim_data, reduction = "umap", label = TRUE, pt.size = .8, group.by = "CellType", repel = TRUE)
p2

0.3.3 Try different data integration methods

To further illustrate which integration method is more suitable under different settings, we visualize the data without integration (simply merging the single cell objects) and after applying three popular data integration methods: CCA, Harmony and Scanorama. The UMAP visualizations across the simulations indicate that the choice of integration method significantly impacts the resulting data integration.

0.3.3.1 Run Seurat CCA

Seurat CCA can be directly applied by functions FindIntegrationAnchors and IntegrateData in Seurat package. For more information, please seeTutorial of SeuratCCA.

### CCA
sim.list <- SplitObject(sim_data, split.by = "Study")
sim.anchors <- FindIntegrationAnchors(object.list = sim.list, dims = 1:30, reduction = "cca")

sim.int <- IntegrateData(anchorset = sim.anchors, dims = 1:30, new.assay.name = "CCA")
# run standard analysis workflow
sim.int <- ScaleData(sim.int, verbose = FALSE)
sim.int <- RunPCA(sim.int, npcs = 30, verbose = FALSE)
sim.int <- RunUMAP(sim.int, dims = 1:30, reduction.name = "umap_cca")

0.3.3.2 Run Harmony

Harmony is an algorithm for performing integration of single cell genomics data sets. To run harmony, we need to install harmony package. For more information, please see Quick start to Harmony.

### Harmony
# install.packages("harmony")

sim.harmony <- harmony::RunHarmony(sim_data, group.by.vars = "Study", reduction.use = "pca",
                                   #dims.use = 1:20, assay.use = "RNA"
    )

sim.int[["harmony"]] <- sim.harmony[["harmony"]]
sim.int <- RunUMAP(sim.int, dims = 1:20, reduction = "harmony", reduction.name = "umap_harmony")

0.3.3.3 UMAP figures for all integrated data

p5 <- DimPlot(sim_data, reduction = "umap", group.by = "Study") +
  theme(legend.position = "none",
        # axis.line.y = element_line( size = 2, linetype = "solid"),
        # axis.line.x = element_line( size = 2, linetype = "solid"),
        axis.text.y = element_text( color="black", size=20),
        axis.title.y = element_text(color="black", size=20),
        axis.text.x = element_text( color="black", size=20),
        axis.title.x = element_text(color="black", size=20))
p6 <- DimPlot(sim.int, reduction = "umap_cca", group.by = "Study") +
  theme(legend.position = "none",
        # axis.line.y = element_line( size = 2, linetype = "solid"),
        # axis.line.x = element_line( size = 2, linetype = "solid"),
        axis.text.y = element_text( color="black", size=20),
        axis.title.y = element_text(color="black", size=20),
        axis.text.x = element_text( color="black", size=20),
        axis.title.x = element_text(color="black", size=20))
p7 <- DimPlot(sim.int, reduction = "umap_harmony", group.by = "Study") +
  theme(legend.position = "none",
        # axis.line.y = element_line( size = 2, linetype = "solid"),
        # axis.line.x = element_line( size = 2, linetype = "solid"),
        axis.text.y = element_text( color="black", size=20),
        axis.title.y = element_text(color="black", size=20),
        axis.text.x = element_text( color="black", size=20),
        axis.title.x = element_text(color="black", size=20))

leg <- cowplot::get_legend(p5)
#> Warning in get_plot_component(plot, "guide-box"): Multiple components found;
#> returning the first one. To return all, use `return_all = TRUE`.
gridExtra::grid.arrange(gridExtra::arrangeGrob(p5 + NoLegend() + ggtitle("Unintegrated"), 
                                               p6 + NoLegend() + ggtitle("Seurat CCA") , 
                                               p7 + NoLegend() + ggtitle("Harmony"),
                                               #p8 + NoLegend() + ggtitle("Scanorama"), 
                                               nrow = 2),
    leg, ncol = 2, widths = c(20, 5))

0.4 3. Applying SCIntRuler to example data

We first split the sim_data by Study and then run GetCluster and NormData to get Louvain clusters and normalized count matrix for each study. Furthermore, to perform the permutation test of relative-between cluster distance, FindNNDist can be then applied. We also have another function FindNNDistC that based on Rcpp and C++ for faster matrix calculation.


sim.list <- SplitObject(sim_data, split.by = "Study")
fullcluster <- GetCluster(sim.list,50,200)
#> Modularity Optimizer version 1.3.0 by Ludo Waltman and Nees Jan van Eck
#> 
#> Number of nodes: 336
#> Number of edges: 21610
#> 
#> Running Louvain algorithm...
#> Maximum modularity in 10 random starts: 0.5099
#> Number of communities: 2
#> Elapsed time: 0 seconds
#> Modularity Optimizer version 1.3.0 by Ludo Waltman and Nees Jan van Eck
#> 
#> Number of nodes: 136
#> Number of edges: 4813
#> 
#> Running Louvain algorithm...
#> Maximum modularity in 10 random starts: 0.7201
#> Number of communities: 2
#> Elapsed time: 0 seconds
#> Modularity Optimizer version 1.3.0 by Ludo Waltman and Nees Jan van Eck
#> 
#> Number of nodes: 328
#> Number of edges: 22343
#> 
#> Running Louvain algorithm...
#> Maximum modularity in 10 random starts: 0.5141
#> Number of communities: 2
#> Elapsed time: 0 seconds

normCount <- NormData(sim.list)

#distmat <- FindNNDist(fullcluster, normCount, 20)
distmat <- FindNNDistC(fullcluster, normCount, 20)
#> 
  |                                                                  
  |                                                            |   0%
  |                                                                  
  |====================                                        |  33%
  |                                                                  
  |========================================                    |  67%
  |                                                                  
  |============================================================| 100%

0.4.1 Calculate SCIntRuler and and an associated visualization

In this example data, we got a SCIntRuler score of 0.57, there is a noticeable but not large overlap of cell types across the data sets, showing a moderate level of shared information. The integration is essential to adjust for these effects and align the shared cell populations, ensuring that the integrated dataset accurately reflects the biological composition. Thus, the methods which can offer a balance between correcting for batch effects and maintaining biological variation would be the best. The UMAP visualizations across the simulations indicate that the choice of integration method significantly impacts the resulting data integration.


testres <- PermTest(fullcluster,distmat,15)
PlotSCIR(fullcluster,sim.list,testres,"")


sim_result <- list(fullcluster,normCount,distmat,testres)

0.5 SessionInfo

#> R version 4.3.2 (2023-10-31)
#> Platform: aarch64-apple-darwin20 (64-bit)
#> Running under: macOS Monterey 12.1
#> 
#> Matrix products: default
#> BLAS:   /Library/Frameworks/R.framework/Versions/4.3-arm64/Resources/lib/libRblas.0.dylib 
#> LAPACK: /Library/Frameworks/R.framework/Versions/4.3-arm64/Resources/lib/libRlapack.dylib;  LAPACK version 3.11.0
#> 
#> locale:
#> [1] C/en_US.UTF-8/en_US.UTF-8/C/en_US.UTF-8/en_US.UTF-8
#> 
#> time zone: America/Chicago
#> tzcode source: internal
#> 
#> attached base packages:
#> [1] stats     graphics  grDevices utils     datasets  methods   base     
#> 
#> other attached packages:
#> [1] ggplot2_3.5.1      dplyr_1.1.4        SeuratObject_4.1.4 Seurat_4.4.0      
#> [5] SCIntRuler_0.99.6  BiocStyle_2.30.0  
#> 
#> loaded via a namespace (and not attached):
#>   [1] RcppAnnoy_0.0.21            splines_4.3.2              
#>   [3] later_1.3.2                 batchelor_1.18.1           
#>   [5] bitops_1.0-7                tibble_3.2.1               
#>   [7] polyclip_1.10-6             lifecycle_1.0.4            
#>   [9] globals_0.16.2              lattice_0.22-5             
#>  [11] MASS_7.3-60.0.1             magrittr_2.0.3             
#>  [13] plotly_4.10.4               sass_0.4.8                 
#>  [15] rmarkdown_2.25              jquerylib_0.1.4            
#>  [17] yaml_2.3.8                  httpuv_1.6.13              
#>  [19] sctransform_0.4.1           spam_2.10-0                
#>  [21] sp_2.1-2                    spatstat.sparse_3.0-3      
#>  [23] reticulate_1.34.0           cowplot_1.1.2              
#>  [25] pbapply_1.7-2               RColorBrewer_1.1-3         
#>  [27] ResidualMatrix_1.12.0       multcomp_1.4-25            
#>  [29] abind_1.4-5                 zlibbioc_1.48.0            
#>  [31] Rtsne_0.17                  GenomicRanges_1.54.1       
#>  [33] purrr_1.0.2                 BiocGenerics_0.48.1        
#>  [35] RCurl_1.98-1.14             TH.data_1.1-2              
#>  [37] sandwich_3.1-0              GenomeInfoDbData_1.2.11    
#>  [39] IRanges_2.36.0              S4Vectors_0.40.2           
#>  [41] ggrepel_0.9.5               irlba_2.3.5.1              
#>  [43] listenv_0.9.0               spatstat.utils_3.0-4       
#>  [45] goftest_1.2-3               spatstat.random_3.2-2      
#>  [47] fitdistrplus_1.1-11         parallelly_1.36.0          
#>  [49] DelayedMatrixStats_1.24.0   coin_1.4-3                 
#>  [51] leiden_0.4.3.1              codetools_0.2-19           
#>  [53] DelayedArray_0.28.0         scuttle_1.12.0             
#>  [55] tidyselect_1.2.0            farver_2.1.1               
#>  [57] ScaledMatrix_1.10.0         matrixStats_1.2.0          
#>  [59] stats4_4.3.2                spatstat.explore_3.2-5     
#>  [61] jsonlite_1.8.8              BiocNeighbors_1.20.2       
#>  [63] ellipsis_0.3.2              progressr_0.14.0           
#>  [65] ggridges_0.5.5              survival_3.5-7             
#>  [67] tools_4.3.2                 ica_1.0-3                  
#>  [69] Rcpp_1.0.12                 glue_1.7.0                 
#>  [71] gridExtra_2.3               SparseArray_1.2.3          
#>  [73] xfun_0.41                   MatrixGenerics_1.14.0      
#>  [75] GenomeInfoDb_1.38.5         withr_3.0.0                
#>  [77] BiocManager_1.30.22         fastmap_1.1.1              
#>  [79] fansi_1.0.6                 digest_0.6.34              
#>  [81] rsvd_1.0.5                  R6_2.5.1                   
#>  [83] mime_0.12                   colorspace_2.1-0           
#>  [85] scattermore_1.2             tensor_1.5                 
#>  [87] spatstat.data_3.0-4         RhpcBLASctl_0.23-42        
#>  [89] utf8_1.2.4                  tidyr_1.3.0                
#>  [91] generics_0.1.3              data.table_1.15.2          
#>  [93] httr_1.4.7                  htmlwidgets_1.6.4          
#>  [95] S4Arrays_1.2.0              uwot_0.1.16                
#>  [97] pkgconfig_2.0.3             gtable_0.3.4               
#>  [99] modeltools_0.2-23           lmtest_0.9-40              
#> [101] SingleCellExperiment_1.24.0 XVector_0.42.0             
#> [103] htmltools_0.5.7             dotCall64_1.1-1            
#> [105] bookdown_0.37               scales_1.3.0               
#> [107] Biobase_2.62.0              png_0.1-8                  
#> [109] harmony_1.2.0               knitr_1.45                 
#> [111] rstudioapi_0.15.0           reshape2_1.4.4             
#> [113] nlme_3.1-164                cachem_1.0.8               
#> [115] zoo_1.8-12                  stringr_1.5.1              
#> [117] KernSmooth_2.23-22          libcoin_1.0-10             
#> [119] parallel_4.3.2              miniUI_0.1.1.1             
#> [121] pillar_1.9.0                grid_4.3.2                 
#> [123] vctrs_0.6.5                 RANN_2.6.1                 
#> [125] promises_1.2.1              BiocSingular_1.18.0        
#> [127] beachmat_2.18.0             xtable_1.8-4               
#> [129] cluster_2.1.6               evaluate_0.23              
#> [131] magick_2.8.2                mvtnorm_1.2-4              
#> [133] cli_3.6.2                   compiler_4.3.2             
#> [135] rlang_1.1.3                 crayon_1.5.2               
#> [137] future.apply_1.11.1         labeling_0.4.3             
#> [139] plyr_1.8.9                  stringi_1.8.3              
#> [141] viridisLite_0.4.2           deldir_2.0-2               
#> [143] BiocParallel_1.36.0         munsell_0.5.0              
#> [145] lazyeval_0.2.2              spatstat.geom_3.2-7        
#> [147] Matrix_1.6-1                patchwork_1.2.0            
#> [149] sparseMatrixStats_1.14.0    future_1.33.1              
#> [151] shiny_1.8.0                 SummarizedExperiment_1.32.0
#> [153] highr_0.10                  ROCR_1.0-11                
#> [155] igraph_1.6.0                bslib_0.6.1