Chapter 9 Mouse HSC (multiple technologies)
9.1 Introduction
The blood is probably the most well-studied tissue in the single-cell field, mostly because everything is already dissociated “for free”. Of particular interest has been the use of single-cell genomics to study cell fate decisions in haematopoeisis. Indeed, it was not long ago that dueling interpretations of haematopoeitic stem cell (HSC) datasets were a mainstay of single-cell conferences. Sadly, these times have mostly passed so we will instead entertain ourselves by combining a small number of these datasets into a single analysis.
9.2 Data loading
#--- data-loading ---#
library(scRNAseq)
sce.nest <- NestorowaHSCData()
#--- gene-annotation ---#
library(AnnotationHub)
ens.mm.v97 <- AnnotationHub()[["AH73905"]]
anno <- select(ens.mm.v97, keys=rownames(sce.nest), 
    keytype="GENEID", columns=c("SYMBOL", "SEQNAME"))
rowData(sce.nest) <- anno[match(rownames(sce.nest), anno$GENEID),]
#--- quality-control ---#
library(scater)
stats <- perCellQCMetrics(sce.nest)
qc <- quickPerCellQC(stats, percent_subsets="altexps_ERCC_percent")
sce.nest <- sce.nest[,!qc$discard]
#--- normalization ---#
library(scran)
set.seed(101000110)
clusters <- quickCluster(sce.nest)
sce.nest <- computeSumFactors(sce.nest, clusters=clusters)
sce.nest <- logNormCounts(sce.nest)
#--- variance-modelling ---#
set.seed(00010101)
dec.nest <- modelGeneVarWithSpikes(sce.nest, "ERCC")
top.nest <- getTopHVGs(dec.nest, prop=0.1)## class: SingleCellExperiment 
## dim: 46078 1656 
## metadata(0):
## assays(2): counts logcounts
## rownames(46078): ENSMUSG00000000001 ENSMUSG00000000003 ...
##   ENSMUSG00000107391 ENSMUSG00000107392
## rowData names(3): GENEID SYMBOL SEQNAME
## colnames(1656): HSPC_025 HSPC_031 ... Prog_852 Prog_810
## colData names(3): cell.type FACS sizeFactor
## reducedDimNames(1): diffusion
## mainExpName: endogenous
## altExpNames(1): ERCCThe Grun dataset requires a little bit of subsetting and re-analysis to only consider the sorted HSCs.
#--- data-loading ---#
library(scRNAseq)
sce.grun.hsc <- GrunHSCData(ensembl=TRUE)
#--- gene-annotation ---#
library(AnnotationHub)
ens.mm.v97 <- AnnotationHub()[["AH73905"]]
anno <- select(ens.mm.v97, keys=rownames(sce.grun.hsc), 
    keytype="GENEID", columns=c("SYMBOL", "SEQNAME"))
rowData(sce.grun.hsc) <- anno[match(rownames(sce.grun.hsc), anno$GENEID),]
#--- quality-control ---#
library(scuttle)
stats <- perCellQCMetrics(sce.grun.hsc)
qc <- quickPerCellQC(stats, batch=sce.grun.hsc$protocol,
    subset=grepl("sorted", sce.grun.hsc$protocol))
sce.grun.hsc <- sce.grun.hsc[,!qc$discard]library(scuttle)
sce.grun.hsc <- sce.grun.hsc[,sce.grun.hsc$protocol=="sorted hematopoietic stem cells"]
sce.grun.hsc <- logNormCounts(sce.grun.hsc)
set.seed(11001)
library(scran)
dec.grun.hsc <- modelGeneVarByPoisson(sce.grun.hsc) Finally, we will grab the Paul dataset, which we will also subset to only consider the unsorted myeloid population. This removes the various knockout conditions that just complicates matters.
#--- data-loading ---#
library(scRNAseq)
sce.paul <- PaulHSCData(ensembl=TRUE)
#--- gene-annotation ---#
library(AnnotationHub)
ens.mm.v97 <- AnnotationHub()[["AH73905"]]
anno <- select(ens.mm.v97, keys=rownames(sce.paul), 
    keytype="GENEID", columns=c("SYMBOL", "SEQNAME"))
rowData(sce.paul) <- anno[match(rownames(sce.paul), anno$GENEID),]
#--- quality-control ---#
library(scater)
stats <- perCellQCMetrics(sce.paul) 
qc <- quickPerCellQC(stats, batch=sce.paul$Plate_ID)
# Detecting batches with unusually low threshold values.
lib.thresholds <- attr(qc$low_lib_size, "thresholds")["lower",]
nfeat.thresholds <- attr(qc$low_n_features, "thresholds")["lower",]
ignore <- union(names(lib.thresholds)[lib.thresholds < 100],
    names(nfeat.thresholds)[nfeat.thresholds < 100])
# Repeating the QC using only the "high-quality" batches.
qc2 <- quickPerCellQC(stats, batch=sce.paul$Plate_ID,
    subset=!sce.paul$Plate_ID %in% ignore)
sce.paul <- sce.paul[,!qc2$discard]9.3 Setting up the merge
common <- Reduce(intersect, list(rownames(sce.nest),
    rownames(sce.grun.hsc), rownames(sce.paul)))
length(common)## [1] 17147Combining variances to obtain a single set of HVGs.
combined.dec <- combineVar(
    dec.nest[common,], 
    dec.grun.hsc[common,], 
    dec.paul[common,]
)
hvgs <- getTopHVGs(combined.dec, n=5000)Adjusting for gross differences in sequencing depth.
9.4 Merging the datasets
We turn on auto.merge=TRUE to instruct fastMNN() to merge the batch that offers the largest number of MNNs.
This aims to perform the “easiest” merges first, i.e., between the most replicate-like batches,
before tackling merges between batches that have greater differences in their population composition.
Not too much variance lost inside each batch, hopefully. We also observe that the algorithm chose to merge the more diverse Nestorowa and Paul datasets before dealing with the HSC-only Grun dataset.
## DataFrame with 2 rows and 3 columns
##             left     right                        lost.var
##           <List>    <List>                        <matrix>
## 1           Paul Nestorowa 0.01069374:0.0000000:0.00739465
## 2 Paul,Nestorowa      Grun 0.00562344:0.0178334:0.007026159.5 Combined analyses
The Grun dataset does not contribute to many clusters, consistent with a pure undifferentiated HSC population. Most of the other clusters contain contributions from the Nestorowa and Paul datasets, though some are unique to the Paul dataset. This may be due to incomplete correction though we tend to think that this are Paul-specific subpopulations, given that the Nestorowa dataset does not have similarly sized unique clusters that might represent their uncorrected counterparts.
library(bluster)
colLabels(merged) <- clusterRows(reducedDim(merged), 
    NNGraphParam(cluster.fun="louvain"))
table(Cluster=colLabels(merged), Batch=merged$batch)##        Batch
## Cluster Grun Nestorowa Paul
##      1     0        40  206
##      2     0        19    0
##      3    39       353  146
##      4     0         6   29
##      5     0       217  487
##      6     0       162  522
##      7     0       133  191
##      8    22       411   94
##      9   230       315  348
##      10    0         0  385
##      11    0         0  397While I prefer \(t\)-SNE plots, we’ll switch to a UMAP plot to highlight some of the trajectory-like structure across clusters (Figure 9.1).
library(scater)
set.seed(101010101)
merged <- runUMAP(merged, dimred="corrected")
gridExtra::grid.arrange(
    plotUMAP(merged, colour_by="label"),
    plotUMAP(merged, colour_by="batch"),
    ncol=2
) 
Figure 9.1: Obligatory UMAP plot of the merged HSC datasets, where each point represents a cell and is colored by the batch of origin (left) or its assigned cluster (right).
In fact, we might as well compute a trajectory right now. TSCAN constructs a reasonable minimum spanning tree but the path choices are somewhat incongruent with the UMAP coordinates (Figure 9.2). This is most likely due to the fact that TSCAN operates on cluster centroids, which is simple and efficient but does not consider the variance of cells within each cluster. It is entirely possible for two well-separated clusters to be closer than two adjacent clusters if the latter span a wider region of the coordinate space.
common.pseudo <- averagePseudotime(pseudo.out$ordering)
plotUMAP(merged, colour_by=I(common.pseudo), 
        text_by="label", text_colour="red") +
    geom_line(data=pseudo.out$connected$UMAP, 
        mapping=aes(x=dim1, y=dim2, group=edge)) 
Figure 9.2: Another UMAP plot of the merged HSC datasets, where each point represents a cell and is colored by its TSCAN pseudotime. The lines correspond to the edges of the MST across cluster centers.
To fix this, we construct the minimum spanning tree using distances based on pairs of mutual nearest neighbors between clusters. This focuses on the closeness of the boundaries of each pair of clusters rather than their centroids, ensuring that adjacent clusters are connected even if their centroids are far apart. Doing so yields a trajectory that is more consistent with the visual connections on the UMAP plot (Figure 9.3).
pseudo.out2 <- quickPseudotime(merged, use.dimred="corrected", 
    dist.method="mnn", outgroup=TRUE)
common.pseudo2 <- averagePseudotime(pseudo.out2$ordering)
plotUMAP(merged, colour_by=I(common.pseudo2), 
        text_by="label", text_colour="red") +
    geom_line(data=pseudo.out2$connected$UMAP, 
        mapping=aes(x=dim1, y=dim2, group=edge)) 
Figure 9.3: Yet another UMAP plot of the merged HSC datasets, where each point represents a cell and is colored by its TSCAN pseudotime. The lines correspond to the edges of the MST across cluster centers.
Session Info
R version 4.1.0 beta (2021-05-03 r80259)
Platform: x86_64-pc-linux-gnu (64-bit)
Running under: Ubuntu 20.04.2 LTS
Matrix products: default
BLAS:   /home/biocbuild/bbs-3.14-bioc/R/lib/libRblas.so
LAPACK: /home/biocbuild/bbs-3.14-bioc/R/lib/libRlapack.so
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       
attached base packages:
[1] parallel  stats4    stats     graphics  grDevices utils     datasets 
[8] methods   base     
other attached packages:
 [1] TSCAN_1.31.0                TrajectoryUtils_1.1.0      
 [3] scater_1.21.0               ggplot2_3.3.3              
 [5] bluster_1.3.0               batchelor_1.9.0            
 [7] scran_1.21.1                scuttle_1.3.0              
 [9] SingleCellExperiment_1.15.1 SummarizedExperiment_1.23.0
[11] Biobase_2.53.0              GenomicRanges_1.45.0       
[13] GenomeInfoDb_1.29.0         IRanges_2.27.0             
[15] S4Vectors_0.31.0            BiocGenerics_0.39.0        
[17] MatrixGenerics_1.5.0        matrixStats_0.58.0         
[19] BiocStyle_2.21.0            rebook_1.3.0               
loaded via a namespace (and not attached):
  [1] ggbeeswarm_0.6.0          colorspace_2.0-1         
  [3] ellipsis_0.3.2            mclust_5.4.7             
  [5] XVector_0.33.0            BiocNeighbors_1.11.0     
  [7] farver_2.1.0              fansi_0.4.2              
  [9] splines_4.1.0             codetools_0.2-18         
 [11] sparseMatrixStats_1.5.0   knitr_1.33               
 [13] jsonlite_1.7.2            ResidualMatrix_1.3.0     
 [15] cluster_2.1.2             graph_1.71.0             
 [17] uwot_0.1.10               shiny_1.6.0              
 [19] BiocManager_1.30.15       compiler_4.1.0           
 [21] dqrng_0.3.0               fastmap_1.1.0            
 [23] assertthat_0.2.1          Matrix_1.3-3             
 [25] limma_3.49.0              later_1.2.0              
 [27] BiocSingular_1.9.0        htmltools_0.5.1.1        
 [29] tools_4.1.0               rsvd_1.0.5               
 [31] igraph_1.2.6              gtable_0.3.0             
 [33] glue_1.4.2                GenomeInfoDbData_1.2.6   
 [35] dplyr_1.0.6               rappdirs_0.3.3           
 [37] Rcpp_1.0.6                jquerylib_0.1.4          
 [39] vctrs_0.3.8               nlme_3.1-152             
 [41] DelayedMatrixStats_1.15.0 xfun_0.23                
 [43] stringr_1.4.0             beachmat_2.9.0           
 [45] mime_0.10                 lifecycle_1.0.0          
 [47] irlba_2.3.3               gtools_3.8.2             
 [49] statmod_1.4.36            XML_3.99-0.6             
 [51] edgeR_3.35.0              zlibbioc_1.39.0          
 [53] scales_1.1.1              promises_1.2.0.1         
 [55] yaml_2.2.1                gridExtra_2.3            
 [57] sass_0.4.0                fastICA_1.2-2            
 [59] stringi_1.6.2             highr_0.9                
 [61] ScaledMatrix_1.1.0        caTools_1.18.2           
 [63] filelock_1.0.2            BiocParallel_1.27.0      
 [65] rlang_0.4.11              pkgconfig_2.0.3          
 [67] bitops_1.0-7              evaluate_0.14            
 [69] lattice_0.20-44           purrr_0.3.4              
 [71] CodeDepends_0.6.5         labeling_0.4.2           
 [73] cowplot_1.1.1             tidyselect_1.1.1         
 [75] RcppAnnoy_0.0.18          plyr_1.8.6               
 [77] magrittr_2.0.1            bookdown_0.22            
 [79] R6_2.5.0                  gplots_3.1.1             
 [81] generics_0.1.0            metapod_1.1.0            
 [83] combinat_0.0-8            DelayedArray_0.19.0      
 [85] DBI_1.1.1                 mgcv_1.8-35              
 [87] pillar_1.6.1              withr_2.4.2              
 [89] RCurl_1.98-1.3            tibble_3.1.2             
 [91] dir.expiry_1.1.0          crayon_1.4.1             
 [93] KernSmooth_2.23-20        utf8_1.2.1               
 [95] rmarkdown_2.8             viridis_0.6.1            
 [97] locfit_1.5-9.4            grid_4.1.0               
 [99] digest_0.6.27             xtable_1.8-4             
[101] httpuv_1.6.1              munsell_0.5.0            
[103] beeswarm_0.3.1            viridisLite_0.4.0        
[105] vipor_0.4.5               bslib_0.2.5.1