scCB2 1.0.0
Droplet-based single-cell RNA sequencing (scRNA-seq) is a powerful and widely-used approach for profiling genome-wide gene expression
in individual cells. Current commercial droplet-based technologies such as 10X Genomics utilize gel beads, each containing
oligonucleotide indexes made up of bead-specific barcodes combined with unique molecular identifiers (UMIs) and oligo-dT tags
to prime polyadenylated RNA. Single cells of interest are combined with reagents in one channel of a microfluidic chip,
and gel beads in another, to form gel-beads in emulsion, or GEMs. Oligonucleotide indexes bind polyadenylated RNA within each GEM
reaction vesicle before gel beads are dissolved releasing the bound oligos into solution for reverse transcription.
By design, each resulting cDNA molecule contains a UMI and a GEM-specific barcode that, ideally,
tags mRNA from an individual cell, but this is often not the case in practice. To distinguish true cells from background barcodes in
droplet-based single cell RNA-seq experiments, we introduce CB2 and scCB2, its corresponding R package.
CB2 extends the EmptyDrops approach by introducing a clustering step that groups similar barcodes and
then conducts a statistical test to identify groups with expression distributions that vary from the background.
While advantages are expected in many settings, users will benefit from
noting that CB2 does not test for doublets or multiplets and, consequently, some of the high count identifications
may consist of two or more cells. Methods for identifying multiplets may prove useful after applying CB2.
It is also important to note that any method for distinguishing cells from background barcodes is technically correct in
identifying low-quality cells given that damaged cells exhibit expression profiles that differ from the background.
Specifically, mitochondrial gene expression is often high in damaged cells.
Such cells are typically not of interest in downstream analysis and should therefore be removed.
The GetCellMat function in scCB2 may be used toward this end.
Install from Bioconductor:
if (!requireNamespace("BiocManager", quietly = TRUE))
    install.packages("BiocManager")
BiocManager::install("scCB2")QuickCB2 is an all-in-one function to apply CB2 on 10x Cell Ranger raw data and get a matrix of real cells identified by CB2 under default settings. By specifying AsSeurat = TRUE, a Seurat object is returned so that users can directly apply the Seurat pipeline for downstream analyses.
Usage:
library(scCB2)
# If raw data has three separate files within one directory
# and you want to control FDR at the default 1%:
RealCell <-  QuickCB2(dir = "/path/to/raw/data/directory")
# If raw data is in HDF5 format and 
# you'd like a Seurat object under default FDR threshold:
RealCell_S <-  QuickCB2(h5file = "/path/to/raw/data/HDF5", 
                        AsSeurat = TRUE)An example illustrating how it works and what the final output looks like can be found at the end of Detailed Steps.
The computational speed is related to the size and structure of input datasets. As a reference, scCB2 running on a medium-size dataset (around 30,000 genes and 8,000 cells after cell calling) using 6 cores takes less than 10 minutes.
For users who would like to save the CB2 output cell matrix to 10x format (e.g. “matrix.mtx”, “barcodes.tsv” and “genes.tsv”), there are existing packages to help. For example in package DropletUtils:
DropletUtils::write10xCounts(path = "/path/to/save/data",
                             x = RealCell)Currently, the most widely-used droplet-based protocol is 10x Chromium. Our package provides functions to directly read 10x Cell Ranger output files and generate a feature-by-barcode count matrix that may be read into R. Public 10x datasets can be found here.
Our package contains a small subset of 10x data, mbrainSub, corresponding to the first 50,000 barcodes of 1k Brain Cells from an E18 Mouse.
We first generate 10x output files of mbrainSub, then read it using our built-in functions.
library(scCB2)
library(SummarizedExperiment)
data(mbrainSub)
data.dir <- file.path(tempdir(),"CB2_example")
DropletUtils::write10xCounts(data.dir,
                             mbrainSub,
                             version = "3")
list.files(data.dir)## [1] "barcodes.tsv.gz" "features.tsv.gz" "matrix.mtx.gz"For Cell Ranger version <3, the raw data from 10x Cell Ranger output contains “barcodes.tsv”, “genes.tsv” and “matrix.mtx”. For Cell Ranger version >=3, the output files are “barcodes.tsv.gz”, “features.tsv.gz” and “matrix.mtx.gz”. We now read these files back into R and compare with original data matrix.
mbrainSub_2 <- Read10xRaw(data.dir)
identical(mbrainSub, mbrainSub_2)## [1] TRUEIf raw data is not from the 10x Chromium pipeline, a user may manually create the feature-by-barcode count matrix with rows representing genes and columns representing barcodes. Gene and barcode IDs should be unique. The format of the count matrix can be either a sparse matrix or standard matrix.
The main function CB2FindCell takes a raw count matrix as input and returns real cells, test statistics, and p-values. Now we apply CB2FindCell on mbrainSub, controlling FDR at 0.01 level (Default), assuming all barcodes with total count less than or equal to 100 are background empty droplets (Default), using 2 cores parallel computation (Default: number of total cores in the machine minus 2). For detailed information, see ?CB2FindCell.
CBOut <- CB2FindCell(mbrainSub, Ncores = 2)## Time difference of 2.277046 minsstr(assay(CBOut)) # cell matrix## Formal class 'dgCMatrix' [package "Matrix"] with 6 slots
##   ..@ i       : int [1:273799] 62 469 538 663 758 903 1251 1266 1396 1532 ...
##   ..@ p       : int [1:174] 0 219 2503 4608 6288 6512 6796 7194 7335 7789 ...
##   ..@ Dim     : int [1:2] 27998 173
##   ..@ Dimnames:List of 2
##   .. ..$ : chr [1:27998] "Xkr4" "Gm1992" "Gm37381" "Rp1" ...
##   .. ..$ : chr [1:173] "AAACCTGGTGCTCTTC-1" "AAACGGGAGCCACGTC-1" "AAACGGGAGCGAGAAA-1" "AAACGGGCAGTTTACG-1" ...
##   ..@ x       : num [1:273799] 1 1 1 1 1 1 1 1 1 1 ...
##   ..@ factors : list()str(metadata(CBOut)) # test statistics, p-values, etc## List of 4
##  $ ClusterStat:'data.frame': 5 obs. of  4 variables:
##   ..$ corr : num [1:5] 0.6715 0.6773 0.0509 0.38 0.5547
##   ..$ count: num [1:5] 260 315 271 113 4679
##   ..$ pval : num [1:5] 0.285714 0.068931 0.000999 0.004995 0.000999
##   ..$ padj : num [1:5] 0.28571 0.08616 0.0025 0.00833 0.0025
##  $ Cluster    :List of 5
##   ..$ : chr [1:85] "AACACGTAGGCAAAGA-1" "ACAGCCGCAAACGCGA-1" "AACACGTGTATAGGTA-1" "AACTCAGTCTCGGACG-1" ...
##   ..$ : chr [1:41] "AACTTTCAGGCCCGTT-1" "AACTCTTTCGCCGTGA-1" "AACTTTCGTACCGTTA-1" "AACCATGGTTGCCTCT-1" ...
##   ..$ : chr [1:3] "AAGGCAGGTCTTGCGG-1" "ACATCAGCACATTAGC-1" "AAGACCTAGACTGGGT-1"
##   ..$ : chr [1:6] "AATCCAGAGATCTGAA-1" "AACCATGTCTCGCATC-1" "AACACGTTCTCTAGGA-1" "AACTCCCGTGCTTCTC-1" ...
##   ..$ : chr [1:23] "ACCAGTAAGTGCGATG-1" "AAGTCTGAGGACAGCT-1" "ACATACGCAAGCCGTC-1" "AAGGCAGGTCTAGAGG-1" ...
##  $ BarcodeStat:'data.frame': 203 obs. of  4 variables:
##   ..$ logLH: num [1:203] -762 -770 -886 -454 -9992 ...
##   ..$ count: num [1:203] 337 304 312 207 5717 ...
##   ..$ pval : num [1:203] 0.9446 0.4308 0.001 1 0.0001 ...
##   ..$ padj : num [1:203] 1 0.671241 0.001854 1 0.000202 ...
##  $ background : Named num [1:11121] 8 3 2 0 2 2 0 1 3 1 ...
##   ..- attr(*, "names")= chr [1:11121] "Mrpl15" "Lypla1" "Tcea1" "Rgs20" ...If readers are not interested in the output testing information, GetCellMat can extract the real cell matrix directly from CB2FindCell output. It also provides a filtering option to remove broken cells based on the proportion of mitochondrial gene expressions. Now we apply GetCellMat on CBOut, filtering out cells whose mitochondrial proportions are greater than 0.25 (Default: 1, No filtering).
RealCell <- GetCellMat(CBOut, MTfilter = 0.25)
str(RealCell)## Formal class 'dgCMatrix' [package "Matrix"] with 6 slots
##   ..@ i       : int [1:272781] 62 469 538 663 758 903 1251 1266 1396 1532 ...
##   ..@ p       : int [1:171] 0 219 2503 4608 6288 6512 6796 7194 7335 7789 ...
##   ..@ Dim     : int [1:2] 27998 170
##   ..@ Dimnames:List of 2
##   .. ..$ : chr [1:27998] "Xkr4" "Gm1992" "Gm37381" "Rp1" ...
##   .. ..$ : chr [1:170] "AAACCTGGTGCTCTTC-1" "AAACGGGAGCCACGTC-1" "AAACGGGAGCGAGAAA-1" "AAACGGGCAGTTTACG-1" ...
##   ..@ x       : num [1:272781] 1 1 1 1 1 1 1 1 1 1 ...
##   ..@ factors : list()After CB2 pre-processing, the real cell matrix is still in matrix format, so it can be directly used in downstream statistical analyses. For example, if we want to use the Seurat pipeline, we can easily create a Seurat object using
SeuratObj <- Seurat::CreateSeuratObject(counts = RealCell, 
                                        project = "mbrain_example")
SeuratObj## An object of class Seurat 
## 27998 features across 170 samples within 1 assay 
## Active assay: RNA (27998 features, 0 variable features)Under default parameters, we can directly use the all-in-one function QuickCB2 to get the real cell matrix from 10x raw data.
RealCell_Quick <- QuickCB2(dir = data.dir, Ncores = 2)## Time difference of 2.340223 minsstr(RealCell_Quick)## Formal class 'dgCMatrix' [package "Matrix"] with 6 slots
##   ..@ i       : int [1:273471] 62 469 538 663 758 903 1251 1266 1396 1532 ...
##   ..@ p       : int [1:173] 0 219 2503 4608 6288 6512 6796 7194 7335 7789 ...
##   ..@ Dim     : int [1:2] 27998 172
##   ..@ Dimnames:List of 2
##   .. ..$ : chr [1:27998] "Xkr4" "Gm1992" "Gm37381" "Rp1" ...
##   .. ..$ : chr [1:172] "AAACCTGGTGCTCTTC-1" "AAACGGGAGCCACGTC-1" "AAACGGGAGCGAGAAA-1" "AAACGGGCAGTTTACG-1" ...
##   ..@ x       : num [1:273471] 1 1 1 1 1 1 1 1 1 1 ...
##   ..@ factors : list()Now it’s ready for downstream analysis such as normalization and clustering. Example Seurat tutorial: https://satijalab.org/seurat/v3.1/pbmc3k_tutorial.html
sessionInfo()## R version 4.0.3 (2020-10-10)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 18.04.5 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.12-bioc/R/lib/libRblas.so
## LAPACK: /home/biocbuild/bbs-3.12-bioc/R/lib/libRlapack.so
## 
## locale:
##  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
##  [3] LC_TIME=en_US.UTF-8        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] parallel  stats4    stats     graphics  grDevices utils     datasets 
## [8] methods   base     
## 
## other attached packages:
##  [1] SummarizedExperiment_1.20.0 Biobase_2.50.0             
##  [3] GenomicRanges_1.42.0        GenomeInfoDb_1.26.0        
##  [5] IRanges_2.24.0              S4Vectors_0.28.0           
##  [7] BiocGenerics_0.36.0         MatrixGenerics_1.2.0       
##  [9] matrixStats_0.57.0          scCB2_1.0.0                
## [11] knitr_1.30                  BiocStyle_2.18.0           
## 
## loaded via a namespace (and not attached):
##   [1] plyr_1.8.6                  igraph_1.2.6               
##   [3] lazyeval_0.2.2              splines_4.0.3              
##   [5] BiocParallel_1.24.0         listenv_0.8.0              
##   [7] ggplot2_3.3.2               digest_0.6.27              
##   [9] foreach_1.5.1               htmltools_0.5.0            
##  [11] magrittr_1.5                tensor_1.5                 
##  [13] cluster_2.1.0               doParallel_1.0.16          
##  [15] ROCR_1.0-11                 limma_3.46.0               
##  [17] globals_0.13.1              R.utils_2.10.1             
##  [19] colorspace_1.4-1            rappdirs_0.3.1             
##  [21] ggrepel_0.8.2               xfun_0.18                  
##  [23] dplyr_1.0.2                 crayon_1.3.4               
##  [25] RCurl_1.98-1.2              jsonlite_1.7.1             
##  [27] spatstat_1.64-1             spatstat.data_1.4-3        
##  [29] survival_3.2-7              zoo_1.8-8                  
##  [31] iterators_1.0.13            glue_1.4.2                 
##  [33] polyclip_1.10-0             gtable_0.3.0               
##  [35] zlibbioc_1.36.0             XVector_0.30.0             
##  [37] leiden_0.3.3                DelayedArray_0.16.0        
##  [39] DropletUtils_1.10.0         Rhdf5lib_1.12.0            
##  [41] future.apply_1.6.0          SingleCellExperiment_1.12.0
##  [43] HDF5Array_1.18.0            abind_1.4-5                
##  [45] scales_1.1.1                edgeR_3.32.0               
##  [47] miniUI_0.1.1.1              Rcpp_1.0.5                 
##  [49] viridisLite_0.3.0           xtable_1.8-4               
##  [51] reticulate_1.18             dqrng_0.2.1                
##  [53] rsvd_1.0.3                  htmlwidgets_1.5.2          
##  [55] httr_1.4.2                  RColorBrewer_1.1-2         
##  [57] ellipsis_0.3.1              Seurat_3.2.2               
##  [59] ica_1.0-2                   pkgconfig_2.0.3            
##  [61] R.methodsS3_1.8.1           scuttle_1.0.0              
##  [63] uwot_0.1.8                  deldir_0.1-29              
##  [65] locfit_1.5-9.4              tidyselect_1.1.0           
##  [67] rlang_0.4.8                 reshape2_1.4.4             
##  [69] later_1.1.0.1               munsell_0.5.0              
##  [71] tools_4.0.3                 generics_0.0.2             
##  [73] ggridges_0.5.2              evaluate_0.14              
##  [75] stringr_1.4.0               fastmap_1.0.1              
##  [77] yaml_2.2.1                  goftest_1.2-2              
##  [79] fitdistrplus_1.1-1          purrr_0.3.4                
##  [81] RANN_2.6.1                  pbapply_1.4-3              
##  [83] future_1.19.1               nlme_3.1-150               
##  [85] sparseMatrixStats_1.2.0     mime_0.9                   
##  [87] R.oo_1.24.0                 compiler_4.0.3             
##  [89] plotly_4.9.2.1              png_0.1-7                  
##  [91] spatstat.utils_1.17-0       tibble_3.0.4               
##  [93] stringi_1.5.3               lattice_0.20-41            
##  [95] Matrix_1.2-18               vctrs_0.3.4                
##  [97] pillar_1.4.6                lifecycle_0.2.0            
##  [99] rhdf5filters_1.2.0          BiocManager_1.30.10        
## [101] lmtest_0.9-38               RcppAnnoy_0.0.16           
## [103] data.table_1.13.2           cowplot_1.1.0              
## [105] bitops_1.0-6                irlba_2.3.3                
## [107] httpuv_1.5.4                patchwork_1.0.1            
## [109] R6_2.4.1                    bookdown_0.21              
## [111] promises_1.1.1              KernSmooth_2.23-17         
## [113] gridExtra_2.3               codetools_0.2-16           
## [115] MASS_7.3-53                 rhdf5_2.34.0               
## [117] sctransform_0.3.1           GenomeInfoDbData_1.2.4     
## [119] mgcv_1.8-33                 grid_4.0.3                 
## [121] rpart_4.1-15                beachmat_2.6.0             
## [123] tidyr_1.1.2                 rmarkdown_2.5              
## [125] DelayedMatrixStats_1.12.0   Rtsne_0.15                 
## [127] shiny_1.5.0Ni, Z., Chen, S., Brown, J., & Kendziorski, C. (2020). CB2 improves power of cell detection in droplet-based single-cell RNA sequencing data. Genome Biology, 21(1), 137. https://doi.org/10.1186/s13059-020-02054-8