scuttle 1.4.0
scuttle provides various low-level utilities for single-cell RNA-seq data analysis, typically used at the start of the analysis workflows or within high-level functions in other packages. This vignette will discuss the use of scaling normalization for removing cell-specific biases. To demonstrate, we will obtain the classic Zeisel dataset from the scRNAseq package and apply some quick quality control to remove damaged cells.
library(scRNAseq)
sce <- ZeiselBrainData()
library(scuttle)
sce <- quickPerCellQC(sce, subsets=list(Mito=grep("mt-", rownames(sce))),
    sub.fields=c("subsets_Mito_percent", "altexps_ERCC_percent")) 
sce## class: SingleCellExperiment 
## dim: 20006 2816 
## metadata(0):
## assays(1): counts
## rownames(20006): Tspan12 Tshz1 ... mt-Rnr1 mt-Nd4l
## rowData names(1): featureType
## colnames(2816): 1772071015_C02 1772071017_G12 ... 1772063068_D01
##   1772066098_A12
## colData names(27): tissue group # ... high_altexps_ERCC_percent discard
## reducedDimNames(0):
## mainExpName: endogenous
## altExpNames(2): ERCC repeatNote: A more comprehensive description of the use of scuttle functions (along with other packages) in a scRNA-seq analysis workflow is available at https://osca.bioconductor.org.
Scaling normalization involves dividing the counts for each cell by a cell-specific “size factor” to adjust for uninteresting differences in sequencing depth and capture efficiency.
The librarySizeFactors() function provides a simple definition of the size factor for each cell,
computed as the library size of each cell after scaling them to have a mean of 1 across all cells.
This is fast but inaccurate in the presence of differential expression between cells that introduce composition biases.
summary(librarySizeFactors(sce))##    Min. 1st Qu.  Median    Mean 3rd Qu.    Max. 
##  0.1757  0.5680  0.8680  1.0000  1.2783  4.0839The geometricSizeFactors() function instead computes the geometric mean within each cell.
This is more robust to composition biases but is only accurate when the counts are large and there are few zeroes.
summary(geometricSizeFactors(sce))##    Min. 1st Qu.  Median    Mean 3rd Qu.    Max. 
##  0.8261  0.9104  0.9758  1.0000  1.0640  1.5189The medianSizeFactors() function uses a DESeq2-esque approach based on the median ratio from an average pseudo-cell.
Briefly, we assume that most genes are non-DE, such that any systematic fold difference in coverage (as defined by the median ratio) represents technical biases that must be removed.
This is highly robust to composition biases but relies on sufficient sequencing coverage to obtain well-defined ratios.
summary(medianSizeFactors(sce))##    Min. 1st Qu.  Median    Mean 3rd Qu.    Max.    NA's 
##      NA      NA      NA     NaN      NA      NA    2816All of these size factors can be stored in the SingleCellExperiment via the sizeFactors<-() setter function.
Most downstream functions will pick these up automatically for any calculations that rely on size factors.
sizeFactors(sce) <- librarySizeFactors(sce)Alternatively, functions like computeLibraryFactors() can automatically compute and attach the size factors to our SingleCellExperiment object.
sce <- computeLibraryFactors(sce)
summary(sizeFactors(sce))##    Min. 1st Qu.  Median    Mean 3rd Qu.    Max. 
##  0.1757  0.5680  0.8680  1.0000  1.2783  4.0839The computePooledFactors method implements the pooling strategy for scaling normalization.
This uses an approach similar to medianSizeFactors() to remove composition biases,
but pools cells together to overcome problems with discreteness at low counts.
Per-cell factors are then obtained from the pools using a deconvolution strategy.
library(scran)
clusters <- quickCluster(sce)
sce <- computePooledFactors(sce, clusters=clusters)
summary(sizeFactors(sce))##    Min. 1st Qu.  Median    Mean 3rd Qu.    Max. 
##  0.1340  0.4910  0.8281  1.0000  1.3181  4.4579For larger data sets, a rough clustering should be performed prior to normalization.
computePooledFactors() will then automatically apply normalization within each cluster first, before adjusting the scaling factors to be comparable across clusters.
This reduces the risk of violating our assumptions (of a non-DE majority of genes) when many genes are DE between clusters in a heterogeneous population.
In this case, we use the quickCluster() function from the scran package, but any clustering function can be used, for example:
sce <- computePooledFactors(sce, clusters=sce$level1class)
summary(sizeFactors(sce))##    Min. 1st Qu.  Median    Mean 3rd Qu.    Max. 
##  0.1322  0.4797  0.8265  1.0000  1.3355  4.4953We assume that quality control on the cells has already been performed prior to running this function. Low-quality cells with few expressed genes can often have negative size factor estimates.
An alternative approach is to normalize based on the spike-in counts. The idea is that the same quantity of spike-in RNA was added to each cell prior to library preparation. Size factors are computed to scale the counts such that the total coverage of the spike-in transcripts is equal across cells.
sce2 <- computeSpikeFactors(sce, "ERCC")
summary(sizeFactors(sce2))##    Min. 1st Qu.  Median    Mean 3rd Qu.    Max. 
##  0.1600  0.7746  0.9971  1.0000  1.1851  3.4923The main practical difference from the other strategies is that spike-in normalization preserves differences in total RNA content between cells, whereas computePooledFactors and other non-DE methods do not.
This can be important in certain applications where changes in total RNA content are associated with a biological phenomenon of interest.
Regardless of which size factor calculation we pick, the calculation of normalized expression values simply involves dividing each count by the size factor for the cell.
This eliminates the cell-specific scaling effect for valid comparisons between cells in downstream analyses.
The simplest approach to computing these values is to use the logNormCounts() function:
sce <- logNormCounts(sce)
assayNames(sce)## [1] "counts"    "logcounts"This computes log2-transformed normalized expression values by adding a constant pseudo-count and log-transforming.
The resulting values can be roughly interpreted on the same scale as log-transformed counts and are stored in "logcounts".
This is the most common expression measure for downstream analyses as differences between values can be treated as log-fold changes.
For example, Euclidean distances between cells are analogous to the average log-fold change across genes.
Of course, users can construct any arbitrary matrix of the same dimensions as the count matrix and store it as an assay.
Here, we use the normalizeCounts() function to perform some custom normalization with random size factors.
assay(sce, "normed") <- normalizeCounts(sce, log=FALSE,
    size.factors=runif(ncol(sce)), pseudo.count=1.5)scuttle can also calculate counts-per-million using the aptly-named calculateCPM() function.
The output is most appropriately stored as an assay named "cpm" in the assays of the SingleCellExperiment object.
Related functions include calculateTPM() and calculateFPKM(), which do pretty much as advertised.
assay(sce, "cpm") <- calculateCPM(sce)sessionInfo()## R version 4.1.1 (2021-08-10)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 20.04.3 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.14-bioc/R/lib/libRblas.so
## LAPACK: /home/biocbuild/bbs-3.14-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] scran_1.22.0                ensembldb_2.18.0           
##  [3] AnnotationFilter_1.18.0     GenomicFeatures_1.46.0     
##  [5] AnnotationDbi_1.56.0        scuttle_1.4.0              
##  [7] scRNAseq_2.7.2              SingleCellExperiment_1.16.0
##  [9] SummarizedExperiment_1.24.0 Biobase_2.54.0             
## [11] GenomicRanges_1.46.0        GenomeInfoDb_1.30.0        
## [13] IRanges_2.28.0              S4Vectors_0.32.0           
## [15] BiocGenerics_0.40.0         MatrixGenerics_1.6.0       
## [17] matrixStats_0.61.0          BiocStyle_2.22.0           
## 
## loaded via a namespace (and not attached):
##   [1] rjson_0.2.20                  ellipsis_0.3.2               
##   [3] bluster_1.4.0                 XVector_0.34.0               
##   [5] BiocNeighbors_1.12.0          bit64_4.0.5                  
##   [7] interactiveDisplayBase_1.32.0 fansi_0.5.0                  
##   [9] xml2_1.3.2                    sparseMatrixStats_1.6.0      
##  [11] cachem_1.0.6                  knitr_1.36                   
##  [13] jsonlite_1.7.2                Rsamtools_2.10.0             
##  [15] cluster_2.1.2                 dbplyr_2.1.1                 
##  [17] png_0.1-7                     shiny_1.7.1                  
##  [19] BiocManager_1.30.16           compiler_4.1.1               
##  [21] httr_1.4.2                    dqrng_0.3.0                  
##  [23] assertthat_0.2.1              Matrix_1.3-4                 
##  [25] fastmap_1.1.0                 lazyeval_0.2.2               
##  [27] limma_3.50.0                  later_1.3.0                  
##  [29] BiocSingular_1.10.0           htmltools_0.5.2              
##  [31] prettyunits_1.1.1             tools_4.1.1                  
##  [33] igraph_1.2.7                  rsvd_1.0.5                   
##  [35] glue_1.4.2                    GenomeInfoDbData_1.2.7       
##  [37] dplyr_1.0.7                   rappdirs_0.3.3               
##  [39] Rcpp_1.0.7                    jquerylib_0.1.4              
##  [41] vctrs_0.3.8                   Biostrings_2.62.0            
##  [43] ExperimentHub_2.2.0           rtracklayer_1.54.0           
##  [45] DelayedMatrixStats_1.16.0     xfun_0.27                    
##  [47] stringr_1.4.0                 beachmat_2.10.0              
##  [49] mime_0.12                     lifecycle_1.0.1              
##  [51] irlba_2.3.3                   restfulr_0.0.13              
##  [53] statmod_1.4.36                XML_3.99-0.8                 
##  [55] edgeR_3.36.0                  AnnotationHub_3.2.0          
##  [57] zlibbioc_1.40.0               hms_1.1.1                    
##  [59] promises_1.2.0.1              ProtGenerics_1.26.0          
##  [61] parallel_4.1.1                yaml_2.2.1                   
##  [63] curl_4.3.2                    memoise_2.0.0                
##  [65] sass_0.4.0                    biomaRt_2.50.0               
##  [67] stringi_1.7.5                 RSQLite_2.2.8                
##  [69] BiocVersion_3.14.0            BiocIO_1.4.0                 
##  [71] ScaledMatrix_1.2.0            filelock_1.0.2               
##  [73] BiocParallel_1.28.0           rlang_0.4.12                 
##  [75] pkgconfig_2.0.3               bitops_1.0-7                 
##  [77] evaluate_0.14                 lattice_0.20-45              
##  [79] purrr_0.3.4                   GenomicAlignments_1.30.0     
##  [81] bit_4.0.4                     tidyselect_1.1.1             
##  [83] magrittr_2.0.1                bookdown_0.24                
##  [85] R6_2.5.1                      generics_0.1.1               
##  [87] metapod_1.2.0                 DelayedArray_0.20.0          
##  [89] DBI_1.1.1                     pillar_1.6.4                 
##  [91] withr_2.4.2                   KEGGREST_1.34.0              
##  [93] RCurl_1.98-1.5                tibble_3.1.5                 
##  [95] crayon_1.4.1                  utf8_1.2.2                   
##  [97] BiocFileCache_2.2.0           rmarkdown_2.11               
##  [99] progress_1.2.2                locfit_1.5-9.4               
## [101] grid_4.1.1                    blob_1.2.2                   
## [103] digest_0.6.28                 xtable_1.8-4                 
## [105] httpuv_1.6.3                  bslib_0.3.1