In this vignette we will demonstrate how to construct cell trajectories with Monocle 3 using single-cell ATAC-seq data. Please see the Monocle 3 website for information about installing Monocle 3.

To facilitate conversion between the Seurat (used by Signac) and CellDataSet (used by Monocle 3) formats, we will use a conversion function in the SeuratWrappers package available on GitHub.

Data loading

We will use a single-cell ATAC-seq dataset containing human CD34+ hematopoietic stem and progenitor cells published by Satpathy and Granja et al. (2019, Nature Biotechnology).

The processed dataset is available on NCBI GEO here: https://www.ncbi.nlm.nih.gov/geo/query/acc.cgi?acc=GSE129785

Note that the fragment file is present inside the GSE129785_RAW.tar archive, and the index for the fragment file is not supplied. You can index the file yourself using tabix, for example: tabix -p bed <fragment_file>.

First we will load the dataset and perform some standard preprocessing using Signac.

filepath <- "../vignette_data/GSE129785/GSE129785_scATAC-Hematopoiesis-CD34"

peaks <- read.table(paste0(filepath, ".peaks.txt.gz"), header = TRUE)
cells <- read.table(paste0(filepath, ".cell_barcodes.txt.gz"), header = TRUE, stringsAsFactors = FALSE)
rownames(cells) <- make.unique(cells$Barcodes)

mtx <- readMM(file = paste0(filepath, ".mtx"))
mtx <- as(object = mtx, Class = "CsparseMatrix")
colnames(mtx) <- rownames(cells)
rownames(mtx) <- peaks$Feature
bone_assay <- CreateChromatinAssay(
  counts = mtx,
  min.cells = 5,
  fragments = "../vignette_data/GSE129785/GSM3722029_CD34_Progenitors_Rep1_fragments.tsv.gz",
  sep = c("_", "_"),
  genome = "hg19"
)
bone <- CreateSeuratObject(
  counts = bone_assay,
  meta.data = cells,
  assay = "ATAC"
)

# The dataset contains multiple cell types
# We can subset to include just one replicate of CD34+ progenitor cells
bone <- bone[, bone$Group_Barcode == "CD34_Progenitors_Rep1"]

# add cell type annotations from the original paper
cluster_names <- c("HSC",   "MEP",  "CMP-BMP",  "LMPP", "CLP",  "Pro-B",    "Pre-B",    "GMP",
                  "MDP",    "pDC",  "cDC",  "Monocyte-1",   "Monocyte-2",   "Naive-B",  "Memory-B",
                  "Plasma-cell",    "Basophil", "Immature-NK",  "Mature-NK1",   "Mature-NK2",   "Naive-CD4-T1",
                  "Naive-CD4-T2",   "Naive-Treg",   "Memory-CD4-T", "Treg", "Naive-CD8-T1", "Naive-CD8-T2",
                  "Naive-CD8-T3",   "Central-memory-CD8-T", "Effector-memory-CD8-T",    "Gamma delta T")
num.labels <- length(cluster_names)
names(cluster_names) <- paste0( rep("Cluster", num.labels), seq(num.labels) )
new.md <- cluster_names[as.character(bone$Clusters)]
names(new.md) <- Cells(bone)
bone$celltype <- new.md

bone[["ATAC"]]
## ChromatinAssay data with 570650 features for 9913 cells
## Variable features: 0 
## Genome: hg19 
## Annotation present: FALSE 
## Motifs present: FALSE 
## Fragment files: 1

Next we can add gene annotations for the hg19 genome to the object. This will be useful for computing quality control metrics (TSS enrichment score) and plotting.

library(EnsDb.Hsapiens.v75)

# extract gene annotations from EnsDb
annotations <- GetGRangesFromEnsDb(ensdb = EnsDb.Hsapiens.v75)

# change to UCSC style since the data was mapped to hg19
seqlevels(annotations) <- paste0('chr', seqlevels(annotations))
genome(annotations) <- "hg19"

# add the gene information to the object
Annotation(bone) <- annotations

Quality control

We’ll compute TSS enrichment, nucleosome signal score, and the percentage of counts in genomic blacklist regions for each cell, and use these metrics to help remove low quality cells from the datasets.

bone <- TSSEnrichment(bone)
bone <- NucleosomeSignal(bone)
bone$blacklist_fraction <- FractionCountsInRegion(bone, regions = blacklist_hg19)
VlnPlot(
  object = bone,
  features = c("nCount_ATAC", "TSS.enrichment", "nucleosome_signal", "blacklist_fraction"),
  pt.size = 0.1,
  ncol = 4
)

bone <- bone[, (bone$nCount_ATAC < 50000) &
               (bone$TSS.enrichment > 2) & 
               (bone$nucleosome_signal < 5)]

Dataset preprocessing

Next we can run a standard scATAC-seq analysis pipeline using Signac to perform dimension reduction, clustering, and cell type annotation.

bone <- FindTopFeatures(bone, min.cells = 10)
bone <- RunTFIDF(bone)
bone <- RunSVD(bone, n = 100)
DepthCor(bone)

bone <- RunUMAP(
  bone,
  reduction = "lsi",
  dims = 2:50,
  reduction.name = "UMAP"
)
bone <- FindNeighbors(bone, dims = 2:50, reduction = "lsi")
bone <- FindClusters(bone, resolution = 0.8, algorithm = 3)
## Modularity Optimizer version 1.3.0 by Ludo Waltman and Nees Jan van Eck
## 
## Number of nodes: 9765
## Number of edges: 433498
## 
## Running smart local moving algorithm...
## Maximum modularity in 10 random starts: 0.8474
## Number of communities: 18
## Elapsed time: 4 seconds
DimPlot(bone, label = TRUE) + NoLegend()

Assign each cluster to the most common cell type based on the original annotations from the paper.

for(i in levels(bone)) {
  cells_to_reid <- WhichCells(bone, idents = i)
  newid <- names(sort(table(bone$celltype[cells_to_reid]),decreasing=TRUE))[1]
  Idents(bone, cells = cells_to_reid) <- newid
}
bone$assigned_celltype <- Idents(bone)
DimPlot(bone, label = TRUE)

Next we can subset the different lineages and create a trajectory for each lineage. Another way to build the trajectories is to use the whole dataset and build separate pseudotime trajectories for the different cell partitions found by Monocle 3.

DefaultAssay(bone) <- "ATAC"

erythroid <- bone[,  bone$assigned_celltype %in% c("HSC", "MEP", "CMP-BMP")]
lymphoid <- bone[, bone$assigned_celltype %in% c("HSC", "LMPP", "GMP", "CLP", "Pro-B", "pDC", "MDP", "GMP")]

Building trajectories with Monocle 3

We can convert the Seurat object to a CellDataSet object using the as.cell_data_set() function from SeuratWrappers and build the trajectories using Monocle 3. We’ll do this separately for erythroid and lymphoid lineages, but you could explore other strategies building a trajectory for all lineages together.

erythroid.cds <- as.cell_data_set(erythroid)
erythroid.cds <- cluster_cells(cds = erythroid.cds, reduction_method = "UMAP")
erythroid.cds <- learn_graph(erythroid.cds, use_partition = TRUE)

lymphoid.cds <- as.cell_data_set(lymphoid)
lymphoid.cds <- cluster_cells(cds = lymphoid.cds, reduction_method = "UMAP")
lymphoid.cds <- learn_graph(lymphoid.cds, use_partition = TRUE)

To compute pseudotime estimates for each trajectory we need to decide what the start of each trajectory is. In our case, we know that the hematopoietic stem cells are the progenitors of other cell types in the trajectory, so we can set these cells as the root of the trajectory. Monocle 3 includes an interactive function to select cells as the root nodes in the graph. This function will be launched if calling order_cells() without specifying the root_cells parameter. Here we’ve pre-selected some cells as the root, and saved these to a file for reproducibility. This file can be downloaded here.

# load the pre-selected HSCs
hsc <- readLines("../vignette_data/hsc_cells.txt")
# order cells
erythroid.cds <- order_cells(erythroid.cds, reduction_method = "UMAP", root_cells = hsc)
lymphoid.cds <- order_cells(lymphoid.cds, reduction_method = "UMAP", root_cells = hsc)

# plot trajectories colored by pseudotime
plot_cells(
  cds = erythroid.cds,
  color_cells_by = "pseudotime",
  show_trajectory_graph = TRUE
)

plot_cells(
  cds = lymphoid.cds,
  color_cells_by = "pseudotime",
  show_trajectory_graph = TRUE
)

Extract the pseudotime values and add to the Seurat object

bone <- AddMetaData(
  object = bone,
  metadata = erythroid.cds@principal_graph_aux@listData$UMAP$pseudotime,
  col.name = "Erythroid"
)

bone <- AddMetaData(
  object = bone,
  metadata = lymphoid.cds@principal_graph_aux@listData$UMAP$pseudotime,
  col.name = "Lymphoid"
)
FeaturePlot(bone, c("Erythroid", "Lymphoid"), pt.size = 0.1) & scale_color_viridis_c()

Acknowledgements

Thanks to the developers of Monocle 3, especially Cole Trapnell, Hannah Pliner, and members of the Trapnell lab. If you use Monocle please cite the Monocle papers.

Session Info
## R version 4.3.1 (2023-06-16)
## Platform: aarch64-apple-darwin20 (64-bit)
## Running under: macOS Sonoma 14.4.1
## 
## Matrix products: default
## BLAS:   /Library/Frameworks/R.framework/Versions/4.3-arm64/Resources/lib/libRblas.0.dylib 
## LAPACK: /Library/Frameworks/R.framework/Versions/4.3-arm64/Resources/lib/libRlapack.dylib;  LAPACK version 3.11.0
## 
## locale:
## [1] C/UTF-8/C/C/C/C
## 
## time zone: Asia/Singapore
## tzcode source: internal
## 
## attached base packages:
## [1] stats4    stats     graphics  grDevices utils     datasets  methods  
## [8] base     
## 
## other attached packages:
##  [1] EnsDb.Hsapiens.v75_2.99.0   ensembldb_2.26.0           
##  [3] AnnotationFilter_1.26.0     GenomicFeatures_1.54.3     
##  [5] AnnotationDbi_1.64.1        patchwork_1.2.0            
##  [7] ggplot2_3.5.0               Matrix_1.6-5               
##  [9] monocle3_1.3.5              SingleCellExperiment_1.24.0
## [11] SummarizedExperiment_1.32.0 GenomicRanges_1.54.1       
## [13] GenomeInfoDb_1.38.7         IRanges_2.36.0             
## [15] S4Vectors_0.40.2            MatrixGenerics_1.14.0      
## [17] matrixStats_1.2.0           Biobase_2.62.0             
## [19] BiocGenerics_0.48.1         SeuratWrappers_0.3.1       
## [21] Seurat_5.0.3                SeuratObject_5.0.1         
## [23] sp_2.1-3                    Signac_1.13.0              
## 
## loaded via a namespace (and not attached):
##   [1] fs_1.6.3                 ProtGenerics_1.34.0      spatstat.sparse_3.0-3   
##   [4] bitops_1.0-7             httr_1.4.7               RColorBrewer_1.1-3      
##   [7] backports_1.4.1          tools_4.3.1              sctransform_0.4.1       
##  [10] utf8_1.2.4               R6_2.5.1                 lazyeval_0.2.2          
##  [13] uwot_0.1.16              withr_3.0.0              prettyunits_1.2.0       
##  [16] gridExtra_2.3            progressr_0.14.0         cli_3.6.2               
##  [19] textshaping_0.3.7        spatstat.explore_3.2-7   fastDummies_1.7.3       
##  [22] labeling_0.4.3           sass_0.4.9               spatstat.data_3.0-4     
##  [25] proxy_0.4-27             ggridges_0.5.6           pbapply_1.7-2           
##  [28] pkgdown_2.0.7            Rsamtools_2.18.0         systemfonts_1.0.6       
##  [31] foreign_0.8-86           R.utils_2.12.3           dichromat_2.0-0.1       
##  [34] parallelly_1.37.1        BSgenome_1.70.2          rstudioapi_0.16.0       
##  [37] RSQLite_2.3.5            generics_0.1.3           BiocIO_1.12.0           
##  [40] ica_1.0-3                spatstat.random_3.2-3    dplyr_1.1.4             
##  [43] ggbeeswarm_0.7.2         fansi_1.0.6              abind_1.4-5             
##  [46] R.methodsS3_1.8.2        lifecycle_1.0.4          yaml_2.3.8              
##  [49] SparseArray_1.2.4        BiocFileCache_2.10.1     Rtsne_0.17              
##  [52] grid_4.3.1               blob_1.2.4               promises_1.2.1          
##  [55] crayon_1.5.2             miniUI_0.1.1.1           lattice_0.22-6          
##  [58] cowplot_1.1.3            KEGGREST_1.42.0          pillar_1.9.0            
##  [61] knitr_1.45               rjson_0.2.21             boot_1.3-30             
##  [64] future.apply_1.11.2      codetools_0.2-19         fastmatch_1.1-4         
##  [67] leiden_0.4.3.1           glue_1.7.0               leidenbase_0.1.27       
##  [70] data.table_1.15.4        remotes_2.5.0            vctrs_0.6.5             
##  [73] png_0.1-8                spam_2.10-0              gtable_0.3.4            
##  [76] assertthat_0.2.1         cachem_1.0.8             xfun_0.43               
##  [79] S4Arrays_1.2.1           mime_0.12                survival_3.5-8          
##  [82] RcppRoll_0.3.0           fitdistrplus_1.1-11      ROCR_1.0-11             
##  [85] nlme_3.1-164             bit64_4.0.5              progress_1.2.3          
##  [88] filelock_1.0.3           RcppAnnoy_0.0.22         bslib_0.6.2             
##  [91] irlba_2.3.5.1            vipor_0.4.7              rpart_4.1.23            
##  [94] KernSmooth_2.23-22       Hmisc_5.1-2              colorspace_2.1-0        
##  [97] DBI_1.2.2                nnet_7.3-19              ggrastr_1.0.2           
## [100] tidyselect_1.2.1         bit_4.0.5                compiler_4.3.1          
## [103] curl_5.2.1               htmlTable_2.4.2          xml2_1.3.6              
## [106] desc_1.4.3               DelayedArray_0.28.0      plotly_4.10.4           
## [109] rtracklayer_1.62.0       checkmate_2.3.1          scales_1.3.0            
## [112] lmtest_0.9-40            rappdirs_0.3.3           stringr_1.5.1           
## [115] digest_0.6.35            goftest_1.2-3            spatstat.utils_3.0-4    
## [118] minqa_1.2.6              rmarkdown_2.26           XVector_0.42.0          
## [121] base64enc_0.1-3          htmltools_0.5.8          pkgconfig_2.0.3         
## [124] lme4_1.1-35.1            highr_0.10               dbplyr_2.5.0            
## [127] fastmap_1.1.1            rlang_1.1.3              htmlwidgets_1.6.4       
## [130] shiny_1.8.1              farver_2.1.1             jquerylib_0.1.4         
## [133] zoo_1.8-12               jsonlite_1.8.8           BiocParallel_1.36.0     
## [136] R.oo_1.26.0              VariantAnnotation_1.48.1 RCurl_1.98-1.14         
## [139] magrittr_2.0.3           Formula_1.2-5            GenomeInfoDbData_1.2.11 
## [142] dotCall64_1.1-1          munsell_0.5.0            Rcpp_1.0.12             
## [145] viridis_0.6.5            reticulate_1.35.0        stringi_1.8.3           
## [148] zlibbioc_1.48.0          MASS_7.3-60.0.1          plyr_1.8.9              
## [151] parallel_4.3.1           listenv_0.9.1            ggrepel_0.9.5           
## [154] deldir_2.0-4             Biostrings_2.70.2        splines_4.3.1           
## [157] tensor_1.5               hms_1.1.3                igraph_2.0.3            
## [160] spatstat.geom_3.2-9      RcppHNSW_0.6.0           reshape2_1.4.4          
## [163] biomaRt_2.58.2           XML_3.99-0.16.1          evaluate_0.23           
## [166] biovizBase_1.50.0        BiocManager_1.30.22      nloptr_2.0.3            
## [169] httpuv_1.6.15            RANN_2.6.1               tidyr_1.3.1             
## [172] purrr_1.0.2              polyclip_1.10-6          future_1.33.2           
## [175] scattermore_1.2          rsvd_1.0.5               xtable_1.8-4            
## [178] restfulr_0.0.15          RSpectra_0.16-1          later_1.3.2             
## [181] viridisLite_0.4.2        ragg_1.3.0               tibble_3.2.1            
## [184] beeswarm_0.4.0           memoise_2.0.1            GenomicAlignments_1.38.2
## [187] cluster_2.1.6            globals_0.16.3