Contents

1 tl;dr

To demonstrate, we’ll use one of the mammary gland datasets from the scRNAseq package. We will subset it down to a random set of 1000 cells for speed.

library(scRNAseq)
sce <- BachMammaryData(samples="G_1")

set.seed(1001)
sce <- sce[,sample(ncol(sce), 1000)]

For the purposes of this demonstration, we’ll perform an extremely expedited analysis. One would usually take more care here and do some quality control, create some diagnostic plots, etc., but we don’t have the space for that.

library(scuttle)
sce <- logNormCounts(sce)

library(scran)
dec <- modelGeneVar(sce)
hvgs <- getTopHVGs(dec, n=1000)

library(scater)
set.seed(1002)
sce <- runPCA(sce, ncomponents=10, subset_row=hvgs)
sce <- runTSNE(sce, dimred="PCA")

We run computeDoubletDensity() to obtain a doublet score for each cell based on the density of simulated doublets around it. We log this to get some better dynamic range.

set.seed(1003)
library(scDblFinder)
scores <- computeDoubletDensity(sce, subset.row=hvgs)
plotTSNE(sce, colour_by=I(log1p(scores)))

2 Algorithm overview

We use a fairly simple approach in doubletCells that involves creating simulated doublets from the original data set:

  1. Perform a PCA on the log-normalized expression for all cells in the dataset.
  2. Randomly select two cells and add their count profiles together. Compute the log-normalized profile and project it into the PC space.
  3. Repeat 2 to obtain \(N_s\) simulated doublet cells.
  4. For each cell, compute the local density of simulated doublets, scaled by the density of the original cells. This is used as the doublet score.

3 Size factor handling

3.1 Normalization size factors

We allow specification of two sets of size factors for different purposes. The first set is the normalization set: division of counts by these size factors yields expression values to be compared across cells. This is necessary to compute log-normalized expression values for the PCA.

These size factors are usually computed from some method that assumes most genes are not DE. We default to library size normalization though any arbitrary set of size factors can be used. The size factor for each doublet is computed as the sum of size factors for the individual cells, based on the additivity of scaling biases.

3.2 RNA content size factors

The second set is the RNA content set: division of counts by these size factors yields expression values that are proportional to absolute abundance across cells. This affects the creation of simulated doublets by controlling the scaling of the count profiles for the individual cells. These size factors would normally be estimated with spike-ins, but in their absence we default to using unity for all cells.

The use of unity values implies that the library size for each cell is a good proxy for total RNA content. This is unlikely to be true: technical biases mean that the library size is an imprecise relative estimate of the content. Saturation effects and composition biases also mean that the expected library size for each population is not an accurate estimate of content. The imprecision will spread out the simulated doublets while the inaccuracy will result in a systematic shift from the location of true doublets.

Arguably, such problems exist for any doublet estimation method without spike-in information. We can only hope that the inaccuracies have only minor effects on the creation of simulated cells. Indeed, the first effect does mitigate the second to some extent by ensuring that some simulated doublets will occupy the neighbourhood of the true doublets.

3.3 Interactions between them

These two sets of size factors play different roles so it is possible to specify both of them. We use the following algorithm to accommodate non-unity values for the RNA content size factors:

  1. The RNA content size factors are used to scale the counts first. This ensures that RNA content has the desired effect in step 2 of Section 2.
  2. The normalization size factors are also divided by the content size factors. This ensures that normalization has the correct effect, see below.
  3. The rest of the algorithm proceeds as if the RNA content size factors were unity. Addition of count profiles is done without further scaling, and normalized expression values are computed with the rescaled normalization size factors.

To understand the correctness of the rescaled normalization size factors, consider a non-DE gene with abundance \(\lambda_g\). The expected count in each cell is \(\lambda_g s_i\) for scaling bias \(s_i\) (i.e., normalization size factor). The rescaled count is \(\lambda_g s_i c_i^{-1}\) for some RNA content size factor \(c_i\). The rescaled normalization size factor is \(s_i c_i^{-1}\), such that normalization yields \(\lambda_g\) as desired. This also holds for doublets where the scaling biases and size factors are additive.

4 Doublet score calculations

We assume that the simulation accurately mimics doublet creation - amongst other things, we assume that doublets are equally likely to form between any cell populations and any differences in total RNA between subpopulations are captured or negligible. If these assumptions hold, then at any given region in the expression space, the number of doublets among the real cells is proportional to the number of simulated doublets lying in the same region. Thus, the probability that a cell is a doublet is proportional to the ratio of the number of neighboring simulated doublets to the number of neighboring real cells.

A mild additional challenge here is that the number of simulated cells \(N_s\) can vary. Ideally, we would like the expected output of the function to be the same regardless of the user’s choice of \(N_s\), i.e., the chosen value should only affect the precision/speed trade-off. Many other doublet-based methods take a \(k\)-nearest neighbours approach to compute densities; but if \(N_s\) is too large relative to the number of real cells, all of the \(k\) nearest neighbours will be simulated, while if \(N_s\) is too small, all of the nearest neighbors will be original cells.

Thus, we use a modified version of the \(k\)NN approach whereby we identify the distance from each cell to its \(k\)-th nearest neighbor. This defines a hypersphere around that cell in which we count the number of simulated cells. We then compute the odds ratio of the number of simulated cells in the hypersphere to \(N_s\), divided by the ratio of \(k\) to the total number of cells in the dataset. This score captures the relative frequency of simulated cells to real cells while being robust to changes to \(N_s\).

Session information

sessionInfo()
## R Under development (unstable) (2024-03-18 r86148)
## Platform: x86_64-pc-linux-gnu
## Running under: Ubuntu 22.04.4 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.19-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.13.0              scDblFinder_1.17.3         
##  [3] scater_1.31.2               ggplot2_3.5.0              
##  [5] scran_1.31.3                scuttle_1.13.1             
##  [7] ensembldb_2.27.1            AnnotationFilter_1.27.0    
##  [9] GenomicFeatures_1.55.4      AnnotationDbi_1.65.2       
## [11] scRNAseq_2.17.6             SingleCellExperiment_1.25.0
## [13] SummarizedExperiment_1.33.3 Biobase_2.63.0             
## [15] GenomicRanges_1.55.4        GenomeInfoDb_1.39.9        
## [17] IRanges_2.37.1              S4Vectors_0.41.5           
## [19] BiocGenerics_0.49.1         MatrixGenerics_1.15.0      
## [21] matrixStats_1.2.0           BiocStyle_2.31.0           
## 
## loaded via a namespace (and not attached):
##   [1] jsonlite_1.8.8            magrittr_2.0.3           
##   [3] magick_2.8.3              ggbeeswarm_0.7.2         
##   [5] gypsum_0.99.15            farver_2.1.1             
##   [7] rmarkdown_2.26            BiocIO_1.13.0            
##   [9] zlibbioc_1.49.3           vctrs_0.6.5              
##  [11] memoise_2.0.1             Rsamtools_2.19.4         
##  [13] DelayedMatrixStats_1.25.1 RCurl_1.98-1.14          
##  [15] base64enc_0.1-3           htmltools_0.5.7          
##  [17] S4Arrays_1.3.6            AnnotationHub_3.11.3     
##  [19] curl_5.2.1                BiocNeighbors_1.21.2     
##  [21] xgboost_1.7.7.1           Rhdf5lib_1.25.1          
##  [23] SparseArray_1.3.4         rhdf5_2.47.6             
##  [25] sass_0.4.9                alabaster.base_1.3.23    
##  [27] bslib_0.6.1               alabaster.sce_1.3.3      
##  [29] httr2_1.0.0               cachem_1.0.8             
##  [31] GenomicAlignments_1.39.4  igraph_2.0.3             
##  [33] mime_0.12                 lifecycle_1.0.4          
##  [35] pkgconfig_2.0.3           rsvd_1.0.5               
##  [37] Matrix_1.6-5              R6_2.5.1                 
##  [39] fastmap_1.1.1             GenomeInfoDbData_1.2.11  
##  [41] digest_0.6.35             colorspace_2.1-0         
##  [43] dqrng_0.3.2               irlba_2.3.5.1            
##  [45] ExperimentHub_2.11.1      aws.signature_0.6.0      
##  [47] RSQLite_2.3.5             beachmat_2.19.1          
##  [49] labeling_0.4.3            filelock_1.0.3           
##  [51] fansi_1.0.6               httr_1.4.7               
##  [53] abind_1.4-5               compiler_4.4.0           
##  [55] bit64_4.0.5               withr_3.0.0              
##  [57] BiocParallel_1.37.1       viridis_0.6.5            
##  [59] DBI_1.2.2                 highr_0.10               
##  [61] HDF5Array_1.31.6          alabaster.ranges_1.3.3   
##  [63] alabaster.schemas_1.3.1   MASS_7.3-60.2            
##  [65] rappdirs_0.3.3            DelayedArray_0.29.9      
##  [67] rjson_0.2.21              tools_4.4.0              
##  [69] vipor_0.4.7               beeswarm_0.4.0           
##  [71] glue_1.7.0                restfulr_0.0.15          
##  [73] rhdf5filters_1.15.4       grid_4.4.0               
##  [75] Rtsne_0.17                cluster_2.1.6            
##  [77] generics_0.1.3            gtable_0.3.4             
##  [79] data.table_1.15.2         metapod_1.11.1           
##  [81] BiocSingular_1.19.0       ScaledMatrix_1.11.1      
##  [83] xml2_1.3.6                utf8_1.2.4               
##  [85] XVector_0.43.1            ggrepel_0.9.5            
##  [87] BiocVersion_3.19.1        pillar_1.9.0             
##  [89] limma_3.59.6              dplyr_1.1.4              
##  [91] BiocFileCache_2.11.1      lattice_0.22-6           
##  [93] rtracklayer_1.63.1        bit_4.0.5                
##  [95] tidyselect_1.2.1          locfit_1.5-9.9           
##  [97] Biostrings_2.71.4         knitr_1.45               
##  [99] gridExtra_2.3             bookdown_0.38            
## [101] ProtGenerics_1.35.4       edgeR_4.1.18             
## [103] xfun_0.42                 statmod_1.5.0            
## [105] lazyeval_0.2.2            yaml_2.3.8               
## [107] evaluate_0.23             codetools_0.2-19         
## [109] tibble_3.2.1              alabaster.matrix_1.3.13  
## [111] BiocManager_1.30.22       cli_3.6.2                
## [113] munsell_0.5.0             jquerylib_0.1.4          
## [115] Rcpp_1.0.12               dbplyr_2.5.0             
## [117] png_0.1-8                 XML_3.99-0.16.1          
## [119] parallel_4.4.0            blob_1.2.4               
## [121] aws.s3_0.3.21             sparseMatrixStats_1.15.0 
## [123] bitops_1.0-7              viridisLite_0.4.2        
## [125] alabaster.se_1.3.4        scales_1.3.0             
## [127] purrr_1.0.2               crayon_1.5.2             
## [129] rlang_1.1.3               cowplot_1.1.3            
## [131] KEGGREST_1.43.0