Chapter 1 Introduction
1.1 Motivation
The Bioconductor package SingleR implements an automatic annotation method for single-cell RNA sequencing (scRNA-seq) data (Aran et al. 2019). Given a reference dataset of samples (single-cell or bulk) with known labels, it assigns those labels to new cells from a test dataset based on similarities in their expression profiles. This provides a convenient way of transferring biological knowledge across datasets, allowing users to leverage the domain expertise implicit in the creation of each reference. The most common application of SingleR involves predicting cell type (or “state”, or “kind”) in a new dataset, a process that is facilitated by the availability of curated references and compatibility with user-supplied datasets. In this manner, the burden of manually interpreting clusters and defining marker genes only has to be done once, for the reference dataset, and this knowledge can be propagated to new datasets in an automated manner.
1.2 Method description
SingleR can be considered a robust variant of nearest-neighbors classification, with some tweaks to improve resolution for closely related labels. For each test cell:
- We compute the Spearman correlation between its expression profile and that of each reference sample. The use of Spearman’s correlation provides a measure of robustness to batch effects across datasets. The calculation only uses the union of marker genes identified by pairwise comparisons between labels in the reference data, so as to improve resolution of separation between labels.
- We define the per-label score as a fixed quantile (by default, 0.8) of the correlations across all samples with that label. This accounts for differences in the number of reference samples for each label, which interferes with simpler flavors of nearest neighbor classification; it also avoids penalizing classifications to heterogeneous labels by only requiring a good match to a minority of samples.
- We repeat the score calculation for all labels in the reference dataset. The label with the highest score is used as SingleR’s prediction for this cell.
- We optionally perform a fine-tuning step to improve resolution between closely related labels. The reference dataset is subsetted to only include labels with scores close to the maximum; scores are recomputed using only marker genes for the subset of labels, thus focusing on the most relevant features; and this process is iterated until only one label remains.
1.3 Quick start
We will demonstrate the use of SingleR() on a well-known 10X Genomics dataset (Zheng et al. 2017)
with the Human Primary Cell Atlas dataset (Mabbott et al. 2013) as the reference.
# Loading test data.
library(TENxPBMCData)
new.data <- TENxPBMCData("pbmc4k")
# Loading reference data with Ensembl annotations.
library(celldex)
ref.data <- HumanPrimaryCellAtlasData(ensembl=TRUE)
# Performing predictions.
library(SingleR)
predictions <- SingleR(test=new.data, assay.type.test=1, 
    ref=ref.data, labels=ref.data$label.main)
table(predictions$labels)## 
##           B_cell              CMP               DC              GMP 
##              606                8                1                2 
##         Monocyte          NK_cell        Platelets Pre-B_cell_CD34- 
##             1164              217                3               46 
##          T_cells 
##             2293And that’s it, really.
1.4 Where to get help
Questions on the general use of SingleR should be posted to the Bioconductor support site. Please send requests for general assistance and advice to the support site rather than to the individual authors. Bug reports or feature requests should be made to the GitHub repository; well-considered suggestions for improvements are always welcome.
Session information
R version 4.5.0 RC (2025-04-04 r88126)
Platform: x86_64-pc-linux-gnu
Running under: Ubuntu 24.04.2 LTS
Matrix products: default
BLAS:   /home/biocbuild/bbs-3.21-bioc/R/lib/libRblas.so 
LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.12.0  LAPACK version 3.12.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] SingleR_2.10.0              ensembldb_2.32.0           
 [3] AnnotationFilter_1.32.0     GenomicFeatures_1.60.0     
 [5] AnnotationDbi_1.70.0        celldex_1.17.0             
 [7] TENxPBMCData_1.25.0         HDF5Array_1.36.0           
 [9] h5mread_1.0.0               rhdf5_2.52.0               
[11] DelayedArray_0.34.0         SparseArray_1.8.0          
[13] S4Arrays_1.8.0              abind_1.4-8                
[15] Matrix_1.7-3                SingleCellExperiment_1.30.0
[17] SummarizedExperiment_1.38.0 Biobase_2.68.0             
[19] GenomicRanges_1.60.0        GenomeInfoDb_1.44.0        
[21] IRanges_2.42.0              S4Vectors_0.46.0           
[23] BiocGenerics_0.54.0         generics_0.1.3             
[25] MatrixGenerics_1.20.0       matrixStats_1.5.0          
[27] BiocStyle_2.36.0            rebook_1.18.0              
loaded via a namespace (and not attached):
 [1] DBI_1.2.3                 bitops_1.0-9             
 [3] httr2_1.1.2               CodeDepends_0.6.6        
 [5] rlang_1.1.6               magrittr_2.0.3           
 [7] gypsum_1.4.0              compiler_4.5.0           
 [9] RSQLite_2.3.9             dir.expiry_1.16.0        
[11] DelayedMatrixStats_1.30.0 png_0.1-8                
[13] vctrs_0.6.5               ProtGenerics_1.40.0      
[15] pkgconfig_2.0.3           crayon_1.5.3             
[17] fastmap_1.2.0             dbplyr_2.5.0             
[19] XVector_0.48.0            Rsamtools_2.24.0         
[21] rmarkdown_2.29            graph_1.86.0             
[23] UCSC.utils_1.4.0          purrr_1.0.4              
[25] bit_4.6.0                 xfun_0.52                
[27] beachmat_2.24.0           cachem_1.1.0             
[29] jsonlite_2.0.0            blob_1.2.4               
[31] rhdf5filters_1.20.0       BiocParallel_1.42.0      
[33] Rhdf5lib_1.30.0           parallel_4.5.0           
[35] R6_2.6.1                  bslib_0.9.0              
[37] rtracklayer_1.68.0        jquerylib_0.1.4          
[39] Rcpp_1.0.14               bookdown_0.43            
[41] knitr_1.50                tidyselect_1.2.1         
[43] yaml_2.3.10               codetools_0.2-20         
[45] curl_6.2.2                lattice_0.22-7           
[47] tibble_3.2.1              withr_3.0.2              
[49] KEGGREST_1.48.0           evaluate_1.0.3           
[51] BiocFileCache_2.16.0      alabaster.schemas_1.8.0  
[53] ExperimentHub_2.16.0      Biostrings_2.76.0        
[55] pillar_1.10.2             BiocManager_1.30.25      
[57] filelock_1.0.3            RCurl_1.98-1.17          
[59] BiocVersion_3.21.1        sparseMatrixStats_1.20.0 
[61] alabaster.base_1.8.0      glue_1.8.0               
[63] alabaster.ranges_1.8.0    lazyeval_0.2.2           
[65] alabaster.matrix_1.8.0    tools_4.5.0              
[67] beachmat.hdf5_1.6.0       BiocIO_1.18.0            
[69] AnnotationHub_3.16.0      BiocNeighbors_2.2.0      
[71] GenomicAlignments_1.44.0  XML_3.99-0.18            
[73] grid_4.5.0                GenomeInfoDbData_1.2.14  
[75] restfulr_0.0.15           cli_3.6.4                
[77] rappdirs_0.3.3            dplyr_1.1.4              
[79] alabaster.se_1.8.0        sass_0.4.10              
[81] digest_0.6.37             rjson_0.2.23             
[83] memoise_2.0.1             htmltools_0.5.8.1        
[85] lifecycle_1.0.4           httr_1.4.7               
[87] mime_0.13                 bit64_4.6.0-1            Bibliography
Aran, D., A. P. Looney, L. Liu, E. Wu, V. Fong, A. Hsu, S. Chak, et al. 2019. “Reference-based analysis of lung single-cell sequencing reveals a transitional profibrotic macrophage.” Nat. Immunol. 20 (2): 163–72.
Mabbott, Neil A., J. K. Baillie, Helen Brown, Tom C. Freeman, and David A. Hume. 2013. “An expression atlas of human primary cells: Inference of gene function from coexpression networks.” BMC Genomics 14. https://doi.org/10.1186/1471-2164-14-632.
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.