Chapter 5 Analysis overview

5.1 Outline

This chapter provides an overview of the framework of a typical scRNA-seq analysis workflow (Figure 5.1).

Schematic of a typical scRNA-seq analysis workflow. Each stage (separated by dashed lines) consists of a number of specific steps, many of which operate on and modify a `SingleCellExperiment` instance.

Figure 5.1: Schematic of a typical scRNA-seq analysis workflow. Each stage (separated by dashed lines) consists of a number of specific steps, many of which operate on and modify a SingleCellExperiment instance.

In the simplest case, the workflow has the following form:

  1. We compute quality control metrics to remove low-quality cells that would interfere with downstream analyses. These cells may have been damaged during processing or may not have been fully captured by the sequencing protocol. Common metrics includes the total counts per cell, the proportion of spike-in or mitochondrial reads and the number of detected features.
  2. We convert the counts into normalized expression values to eliminate cell-specific biases (e.g., in capture efficiency). This allows us to perform explicit comparisons across cells in downstream steps like clustering. We also apply a transformation, typically log, to adjust for the mean-variance relationship.
  3. We perform feature selection to pick a subset of interesting features for downstream analysis. This is done by modelling the variance across cells for each gene and retaining genes that are highly variable. The aim is to reduce computational overhead and noise from uninteresting genes.
  4. We apply dimensionality reduction to compact the data and further reduce noise. Principal components analysis is typically used to obtain an initial low-rank representation for more computational work, followed by more aggressive methods like \(t\)-stochastic neighbor embedding for visualization purposes.
  5. We cluster cells into groups according to similarities in their (normalized) expression profiles. This aims to obtain groupings that serve as empirical proxies for distinct biological states. We typically interpret these groupings by identifying differentially expressed marker genes between clusters.

Subsequent chapters will describe each analysis step in more detail.

5.3 Quick start (multiple batches)

Here we use the pancreas Smart-seq2 dataset from Segerstolpe et al. (2016), again provided in the scRNAseq package. This starts from a count matrix and finishes with clusters (Figure 5.2) with some additional tweaks to eliminate uninteresting batch effects between individuals. Note that a more elaborate analysis of the same dataset with justifications for each step is available in Workflow Chapter 8.

UMAP plot of the pancreas dataset, where each point is a cell and is colored by the assigned cluster identity (left) or the individual of origin (right).

Figure 5.3: UMAP plot of the pancreas dataset, where each point is a cell and is colored by the assigned cluster identity (left) or the individual of origin (right).

Session Info

R version 4.2.1 (2022-06-23)
Platform: x86_64-pc-linux-gnu (64-bit)
Running under: Ubuntu 20.04.5 LTS

Matrix products: default
BLAS:   /home/biocbuild/bbs-3.16-bioc/R/lib/libRblas.so
LAPACK: /home/biocbuild/bbs-3.16-bioc/R/lib/libRlapack.so

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       

attached base packages:
[1] stats4    stats     graphics  grDevices utils     datasets  methods  
[8] base     

other attached packages:
 [1] batchelor_1.14.0            bluster_1.8.0              
 [3] scran_1.26.0                scater_1.26.0              
 [5] ggplot2_3.3.6               scuttle_1.8.0              
 [7] scRNAseq_2.11.0             SingleCellExperiment_1.20.0
 [9] SummarizedExperiment_1.28.0 Biobase_2.58.0             
[11] GenomicRanges_1.50.0        GenomeInfoDb_1.34.0        
[13] IRanges_2.32.0              S4Vectors_0.36.0           
[15] BiocGenerics_0.44.0         MatrixGenerics_1.10.0      
[17] matrixStats_0.62.0          BiocStyle_2.26.0           
[19] rebook_1.8.0               

loaded via a namespace (and not attached):
  [1] AnnotationHub_3.6.0           BiocFileCache_2.6.0          
  [3] igraph_1.3.5                  lazyeval_0.2.2               
  [5] BiocParallel_1.32.0           digest_0.6.30                
  [7] ensembldb_2.22.0              htmltools_0.5.3              
  [9] viridis_0.6.2                 fansi_1.0.3                  
 [11] magrittr_2.0.3                memoise_2.0.1                
 [13] ScaledMatrix_1.6.0            cluster_2.1.4                
 [15] limma_3.54.0                  Biostrings_2.66.0            
 [17] prettyunits_1.1.1             colorspace_2.0-3             
 [19] blob_1.2.3                    rappdirs_0.3.3               
 [21] ggrepel_0.9.1                 xfun_0.34                    
 [23] dplyr_1.0.10                  crayon_1.5.2                 
 [25] RCurl_1.98-1.9                jsonlite_1.8.3               
 [27] graph_1.76.0                  glue_1.6.2                   
 [29] gtable_0.3.1                  zlibbioc_1.44.0              
 [31] XVector_0.38.0                DelayedArray_0.24.0          
 [33] BiocSingular_1.14.0           scales_1.2.1                 
 [35] edgeR_3.40.0                  DBI_1.1.3                    
 [37] Rcpp_1.0.9                    viridisLite_0.4.1            
 [39] xtable_1.8-4                  progress_1.2.2               
 [41] dqrng_0.3.0                   bit_4.0.4                    
 [43] rsvd_1.0.5                    ResidualMatrix_1.8.0         
 [45] metapod_1.6.0                 httr_1.4.4                   
 [47] FNN_1.1.3.1                   dir.expiry_1.6.0             
 [49] ellipsis_0.3.2                farver_2.1.1                 
 [51] pkgconfig_2.0.3               XML_3.99-0.12                
 [53] uwot_0.1.14                   CodeDepends_0.6.5            
 [55] sass_0.4.2                    dbplyr_2.2.1                 
 [57] locfit_1.5-9.6                utf8_1.2.2                   
 [59] labeling_0.4.2                tidyselect_1.2.0             
 [61] rlang_1.0.6                   later_1.3.0                  
 [63] AnnotationDbi_1.60.0          munsell_0.5.0                
 [65] BiocVersion_3.16.0            tools_4.2.1                  
 [67] cachem_1.0.6                  cli_3.4.1                    
 [69] generics_0.1.3                RSQLite_2.2.18               
 [71] ExperimentHub_2.6.0           evaluate_0.17                
 [73] stringr_1.4.1                 fastmap_1.1.0                
 [75] yaml_2.3.6                    knitr_1.40                   
 [77] bit64_4.0.5                   purrr_0.3.5                  
 [79] KEGGREST_1.38.0               AnnotationFilter_1.22.0      
 [81] sparseMatrixStats_1.10.0      mime_0.12                    
 [83] xml2_1.3.3                    biomaRt_2.54.0               
 [85] compiler_4.2.1                beeswarm_0.4.0               
 [87] filelock_1.0.2                curl_4.3.3                   
 [89] png_0.1-7                     interactiveDisplayBase_1.36.0
 [91] statmod_1.4.37                tibble_3.1.8                 
 [93] bslib_0.4.0                   stringi_1.7.8                
 [95] highr_0.9                     GenomicFeatures_1.50.0       
 [97] lattice_0.20-45               ProtGenerics_1.30.0          
 [99] Matrix_1.5-1                  vctrs_0.5.0                  
[101] pillar_1.8.1                  lifecycle_1.0.3              
[103] BiocManager_1.30.19           jquerylib_0.1.4              
[105] RcppAnnoy_0.0.20              BiocNeighbors_1.16.0         
[107] cowplot_1.1.1                 bitops_1.0-7                 
[109] irlba_2.3.5.1                 httpuv_1.6.6                 
[111] rtracklayer_1.58.0            R6_2.5.1                     
[113] BiocIO_1.8.0                  bookdown_0.29                
[115] promises_1.2.0.1              gridExtra_2.3                
[117] vipor_0.4.5                   codetools_0.2-18             
[119] assertthat_0.2.1              rjson_0.2.21                 
[121] withr_2.5.0                   GenomicAlignments_1.34.0     
[123] Rsamtools_2.14.0              GenomeInfoDbData_1.2.9       
[125] parallel_4.2.1                hms_1.1.2                    
[127] grid_4.2.1                    beachmat_2.14.0              
[129] rmarkdown_2.17                DelayedMatrixStats_1.20.0    
[131] shiny_1.7.3                   ggbeeswarm_0.6.0             
[133] restfulr_0.0.15              

Islam, S., A. Zeisel, S. Joost, G. La Manno, P. Zajac, M. Kasper, P. Lonnerberg, and S. Linnarsson. 2014. “Quantitative single-cell RNA-seq with unique molecular identifiers.” Nat. Methods 11 (2): 163–66.

Lun, A. T. L., F. J. Calero-Nieto, L. Haim-Vilmovsky, B. Gottgens, and J. C. Marioni. 2017. “Assessing the reliability of spike-in normalization for analyses of single-cell RNA sequencing data.” Genome Res. 27 (11): 1795–1806.

Macosko, E. Z., A. Basu, R. Satija, J. Nemesh, K. Shekhar, M. Goldman, I. Tirosh, et al. 2015. “Highly parallel genome-wide expression profiling of individual cells using nanoliter droplets.” Cell 161 (5): 1202–14.

Mereu, Elisabetta, Atefeh Lafzi, Catia Moutinho, Christoph Ziegenhain, Davis J. MacCarthy, Adrian Alvarez, Eduard Batlle, et al. 2019. “Benchmarking Single-Cell Rna Sequencing Protocols for Cell Atlas Projects.” bioRxiv. https://doi.org/10.1101/630087.

Muraro, M. J., G. Dharmadhikari, D. Grun, N. Groen, T. Dielen, E. Jansen, L. van Gurp, et al. 2016. “A Single-Cell Transcriptome Atlas of the Human Pancreas.” Cell Syst 3 (4): 385–94.

Segerstolpe, A., A. Palasantza, P. Eliasson, E. M. Andersson, A. C. Andreasson, X. Sun, S. Picelli, et al. 2016. “Single-Cell Transcriptome Profiling of Human Pancreatic Islets in Health and Type 2 Diabetes.” Cell Metab. 24 (4): 593–607.

Srivastava, A., L. Malik, T. Smith, I. Sudbery, and R. Patro. 2019. “Alevin efficiently estimates accurate gene abundances from dscRNA-seq data.” Genome Biol 20 (1): 65.

Svensson, V., E. da Veiga Beltrame, and L. Pachter. 2019. “Quantifying the Tradeoff Between Sequencing Depth and Cell Number in Single-Cell Rna-Seq.” bioRxiv, 762773.

Wilson, N. K., D. G. Kent, F. Buettner, M. Shehata, I. C. Macaulay, F. J. Calero-Nieto, M. Sanchez Castillo, et al. 2015. “Combined single-cell functional and gene expression analysis resolves heterogeneity within stem cell populations.” Cell Stem Cell 16 (6): 712–24.

Zhang, M. J., V. Ntranos, and D. Tse. 2020. “Determining sequencing depth in a single-cell RNA-seq experiment.” Nat Commun 11 (1): 774.

Zheng, G. X., J. M. Terry, P. Belgrader, P. Ryvkin, Z. W. Bent, R. Wilson, S. B. Ziraldo, et al. 2017. “Massively parallel digital transcriptional profiling of single cells.” Nat Commun 8 (January): 14049.

Ziegenhain, C., B. Vieth, S. Parekh, B. Reinius, A. Guillaumet-Adkins, M. Smets, H. Leonhardt, H. Heyn, I. Hellmann, and W. Enard. 2017. “Comparative Analysis of Single-Cell RNA Sequencing Methods.” Mol. Cell 65 (4): 631–43.

References

Macosko, E. Z., A. Basu, R. Satija, J. Nemesh, K. Shekhar, M. Goldman, I. Tirosh, et al. 2015. “Highly parallel genome-wide expression profiling of individual cells using nanoliter droplets.” Cell 161 (5): 1202–14.

Segerstolpe, A., A. Palasantza, P. Eliasson, E. M. Andersson, A. C. Andreasson, X. Sun, S. Picelli, et al. 2016. “Single-Cell Transcriptome Profiling of Human Pancreatic Islets in Health and Type 2 Diabetes.” Cell Metab. 24 (4): 593–607.