1 Overview

The celldex package provides convenient access to several cell type reference datasets. Most of these references are derived from bulk RNA-seq or microarray data of cell populations that (hopefully) consist of a pure cell type after sorting and/or culturing. The aim is to provide a common resource for further analysis like cell type annotation of single cell expression data or deconvolution of cell type proportions in bulk expression datasets.

Each dataset contains a log-normalized expression matrix that is intended to be comparable to log-UMI counts from common single-cell protocols (Aran et al. 2019) or gene length-adjusted values from bulk datasets. By default, gene annotation is returned in terms of gene symbols, but they can be coerced to Ensembl annotation with ensembl=TRUE for more robust cross-referencing across studies.

Typically, each reference provides three levels of cell type annotation in its column metadata:

  • label.main, broad annotation that defines the major cell types. This has few unique levels that allows for fast annotation but at low resolution.
  • label.fine, fine-grained annotation that defines subtypes or states. This has more unique levels that results in slower annotation but at much higher resolution.
  • label.ont, fine-grained annotation mapped to the standard vocabulary in the Cell Ontology. This enables synchronization of labels across references as well as dynamic adjustment of the resolution.

2 Finding references

We can examine the available references using the surveyReferences() function. This returns a DataFrame of the reference’s name and version, along with additional information like the title, description, species, number of samples, available labels, and so on.

library(celldex)
surveyReferences()
## DataFrame with 7 rows and 10 columns
##                     name     version        path                  title
##              <character> <character> <character>            <character>
## 1                 immgen  2024-02-26          NA Mouse microarray exp..
## 2       blueprint_encode  2024-02-26          NA Human bulk RNA-seq d..
## 3                   dice  2024-02-26          NA Human bulk RNA-seq d..
## 4                   hpca  2024-02-26          NA Microarray data from..
## 5          monaco_immune  2024-02-26          NA Human bulk RNA-seq d..
## 6           mouse_rnaseq  2024-02-26          NA Bulk RNA-seq data of..
## 7 novershtern_hematopo..  2024-02-26          NA Bulk microarray expr..
##              description taxonomy_id  genome   samples
##              <character>      <List>  <List> <integer>
## 1 Mouse microarray exp..       10090               830
## 2 Human bulk RNA-seq d..        9606               259
## 3 Human bulk RNA-seq d..        9606              1561
## 4 Microarray data from..        9606               713
## 5 Human bulk RNA-seq d..        9606  GRCh38       114
## 6 Bulk RNA-seq data of..       10090 MGSCv37       358
## 7 Bulk microarray expr..        9606               211
##                            labels
##                            <List>
## 1 label.main,label.fine,label.ont
## 2 label.main,label.fine,label.ont
## 3 label.main,label.fine,label.ont
## 4 label.main,label.fine,label.ont
## 5 label.main,label.fine,label.ont
## 6 label.main,label.fine,label.ont
## 7 label.main,label.fine,label.ont
##                                                                                sources
##                                                                   <SplitDataFrameList>
## 1                                   PubMed:18800157:NA,GEO:GSE15907:NA,GEO:GSE37448:NA
## 2                             PubMed:22955616:NA,PubMed:24091925:NA,PubMed:30643263:NA
## 3                   PubMed:30449622:NA,ExperimentHub:EH3488:NA,ExperimentHub:EH3489:NA
## 4 PubMed:24053356:NA,PubMed:30643263:NA,GitHub:dviraran/SingleR:adc4a0e4d5cfa79db18f..
## 5                          PubMed:30726743:NA,GEO:GSE107011:NA,ExperimentHub:EH3496:NA
## 6                  PubMed:30858345:NA,URL:https://github.com/B..:NA,PubMed:30643263:NA
## 7                           PubMed:21241896:NA,GEO:GSE24759:NA,ExperimentHub:EH3490:NA

Alternatively, users can search the text of each reference’s metadata to identify relevant datasets. This may require some experimentation as it depends on the level of detail in the metadata supplied by the uploader.

searchReferences("B cell")
## DataFrame with 4 rows and 10 columns
##                     name     version        path                  title
##              <character> <character> <character>            <character>
## 1                   dice  2024-02-26          NA Human bulk RNA-seq d..
## 2          monaco_immune  2024-02-26          NA Human bulk RNA-seq d..
## 3           mouse_rnaseq  2024-02-26          NA Bulk RNA-seq data of..
## 4 novershtern_hematopo..  2024-02-26          NA Bulk microarray expr..
##              description taxonomy_id  genome   samples
##              <character>      <List>  <List> <integer>
## 1 Human bulk RNA-seq d..        9606              1561
## 2 Human bulk RNA-seq d..        9606  GRCh38       114
## 3 Bulk RNA-seq data of..       10090 MGSCv37       358
## 4 Bulk microarray expr..        9606               211
##                            labels
##                            <List>
## 1 label.main,label.fine,label.ont
## 2 label.main,label.fine,label.ont
## 3 label.main,label.fine,label.ont
## 4 label.main,label.fine,label.ont
##                                                               sources
##                                                  <SplitDataFrameList>
## 1  PubMed:30449622:NA,ExperimentHub:EH3488:NA,ExperimentHub:EH3489:NA
## 2         PubMed:30726743:NA,GEO:GSE107011:NA,ExperimentHub:EH3496:NA
## 3 PubMed:30858345:NA,URL:https://github.com/B..:NA,PubMed:30643263:NA
## 4          PubMed:21241896:NA,GEO:GSE24759:NA,ExperimentHub:EH3490:NA
searchReferences(
    defineTextQuery("immun%", partial=TRUE) & 
    defineTextQuery("10090", field="taxonomy_id")
)
## DataFrame with 1 row and 10 columns
##          name     version        path                  title
##   <character> <character> <character>            <character>
## 1      immgen  2024-02-26          NA Mouse microarray exp..
##              description taxonomy_id genome   samples
##              <character>      <List> <List> <integer>
## 1 Mouse microarray exp..       10090              830
##                            labels
##                            <List>
## 1 label.main,label.fine,label.ont
##                                              sources
##                                 <SplitDataFrameList>
## 1 PubMed:18800157:NA,GEO:GSE15907:NA,GEO:GSE37448:NA

Keep in mind that the search results are not guaranteed to be reproducible - more datasets may be added over time, and existing datasets may be updated with new versions. Once a dataset of interest is identified, users should explicitly list the name and version of the dataset in their scripts to ensure reproducibility.

3 General-purpose references

3.1 Human primary cell atlas (HPCA)

The HPCA reference consists of publicly available microarray datasets derived from human primary cells (Mabbott et al. 2013). Most of the labels refer to blood subpopulations but cell types from other tissues are also available.

library(celldex)
ref <- fetchReference("hpca", "2024-02-26")

This reference also contains many cells and cell lines that have been treated or collected from pathogenic conditions.

3.2 Blueprint/ENCODE

The Blueprint/ENCODE reference consists of bulk RNA-seq data for pure stroma and immune cells generated by Blueprint (Martens and Stunnenberg 2013) and ENCODE projects (The ENCODE Project Consortium 2012).

ref <- fetchReference("blueprint_encode", "2024-02-26")

This reference is best suited to mixed samples that do not require fine resolution, and is particularly suited for situations where easily interpretable labels are required quickly. It provides decent immune cell granularity, though it does not contain finer monocyte and dendritic cell subtypes.

3.3 Mouse RNA-seq

This reference consists of a collection of mouse bulk RNA-seq data sets downloaded from the gene expression omnibus (Benayoun et al. 2019). A variety of cell types are available, again mostly from blood but also covering several other tissues.

ref <- fetchReference("mouse_rnaseq", "2024-02-26")

This reference is best suited to bulk tissue samples from brain, blood, or heart where low-resolution labels are adequate.

4 Immune references

4.1 Immunological Genome Project (ImmGen)

The ImmGen reference consists of microarray profiles of pure mouse immune cells from the project of the same name (Heng et al. 2008). This is currently the most highly resolved immune reference - possibly overwhelmingly so, given the granularity of the fine labels.

ref <- fetchReference("immgen", "2024-02-26")

This reference provides exhaustive coverage of a dizzying number of cell subtypes. However, this can be a double-edged sword as the high resolution can be difficult to interpret, especially for samples derived from experimental conditions that are not of interest. Users may want to remove certain samples themselves depending on the use case.

4.2 Database of Immune Cell Expression/eQTLs/Epigenomics (DICE)

The DICE reference consists of bulk RNA-seq samples of sorted cell populations from the project of the same name (Schmiedel et al. 2018).

ref <- fetchReference("dice", "2024-02-26")

This reference is particularly useful to those interested in CD4+ T cell subsets, though the lack of CD4+ central memory and effector memory samples may decrease accuracy in some cases. In addition, the lack of dendritic cells and a single B cell subset may result in those populations being improperly labeled or having their label pruned in a typical PBMC sample.

4.3 Novershtern hematopoietic data

The Novershtern reference (previously known as Differentiation Map) consists of microarray datasets for sorted hematopoietic cell populations from GSE24759 (Novershtern et al. 2011).

ref <- fetchReference("novershtern_hematopoietic", "2024-02-26")

This reference provides the greatest resolution for myeloid and progenitor cells among the human immune references. It has fewer T cell subsets than the other immune references but contains many more NK, erythroid, and granulocytic subsets. It is likely the best option for bone marrow samples.

4.4 Monaco immune data

The Monaco reference consists of bulk RNA-seq samples of sorted immune cell populations from GSE107011 (Monaco et al. 2019).

ref <- fetchReference("monaco_immune", "2024-02-26")

This is the human immune reference that best covers all of the bases for a typical PBMC sample. It provides expansive B and T cell subsets, differentiates between classical and non-classical monocytes, includes basic dendritic cell subsets, and also includes neutrophil and basophil samples to help identify small contaminating populations that may have slipped into a PBMC preparation.

5 Adding new references

Want to contribute your own reference dataset to this package? It’s easy! Just follow these simple steps for instant fame and prestige.

  1. Obtain log-normalized expression values and cell type labels. While not strictly required, we recommend trying to organize the labels into label.fine, label.main and label.ont, so that users have a consistent experience with your reference. Let’s just make up something here.

    norm <- matrix(runif(1000), ncol=20)
    rownames(norm) <- sprintf("GENE_%i", seq_len(nrow(norm)))
    
    labels <- DataFrame(label.main=rep(LETTERS[1:5], each=4))
    labels$label.fine <- sprintf("%s%i", labels$label.main, rep(c(1, 1, 2, 2), 5))
    labels$label.ont <- sprintf("CL:000%i", rep(1:5, each=4))
  2. Assemble the metadata for your dataset. This should be a list structured as specified in the Bioconductor metadata schema. Check out some examples from fetchMetadata() - note that the application.takane property will be automatically added later, and so can be omitted from the list that you create.

    meta <- list(
        title="My reference",
        description="This is my reference dataset",
        taxonomy_id="10090",
        genome="GRCh38",
        sources=list(
            list(provider="GEO", id="GSE12345"),
            list(provider="PubMed", id="1234567")
        ),
        maintainer_name="Chihaya Kisaragi",
        maintainer_email="kisaragi.chihaya@765pro.com"
    )
  3. Save your normalized expression matrix and labels to disk with saveReference(). This saves the dataset into a “staging directory” using language-agnostic file formats - check out the alabaster framework for more details. In more complex cases involving multiple datasets, users may save each dataset into a subdirectory of the staging directory.

    # Simple case: you only have one dataset to upload.
    staging <- tempfile()
    saveReference(norm, labels, staging, meta)
    list.files(staging, recursive=TRUE)
    ## [1] "OBJECT"                       "_bioconductor.json"          
    ## [3] "assays/0/OBJECT"              "assays/0/array.h5"           
    ## [5] "assays/names.json"            "column_data/OBJECT"          
    ## [7] "column_data/basic_columns.h5" "row_data/OBJECT"             
    ## [9] "row_data/basic_columns.h5"
    # Complex case: you have multiple subdatasets to upload.
    staging <- tempfile()
    dir.create(staging)
    saveReference(norm, labels, file.path(staging, "foo"), meta)
    saveReference(norm, labels, file.path(staging, "bar"), meta) # and so on.

    You can check that everything was correctly saved by reloading the on-disk data into the R session for inspection. This yields a SummarizedExperiment with the log-expression matrix in the assay named "logcounts".

    alabaster.base::readObject(file.path(staging, "foo"))
    ## class: SummarizedExperiment 
    ## dim: 50 20 
    ## metadata(0):
    ## assays(1): logcounts
    ## rownames(50): GENE_1 GENE_2 ... GENE_49 GENE_50
    ## rowData names(0):
    ## colnames: NULL
    ## colData names(3): label.main label.fine label.ont
  4. Open a pull request (PR) for the addition of a new reference. You will need to provide a few things here:

    • The name of your dataset. This should be short enough to type yet distinct from the existing references.
    • The version of your dataset. This is usually just the current date… or whenever you started putting together the dataset for upload. The exact date doesn’t really matter as long as we can establish a timeline for later versions.
    • The code used to assemble the reference dataset as an Rmarkdown file. This should be added to the scripts/ directory of this package, in order to provide some record of how the dataset was created.
  5. Wait for us to grant temporary upload permissions to your GitHub account.

  6. Upload your staging directory to gypsum backend with gypsum::uploadDirectory(). On the first call to this function, it will automatically prompt you to log into GitHub so that the backend can authenticate you. If you are on a system without browser access (e.g., most computing clusters), a token can be manually supplied via gypsum::setAccessToken().

    gypsum::uploadDirectory(staging, "celldex", "my_dataset_name", "my_version")

    You can check that everything was successfully uploaded by just calling fetchReference():

    fetchReference("my_dataset_name", "my_version")

    If you realized you made a mistake, no worries. Use the following call to clear the erroneous dataset, and try again:

    gypsum::rejectProbation("scRNAseq", "my_dataset_name", "my_version")
  7. Comment on the PR to notify us that the dataset has finished uploading and you’re happy with it. We’ll review it and make sure everything’s in order. If some fixes are required, we’ll just clear the dataset so that you can upload a new version with the necessary changes. Otherwise, we’ll approve the dataset. Note that once a version of a dataset is approved, no further changes can be made to that version; you’ll have to upload a new version if you want to modify something.

Session information

sessionInfo()
## R Under development (unstable) (2024-01-16 r85808)
## 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] celldex_1.13.2              SummarizedExperiment_1.33.3
##  [3] Biobase_2.63.0              GenomicRanges_1.55.3       
##  [5] GenomeInfoDb_1.39.7         IRanges_2.37.1             
##  [7] S4Vectors_0.41.4            BiocGenerics_0.49.1        
##  [9] MatrixGenerics_1.15.0       matrixStats_1.2.0          
## [11] BiocStyle_2.31.0           
## 
## loaded via a namespace (and not attached):
##  [1] tidyselect_1.2.0          jsonvalidate_1.3.2       
##  [3] alabaster.se_1.3.4        dplyr_1.1.4              
##  [5] blob_1.2.4                filelock_1.0.3           
##  [7] Biostrings_2.71.2         fastmap_1.1.1            
##  [9] BiocFileCache_2.11.1      digest_0.6.34            
## [11] lifecycle_1.0.4           ellipsis_0.3.2           
## [13] alabaster.matrix_1.3.13   KEGGREST_1.43.0          
## [15] alabaster.base_1.3.20     RSQLite_2.3.5            
## [17] magrittr_2.0.3            compiler_4.4.0           
## [19] rlang_1.1.3               sass_0.4.8               
## [21] tools_4.4.0               utf8_1.2.4               
## [23] yaml_2.3.8                knitr_1.45               
## [25] htmlwidgets_1.6.4         S4Arrays_1.3.6           
## [27] bit_4.0.5                 curl_5.2.1               
## [29] aws.signature_0.6.0       DelayedArray_0.29.9      
## [31] xml2_1.3.6                abind_1.4-5              
## [33] HDF5Array_1.31.6          gypsum_0.99.11           
## [35] grid_4.4.0                fansi_1.0.6              
## [37] ExperimentHub_2.11.1      Rhdf5lib_1.25.1          
## [39] cli_3.6.2                 rmarkdown_2.25           
## [41] crayon_1.5.2              generics_0.1.3           
## [43] httr_1.4.7                DelayedMatrixStats_1.25.1
## [45] DBI_1.2.2                 cachem_1.0.8             
## [47] rhdf5_2.47.4              zlibbioc_1.49.0          
## [49] parallel_4.4.0            AnnotationDbi_1.65.2     
## [51] BiocManager_1.30.22       XVector_0.43.1           
## [53] alabaster.schemas_1.3.1   base64enc_0.1-3          
## [55] vctrs_0.6.5               V8_4.4.2                 
## [57] Matrix_1.6-5              jsonlite_1.8.8           
## [59] bookdown_0.38             bit64_4.0.5              
## [61] crosstalk_1.2.1           alabaster.ranges_1.3.3   
## [63] jquerylib_0.1.4           glue_1.7.0               
## [65] DT_0.32                   BiocVersion_3.19.1       
## [67] aws.s3_0.3.21             tibble_3.2.1             
## [69] pillar_1.9.0              rappdirs_0.3.3           
## [71] htmltools_0.5.7           rhdf5filters_1.15.2      
## [73] GenomeInfoDbData_1.2.11   R6_2.5.1                 
## [75] dbplyr_2.4.0              httr2_1.0.0              
## [77] sparseMatrixStats_1.15.0  evaluate_0.23            
## [79] lattice_0.22-5            AnnotationHub_3.11.1     
## [81] png_0.1-8                 memoise_2.0.1            
## [83] bslib_0.6.1               Rcpp_1.0.12              
## [85] SparseArray_1.3.4         xfun_0.42                
## [87] pkgconfig_2.0.3

References

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.

Benayoun, Bérénice A., Elizabeth A. Pollina, Param Priya Singh, Salah Mahmoudi, Itamar Harel, Kerriann M. Casey, Ben W. Dulken, Anshul Kundaje, and Anne Brunet. 2019. “Remodeling of epigenome and transcriptome landscapes with aging in mice reveals widespread induction of inflammatory responses.” Genome Research 29: 697–709. https://doi.org/10.1101/gr.240093.118.

Heng, Tracy S. P., Michio W. Painter, Kutlu Elpek, Veronika Lukacs-Kornek, Nora Mauermann, Shannon J. Turley, Daphne Koller, et al. 2008. “The immunological genome project: Networks of gene expression in immune cells.” Nature Immunology 9 (10): 1091–4. https://doi.org/10.1038/ni1008-1091.

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.

Martens, Joost H A, and Hendrik G. Stunnenberg. 2013. “BLUEPRINT: Mapping human blood cell epigenomes.” Haematologica 98: 1487–9. https://doi.org/10.3324/haematol.2013.094243.

Monaco, Gianni, Bernett Lee, Weili Xu, Seri Mustafah, You Yi Hwang, Christophe Carré, Nicolas Burdin, et al. 2019. “RNA-Seq Signatures Normalized by mRNA Abundance Allow Absolute Deconvolution of Human Immune Cell Types.” Cell Reports 26 (6): 1627–1640.e7. https://doi.org/10.1016/j.celrep.2019.01.041.

Novershtern, Noa, Aravind Subramanian, Lee N. Lawton, Raymond H. Mak, W. Nicholas Haining, Marie E. McConkey, Naomi Habib, et al. 2011. “Densely Interconnected Transcriptional Circuits Control Cell States in Human Hematopoiesis.” Cell 144 (2): 296–309. https://doi.org/10.1016/j.cell.2011.01.004.

Schmiedel, Benjamin J., Divya Singh, Ariel Madrigal, Alan G. Valdovino-Gonzalez, Brandie M. White, Jose Zapardiel-Gonzalo, Brendan Ha, et al. 2018. “Impact of Genetic Polymorphisms on Human Immune Cell Gene Expression.” Cell 175 (6): 1701–1715.e16. https://doi.org/10.1016/j.cell.2018.10.022.

The ENCODE Project Consortium. 2012. “An integrated encyclopedia of DNA elements in the human genome.” Nature. https://doi.org/10.1038/nature11247.