Skip to contents

Introduction

Changes in cell type composition play an important role in health and disease. Recent advances in single cell technology have enabled measurement of cell type composition at increasing cell lineage resolution across large cohorts of individuals. Yet this raises new challenges for statistical analysis of these compositional data to identify changes associated with a phenotype. We introduce crumblr, a scalable statistical method for analyzing count ratio data using precision-weighted linear models incorporating random effects for complex study designs. Uniquely, crumblr performs tests of association at multiple levels of the cell lineage hierarchy using multivariate regression to increase power over tests of a single cell component. In simulations, crumblr increases power compared to existing methods, while controlling the false positive rate.

The crumblr package integrates with the variancePartition and dreamlet packages in the Bioconductor ecosystem.

Here we consider counts for 8 cell types from quantified using single cell RNA-seq data from unstimulated and interferon β stimulated PBMCs from 8 subjects (Kang, et al., 2018).

The functions here incorporate the precision weights:

  • variancePartition::fitExtractVarPartModel()
  • variancePartition::dream()
  • limma::lmFit()

Installation

To install this package, start R and enter:

# 1) Make sure Bioconductor is installed
if (!require("BiocManager", quietly = TRUE)) {
  install.packages("BiocManager")
}

# 2) Install crumblr and dependencies:
# From Bioconductor
BiocManager::install("crumblr")

Process data

Here we evaluate whether the observed cell proportions change in response to interferon β. Given the results here, we cannot reject the null hypothesis that interferon β does not affect the cell type proportions.

library(crumblr)

# Load cell counts, clustering and metadata
# from Kang, et al. (2018) https://doi.org/10.1038/nbt.4042
data(IFNCellCounts)

# Apply crumblr transformation
# cobj is an EList object compatable with limma workflow
# cobj$E stores transformed values
# cobj$weights stores precision weights
#    corresponding to the regularized inverse variance
cobj <- crumblr(df_cellCounts)

Variance partitioning

Decomposing the variance illustrates that more variation is explained by subject than stimulation status.

library(variancePartition)

# Partition variance into components for Subject (i.e. ind)
#   and stimulation status, and residual variation
form <- ~ (1 | ind) + (1 | StimStatus)
vp <- fitExtractVarPartModel(cobj, form, info)

# Plot variance fractions
fig.vp <- plotPercentBars(vp)
fig.vp

PCA

Performing PCA on the transformed cell counts indicates that the samples cluster based on subject rather than stimulation status.

library(ggplot2)

# Perform PCA
# use crumblr::standardize() to get values with
# approximately equal sampling variance,
# which is a key property for downstream PCA and clustering analysis.
pca <- prcomp(t(standardize(cobj)))

# merge with metadata
df_pca <- merge(pca$x, info, by = "row.names")

# Plot PCA
#   color by Subject
#   shape by Stimulated vs unstimulated
ggplot(df_pca, aes(PC1, PC2, color = as.character(ind), shape = StimStatus)) +
  geom_point(size = 3) +
  theme_classic() +
  theme(aspect.ratio = 1) +
  scale_color_discrete(name = "Subject") +
  xlab("PC1") +
  ylab("PC2")

Hierarchical clustering

The samples from the same subject also cluster together.

heatmap(cobj$E)

Differential testing

# Use variancePartition workflow to analyze each cell type
# Perform regression on each cell type separately
#  then use eBayes to shrink residual variance
# Also compatible with limma::lmFit()
fit <- dream(cobj, ~ StimStatus + ind, info)
fit <- eBayes(fit)

# Extract results for each cell type
topTable(fit, coef = "StimStatusstim", number = Inf)
##                         logFC    AveExpr          t     P.Value  adj.P.Val         B
## CD8 T cells       -0.25085170  0.0857175 -4.0787416 0.002436375 0.01949100 -1.279815
## Dendritic cells    0.37386979 -2.1849234  3.1619195 0.010692544 0.02738587 -2.638507
## CD14+ Monocytes   -0.10525402  1.2698117 -3.1226341 0.011413912 0.02738587 -2.709377
## B cells           -0.10478652  0.5516882 -3.0134349 0.013692935 0.02738587 -2.940542
## CD4 T cells       -0.07840101  2.0201947 -2.2318104 0.050869691 0.08139151 -4.128069
## FCGR3A+ Monocytes  0.07425165 -0.2567492  1.6647681 0.128337022 0.17111603 -4.935304
## NK cells           0.10270672  0.3797777  1.5181860 0.161321761 0.18436773 -5.247806
## Megakaryocytes     0.01377768 -1.8655172  0.1555131 0.879651456 0.87965146 -6.198336

Multivariate testing along a tree

We can gain power by jointly testing multiple cell types using a multivariate statistical model, instead of testing one cell type at a time. Here we construct a hierarchical clustering between cell types based on gene expression from pseudobulk, and perform a multivariate test for each internal node of the tree based on its leaf nodes. The results for the leaves are the same as from topTable() above. At each internal node treeTest() performs a fixed effects meta-analysis of the coefficients of the leaves while modeling the covariance between coefficient estimates. In the backend, this is implemented using variancePartition::mvTest() and remaCor package.

# Perform multivariate test across the hierarchy
res <- treeTest(fit, cobj, hcl, coef = "StimStatusstim")

# Plot hierarchy and testing results
plotTreeTest(res)

# Plot hierarchy and regression coefficients
plotTreeTestBeta(res)

Combined plotting

plotTreeTestBeta(res) +
  theme(legend.position = "bottom", legend.box = "vertical") |
  plotForest(res, hide = FALSE) |
  fig.vp

Session Info

## R version 4.4.1 (2024-06-14)
## Platform: aarch64-apple-darwin23.5.0
## Running under: macOS Sonoma 14.7.1
## 
## Matrix products: default
## BLAS:   /Users/gabrielhoffman/prog/R-4.4.1/lib/libRblas.dylib 
## LAPACK: /opt/homebrew/Cellar/r/4.4.2_2/lib/R/lib/libRlapack.dylib;  LAPACK version 3.12.0
## 
## locale:
## [1] en_US.UTF-8/en_US.UTF-8/en_US.UTF-8/C/en_US.UTF-8/en_US.UTF-8
## 
## time zone: America/New_York
## tzcode source: internal
## 
## attached base packages:
## [1] stats     graphics  grDevices utils     datasets  methods   base     
## 
## other attached packages:
## [1] variancePartition_1.36.3 BiocParallel_1.40.0      limma_3.62.1            
## [4] crumblr_0.99.14          ggplot2_3.5.1           
## 
## loaded via a namespace (and not attached):
##   [1] Rdpack_2.6.2                bitops_1.0-9                gridExtra_2.3              
##   [4] rlang_1.1.4                 magrittr_2.0.3              matrixStats_1.4.1          
##   [7] compiler_4.4.1              reshape2_1.4.4              systemfonts_1.1.0          
##  [10] vctrs_0.6.5                 RcppZiggurat_0.1.6          stringr_1.5.1              
##  [13] pkgconfig_2.0.3             crayon_1.5.3                fastmap_1.2.0              
##  [16] backports_1.5.0             XVector_0.46.0              labeling_0.4.3             
##  [19] caTools_1.18.3              utf8_1.2.4                  rmarkdown_2.29             
##  [22] nloptr_2.1.1                UCSC.utils_1.2.0            ragg_1.3.3                 
##  [25] purrr_1.0.2                 xfun_0.49                   Rfast_2.1.0                
##  [28] zlibbioc_1.52.0             cachem_1.1.0                aplot_0.2.4                
##  [31] GenomeInfoDb_1.42.1         jsonlite_1.8.9              EnvStats_3.0.0             
##  [34] remaCor_0.0.18              DelayedArray_0.32.0         broom_1.0.7                
##  [37] parallel_4.4.1              R6_2.5.1                    stringi_1.8.4              
##  [40] bslib_0.8.0                 boot_1.3-31                 numDeriv_2016.8-1.1        
##  [43] GenomicRanges_1.58.0        jquerylib_0.1.4             Rcpp_1.0.13-1              
##  [46] SummarizedExperiment_1.36.0 iterators_1.0.14            knitr_1.49                 
##  [49] IRanges_2.40.1              Matrix_1.7-1                splines_4.4.1              
##  [52] tidyselect_1.2.1            viridis_0.6.5               abind_1.4-8                
##  [55] yaml_2.3.10                 gplots_3.2.0                codetools_0.2-20           
##  [58] plyr_1.8.9                  lmerTest_3.1-3              lattice_0.22-6             
##  [61] tibble_3.2.1                Biobase_2.66.0              treeio_1.26.0              
##  [64] withr_3.0.2                 evaluate_1.0.1              gridGraphics_0.5-1         
##  [67] desc_1.4.3                  RcppParallel_5.1.9          pillar_1.9.0               
##  [70] ggtree_3.10.1               MatrixGenerics_1.18.0       KernSmooth_2.23-24         
##  [73] stats4_4.4.1                ggfun_0.1.8                 generics_0.1.3             
##  [76] S4Vectors_0.44.0            munsell_0.5.1               scales_1.3.0               
##  [79] aod_1.3.3                   tidytree_0.4.6              minqa_1.2.8                
##  [82] gtools_3.9.5                RhpcBLASctl_0.23-42         glue_1.8.0                 
##  [85] lazyeval_0.2.2              tools_4.4.1                 fANCOVA_0.6-1              
##  [88] lme4_1.1-35.5               mvtnorm_1.3-2               fs_1.6.5                   
##  [91] grid_4.4.1                  tidyr_1.3.1                 ape_5.8-1                  
##  [94] rbibutils_2.3               colorspace_2.1-1            SingleCellExperiment_1.28.1
##  [97] nlme_3.1-166                GenomeInfoDbData_1.2.13     patchwork_1.3.0            
## [100] cli_3.6.3                   textshaping_0.4.1           fansi_1.0.6                
## [103] viridisLite_0.4.2           S4Arrays_1.6.0              dplyr_1.1.4                
## [106] corpcor_1.6.10              gtable_0.3.6                yulab.utils_0.1.8          
## [109] sass_0.4.9                  digest_0.6.37               BiocGenerics_0.52.0        
## [112] pbkrtest_0.5.3              SparseArray_1.6.0           ggplotify_0.1.2            
## [115] htmlwidgets_1.6.4           farver_2.1.2                htmltools_0.5.8.1          
## [118] pkgdown_2.1.1               lifecycle_1.0.4             httr_1.4.7                 
## [121] statmod_1.5.0               MASS_7.3-61