LineagePulse 1.12.0
LineagePulse is a differential expression algorithm for single-cell RNA-seq (scRNA-seq) data. LineagePulse is based on zero-inflated negative binomial noise model and can capture both discrete and continuous population structures: Discrete population structures are groups of cells (e.g. condition of an experiment or tSNE clusters). Continous population structures can for example be pseudotemporal orderings of cells or temporal orderings of cells. The main use and novelty of LineagePulse lies in its ability to fit gene expression trajectories on pseudotemporal orderings of cells well. Note that LineagePulse does not infer a pseudotemporal ordering but is a downstream analytic tool to analyse gene expression trajectories on a given pseudotemporal ordering (such as from diffusion pseudotime or monocle2).
To run LineagPulse on scRNA-seq data, the user needs to use a minimal input parameter set for the wrapper function runLineagePulse, which then performs all normalisation, model fitting and differential expression analysis steps without any more user interaction required:
Additionally, one can provide:
Lastly, the experienced user who has a solid grasp of the mathematical and algorithmic basis of LineagePulse may change the defaults of these advanced input options:
Here, we present a differential expression analysis scenario on a longitudinal ordering. The differential expression results are in a data frame which can be accessed from the output object via list like properties ($). The core differential expression analysis result are p-value and false-discovery-rate corrected p-value of differential expression which are the result of a gene-wise hypothesis test of a non-constant expression model (impulse, splines or groups) versus a constant expression model.
library(LineagePulse)
lsSimulatedData <- simulateContinuousDataSet(
  scaNCells = 100,
  scaNConst = 10,
  scaNLin = 10,
  scaNImp = 10,
  scaMumax = 100,
  scaSDMuAmplitude = 3,
  vecNormConstExternal=NULL,
  vecDispExternal=rep(20, 30),
  vecGeneWiseDropoutRates = rep(0.1, 30))## Draw mean trajectories## Setting size factors uniformly =1## Draw dispersion## Simulate negative binomial noise## Simulate drop-outobjLP <- runLineagePulse(
  counts = lsSimulatedData$counts,
  dfAnnotation = lsSimulatedData$annot)## LineagePulse for count data: v1.12.0## --- Data preprocessing## # 0 out of 100 cells did not have a continuous covariate and were excluded.## # 0 out of 30 genes did not contain non-zero observations and are excluded from analysis.## # 0 out of 100 cells did not contain non-zero observations and are excluded from analysis.## --- Compute normalisation constants:## # All size factors are set to one.## --- Fit ZINB model for both H1 and H0.## ### a) Fit ZINB model A (H0: mu=constant disp=constant) with noise model.## #  .   Initialisation: ll -25644.0703038675## # 1.  Iteration with ll   -13787.6142547572 in 0.04 min.## # 2.  Iteration with ll   -13716.4212941305 in 0.04 min.## # 3.  Iteration with ll   -13716.4211808313 in 0.04 min.## Finished fitting zero-inflated negative binomial model A with noise model in 0.16 min.## ### b) Fit ZINB model B (H1: mu=splines disp=constant).## #  .   Initialisation: ll -15044.4826072437## # 1.  Iteration with ll   -13172.0147733792 in 0.03 min.## Finished fitting zero-inflated negative binomial model B in 0.05 min.## ### c) Fit NB model A (H0: mu=constant disp=constant).## #  .   Initialisation: ll -14864.9420326092## # 1.  Iteration with ll   -14681.9083396226 in 0.01 min.## Finished fitting NB model B in 0.03 min.## ### d) Fit NB model B (H1: mu=splines disp=constant).## #  .   Initialisation: ll -15078.0156959573## # 1.  Iteration with ll   -14550.2910694108 in 0.02 min.## Finished fitting NB model B in 0.03 min.## Time elapsed during ZINB fitting: 0.31 min## --- Run differential expression analysis.## Finished runLineagePulse().head(objLP$dfResults)##          gene           p        padj   mean_H0        p_nb   padj_nb
## gene_1 gene_1 0.655658022 0.819572527 84.670491 0.655658022 0.9984729
## gene_2 gene_2 0.825716903 0.952750273 73.330170 0.825716903 0.9984729
## gene_3 gene_3 0.264251869 0.440419781 27.680015 0.264251869 0.9984729
## gene_4 gene_4 0.044035816 0.082567155 40.259587 0.044035816 0.9984729
## gene_5 gene_5 0.003717835 0.007966789  9.009843 0.003717835 0.9984729
## gene_6 gene_6 0.598213380 0.780278321 80.913361 0.598213380 0.9984729
##        df_full_zinb df_red_zinb df_full_nb df_red_nb loglik_full_zinb
## gene_1            7           2          7         2        -456.3149
## gene_2            7           2          7         2        -462.6678
## gene_3            7           2          7         2        -381.8069
## gene_4            7           2          7         2        -403.2238
## gene_5            7           2          7         2        -301.6189
## gene_6            7           2          7         2        -462.1912
##        loglik_red_zinb loglik_full_nb loglik_red_nb allZero
## gene_1       -457.9590      -540.8938     -541.5709   FALSE
## gene_2       -463.7508      -528.4409     -528.5662   FALSE
## gene_3       -385.0354      -431.4182     -431.7145   FALSE
## gene_4       -408.9228      -465.5709     -466.1856   FALSE
## gene_5       -310.3449      -302.1100     -302.4992   FALSE
## gene_6       -464.0250      -531.3560     -532.4584   FALSEIn addition to the raw p-values, one may be interested in further details of the expression models such as shape of the expression mean as a function of pseudotime, log fold changes (LFC) and global expression trends as function of pseudotime. We address each of these follow-up questions with separate sections in the following. Note that all of these follow-up questions are answered based on the model that were fit to compute the p-value of differential expression. Therefore, once runLineagePulse() was called once, no further model fitting is required.
# Further inspection of results ## Plot gene-wise trajectories
Multiple options are available for gene-wise expression trajectory plotting: Observations can be coloured by the posterior probability of drop-out (boolColourByDropout). Observations can be normalized based on the alternative expression model or taken as raw observerations for the scatter plot (boolH1NormCounts). Lineage contours can be added to aid visual interpretation of non-uniform population density in pseudotime related effects (boolLineageContour). Log counts can be displayed instead of counts if the fold changes are large (boolLogPlot). In any case, the output object of the gene-wise expression trajectors plotting function plotGene is a ggplot2 object which can then be printed or modified.
# plot the gene with the lowest p-value of differential expression
gplotExprProfile <- plotGene(
objLP = objLP, boolLogPlot = FALSE,
strGeneID = objLP$dfResults[which.min(objLP$dfResults$p),]$gene,
boolLineageContour = FALSE)
gplotExprProfileThe function plotGene also shows the H1 model fit under a negative binomial noise model (“H1(NB)”) as a reference to show what the model fit looks like if drop-out is not accounted for.
LineagePulse provides the user with parameter extraction functions that allow the user to interact directly with the raw model fits for analytic tasks or questions not addressed above.
# extract the mean parameter fits per cell of the gene with the lowest p-value.
matMeanParamFit <- getFitsMean(
    lsMuModel = lsMuModelH1(objLP),
    vecGeneIDs = objLP$dfResults[which.min(objLP$dfResults$p),]$gene)
cat("Minimum fitted mean parameter: ", round(min(matMeanParamFit),1) )## Minimum fitted mean parameter:  3.2cat("Mean fitted mean parameter: ", round(mean(matMeanParamFit),1) )## Mean fitted mean parameter:  41.5Given a discrete population structure, such as tSNE cluster or experimental conditions, a fold change is the ratio of the mean expression value of both groups. The definition of a fold change is less clear if a continous expression trajector is considered: Of interest may be for example the fold change from the first to the last cell on the expression trajectory or from the minimum to the maximum expression value. Note that in both cases, we compute fold changes on the model fit of the expression mean parameter which is corrected for noise and therefore more stable than the estimate based on the raw expression count observation.
# first, extract the model fits for a given gene again
vecMeanParamFit <- getFitsMean(
    lsMuModel = lsMuModelH1(objLP),
    vecGeneIDs = objLP$dfResults[which.min(objLP$dfResults$p),]$gene)
# compute log2-fold change from first to last cell on trajectory
idxFirstCell <- which.min(dfAnnotationProc(objLP)$pseudotime)
idxLastCell <- which.max(dfAnnotationProc(objLP)$pseudotime)
cat("LFC first to last cell on trajectory: ",
    round( (log(vecMeanParamFit[idxLastCell]) - 
                log(vecMeanParamFit[idxFirstCell])) / log(2) ,1) )## LFC first to last cell on trajectory:# compute log2-fold change from minimum to maximum value of expression trajectory
cat("LFC minimum to maximum expression value of model fit: ", 
    round( (log(max(vecMeanParamFit)) - 
                log(min(vecMeanParamFit))) / log(2),1) )## LFC minimum to maximum expression value of model fit:  4.6Global expression profiles or expression profiles across large groups of genes can be visualised via heatmaps of expression z-scores. One could extract the expression mean parameter fits as described above and create such heatmaps from scratch. LineaegePulse also offers a wrapper for creating such a heatmap:
# create heatmap with all differentially expressed genes
lsHeatmaps <- sortGeneTrajectories(
    vecIDs = objLP$dfResults[which(objLP$dfResults$padj < 0.01),]$gene,
    lsMuModel = lsMuModelH1(objLP),
    dirHeatmap=NULL)
print(lsHeatmaps$hmGeneSorted)sessionInfo()## R version 4.1.0 (2021-05-18)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 20.04.2 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.13-bioc/R/lib/libRblas.so
## LAPACK: /home/biocbuild/bbs-3.13-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] stats     graphics  grDevices utils     datasets  methods   base     
## 
## other attached packages:
## [1] LineagePulse_1.12.0 BiocStyle_2.20.0   
## 
## loaded via a namespace (and not attached):
##  [1] MatrixGenerics_1.4.0        Biobase_2.52.0             
##  [3] sass_0.4.0                  splines_4.1.0              
##  [5] jsonlite_1.7.2              foreach_1.5.1              
##  [7] gtools_3.8.2                bslib_0.2.5.1              
##  [9] assertthat_0.2.1            highr_0.9                  
## [11] BiocManager_1.30.15         stats4_4.1.0               
## [13] GenomeInfoDbData_1.2.6      yaml_2.2.1                 
## [15] pillar_1.6.1                lattice_0.20-44            
## [17] glue_1.4.2                  digest_0.6.27              
## [19] GenomicRanges_1.44.0        RColorBrewer_1.1-2         
## [21] XVector_0.32.0              colorspace_2.0-1           
## [23] htmltools_0.5.1.1           Matrix_1.3-3               
## [25] pkgconfig_2.0.3             GetoptLong_1.0.5           
## [27] magick_2.7.2                bookdown_0.22              
## [29] zlibbioc_1.38.0             purrr_0.3.4                
## [31] scales_1.1.1                BiocParallel_1.26.0        
## [33] tibble_3.1.2                farver_2.1.0               
## [35] generics_0.1.0              IRanges_2.26.0             
## [37] ggplot2_3.3.3               ellipsis_0.3.2             
## [39] SummarizedExperiment_1.22.0 BiocGenerics_0.38.0        
## [41] magrittr_2.0.1              crayon_1.4.1               
## [43] evaluate_0.14               fansi_0.4.2                
## [45] gplots_3.1.1                doParallel_1.0.16          
## [47] Cairo_1.5-12.2              tools_4.1.0                
## [49] GlobalOptions_0.1.2         lifecycle_1.0.0            
## [51] matrixStats_0.58.0          ComplexHeatmap_2.8.0       
## [53] stringr_1.4.0               S4Vectors_0.30.0           
## [55] munsell_0.5.0               cluster_2.1.2              
## [57] DelayedArray_0.18.0         compiler_4.1.0             
## [59] jquerylib_0.1.4             GenomeInfoDb_1.28.0        
## [61] caTools_1.18.2              rlang_0.4.11               
## [63] grid_4.1.0                  RCurl_1.98-1.3             
## [65] iterators_1.0.13            rjson_0.2.20               
## [67] SingleCellExperiment_1.14.0 circlize_0.4.12            
## [69] labeling_0.4.2              bitops_1.0-7               
## [71] rmarkdown_2.8               gtable_0.3.0               
## [73] codetools_0.2-18            DBI_1.1.1                  
## [75] R6_2.5.0                    knitr_1.33                 
## [77] dplyr_1.0.6                 utf8_1.2.1                 
## [79] clue_0.3-59                 KernSmooth_2.23-20         
## [81] shape_1.4.6                 stringi_1.6.2              
## [83] Rcpp_1.0.6                  parallel_4.1.0             
## [85] vctrs_0.3.8                 png_0.1-7                  
## [87] tidyselect_1.1.1            xfun_0.23