1 Installation

if (!requireNamespace("BiocManager", quietly = TRUE))
    install.packages("BiocManager")
BiocManager::install("SingleCellMultiModal")

1.1 Load

library(SingleCellMultiModal)
library(MultiAssayExperiment)
library(scran)
library(scater)

2 Description

This data set consists of about 10K Peripheral Blood Mononuclear Cells (PBMCs) derived from a single healthy donor. It is available from the 10x Genomics website.

Provided are the RNA expression counts quantified at the gene level and the chromatin accessibility levels quantified at the peak level. Here we provide the default peaks called by the CellRanger software. If you want to explore other peak definitions or chromatin accessibility quantifications (at the promoter level, etc.), you have download the fragments.tsv.gz file from the 10x Genomics website.

3 Downloading datasets

The user can see the available dataset by using the default options

mae <- scMultiome("pbmc_10x", mode = "*", dry.run = FALSE, format = "MTX")
## Working on: pbmc_atac_se.rds
## Working on: pbmc_atac.mtx.gz
## Working on: pbmc_rna_se.rds
## Working on: pbmc_rna.mtx.gz
## Working on: pbmc_atac,
##  pbmc_rna
## see ?SingleCellMultiModal and browseVignettes('SingleCellMultiModal') for documentation
## loading from cache
## see ?SingleCellMultiModal and browseVignettes('SingleCellMultiModal') for documentation
## loading from cache
## Working on: pbmc_atac,
##  pbmc_rna
## see ?SingleCellMultiModal and browseVignettes('SingleCellMultiModal') for documentation
## loading from cache
## see ?SingleCellMultiModal and browseVignettes('SingleCellMultiModal') for documentation
## loading from cache
## Working on: pbmc_colData
## Working on: pbmc_sampleMap
## see ?SingleCellMultiModal and browseVignettes('SingleCellMultiModal') for documentation
## loading from cache
## see ?SingleCellMultiModal and browseVignettes('SingleCellMultiModal') for documentation
## loading from cache

4 Exploring the data structure

There are two assays: rna and atac, stored as SingleCellExperiment objects

mae
## A MultiAssayExperiment object of 2 listed
##  experiments with user-defined names and respective classes.
##  Containing an ExperimentList class object of length 2:
##  [1] atac: SingleCellExperiment with 108344 rows and 10032 columns
##  [2] rna: SingleCellExperiment with 36549 rows and 10032 columns
## Functionality:
##  experiments() - obtain the ExperimentList instance
##  colData() - the primary/phenotype DataFrame
##  sampleMap() - the sample coordination DataFrame
##  `$`, `[`, `[[` - extract colData columns, subset, or experiment
##  *Format() - convert into a long or wide DataFrame
##  assays() - convert ExperimentList to a SimpleList of matrices
##  exportClass() - save data to flat files

where the cells are the same in both assays:

upsetSamples(mae)

4.1 Cell metadata

Columns:

  • nCount_RNA: number of read counts
  • nFeature_RNA: number of genes with at least one read count
  • nCount_ATAC: number of ATAC read counts
  • nFeature_ATAC: number of ATAC peaks with at least one read count
  • celltype: The cell types have been annotated by the 10x Genomics R&D team using gene markers. They provide a rough characterisation of the cell type diversity, but keep in mind that they are not ground truth labels.
  • broad_celltype: Lymphoid or Myeloid origin

The cells have not been QC-ed, choosing a minimum number of genes/peaks per cell depends is left to you! In addition, there are further quality control criteria that you may want to apply, including mitochondrial coverage, fraction of reads overlapping ENCODE Blacklisted regions, Transcription start site enrichment, etc. See suggestions below for software that can perform a semi-automated quality control pipeline

head(colData(mae))
## DataFrame with 6 rows and 6 columns
##                  nCount_RNA nFeature_RNA nCount_ATAC nFeature_ATAC
##                   <integer>    <integer>   <integer>     <integer>
## AAACAGCCAAGGAATC       8380         3308       55582         13878
## AAACAGCCAATCCCTT       3771         1896       20495          7253
## AAACAGCCAATGCGCT       6876         2904       16674          6528
## AAACAGCCAGTAGGTG       7614         3061       39454         11633
## AAACAGCCAGTTTACG       3633         1691       20523          7245
## AAACAGCCATCCAGGT       7782         3028       22412          8602
##                                celltype broad_celltype
##                             <character>    <character>
## AAACAGCCAAGGAATC      naive CD4 T cells       Lymphoid
## AAACAGCCAATCCCTT     memory CD4 T cells       Lymphoid
## AAACAGCCAATGCGCT      naive CD4 T cells       Lymphoid
## AAACAGCCAGTAGGTG      naive CD4 T cells       Lymphoid
## AAACAGCCAGTTTACG     memory CD4 T cells       Lymphoid
## AAACAGCCATCCAGGT non-classical monocy..        Myeloid

4.2 RNA expression

The RNA expression consists of 36,549 genes and 10,032 cells, stored using the dgCMatrix sparse matrix format

dim(experiments(mae)[["rna"]])
## [1] 36549 10032
names(experiments(mae))
## [1] "atac" "rna"

Let’s do some standard dimensionality reduction plot:

sce.rna <- experiments(mae)[["rna"]]

# Normalisation
sce.rna <- logNormCounts(sce.rna)

# Feature selection
decomp <- modelGeneVar(sce.rna)
hvgs <- rownames(decomp)[decomp$mean>0.01 & decomp$p.value <= 0.05]
sce.rna <- sce.rna[hvgs,]

# PCA
sce.rna <- runPCA(sce.rna, ncomponents = 25)

# UMAP
set.seed(42)
sce.rna <- runUMAP(sce.rna, dimred="PCA", n_neighbors = 25, min_dist = 0.3)
plotUMAP(sce.rna, colour_by="celltype", point_size=0.5, point_alpha=1)

4.3 Chromatin Accessibility

The ATAC expression consists of 108,344 peaks and 10,032 cells:

dim(experiments(mae)[["atac"]])
## [1] 108344  10032

Let’s do some standard dimensionality reduction plot. Note that scATAC-seq data is sparser than scRNA-seq, almost binary. The log normalisation + PCA approach that scater implements for scRNA-seq is not a good strategy for scATAC-seq data. Topic modelling or TFIDF+SVD are a better strategy. Please see the package recommendations below.

sce.atac <- experiments(mae)[["atac"]]

# Normalisation
sce.atac <- logNormCounts(sce.atac)

# Feature selection
decomp <- modelGeneVar(sce.atac)
hvgs <- rownames(decomp)[decomp$mean>0.25]
sce.atac <- sce.atac[hvgs,]

# PCA
sce.atac <- runPCA(sce.atac, ncomponents = 25)

# UMAP
set.seed(42)
sce.atac <- runUMAP(sce.atac, dimred="PCA", n_neighbors = 25, min_dist = 0.3)
plotUMAP(sce.atac, colour_by="celltype", point_size=0.5, point_alpha=1)

5 Suggested software for the downstream analysis

These are my personal recommendations of R-based analysis software:

6 sessionInfo

sessionInfo()
## R version 4.3.1 (2023-06-16)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 22.04.3 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.18-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] scater_1.30.0               ggplot2_3.4.4              
##  [3] scran_1.30.0                scuttle_1.12.0             
##  [5] rhdf5_2.46.0                HDF5Array_1.30.0           
##  [7] RaggedExperiment_1.26.0     Matrix_1.6-1.1             
##  [9] SingleCellExperiment_1.24.0 SingleCellMultiModal_1.14.0
## [11] MultiAssayExperiment_1.28.0 SummarizedExperiment_1.32.0
## [13] Biobase_2.62.0              GenomicRanges_1.54.0       
## [15] GenomeInfoDb_1.38.0         IRanges_2.36.0             
## [17] S4Vectors_0.40.0            BiocGenerics_0.48.0        
## [19] MatrixGenerics_1.14.0       matrixStats_1.0.0          
## [21] BiocStyle_2.30.0           
## 
## loaded via a namespace (and not attached):
##   [1] jsonlite_1.8.7                magrittr_2.0.3               
##   [3] ggbeeswarm_0.7.2              magick_2.8.1                 
##   [5] farver_2.1.1                  rmarkdown_2.25               
##   [7] zlibbioc_1.48.0               vctrs_0.6.4                  
##   [9] memoise_2.0.1                 DelayedMatrixStats_1.24.0    
##  [11] RCurl_1.98-1.12               htmltools_0.5.6.1            
##  [13] S4Arrays_1.2.0                BiocBaseUtils_1.4.0          
##  [15] AnnotationHub_3.10.0          curl_5.1.0                   
##  [17] BiocNeighbors_1.20.0          Rhdf5lib_1.24.0              
##  [19] SparseArray_1.2.0             sass_0.4.7                   
##  [21] bslib_0.5.1                   plyr_1.8.9                   
##  [23] cachem_1.0.8                  igraph_1.5.1                 
##  [25] mime_0.12                     lifecycle_1.0.3              
##  [27] pkgconfig_2.0.3               rsvd_1.0.5                   
##  [29] R6_2.5.1                      fastmap_1.1.1                
##  [31] GenomeInfoDbData_1.2.11       shiny_1.7.5.1                
##  [33] digest_0.6.33                 colorspace_2.1-0             
##  [35] AnnotationDbi_1.64.0          dqrng_0.3.1                  
##  [37] irlba_2.3.5.1                 ExperimentHub_2.10.0         
##  [39] RSQLite_2.3.1                 beachmat_2.18.0              
##  [41] labeling_0.4.3                filelock_1.0.2               
##  [43] fansi_1.0.5                   httr_1.4.7                   
##  [45] abind_1.4-5                   compiler_4.3.1               
##  [47] bit64_4.0.5                   withr_2.5.1                  
##  [49] BiocParallel_1.36.0           viridis_0.6.4                
##  [51] DBI_1.1.3                     UpSetR_1.4.0                 
##  [53] rappdirs_0.3.3                DelayedArray_0.28.0          
##  [55] rjson_0.2.21                  bluster_1.12.0               
##  [57] tools_4.3.1                   vipor_0.4.5                  
##  [59] beeswarm_0.4.0                interactiveDisplayBase_1.40.0
##  [61] httpuv_1.6.12                 glue_1.6.2                   
##  [63] rhdf5filters_1.14.0           promises_1.2.1               
##  [65] grid_4.3.1                    cluster_2.1.4                
##  [67] generics_0.1.3                gtable_0.3.4                 
##  [69] BiocSingular_1.18.0           ScaledMatrix_1.10.0          
##  [71] metapod_1.10.0                utf8_1.2.4                   
##  [73] XVector_0.42.0                RcppAnnoy_0.0.21             
##  [75] ggrepel_0.9.4                 BiocVersion_3.18.0           
##  [77] pillar_1.9.0                  limma_3.58.0                 
##  [79] later_1.3.1                   dplyr_1.1.3                  
##  [81] BiocFileCache_2.10.0          lattice_0.22-5               
##  [83] bit_4.0.5                     tidyselect_1.2.0             
##  [85] locfit_1.5-9.8                Biostrings_2.70.1            
##  [87] knitr_1.44                    gridExtra_2.3                
##  [89] bookdown_0.36                 edgeR_4.0.0                  
##  [91] xfun_0.40                     statmod_1.5.0                
##  [93] yaml_2.3.7                    evaluate_0.22                
##  [95] codetools_0.2-19              tibble_3.2.1                 
##  [97] BiocManager_1.30.22           cli_3.6.1                    
##  [99] uwot_0.1.16                   xtable_1.8-4                 
## [101] munsell_0.5.0                 jquerylib_0.1.4              
## [103] Rcpp_1.0.11                   dbplyr_2.3.4                 
## [105] png_0.1-8                     parallel_4.3.1               
## [107] ellipsis_0.3.2                blob_1.2.4                   
## [109] sparseMatrixStats_1.14.0      bitops_1.0-7                 
## [111] SpatialExperiment_1.12.0      viridisLite_0.4.2            
## [113] scales_1.2.1                  purrr_1.0.2                  
## [115] crayon_1.5.2                  rlang_1.1.1                  
## [117] cowplot_1.1.1                 KEGGREST_1.42.0              
## [119] formatR_1.14