We will use a synthetic dataset to illustrate the functionalities of the condiments package. We start directly with a dataset where the following steps are assumed to have been run:
# For analysis
library(condiments)
library(slingshot)
# For data manipulation
library(dplyr)
library(tidyr)
# For visualization
library(ggplot2)
library(RColorBrewer)
library(viridis)
set.seed(2071)
theme_set(theme_classic())
data("toy_dataset", package = "condiments")
df <- toy_dataset$sd
As such, we start with a matrix df
of metadata for the cells: coordinates in a reduced dimension space (Dim1, Dim2)
, a vector of conditions assignments conditions
(A or B) and a lineage assignment.
We can first plot the cells on the reduced dimensions
p <- ggplot(df, aes(x = Dim1, y = Dim2, col = conditions)) +
geom_point() +
scale_color_brewer(type = "qual")
p
We can also visualize the underlying skeleton structure of the two conditions.
p <- ggplot(df, aes(x = Dim1, y = Dim2, col = conditions)) +
geom_point(alpha = .5) +
geom_point(data = toy_dataset$mst, size = 2) +
geom_path(data = toy_dataset$mst, aes(group = lineages), size = 1.5) +
scale_color_brewer(type = "qual") +
facet_wrap(~conditions) +
guides(col = FALSE)
## Warning: Using `size` aesthetic for lines was deprecated in ggplot2 3.4.0.
## ℹ Please use `linewidth` instead.
## This warning is displayed once every 8 hours.
## Call `lifecycle::last_lifecycle_warnings()` to see where this warning was
## generated.
## Warning: The `<scale>` argument of `guides()` cannot be `FALSE`. Use "none" instead as
## of ggplot2 3.3.4.
## This warning is displayed once every 8 hours.
## Call `lifecycle::last_lifecycle_warnings()` to see where this warning was
## generated.
p
We can then compute the imbalance score of each cell using the imbalance_score function.
scores <- imbalance_score(Object = df %>% select(Dim1, Dim2) %>% as.matrix(),
conditions = df$conditions)
df$scores <- scores$scores
df$scaled_scores <- scores$scaled_scores
There are two types of scores. The raw score is computed on each cell and looks at the condition distribution of its neighbors compared the the overall distribution. The size of the neighborhood can be set using the k
argument, which specify the number of neighbors to consider. Higher values means more local imbalance.
ggplot(df, aes(x = Dim1, y = Dim2, col = scores)) +
geom_point() +
scale_color_viridis_c(option = "C")
The local scores are quite noisy so we can then use local smoothers to smooth the scores of individual cells. The smoothness is dictated by the smooth
argument. Those smoothed scores were also computed using the imbalance_score
function.
ggplot(df, aes(x = Dim1, y = Dim2, col = scaled_scores)) +
geom_point() +
scale_color_viridis_c(option = "C")
As could be guessed from the original plot, the bottom lineage shows a lot of imbalance while the top one does not. The imbalance score can be used to check: + If the integration has been successful. In general, some regions should be balanced + To identify the regions of imbalance for further analyses.
The first step of our workflow is to decide whether or not to infer the trajectories separately or not. On average, it is better to infer a common trajectory, since a) this allow for a wider range of downstream analyses, and b) more cells are used to estimate the trajectory. However, the condition effect might be strong enough to massively disrupt the differentiation process, which would require fitting separate trajectories.
slingshot(Street et al. 2018) relies on a reduced dimensionality reduction representation of the data, as well as on cluster labels. We can visualize those below:
ggplot(df, aes(x = Dim1, y = Dim2, col = cl)) +
geom_point()
The topologyTest assess the quality of the common trajectory inference done by slingshot and test whether we should fit a common or separate trajectory. This test relies on repeated permutations of the conditions followed by trajectory inference so it can take a few seconds.
rd <- as.matrix(df[, c("Dim1", "Dim2")])
sds <- slingshot(rd, df$cl)
## Takes ~1m30s to run
top_res <- topologyTest(sds = sds, conditions = df$conditions)
## Generating permuted trajectories
## Running KS-mean test
knitr::kable(top_res)
method | thresh | statistic | p.value |
---|---|---|---|
KS_mean | 0.01 | 0 | 1 |
The test clearly fails to reject the null that we can fit a common trajectory so we can continue with the sds
object. This will facilitate downstream analysis. For an example of how to proceed if the topologyTest reject the null, we invite the user to refer to relevant case study used in our paper.
We can thus visualize the trajectory
ggplot(df, aes(x = Dim1, y = Dim2, col = cl)) +
geom_point() +
geom_path(data = slingCurves(sds, as.df = TRUE) %>% arrange(Order),
aes(group = Lineage), col = "black", size = 2)
Even though we can fit a common trajectory, it does not mean that the cells will differentiate similarly between the conditions. The first question we can ask is: for a given lineage, are cells equally represented along pseudotime between conditions?
psts <- slingPseudotime(sds) %>%
as.data.frame() %>%
mutate(cells = rownames(.),
conditions = df$conditions) %>%
pivot_longer(starts_with("Lineage"), values_to = "pseudotime", names_to = "lineages")
ggplot(psts, aes(x = pseudotime, fill = conditions)) +
geom_density(alpha = .5) +
scale_fill_brewer(type = "qual") +
facet_wrap(~lineages) +
theme(legend.position = "bottom")
The pseudotime distributions are identical across conditions for the first lineage but there are clear differences between the two conditions in the second lineage.
To test for differential progression, we use the progressionTest. The test can be run with global = TRUE
to test when pooling all lineages, or lineages = TRUE
to test every lineage independently, or both. Several tests are implemented in the progressionTest. function. Here, we will use the default, the custom KS test (Smirnov 1939).
prog_res <- progressionTest(sds, conditions = df$conditions, global = TRUE, lineages = TRUE)
knitr::kable(prog_res)
lineage | statistic | p.value |
---|---|---|
All | 5.5063660 | 0.0000000 |
1 | 0.0343831 | 0.9940762 |
2 | 0.4699371 | 0.0000000 |
As expected, there is a global difference over all lineages, which is driven by differences of distribution across lineage 2 (i.e. the bottom one).
Even though we can fit a common trajectory, it does not mean that the cells will differentiate similarly between the conditions. The first question we can ask is: for a given lineage, are cells equally between the two lineages for the two conditions?
Visualizing differences 2D distributions can be somewhat tricky. However, it is important to note that the sum of all lineage weights should sum to 1. As such, we can only plot the weights for the first lineage.
df$weight_1 <- slingCurveWeights(sds, as.probs = TRUE)[, 1]
ggplot(df, aes(x = weight_1, fill = conditions)) +
geom_density(alpha = .5) +
scale_fill_brewer(type = "qual") +
labs(x = "Curve weight for the first lineage")
The distribution has tri modes, which is very often the case for two lineages: + A weight around 0 represent a cell that is mostly assigned to the other lineage (i.e. lineage 2 here) + A weight around .5 represent a cell that is equally assigned to both lineages, i.e. before the bifurcation. + A weight around 1 represent a cell that is mostly assigned to this lineage (i.e. lineage 1 here)
In condition A, we have many more cells with a weight of 0 and, since those are density plots, fewer cells with weights around .5 and 1. Visually, we can guess that cells in condition B differentiate preferentially along lineage 1.
To test for differential fate selection, we use the fateSelectionTest. The test can be run with global = TRUE
to test when pooling all pairs of lineages, or pairwise = TRUE
to test every pair independently, or both. Here, there is only one pair so the options are equivalent. Several tests are implemented in the fateSelectionTest. function. Here, we will use the default, the classifier test(Lopez-Paz and Oquab 2016).
set.seed(12)
dif_res <- fateSelectionTest(sds, conditions = df$conditions, global = FALSE, pairwise = TRUE)
## note: only 1 unique complexity parameters in default grid. Truncating the grid to 1 .
## Loading required package: lattice
## note: only 1 unique complexity parameters in default grid. Truncating the grid to 1 .
knitr::kable(dif_res)
pair | statistic | p.value |
---|---|---|
1vs2 | 0.6476577 | 5.6e-06 |
As could be guessed from the plot, we have clear differential fate selection.
The workflow above focus on global differences, looking at broad patterns of differentiation. While this is a necessary first step, gene-level information is also quite meaningful.
To do so requires tradeSeq(Van den Berge et al. 2020) > 1.3.0. Considering that we have a count matrix counts
, the basic workflow is:s
library(tradeSeq)
sce <- fitGAM(counts = counts, sds = sds, conditions = df$conditions)
cond_genes <- conditionTest(sds)
For more details on fitting the smoothers, we refer users to the tradeSeq website and to the accompanying Bioconductor workshop.
For both of the above procedures, it is important to note that we are making multiple comparisons (in this case, 5). The p-values we obtain from these tests should be corrected for multiple testing, especially for trajectories with a large number of lineages.
That said, trajectory inference is often one of the last computational methods in a very long analysis pipeline (generally including gene-level quantification, gene filtering / feature selection, and dimensionality reduction). Hence, we strongly discourage the reader from putting too much faith in any p-value that comes out of this analysis. Such values may be useful suggestions, indicating particular features or cells for follow-up study, but should generally not be treated as meaningful statistical quantities.
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] caret_6.0-94 lattice_0.22-5
## [3] viridis_0.6.4 viridisLite_0.4.2
## [5] RColorBrewer_1.1-3 ggplot2_3.4.4
## [7] tidyr_1.3.0 dplyr_1.1.3
## [9] slingshot_2.10.0 TrajectoryUtils_1.10.0
## [11] SingleCellExperiment_1.24.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] princurve_2.1.6 condiments_1.10.0
## [23] knitr_1.44
##
## loaded via a namespace (and not attached):
## [1] jsonlite_1.8.7 magrittr_2.0.3
## [3] ggbeeswarm_0.7.2 spatstat.utils_3.0-4
## [5] farver_2.1.1 rmarkdown_2.25
## [7] zlibbioc_1.48.0 vctrs_0.6.4
## [9] spatstat.explore_3.2-5 DelayedMatrixStats_1.24.0
## [11] RCurl_1.98-1.12 htmltools_0.5.6.1
## [13] S4Arrays_1.2.0 BiocNeighbors_1.20.0
## [15] SparseArray_1.2.0 pROC_1.18.4
## [17] sass_0.4.7 parallelly_1.36.0
## [19] bslib_0.5.1 plyr_1.8.9
## [21] lubridate_1.9.3 cachem_1.0.8
## [23] igraph_1.5.1 lifecycle_1.0.3
## [25] iterators_1.0.14 pkgconfig_2.0.3
## [27] rsvd_1.0.5 Matrix_1.6-1.1
## [29] R6_2.5.1 fastmap_1.1.1
## [31] GenomeInfoDbData_1.2.11 future_1.33.0
## [33] digest_0.6.33 colorspace_2.1-0
## [35] tensor_1.5 scater_1.30.0
## [37] irlba_2.3.5.1 beachmat_2.18.0
## [39] spatstat.linnet_3.1-1 labeling_0.4.3
## [41] randomForest_4.7-1.1 fansi_1.0.5
## [43] spatstat.sparse_3.0-3 timechange_0.2.0
## [45] polyclip_1.10-6 abind_1.4-5
## [47] mgcv_1.9-0 compiler_4.3.1
## [49] rngtools_1.5.2 proxy_0.4-27
## [51] withr_2.5.1 doParallel_1.0.17
## [53] BiocParallel_1.36.0 spatstat.model_3.2-8
## [55] MASS_7.3-60 lava_1.7.2.1
## [57] DelayedArray_0.28.0 ModelMetrics_1.2.2.2
## [59] tools_4.3.1 vipor_0.4.5
## [61] beeswarm_0.4.0 future.apply_1.11.0
## [63] nnet_7.3-19 goftest_1.2-3
## [65] glue_1.6.2 nlme_3.1-163
## [67] grid_4.3.1 reshape2_1.4.4
## [69] generics_0.1.3 recipes_1.0.8
## [71] gtable_0.3.4 spatstat.data_3.0-3
## [73] class_7.3-22 data.table_1.14.8
## [75] ScaledMatrix_1.10.0 BiocSingular_1.18.0
## [77] utf8_1.2.4 XVector_0.42.0
## [79] spatstat.geom_3.2-7 ggrepel_0.9.4
## [81] RANN_2.6.1 foreach_1.5.2
## [83] pillar_1.9.0 stringr_1.5.0
## [85] limma_3.58.0 Ecume_0.9.1
## [87] splines_4.3.1 survival_3.5-7
## [89] deldir_1.0-9 tidyselect_1.2.0
## [91] scuttle_1.12.0 pbapply_1.7-2
## [93] transport_0.14-6 gridExtra_2.3
## [95] xfun_0.40 statmod_1.5.0
## [97] hardhat_1.3.0 distinct_1.14.0
## [99] timeDate_4022.108 stringi_1.7.12
## [101] yaml_2.3.7 evaluate_0.22
## [103] codetools_0.2-19 kernlab_0.9-32
## [105] spatstat_3.0-6 tibble_3.2.1
## [107] cli_3.6.1 rpart_4.1.21
## [109] munsell_0.5.0 jquerylib_0.1.4
## [111] Rcpp_1.0.11 globals_0.16.2
## [113] spatstat.random_3.2-1 parallel_4.3.1
## [115] gower_1.0.1 doRNG_1.8.6
## [117] sparseMatrixStats_1.14.0 bitops_1.0-7
## [119] listenv_0.9.0 ipred_0.9-14
## [121] scales_1.2.1 prodlim_2023.08.28
## [123] e1071_1.7-13 purrr_1.0.2
## [125] crayon_1.5.2 rlang_1.1.1
Lopez-Paz, David, and Maxime Oquab. 2016. “Revisiting Classifier Two-Sample Tests.” Arxiv, October, 1–15. http://arxiv.org/abs/1610.06545.
Smirnov, Nikolai V. 1939. “On the Estimation of the Discrepancy Between Empirical Curves of Distribution for Two Independent Samples.” Bull. Math. Univ. Moscou 2 (2): 3–14.
Street, Kelly, Davide Risso, Russell B. Fletcher, Diya Das, John Ngai, Nir Yosef, Elizabeth Purdom, and Sandrine Dudoit. 2018. “Slingshot: cell lineage and pseudotime inference for single-cell transcriptomics.” BMC Genomics 19 (1): 477. https://doi.org/10.1186/s12864-018-4772-0.
Van den Berge, Koen, Hector Roux de Bézieux, Kelly Street, Wouter Saelens, Robrecht Cannoodt, Yvan Saeys, Sandrine Dudoit, and Lieven Clement. 2020. “Trajectory-based differential expression analysis for single-cell sequencing data.” Nature Communications 11 (1): 1201. https://doi.org/10.1038/s41467-020-14766-3.