Skip to main content
Genome Biology logoLink to Genome Biology
. 2016 Apr 15;17:70. doi: 10.1186/s13059-016-0930-3

Beyond comparisons of means: understanding changes in gene expression at the single-cell level

Catalina A Vallejos 1,2,, Sylvia Richardson 1,, John C Marioni 2,3,
PMCID: PMC4832562  PMID: 27083558

Abstract

Traditional differential expression tools are limited to detecting changes in overall expression, and fail to uncover the rich information provided by single-cell level data sets. We present a Bayesian hierarchical model that builds upon BASiCS to study changes that lie beyond comparisons of means, incorporating built-in normalization and quantifying technical artifacts by borrowing information from spike-in genes. Using a probabilistic approach, we highlight genes undergoing changes in cell-to-cell heterogeneity but whose overall expression remains unchanged. Control experiments validate our method’s performance and a case study suggests that novel biological insights can be revealed. Our method is implemented in R and available at https://github.com/catavallejos/BASiCS.

Electronic supplementary material

The online version of this article (doi:10.1186/s13059-016-0930-3) contains supplementary material, which is available to authorized users.

Keywords: Single-cell RNA-seq, Differential expression, Cellular heterogeneity

Background

The transcriptomics revolution – moving from bulk samples to single-cell (SC) resolution – provides novel insights into a tissue’s function and regulation. In particular, single-cell RNA sequencing (scRNA-seq) has led to the identification of novel sub-populations of cells in multiple contexts [13]. However, compared to bulk RNA-seq, a critical aspect of scRNA-seq data sets is an increased cell-to-cell variability among the expression counts. Part of this variance inflation is related to biological differences in the expression profiles of the cells (e.g., changes in mRNA content and the existence of cell sub-populations or transient states), which disappears when measuring bulk gene expression as an average across thousands of cells. Nonetheless, this increase in variability is also due in part to technical noise arising from the manipulation of small amounts of starting material, which is reflected in weak correlations between technical replicates [4]. Such technical artifacts are confounded with genuine transcriptional heterogeneity and can mask the biological signal.

Among others, one objective of RNA-seq experiments is to characterize transcriptional differences between pre-specified populations of cells (given by experimental conditions or cell types). This is a key step for understanding a cell’s fate and functionality. In the context of bulk RNA-seq, two popular methods for this purpose are edgeR [5] and DESeq2 [6]. However, these are not designed to capture features that are specific to scRNA-seq data sets. In contrast, SCDE [7] has been specifically developed to deal with scRNA-seq data sets. All of these methods target the detection of differentially expressed genes based on log-fold changes (LFCs) of overall expression between the populations. However, restricting the analysis to changes in overall expression does not take full advantage of the rich information provided by scRNA-seq. In particular – and unlike bulk RNA-seq – scRNA-seq can also reveal information about cell-to-cell expression heterogeneity. Critically, traditional approaches will fail to highlight genes whose expression is less stable in any given population but whose overall expression remains unchanged between populations.

More flexible approaches, capable of studying changes that lie beyond comparisons of means, are required to characterize differences between distinct populations of cells better. In this article, we develop a quantitative method to fill this gap, allowing the identification of genes whose cell-to-cell heterogeneity pattern changes between pre-specified populations of cells. In particular, genes with less variation in expression levels within a specific population of cells might be under more stringent regulatory control. Additionally, genes having increased biological variability in a given population of cells could suggest the existence of additional sub-groups within the analyzed populations. To the best of our knowledge, this is the first probabilistic tool developed for this purpose in the context of scRNA-seq analyses. We demonstrate the performance of our method using control experiments and by comparing expression patterns of mouse embryonic stem cells (mESCs) between different stages of the cell cycle.

Results and discussion

A statistical model to detect changes in expression patterns for scRNA-seq data sets

We propose a statistical approach to compare expression patterns between P pre-specified populations of cells. It builds upon BASiCS [8], a Bayesian model for the analysis of scRNA-seq data. As in traditional differential expression analyses, for any given gene i, changes in overall expression are identified by comparing population-specific expression rates μi(p) (p=1,…,P), defined as the relative abundance of gene i within the cells in population p. However, the main focus of our approach is to assess differences in biological cell-to-cell heterogeneity between the populations. These are quantified through changes in population- and gene-specific biological over-dispersion parameters δi(p) (p=1,…,P), designed to capture residual variance inflation (after normalization and technical noise removal) while attenuating the well-known confounding relationship between mean and variance in count-based data sets [9] (a similar concept was defined in the context of bulk RNA-seq by [10], using the term biological coefficient of variation). Importantly, such changes cannot be uncovered by standard differential expression methods, which are restricted to changes in overall expression. Hence, our approach provides novel biological insights by highlighting genes that undergo changes in cell-to-cell heterogeneity between the populations despite the overall expression level being preserved.

To disentangle technical from biological effects, we exploit spike-in genes that are added to the lysis buffer and thence theoretically present at the same amount in every cell (e.g., the 92 ERCC molecules developed by the External RNA Control Consortium [11]). These provide an internal control or gold standard to estimate the strength of technical variability and to aid normalization. In particular, these control genes allow inference on cell-to-cell differences in mRNA content, providing additional information about the analyzed populations of cells [12]. These are quantified through changes between cell-specific normalizing constants ϕj(p) (for the jth cell within the pth population). Critically, as described in Additional file 1: Note S1 and Fig. S1, global shifts in mRNA content between populations do not induce spurious differences when comparing gene-specific parameters (provided the offset correction described in ‘Methods’ is applied).

A graphical representation of our model is displayed in Fig. 1 (based on a two-group comparison). It illustrates how our method borrows information across all cells and genes (biological transcripts and spike-in genes) to perform inference. Posterior inference is implemented via a Markov chain Monte Carlo (MCMC) algorithm, generating draws from the posterior distribution of all model parameters. Post-processing of these draws allows quantification of supporting evidence regarding changes in expression patterns (mean and over-dispersion). These are measured using a probabilistic approach based on tail posterior probabilities associated with decision rules, where a probability cut-off is calibrated through the expected false discovery rate (EFDR) [13].

Fig. 1.

Fig. 1

Graphical representation of our model for detecting changes in expression patterns (mean and over-dispersion) based on comparing two predefined population of cells. The diagram considers expression counts of two genes (i is biological and i is technical) and two cells (j p and jp) from each population p=1,2. Observed expression counts are represented by square nodes. The central rhomboid node denotes the known input number of mRNA molecules for a technical gene i , which is assumed to be constant across all cells. The remaining circular nodes represent unknown elements, using black to denote random effects and red to denote model parameters (fixed effects) that lie on the top of the model’s hierarchy. Here, ϕj(p)’s and sj(p)’s act as normalizing constants that are cell-specific and θ p’s are global over-dispersion parameters capturing technical variability, which affect the expression counts of all genes and cells within each population. In this diagram, νj(p)’s and ρij(p)’s represent random effects related to technical and biological variability components, whose variability is controlled by θ p’s and δi(p)’s, respectively (see Additional file 1: Note 6.1). Finally, μi(p)’s and δi(p)’s, respectively, measure the overall expression of a gene i and its residual biological cell-to-cell over-dispersion (after normalization, technical noise removal and adjustment for overall expression) within each population. Colored areas highlight elements that are shared within a gene and/or cell. The latter emphasizes how our model borrows information across all cells to estimate parameters that are gene-specific and all genes to estimate parameters that are cell-specific. More details regarding the model setup can be found in the ‘Methods’ section of this article

Our strategy is flexible and can be combined with a variety of decision rules, which can be altered to reflect the biological question of interest. For example, if the aim is to detect genes whose overall expression changes between populations p and p, a natural decision rule is |log(μi(p)/μi(p))|>τ0, where τ0≥0 is an a priori chosen biologically significant threshold for LFCs in overall expression, to avoid highlighting genes with small changes in expression that are likely to be less biologically relevant [6, 14]. Alternatively, changes in biological cell-to-cell heterogeneity can be assessed using |log(δi(p)/δi(p))|>ω0, for a given minimum tolerance threshold ω0≥0. This is the main focus of this article. As a default option, we suggest setting τ0=ω0=0.4, which roughly coincides with a 50 % increase in overall expression or over-dispersion in whichever group of cells has the largest value (this choice is also supported by the control experiments shown in this article). To improve the interpretation of the genes highlighted by our method, these decision rules can also be complemented by, e.g., requiring a minimum number of cells where the expression of a gene is detected.

More details regarding the model setup and the implementation of posterior inference can be found in ‘Methods’.

Alternative approaches for identifying changes in mean expression

To date, most differential expression analyses of scRNA-seq data sets have borrowed methodology from bulk RNA-seq literature (e.g., DESeq2 [6] and edgeR [5]). However, such methods are not designed to capture features that are specific to SC-level experiments (e.g., the increased levels of technical noise). Instead, BASiCS, SCDE [7] and MAST [15] have been specifically developed with scRNA-seq data sets in mind. SCDE is designed to detect changes in mean expression while accounting for dropout events, where the expression of a gene is undetected in some cells due to biological variability or technical artifacts. For this purpose, SCDE employs a two-component mixture model where negative binomial and low-magnitude Poisson components model amplified genes and the background signal related to dropout events, respectively. MAST is designed to capture more complex changes in expression, using a hurdle model to study both changes in the proportion of cells where a gene is expressed above background and in the positive expression mean, defined as a conditional value – given than the gene is expressed above background levels. Additionally, MAST uses the fraction of genes that are detectably expressed in each cell (the cellular detection rate or CDR) as a proxy to quantify technical and biological artifacts (e.g., cell volume). SCDE and MAST rely on pre-normalized expression counts. Moreover, unlike BASiCS, SCDE and MAST use a definition of changes in expression mean that is conceptually different to what would be obtained based on a bulk population (which would consider all cells within a group, regardless of whether a gene is expressed above background or not).

The performance of these methods is compared in Additional file 1: Note S2 using real and simulated data sets. While control of the false discovery rate (FDR) is not well calibrated for BASiCS when setting τ0=0, this control is substantially improved when increasing the LFC threshold to τ0=0.4 – which is the default option we recommend (Additional file 1: Table S1). Not surprisingly, the higher FDR rates of BASiCS lead to higher sensitivity. In fact, our simulations suggest that BASiCS can correctly identify more genes that are differentially expressed than other methods. While this conclusion is based on synthetic data, it is also supported by the analysis of the cell-cycle data set described in [16] (see Additional file 1: Fig. S2), where we observe that SCDE and MAST fail to highlight a large number of genes for which a visual inspection suggests clear changes in overall expression (Additional file 1: Figs. S3 and S4). We hypothesize that this is partly due to conceptual differences in the definition of overall expression and, for MAST, the use of CDR as a covariate.

Alternative approaches for identifying changes in heterogeneity of expression

To the best of our knowledge, BASiCS is the first probabilistic tool to quantify gene-specific changes in the variability of expression between populations of cells. Instead, previous literature has focused on comparisons based on the coefficient of variation (CV), calculated from pre-normalized expression counts (e.g., [17]), for which no quantitative measure of differential variability has been obtained. More recently, [9] proposed a mean-corrected measure of variability to avoid the confounding effect between mean expression and CV. Nonetheless, the latter was designed to compare expression patterns for sets of genes, rather than for individual genes.

Not surprisingly, our analysis suggests that a quantification of technical variability is critical when comparing variability estimates between cell populations (Additional file 1: Note S3 and Fig. S5). In particular, comparisons based on CV estimates can mask the biological signal if the strength of technical variability varies between populations.

A control experiment: comparing single cells vs pool-and-split samples

To demonstrate the efficacy of our method, we use the control experiment described in [17], where single mESCs are compared against pool-and-split (P&S) samples, consisting of pooled RNA from thousands of mESCs split into SC equivalent volumes. Such a controlled setting provides a situation where substantial changes in overall expression are not expected as, on average, the overall expression of SCs should match the levels measured in P&S samples. Additionally, the design of P&S samples should remove biological variation, leading to a homogeneous set of samples. Hence, P&S samples are expected to show a genuine reduction in biological cell-to-cell heterogeneity compared to SCs.

Here, we display the analysis of samples cultured in a 2i media. Hyper-parameter values for μi(p)’s and δi(p)’s were set to aμ2=aδ2=0.5, so that extreme LFC estimates are shrunk towards (−3,3) (see ‘Methods’). However, varying aμ2 and aδ2 leads to almost identical results (not shown), suggesting that posterior inference is in fact dominated by the data. In these data, expression counts correspond to the number of molecules mapping to each gene within each cell. This is achieved by using unique molecular identifiers (UMIs), which remove amplification biases and reduce sources of technical variation [18]. Our analysis includes 74 SCs and 76 P&S samples (same inclusion criteria as in [17]) and expression counts for 9378 genes (9343 biological and 35 ERCC spikes) defined as those with at least 50 detected molecules in total across all cells. The R code used to perform this analysis is provided in Additional file 2.

To account for potential batch effects, we allowed different levels of technical variability to be estimated in each batch (see Additional file 1: Note S4 and Fig. S6). Moreover, we also performed an independent analysis of each batch of cells. As seen in Additional file 1: Fig. S7, the results based on the full data are roughly replicated in each batch, suggesting that our strategy is able to remove potential artifacts related to this batch effect.

As expected, our method does not reveal major changes in overall expression between SCs and P&S samples as the distribution of LFC estimates is roughly symmetric with respect to the origin (see Fig. 2a) and the majority of genes are not classified as differentially expressed at 5 % EFDR (see Fig. 3b). However, this analysis suggests that setting the minimum LFC tolerance threshold τ0 equal to 0 is too liberal as small LFCs are associated with high posterior probabilities of changes in expression (see Fig. 3a) and the number of differentially expressed genes is inflated (see Fig. 3b). In fact, counter-intuitively, 4710 genes (≈50 % of all analyzed genes) are highlighted to have a change in overall expression when using τ0=0. This is partially explained by the high nominal FDR rates displayed in Additional file 1: Note S2.1 where, for τ0=0, FDR is poorly calibrated when simulating under the null model. In addition, we hypothesize this heavy inflation is also due to small but statistically significant differences in expression that are not biologically meaningful. In fact, the number of genes whose overall expression changes is reduced to 559 (≈6 % of all analyzed genes) when setting τ0=0.4. As discussed earlier, this minimum threshold roughly coincides with a 50 % increase in overall expression and with the 90th percentile of empirical LFC estimates when simulating under the null model (no changes in expression). Posterior inference regarding biological over-dispersion is consistent with the experimental design, where the P&S samples are expected to have more homogeneous expression patterns. In fact, as shown in Fig. 2b, the distribution of estimated LFCs in biological over-dispersion is skewed towards positive values (higher biological over-dispersion in SCs). This is also supported by the results shown in Fig. 3b, where slightly more than 2000 genes exhibit increased biological over-dispersion in SCs and almost no genes (≈60 genes) are highlighted to have higher biological over-dispersion in the P&S samples (EFDR = 5 %). In this case, the choice of ω0 is less critical (within the range explored here). This is illustrated by the left panels in Fig. 3a, where tail posterior probabilities exceeding the cut-off defined by EFDR = 5 % correspond to similar ranges of LFC estimates.

Fig. 2.

Fig. 2

Estimated LFCs in expression (mean and over-dispersion) when comparing SCs vs P&S samples (2i serum culture). Posterior medians of LFC in (a) overall expression log(μ i(SC)/μ i(P&S)) and (b) biological over-dispersion log(δ i(SC)/δ i(P&S)) against the average between estimates of overall expression rates for SCs and P&S samples. Average values are defined as a weighted average between groups, with weights given by the number of samples within each group of cells. As expected, our analysis does not reveal major changes in expression levels between SC and P&S samples. In fact, the distribution of estimated LFCs in overall expression is roughly symmetric with respect to the origin. In contrast, we infer a substantial decrease in biological over-dispersion in the P&S samples. This is reflected by a skewed distribution of estimated LFCs in biological over-dispersion towards positive values. LFC log-fold change, P&S pool-and-split, SC single cell

Fig. 3.

Fig. 3

Summary of changes in expression patterns (mean and over-dispersion) for SCs vs P&S samples (EFDR = 5 %). a Volcano plots showing posterior medians of LFCs against estimated tail posterior probabilities. Left panels relate to the test where we assess if the absolute LFC in overall expression between SCs and P&S samples exceeds a minimum threshold τ 0. Estimates for LFCs in overall expression are truncated to the range (−1.5,1.5). Pink and green dots represent genes highlighted to have higher overall expression in the SC and P&S samples, respectively. Right panels relate to the test where we assess if the absolute LFC in biological over-dispersion between SC and P&S samples exceeds a minimum threshold ω 0. In all cases, horizontal dashed lines are located at probability cut-offs defined by EFDR = 5 %. Pink and green dots represent genes highlighted to have higher biological over-dispersion in the SC and P&S samples, respectively. b Bins in the horizontal axis summarize changes in overall expression between the groups. We use SC+ and P&S+ to denote that higher overall expression was detected in SC and P&S samples, respectively [the central group of bars (No diff.) corresponds to those genes where no significant differences were found]. Colored bars within each group summarize changes in biological over-dispersion between the groups. We use pink and green bars to denote higher biological over-dispersion in SC and P&S+ samples, respectively (and gray to denote no significant differences were found). The numbers of genes are displayed in log-scale. LFC log-fold change, P&S pool-and-split, SC single cell

mESCs across different cell-cycle stages

Our second example shows the analysis of the mESC data set presented in [16], which contains cells where the cell-cycle phase is known (G1, S and G2M). After applying the same quality control criteria as in [16], our analysis considers 182 cells (59, 58 and 65 cells in stages G1, S and G2M, respectively). To remove genes with consistently low expression across all cells, we excluded those genes with less than 20 reads per million (RPM), on average, across all cells. After this filter, 5,687 genes remain (including 5,634 intrinsic transcripts, and 53 ERCC spike-in genes). The R code used to perform this analysis is provided in Additional file 3.

As a proof of concept, to demonstrate the efficacy of our approach under a negative control, we performed permutation experiments, where cell labels were randomly permuted into three groups (containing 60, 60 and 62 samples, respectively). In this case, our method correctly infers that mRNA content as well as gene expression profiles do not vary across groups of randomly permuted cells (Fig. 4).

Fig. 4.

Fig. 4

Posterior estimates of model parameters based on random permutations of the mESC cell-cycle data set. For a single permuted data set: a Empirical distribution of posterior medians for mRNA content normalizing constants ϕjp across all cells. b Empirical distribution of posterior medians for gene-specific expression rates μ ip across all genes. c Empirical distribution of posterior medians for gene-specific biological over-dispersion parameters δ ip across all genes. d As an average across ten random permutations. Upper diagonal panels compare estimates for gene-specific expression rates μ ip between groups of cells. Lower diagonal panels compare gene-specific biological over-dispersion parameters δ ip between groups of cells

As cells progress through the cell cycle, cellular mRNA content increases. In particular, our model infers that mRNA content is roughly doubled when comparing cells in G1 vs G2M, which is consistent with the duplication of genetic material prior to cell division (Fig. 5a). Our analysis suggests there are no major shifts in expression levels between cell-cycle stages (Fig. 5b and upper triangular panels in Fig. 5d). Nonetheless, a small number of genes are identified as displaying changes in overall expression between cell-cycle phases at 5 % EFDR for τ0=0.4 (Fig. 6). To validate our results, we performed gene ontology (GO) enrichment analysis within those genes classified as differentially expressed between cell-cycle phases (see Additional file 3). Not surprisingly, we found an enrichment of mitotic genes among the 545 genes classified as differentially expressed between G1 and G2M cells. In addition, the 209 differentially expressed genes between S and G2M are enriched for regulators of cytokinesis, which is the final stage of the cell cycle where a progenitor cell divides into two daughter cells [19].

Fig. 5.

Fig. 5

Posterior estimates of model parameters for mESCs across different cell-cycle phases. a Empirical distribution of posterior medians for mRNA content normalizing constants ϕj(p) across all cells. b Empirical distribution of posterior medians for gene-specific expression rates μi(p) across all genes. c Empirical distribution of posterior medians for gene-specific biological over-dispersion parameters δi(p) across all genes. d Upper diagonal panels compare estimates for gene-specific expression rates μi(p) between groups of cells. Lower diagonal panels compare gene-specific biological over-dispersion parameters δi(p) between groups of cells. While our results suggest there are no major shifts in mean expression between cell-cycle stages, our results suggest a substantial decrease in biological over-dispersion when cells move from G1 to the S phase, followed by a slight increase after the transition from S to the G2M phase (to give a rough quantification of this statement, panel (d) includes the percentage of point estimates that lie on each side of the diagonal line)

Fig. 6.

Fig. 6

Summary of changes in expression patterns (mean and over-dispersion) for the mESC cell-cycle data set (EFDR = 5 %). Bins in the horizontal axis summarize changes in overall expression between each pair of groups. We use G1+, S+ and G2M+ to denote that higher overall expression was detected in cell-cycle phase G1, S and G2M, respectively [the central group of bars (No diff.) corresponds to those genes where no significant differences were found]. Colored bars within each group summarize changes in biological over-dispersion between the groups. We use pink, green and yellow bars to denote higher biological over-dispersion in cell-cycle phases G1, S and G2M, respectively (and gray to denote no significant differences were found). The numbers of genes are displayed in log-scale

Our method suggests a substantial decrease in biological over-dispersion when cells move from G1 to the S phase, followed by a slight increase after the transition from S to the G2M phase (see Fig. 5c and the lower triangular panels in Fig. 5d). This is consistent with the findings in [19], where the increased gene expression variability observed in G2M cells is attributed to an unequal distribution of genetic material during cytokinesis and the S phase is shown to have the most stable expression patterns within the cell cycle. Here, we discuss GO enrichment of those genes whose overall expression rate remains constant (EFDR = 5 %, τ0=0.4) but that exhibit changes in biological over-dispersion between cell-cycle stages (EFDR = 5 %, ω0=0.4). Critically, these genes will not be highlighted by traditional differential expression tools, which are restricted to differences in overall expression rates. For example, among the genes with higher biological over-dispersion in G1 with respect to the S phase, we found an enrichment of genes related to protein dephosphorylation. These are known regulators of the cell cycle [20]. Moreover, we found that genes with lower biological over-dispersion in G2M cells are enriched for genes related to DNA replication checkpoint regulation (which delays entry into mitosis until DNA synthesis is completed [21]) relative to G1 cells and mitotic cytokinesis when comparing to S cells. Both of these processes are likely to be more tightly regulated in the G2M phase. A full table with GO enrichment analysis of the results described here is provided in Additional file 3.

Conclusions

Our method provides a quantitative tool to study changes in gene expression patterns between pre-specified populations of cells. Unlike traditional differential expression analyses, our model is able to identify changes in expression that are not necessarily reflected by shifts in the mean. This allows a better understanding of the differences between distinct populations of cells. In particular, we focus on the detection of genes whose residual biological heterogeneity (after normalization and technical noise removal) varies between the populations. This is quantified through biological over-dispersion parameters, which capture variance inflation with respect to the level that would be expected in a homogeneous population of cells while attenuating the well-known confounding relationship between mean and variance in count-based data sets. Despite this, several case studies (including the ones displayed in the manuscript and other examples analyzed throughout model development) suggest that – for a homogeneous population of cells – there is a strong relationship between posterior estimates of overall expression parameters μi(p) and over-dispersion parameters δi(p) (this is broken when analyzing heterogeneous populations, see Section S8 in [8]). This is illustrated in Additional file 1: Note S5 using the cell-cycle data set analyzed here (Additional file 1: Figs. S8 and S9). Due to this interplay between overall expression and over-dispersion, the interpretation of over-dispersion parameters δi(p) requires careful consideration. In particular, it is not trivial to interpret differences between δi(p)’s when the μi(p)’s also change. As a consequence, our analysis focuses on genes undergoing changes in over-dispersion but whose overall expression remains unchanged. This set of genes can provide novel biological insights that would not be uncovered by traditional differential expression analysis tools.

A decision rule to determine changes in expression patterns is defined through a probabilistic approach based on tail posterior probabilities and calibrated using the EFDR. The performance of our method was demonstrated using a controlled experiment where we recovered the expected behavior of gene expression patterns.

One caveat of our approach is the limited interpretation of the over-dispersion parameter when a gene is not expressed in a given population of cells or when the expression of a gene is only detected in a small proportion of cells (e.g., high expression in a handful of cells but no expression in the remaining cells). These situations will be reflected in low and high estimates of δi(p), respectively. However, the biological relevance of these estimates is not clear. Hence, to improve the interpretation of the genes highlighted by our method, we suggest complementing the decision rules presented here by conditioning the results of the test on a minimum number of cells where the expression of a gene is detected.

Currently, our approach requires predefined populations of cells (e.g., defined by cell types or experimental conditions). However, a large number of scRNA-seq experiments involve a mixed population of cells, where cell types are not known a priori (e.g., [13]). In such cases, expression profiles can be used to cluster cells into distinct groups and to characterize markers for such sub-populations. Nonetheless, unknown group structures introduce additional challenges for normalization and quantification of technical variability since, e.g., noise levels can vary substantially between different cell populations. A future extension of our work is to combine the estimation procedure within our model with a clustering step, propagating the uncertainty associated with each of these steps into downstream analysis. In the meantime, if the analyzed population of cells contains a sub-population structure, we advise the user to cluster cells first (e.g., using a rank-based correlation, which is more robust to normalization), thus defining groups of cells that can be used as an input for BASiCS. This step will also aid the interpretation of model parameters that are gene-specific.

Until recently, most scRNA-seq data sets consisted of hundreds (and sometimes thousands) of cells. However, droplet-based approaches [22, 23] have recently allowed parallel sequencing of substantially larger numbers of cells in an effective manner. This brings additional challenges to the statistical analysis of scRNA-seq data sets (e.g., due to the existence of unknown sub-populations, requiring unsupervised approaches). In particular, current protocols do not allow the addition of technical spike-in genes. As a result, the deconvolution of biological and technical artifacts has become less straightforward. Moreover, the increased sample sizes emphasize the need for more computationally efficient approaches that are still able to capture the complex structure embedded within scRNA-seq data sets. To this end, we foresee the use of parallel programming as a tool for reducing computing times. Additionally, we are also exploring approximated posterior inference based, for example, on an integrated nested Laplace approximation [24].

Finally, our approach lies within a generalized linear mixed model framework. Hence, it can be easily extended to include additional information such as covariates (e.g., cell-cycle stage, gene length and GC content) and experimental design (e.g., batch effects) using fixed and/or random effects.

Methods

A statistical model to detect changes in expression patterns for scRNA-seq data sets

In this article, we introduce a statistical model for identifying genes whose expression patterns change between predefined populations of cells (given by experimental conditions or cell types). Such changes can be reflected via the overall expression level of each gene as well as through changes in cell-to-cell biological heterogeneity. Our method is motivated by features that are specific to scRNA-seq data sets. In this context, it is essential to normalize and remove technical artifacts appropriately from the data before extracting the biological signal. This is particularly critical when there are substantial differences in cellular mRNA content, amplification biases and other sources of technical variation. For this purpose, we exploit technical spike-in genes, which are added at the (theoretically) same quantity to each cell’s lysate. A typical example is the set of 92 ERCC molecules developed by the External RNA Control Consortium [11]. Our method builds upon BASiCS [8] and can perform comparisons between multiple populations of cells using a single model. Importantly, our strategy avoids stepwise procedures where data sets are normalized prior to any downstream analysis. This is an advantage over methods using pre-normalized counts, as the normalization step can be distorted by technical artifacts.

We assume that there are P groups of cells to be compared, each containing np cells (p=1,…,P). Let Xij(p) be a random variable representing the expression count of a gene i (i=1,…,q) in the jth cell from group p. Without loss of generality, we assume the first q0 genes are biological and the remaining qq0 are technical spikes. Extending the formulation in BASiCS, we assume that

EXij(p)=ϕj(p)sj(p)μi(p),i=1,,q0;sj(p)μi(p),i=q0+1,,q.and (1)
CV2Xij(p)=(ϕj(p)sj(p)μi(p))1+θp+δi(p)(θp+1),i=1,,q0;(sj(p)μi(p))1+θp,i=q0+1,,q, (2)

with μi(p)μi for i=q0+1,…,q and where CV stands for coefficient of variation (i.e., the ratio between standard deviation and mean). These expressions are the result of a Poisson hierarchical structure (see Additional file 1: Note S6.1). Here, ϕj(p)’s act as cell-specific normalizing constants (fixed effects), capturing differences in input mRNA content across cells (reflected by the expression counts of intrinsic transcripts only). A second set of normalizing constants, sj(p)’s, capture cell-specific scale differences affecting the expression counts of all genes (intrinsic and technical). Among others, these differences can relate to sequencing depth, capture efficiency and amplification biases. However, a precise interpretation of the sj(p)’s varies across experimental protocols, e.g., amplification biases are removed when using UMIs [18]. In addition, θp’s are global technical noise parameters controlling the over-dispersion (with respect to Poisson sampling) of all genes within group p. The overall expression rate of a gene i in group p is denoted by μi(p). These are used to quantify changes in the overall expression of a gene across groups. Similarly, the δi(p)’s capture residual over-dispersion (beyond what is due to technical artifacts) of every gene within each group. These so-called biological over-dispersion parameters relate to heterogeneous expression of a gene across cells. For each group, stable housekeeping-like genes lead to δi(p)0 (low residual variance in expression across cells) and highly variable genes are linked to large values of δi(p). A novelty of our approach is the use of δi(p) to quantify changes in biological over-dispersion. Importantly, this attenuates confounding effects due to changes in overall expression between the groups.

A graphical representation of this model is displayed in Fig. 1. To ensure identifiability of all model parameters, we assume that μi(p)’s are known for the spike-in genes (and given by the number of spike-in molecules that are added to each well). Additionally, we impose the identifiability restriction

1npj=1npϕj(p)=1,forp=1,,P. (3)

Here, we discuss the priors assigned to parameters that are gene- and group-specific (see Additional file 1: Note S6.2 for the remaining elements of the prior). These are given by

μi(p)iidlogN0,aμ2andδi(p)iidlogN0,aδ2fori=1,,q0. (4)

Hereafter, without loss of generality, we simplify our notation to focus on two-group comparisons. This is equivalent to assigning Gaussian prior distributions for LFCs in overall expression (τi) or biological over-dispersion (ωi). In such a case, it follows that

τilogμi(1)μi(2)N0,2aμ2andωilogδi(1)δi(2)N0,2aδ2. (5)

Hence, our prior is symmetric, meaning that we do not a priori expect changes in expression to be skewed towards either group of cells. Values for aμ2 and aδ2 can be elicited using an expected range of values for LFC in expression and biological over-dispersion, respectively. The latter is particularly useful in situations where a gene is not expressed (or very lowly expressed) in one of the groups, where, e.g., LFCs in overall expression are undefined (the maximum likelihood estimate of τi would be ±, the sign depending on which group expresses gene i). A popular solution to this issue is the addition of pseudo-counts, where an arbitrary number is added to all expression counts (in all genes and cells). This strategy is also adopted in models that are based on log-transformed expression counts (e.g., [15]). While the latter guarantees that τi is well defined, it leads to artificial estimates for τi (see Table 1). Instead, our approach exploits an informative prior (indexed by aμ2) to shrink extreme estimates of τi towards an expected range. This strategy leads to a meaningful shrinkage strength, which is based on prior knowledge. Importantly – and unlike the addition of pseudo-counts – our approach is also helpful when comparing biological over-dispersion between the groups. In fact, if a gene i is not expressed in one of the groups, this will lead to a non-finite estimate of ωi (if all expression counts in a group are equal to zero, the corresponding estimate of the biological over-dispersion parameters would be equal to zero). Adding pseudo-counts cannot resolve this issue, but imposing an informative prior for ωi (indexed by aω2) will shrink estimates towards the appropriate range.

Table 1.

Synthetic example to illustrate the effect of addition of pseudo-counts over the estimation of LFCs in overall expression

Empirical Adding 0.5 Adding 1
estimate pseudo-counts pseudo-count
Overall expression rate in population 1 (μi(1)) 10 10.5 11
Overall expression rate in population 2 (μi(2)) 0 0.5 1
LFC in overall expression 1 vs 2 + 3.04 2.40

For simplicity, we assume that normalization is not required so that pseudo-counts are linearly reflected in the overall expression rates. While pseudo-counts introduce an additive effect, LFC estimates measure changes on a multiplicative scale. Hence, addition of pseudo-counts leads to an artificial deflation of LFC estimates. As a consequence, such estimates cannot be meaningfully interpreted

Generally, posterior estimates of τi and ωi are robust to the choice of aμ2 and aδ2, as the data is informative and dominates posterior inference. In fact, these values are only influential when shrinkage is needed, e.g., when there are zero total counts in one of the groups. In such cases, posterior estimates of τi and ωi are dominated by the prior, yet the method described below still provides a tool to quantify evidence of changes in expression. As a default option, we use aμ2=aδ2=0.5 leading to τi,ωi∼ N(0,1). These default values imply that approximately 99 % of the LFCs in overall expression and over-dispersion are expected a priori to lie in the interval (−3,3). This range seems reasonable in light of the case studies we have explored. If a different range is expected, this can be easily modified by the user by setting different values for aμ2 and aδ2.

Posterior samples for all model parameters are generated via an adaptive Metropolis within a Gibbs sampling algorithm [25]. A detailed description of our implementation can be found in Additional file 1: Note S6.3.

Post hoc correction of global shifts in input mRNA content between the groups

The identifiability restriction in Eq. 3 applies only to cells within each group. As a consequence, if they exist, global shifts in cellular mRNA content between groups (e.g., if all mRNAs were present at twice the level in one population related to another) are absorbed by the μi(p)’s. To assess changes in the relative abundance of a gene, we adopt a two-step strategy where: (1) model parameters are estimated using the identifiability restriction in Eq. 3 and (2) global shifts in endogenous mRNA content are treated as a fixed offset and corrected post hoc. For this purpose, we use the sum of overall expression rates (intrinsic genes only) as a proxy for the total mRNA content within each group. Without loss of generality, we use the first group of cells as a reference population. For each population p (p=1,…,P), we define a population-specific offset effect:

Λp=i=1q0μi(p)i=1q0μi(1) (6)

and perform the following offset correction:

μ~i(p)=μi(p)Λp,ϕ~j(p)=ϕj(p)×Λp,i=1,,q0;jp=1,,np. (7)

This is equivalent to replacing the identifiability restriction in Eq. 3 by

1npj=1npϕj(p)=Λp,forp=1,,P. (8)

Technical details regarding the implementation of this post hoc offset correction are explained in Additional file 1: Note S6.4. The effect of this correction is illustrated in Fig. 7 using the cell-cycle data set described in the main text. As an alternative, we also explored the use of the ratio between the total intrinsic counts over total spike-in counts to define a similar offset correction based on

Λp=medianj=1,,npi=1q0Xij(p)i=q0+1qXij(p)medianj=1,,n1i=1q0Xij(1)i=q0+1qXij(1). (9)

Fig. 7.

Fig. 7

Post hoc offset correction for cell-cycle data set. Upper panels display posterior medians for LFC in overall expression against the weighted average between estimates of overall expression rates for G1, S and G2M cells (weights defined by the number of cells in each group). Lower panels illustrate the effect of the offset correction upon the empirical distribution of posterior estimates for mRNA content normalizing constants ϕj(p). These figures illustrate a shift in mRNA content throughout cell-cycle phases. In particular, our model infers that cellular mRNA is roughly duplicated when comparing G1 to G2M cells. LFC log-fold change

For the cell-cycle data set, both alternatives are equivalent. Nonetheless, the first option is more robust in cases where a large number of differentially expressed genes are present. Hereafter, we use μi(p) and ϕj(p) to denote μ~i(p) and ϕ~j(p), respectively.

A probabilistic approach to quantify evidence of changes in expression patterns

A probabilistic approach is adopted, assessing changes in expression patterns (mean and over-dispersion) through a simple and intuitive scale of evidence. Our strategy is flexible and can be combined with a variety of decision rules. In particular, here we focus on highlighting genes whose absolute LFC in overall expression and biological over-dispersion between the populations exceeds minimum tolerance thresholds τ0 and ω0, respectively (τ0,ω0≥0), set a priori. The usage of such minimum tolerance levels for LFCs in expression has also been discussed in [14] and [6] as a tool to improve the biological significance of detected changes in expression and to improve upon FDRs.

For a given probability threshold αM (0.5<αM<1), a gene i is identified as exhibiting a change in overall expression between populations p and p if

πippM(τ0)P(|log(μi(p)/μi(p))|>τ0|{data})>αM,i=1,,q0. (10)

If τ0→0, πiM(τ0)1 becoming uninformative to detect changes in expression. As in [26], in the limiting case where τ0=0, we define

πippM(0)=2maxπ~ippM,1π~ippM1 (11)

with

π~ippM=Plogμi(p)/μi(p)>0{data}. (12)

A similar approach is adopted to study changes in biological over-dispersion between populations p and p, using

πippD(ω0)P|logδi(p)/δi(p)|>ω0|{data}>αD, (13)

for a fixed probability threshold αD (0.5<αD<1). In line with Eqs. 11 and 12, we also define

πippD(0)=2maxπ~ippD,1π~ippD1 (14)

with

π~ippD=Plogδi(p)/δi(p)>0{data}. (15)

Evidence thresholds αM and αD can be fixed a priori. Otherwise, these can be defined by controlling the EFDR [13]. In our context, these are given by

EFDRαM(τ0)=i=1q01πiM(τ0)IπiM(τ0)>αMi=1q0IπiM(τ0)>αM (16)

and

EFDRαD(ω0)=i=1q01πiD(ω0)IπiD(ω0)>αDi=1q0IπiD(ω0)>αD, (17)

where I(A)=1 if event A is true, 0 otherwise. Critically, the usability of this calibration rule relies on the existence of genes under both the null and the alternative hypothesis (i.e., with and without changes in expression). While this is not a practical limitation in real case studies, this calibration might fail to return a value in benchmark data sets (e.g., simulation studies), where there are no changes in expression. As a default, if EFDR calibration is not possible, we set αM=αD=0.90.

The posterior probabilities in Eqs. 10, 11, 13 and 14 can be easily estimated – as a post-processing step – once the model has been fitted (see Additional file 1: Note S6.5). In addition, our strategy is flexible and can be easily extended to investigate more complex hypotheses, which can be defined post hoc, e.g., to identify those genes that show significant changes in cell-to-cell biological over-dispersion but that maintain a constant level of overall expression between the groups, or conditional decision rules where we require a minimum number of cells where the expression of a gene is detected.

Software

Our implementation is freely available as an R package [27], using a combination of R and C++ functions through the Rcpp library [28]. This can be found in https://github.com/catavallejos/BASiCS, released under the GPL license.

Availability of supporting data

All data sets analyzed in this article are publicly available in the cited references.

Ethics

Not applicable.

Additional files

Additional file 1 (3MB, pdf)

Supplementary material. Section S1 illustrates the interaction between cell- and gene-specific model parameters. Section S2 provides a comparative analysis of BASiCS and alternative methods regarding the detection of differentially expressed genes (changes in mean). Section S3 illustrates the usage of the coefficient of variation as a measure of cellular heterogeneity. Section S4 describes the treatment of potential batch effects used for the analysis of the data set provided by [17]. Section S5 illustrates the interplay between mean and over-dispersion parameters that is typically observed in homogeneous populations of cells. Section S6 contains additional details regarding the statistical model presented in this article and the implementation of Bayesian inference. (PDF 1443 kb)

Additional file 2 (1.4MB, pdf)

Data analysis (part 1). R code used to analyze the single cells vs pool-and-split samples data set. (PDF 3952 kb)

Additional file 3 (3.9MB, pdf)

Data analysis (part 2). R code used to analyze the cell-cycle data set. (PDF 3051 kb)

Acknowledgments

We acknowledge all members of the Richardson research group (Medical Research Council - Biostatistics Unit, MRC-BSU) and Marioni laboratory (European Molecular Biology Laboratory - European Bioinformatics Institute, EMBL-EBI; Cancer Research UK - Cambridge Institute, CRUK-CI) for support and discussions during the preparation of this document. In particular, we are grateful to Nils Eling (EMBL-EBI), Antonio Scialdone (EMBL-EBI) and Aaron Lun (CRUK-CI) for numerous discussions and suggestions that enriched the final version of the manuscript. We also thank the editorial team of Genome Biology and two independent reviewers for the positive feedback and many insightful and constructive comments provided.

Abbreviations

BASiCS

Bayesian analysis of single-cell sequencing data

bulk RNA-seq

bulk RNA sequencing

CDR

cellular detection rate

CV

coefficient of variation

EFDR

expected false discovery rate

ERCC

External RNA Control Consortium

FDR

false discovery rate

GO

gene ontology

LFC

log-fold change

MCMC

Markov chain Monte Carlo

mESC

mouse embryonic stem cell

P&S

pool-and-split

SC

single cell

scRNA-seq

single-cell RNA sequencing

UMI

unique molecular identifier

Footnotes

Competing interests

The authors declare that they have no competing interests.

Authors’ contributions

CAV, JCM and SR conceived and designed the methods and experiments. CAV implemented the methods and analyzed the data. All authors were involved in writing the paper and have approved the final version.

Funding

JCM and CAV acknowledge core EMBL funding. SR and CAV acknowledge core MRC funding (MRC_MC_UP_0801/1). JCM acknowledges core support from CRUK.

Contributor Information

Catalina A. Vallejos, Email: catalina.vallejos@mrc-bsu.cam.ac.uk

Sylvia Richardson, Email: sylvia.richardson@mrc-bsu.cam.ac.uk.

John C. Marioni, Email: marioni@ebi.ac.uk

References

  • 1.Zeisel A, Muñoz-Manchado AB, Codeluppi S, Lönnerberg P, La Manno G, Juréus A, et al. Cell types in the mouse cortex and hippocampus revealed by single-cell RNA-seq. Science. 2015;347(6226):1138–42. doi: 10.1126/science.aaa1934. [DOI] [PubMed] [Google Scholar]
  • 2.Jaitin DA, Kenigsberg E, Keren-Shaul H, Elefant N, Paul F, Zaretsky I, et al. Massively parallel single-cell RNA-seq for marker-free decomposition of tissues into cell types. Science. 2014;343(6172):776–9. doi: 10.1126/science.1247651. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 3.Patel AP, Tirosh I, Trombetta JJ, Shalek AK, Gillespie SM, Wakimoto H, et al. Single-cell RNA-seq highlights intratumoral heterogeneity in primary glioblastoma. Science. 2014;344(6190):1396–401. doi: 10.1126/science.1254257. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 4.Brennecke P, Anders S, Kim JK, Kołodziejczyk AA, Zhang X, Proserpio V, et al. Accounting for technical noise in single-cell RNA-seq experiments. Nat Methods. 2013;10(11):1093–5. doi: 10.1038/nmeth.2645. [DOI] [PubMed] [Google Scholar]
  • 5.Robinson MD, McCarthy DJ, Smyth GK. edgeR: a Bioconductor package for differential expression analysis of digital gene expression data. Bioinformatics. 2010;26(1):139–40. doi: 10.1093/bioinformatics/btp616. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 6.Love MI, Huber W, Anders S. Moderated estimation of fold change and dispersion for RNA-seq data with DESeq2. Genome Biol. 2014;15(12):550. doi: 10.1186/s13059-014-0550-8. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 7.Kharchenko PV, Silberstein L, Scadden DT. Bayesian approach to single-cell differential expression analysis. Nat Methods. 2014;11(7):740–2. doi: 10.1038/nmeth.2967. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 8.Vallejos CA, Marioni JC, Richardson S. BASiCS: Bayesian analysis of single-cell sequencing data. PLoS Comput Biol. 2015;11(6):1004333. doi: 10.1371/journal.pcbi.1004333. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 9.Kolodziejczyk AA, Kim JK, Tsang JC, Ilicic T, Henriksson J, Natarajan KN, et al. Single cell RNA-sequencing of pluripotent states unlocks modular transcriptional variation. Cell Stem Cell. 2015;17(4):471–85. doi: 10.1016/j.stem.2015.09.011. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 10.McCarthy DJ, Chen Y, Smyth GK. Differential expression analysis of multifactor RNA-Seq experiments with respect to biological variation. Nucleic Acids Res. 2012;40(10). [DOI] [PMC free article] [PubMed]
  • 11.Jiang L, Schlesinger F, Davis CA, Zhang Y, Li R, Salit M, et al. Synthetic spike-in standards for RNA-seq experiments. Genome Res. 2011;21(9):1543–51. doi: 10.1101/gr.121095.111. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 12.Lovén J, Orlando DA, Sigova AA, Lin CY, Rahl PB, Burge CB, et al. Revisiting global gene expression analysis. Cell. 2012;151(3):476–82. doi: 10.1016/j.cell.2012.10.012. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 13.Newton MA, Noueiry A, Sarkar D, Ahlquist P. Detecting differential gene expression with a semiparametric hierarchical mixture method. Biostatistics. 2004;5(2):155–76. doi: 10.1093/biostatistics/5.2.155. [DOI] [PubMed] [Google Scholar]
  • 14.McCarthy DJ, Smyth GK. Testing significance relative to a fold-change threshold is a treat. Bioinformatics. 2009;25(6):765–71. doi: 10.1093/bioinformatics/btp053. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 15.Finak G, McDavid A, Yajima M, Deng J, Gersuk V, Shalek AK, et al. Mast: a flexible statistical framework for assessing transcriptional changes and characterizing heterogeneity in single-cell RNA sequencing data. Genome Biol. 2015;16(1):1–13. doi: 10.1186/s13059-015-0844-5. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 16.Buettner F, Natarajan KN, Casale FP, Proserpio V, Scialdone A, Theis FJ, et al. Computational analysis of cell-to-cell heterogeneity in single-cell RNA-sequencing data reveals hidden subpopulations of cells. Nat Biotechnol. 2015;33:155–60. doi: 10.1038/nbt.3102. [DOI] [PubMed] [Google Scholar]
  • 17.Grün D, Kester L, van Oudenaarden A. Validation of noise models for single-cell transcriptomics. Nat Methods. 2014;11(6):637–40. doi: 10.1038/nmeth.2930. [DOI] [PubMed] [Google Scholar]
  • 18.Islam S, Zeisel A, Joost S, La Manno G, Zajac P, Kasper M, et al. Quantitative single-cell RNA-seq with unique molecular identifiers. Nat Methods. 2014;11(2):163–6. doi: 10.1038/nmeth.2772. [DOI] [PubMed] [Google Scholar]
  • 19.Darzynkiewicz Z, Crissman H, Traganos F, Steinkamp J. Cell heterogeneity during the cell cycle. J Cell Physiol. 1982;113(3):465–74. doi: 10.1002/jcp.1041130316. [DOI] [PubMed] [Google Scholar]
  • 20.Clemens A. Protein phosphorylation in cell growth regulation. Amsterdam: Harwood Academic Publishers; 1996. [Google Scholar]
  • 21.Boddy MN, Russell P. DNA replication checkpoint. Curr Biol. 2001;11(23):953–6. doi: 10.1016/S0960-9822(01)00572-3. [DOI] [PubMed] [Google Scholar]
  • 22.Klein AM, Mazutis L, Akartuna I, Tallapragada N, Veres A, Li V, et al. Droplet barcoding for single-cell transcriptomics applied to embryonic stem cells. Cell. 2015;161(5):1187–201. doi: 10.1016/j.cell.2015.04.044. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 23.Macosko EZ, Basu A, Satija R, Nemesh J, Shekhar K, Goldman M, et al. Highly parallel genome-wide expression profiling of individual cells using nanoliter droplets. Cell. 2015;161(5):1202–14. doi: 10.1016/j.cell.2015.05.002. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 24.Rue H, Martino S, Chopin N. Approximate Bayesian inference for latent Gaussian models by using integrated nested Laplace approximations. J R Stat Soc Ser B Methodol. 2009;71(2):319–92. doi: 10.1111/j.1467-9868.2008.00700.x. [DOI] [Google Scholar]
  • 25.Roberts GO, Rosenthal JS. Examples of adaptive MCMC. J Comput Graph Stat. 2009;18(2):349–67. doi: 10.1198/jcgs.2009.06134. [DOI] [Google Scholar]
  • 26.Bochkina N, Richardson S. Tail posterior probability for inference in pairwise and multiclass gene expression data. Biometrics. 2007;63(4):1117–25. doi: 10.1111/j.1541-0420.2007.00807.x. [DOI] [PubMed] [Google Scholar]
  • 27.R Core Team . R: a language and environment for statistical computing. Vienna: R Foundation for Statistical Computing; 2014. [Google Scholar]
  • 28.Eddelbuettel D, François R, Allaire J, Chambers J, Bates D, Ushey K. Rcpp: Seamless R and C++ integration. J Stat Softw. 2011;40(8):1–18. doi: 10.18637/jss.v040.i08. [DOI] [Google Scholar]

Associated Data

This section collects any data citations, data availability statements, or supplementary materials included in this article.

Supplementary Materials

Additional file 1 (3MB, pdf)

Supplementary material. Section S1 illustrates the interaction between cell- and gene-specific model parameters. Section S2 provides a comparative analysis of BASiCS and alternative methods regarding the detection of differentially expressed genes (changes in mean). Section S3 illustrates the usage of the coefficient of variation as a measure of cellular heterogeneity. Section S4 describes the treatment of potential batch effects used for the analysis of the data set provided by [17]. Section S5 illustrates the interplay between mean and over-dispersion parameters that is typically observed in homogeneous populations of cells. Section S6 contains additional details regarding the statistical model presented in this article and the implementation of Bayesian inference. (PDF 1443 kb)

Additional file 2 (1.4MB, pdf)

Data analysis (part 1). R code used to analyze the single cells vs pool-and-split samples data set. (PDF 3952 kb)

Additional file 3 (3.9MB, pdf)

Data analysis (part 2). R code used to analyze the cell-cycle data set. (PDF 3051 kb)


Articles from Genome Biology are provided here courtesy of BMC

RESOURCES