Abstract
Free full text
Differential expression analysis for sequence count data
Abstract
High-throughput sequencing assays such as RNA-Seq, ChIP-Seq or barcode counting provide quantitative readouts in the form of count data. To infer differential signal in such data correctly and with good statistical power, estimation of data variability throughout the dynamic range and a suitable error model are required. We propose a method based on the negative binomial distribution, with variance and mean linked by local regression and present an implementation, DESeq, as an R/Bioconductor package.
Background
High-throughput sequencing of DNA fragments is used in a range of quantitative assays. A common feature between these assays is that they sequence large amounts of DNA fragments that reflect, for example, a biological system's repertoire of RNA molecules (RNA-Seq [1,2]) or the DNA or RNA interaction regions of nucleotide binding molecules (ChIP-Seq [3], HITS-CLIP [4]). Typically, these reads are assigned to a class based on their mapping to a common region of the target genome, where each class represents a target transcript, in the case of RNA-Seq, or a binding region, in the case of ChIP-Seq. An important summary statistic is the number of reads in a class; for RNA-Seq, this read count has been found to be (to good approximation) linearly related to the abundance of the target transcript [2]. Interest lies in comparing read counts between different biological conditions. In the simplest case, the comparison is done separately, class by class. We will use the term gene synonymously to class, even though a class may also refer to, for example, a transcription factor binding site, or even a barcode [5].
We would like to use statistical testing to decide whether, for a given gene, an observed difference in read counts is significant, that is, whether it is greater than what would be expected just due to natural random variation.
If reads were independently sampled from a population with given, fixed fractions of genes, the read counts would follow a multinomial distribution, which can be approximated by the Poisson distribution.
Consequently, the Poisson distribution has been used to test for differential expression [6,7]. The Poisson distribution has a single parameter, which is uniquely determined by its mean; its variance and all other properties follow from it; in particular, the variance is equal to the mean. However, it has been noted [1,8] that the assumption of Poisson distribution is too restrictive: it predicts smaller variations than what is seen in the data. Therefore, the resulting statistical test does not control type-I error (the probability of false discoveries) as advertised. We show instances for this later, in the Discussion.
To address this so-called overdispersion problem, it has been proposed to model count data with negative binomial (NB) distributions [9], and this approach is used in the edgeR package for analysis of SAGE and RNA-Seq [8,10]. The NB distribution has parameters, which are uniquely determined by mean μ and variance σ2. However, the number of replicates in data sets of interest is often too small to estimate both parameters, mean and variance, reliably for each gene. For edgeR, Robinson and Smyth assumed [11] that mean and variance are related by σ2 = μ + αμ2, with a single proportionality constant α that is the same throughout the experiment and that can be estimated from the data. Hence, only one parameter needs to be estimated for each gene, allowing application to experiments with small numbers of replicates.
In this paper, we extend this model by allowing more general, data-driven relationships of variance and mean, provide an effective algorithm for fitting the model to data, and show that it provides better fits (Section Model). As a result, more balanced selection of differentially expressed genes throughout the dynamic range of the data can be obtained (Section Testing for differential expression). We demonstrate the method by applying it to four data sets (Section Applications) and discuss how it compares to alternative approaches (Section Conclusions).
Results and Discussion
Model
Description
We assume that the number of reads in sample j that are assigned to gene i can be modeled by a negative binomial (NB) distribution,
which has two parameters, the mean μij and the variance
In practice, we do not know the parameters μij and
First, the mean parameter μij, that is, the expectation value of the observed counts for gene i in sample j, is the product of a condition-dependent per-gene value qi, ρ(j) (where ρ(j) is the experimental condition of sample j) and a size factor sj,
qi,ρ(j) is proportional to the expectation value of the true (but unknown) concentration of fragments from gene i under condition ρ(j). The size factor sj represents the coverage, or sampling depth, of library j, and we will use the term common scale for quantities, such as qi, ρ(j), that are adjusted for coverage by dividing by sj.
Second, the variance
Third, we assume that the per-gene raw variance parameter vi, ρ is a smooth function of qi, ρ,
This assumption is needed because the number of replicates is typically too low to get a precise estimate of the variance for gene i from just the data available for this gene. This assumption allows us to pool the data from genes with similar expression strength for the purpose of variance estimation.
The decomposition of the variance in Equation (3) is motivated by the following hierarchical model: We assume that the actual concentration of fragments from gene i in sample j is proportional to a random variable Rij, such that the rate that fragments from gene i are sequenced is sjrij. For each gene i and all samples j of condition ρ, the Rij are i.i.d. with mean qiρ and variance viρ. Thus, the count value Kij, conditioned on Rij = rij, is Poisson distributed with rate sjrij. The marginal distribution of Kij - when allowing for variation in Rij - has the mean μij and (according to the law of total variance) the variance given in Equation (3). Furthermore, if the higher moments of Rij are modeled according to a gamma distribution, the marginal distribution of Kij is NB (see, for example, [12], Section 4.2.2).
Fitting
We now describe how the model can be fitted to data. The data are an n × m table of counts, kij, where i = 1,..., n indexes the genes, and j = 1,..., m indexes the samples. The model has three sets of parameters:
(i) m size factors sj; the expectation values of all counts from sample j are proportional to sj.
(ii) for each experimental condition ρ, n expression strength parameters qiρ; they reflect the expected abundance of fragments from gene i under condition ρ, that is, expectation values of counts for gene i are proportional to qiρ.
(iii) The smooth functions vρ : + → +; for each condition ρ, vρ models the dependence of the raw variance viρ on the expected mean qiρ.
The purpose of the size factors sj is to render counts from different samples, which may have been sequenced to different depths, comparable. Hence, the ratios (
Hence, to estimate the size factors, we take the median of the ratios of observed counts. Generalizing the procedure just outlined to the case of more than two samples, we use:
The denominator of this expression can be interpreted as a pseudo-reference sample obtained by taking the geometric mean across samples. Thus, each size factor estimate
To estimate qiρ, we use the average of the counts from the samples j corresponding to condition ρ, transformed to the common scale:
where mρ is the number of replicates of condition ρ and the sum runs over these replicates. the functions vρ, we first calculate sample variances on the common scale
and define
In Supplementary Note B in Additional file 1 we show that wiρ - ziρ is an unbiased estimator for the raw variance parameter viρ of Equation (3).
However, for small numbers of replicates, mρ, as is typically the case in applications, the values wiρ are highly variable, and wiρ - ziρ would not be a useful variance estimator for statistical inference. Instead, we use local regression [14] on the graph
as our estimate for the raw variance.
Some attention is needed to avoid estimation biases in the local regression. wiρ is a sum of squared random variables, and the residuals
Testing for differential expression
Suppose that we have mA replicate samples for biological condition A and mB samples for condition B. For each gene i, we would like to weigh the evidence in the data for differential expression of that gene between the two conditions. In particular, we would like to test the null hypothesis qiA = qiB, where qiA is the expression strength parameter for the samples of condition A, and qiB for condition B. To this end, we define, as test statistic, the total counts in each condition,
and their overall sum KiS = KiA + KiB. From the error model described in the previous Section, we show below that - under the null hypothesis - we can compute the probabilities of the events KiA = a and KiB = b for any pair of numbers a and b. We denote this probability by p(a, b). The P value of a pair of observed count sums (kiA, kiB) is then the sum of all probabilities less or equal to p(kiA, kiB), given that the overall sum is kiS:
The variables a and b in the above sums take the values 0,..., kiS. The approach presented so far follows that of Robinson and Smyth [11] and is analogous to that taken by other conditioned tests, such as Fisher's exact test. (See Reference [17], Chapter 3 for a discussion of the merits of conditioning in tests.)
Computation of p(a, b). First, assume that, under the null hypothesis, counts from different samples are independent. Then, p(a, b) = Pr(KiA = a) Pr(KiB = b). The problem thus is computing the probability of the event KiA = a, and, analogously, of KiB = b. The random variable KiA is the sum of mA
NB-distributed random variables. We approximate its distribution by a NB distribution whose parameters we obtain from those of the Kij. To this end, we first compute the pooled mean estimate from the counts of both conditions,
which accounts for the fact that the null hypothesis stipulates that qiA = qiB. The summed mean and variance for condition A are
Supplementary Note C in Additional file 1 describes how the distribution parameters of the NB for KiA can be determined from
Supplementary Note D in Additional file 1 explains how we evaluate the sums in Equation (11).
Applications
Data sets
We present results based on the following data sets:
RNA-Seq in fly embryos
B. Wilczynski, Y.-H. Liu, N. Delhomme and E. Furlong have conducted RNA-Seq experiments in fly embryos and kindly shared part of their data with us ahead of publication. In each sample of this data set, a gene was engineered to be over-expressed, and we compare two biological replicates each of two such conditions, in the following denoted as 'A' and 'B'.
Tag-Seq of neural stem cells
Engström et al. [18] performed Tag-Seq [19] for tissue cultures of neural cells, including four from glioblastoma-derived neural stem-cells ('GNS') and two from non-cancerous neural stem ('NS') cells. As each tissue culture was derived from a different subject and so has a different genotype, these data show high variability.
RNA-Seq of yeast
Nagalakshmi et al. [1] performed RNA-Seq on replicates of Saccharomyces cerevisiae cultures. They tested two library preparation protocols, dT and RH, and obtained three sequencing runs for each protocol, such that for the first run of each protocol, they had one further technical replicate (same culture, replicated library preparation) and one further biological replicate (different culture).
ChIP-Seq of HapMap samples
Kasowski et al. [20] compared protein occupation of DNA regions between ten human individuals by ChIP-Seq. They compiled a list of regions for polymerase II and NF-κB, and counted, for each sample, the number of reads that mapped onto each region. The aim of the study was to investigate how much the regions' occupation differed between individuals.
Variance estimation
We start by demonstrating the variance estimation. Figure Figure1a1a shows the sample variances wiρ (Equation (7)) plotted against the means
The many data points in Figure Figure1b1b that lie far above the fitted orange curve may let the fit of the local regression appear poor. However, a strong skew of the residual distribution is to be expected. See Supplementary Note E in Additional file 1 for details and a discussion of diagnostics suitable to verify the fit.
Testing
In order to verify that DESeq maintains control of type-I error, we contrasted one of the replicates for condition A in the fly data against the other one, using for both samples the variance function estimated from the two replicates. Figure Figure22 shows the empirical cumulative distribution functions (ECDFs) of the P values obtained from this comparison. To control type-I error, the proportion of P values below a threshold α has to be ≤ α, that is, the ECDF curve (blue line) should not get above the diagonal (gray line). As the figure indicates, type-I error is controlled by edgeR and DESeq, but not by a Poisson-based χ2 test. The latter underestimates the variability of the data and would thus make many false positive rejections. In addition to this evaluation on real data, we also verified DESeq's type-I error control on simulated data that were generated from the error model described above; see Supplementary Note G in Additional file 1. Next, we contrasted the two A samples against the two B samples. Using the procedure described in the previous Section, we computed a P value for each gene. Figure Figure33 shows the obtained fold changes and P values. 12% of the P values were below 5%. Adjustment for multiple-testing with the procedure of Benjamini and Hochberg [21] yielded significant differential expression at false discovery rate (FDR) of 10% for 864 genes (of 17,605). These are marked in red in the figure. Figure Figure33 demonstrates how the ability to detect differential expression depends on overall counts. Specifically, the strong shot noise for low counts causes the testing procedure to call only very high fold changes significant. It can also be seen that, for counts below approximately 100, even a small increase in count levels reduces the impact of shot noise and hence the fold-change requirement, while at higher counts, when shot noise becomes unimportant (cf. Figure Figure1b),1b), the fold-change cut-off depends only weakly on count level. These plots are helpful to guide experiment design: For weakly expressed genes, in the region where shot noise is important, power can be increased by deeper sequencing, while for the higher-count regime, increased power can only be achieved with further biological replicates.
Comparison with edgeR
We also analyzed the data with edgeR (version 1.6.0; [8,10,11]). We ran edgeR with four different settings, namely in common-dispersion and in tagwise-dispersion mode, and either using the size factors as estimated by DESeq or taking the total numbers of sequenced reads. The results did not depend much on these choices, and here we report the results for tag-wise dispersion mode with DESeq-estimated size factors. (The R code required to reproduce all analyses, figures and numbers reported in this article is provided in Additional file 2; in addition, this supplement provides the results for the other settings of edgeR. The raw data can be found in Additional file 3.)
Going back to Figure Figure11 we see that edgeR's single-value dispersion estimate of the variance is lower than that of DESeq for weakly expressed genes and higher for strongly expressed genes. As a consequence, as we have seen in Figure Figure2edgeR2edgeR is anti-conservative for lowly expressed genes. However, it compensates for this by being more conservative with strongly expressed genes, so that, on average, type-I error control is maintained.
Nevertheless, in a test between different conditions, this behavior can result in a bias in the list of discoveries; for the present data, as Figure Figure44 shows, weakly expressed genes seem to be overrepresented, while very few genes with high average level are called differentially expressed by edgeR. While overall the sensitivity of both methods seemed comparable (DESeq reported 864 hits, edgeR 1, 127 hits), DESeq produced results which were more balanced over the dynamic range.
Similar results were obtained with the neural stem cell data, a data set with a different biological background and different noise characteristics (see Supplementary Note F in Additional file 1). The flexibility of the variance estimation scheme presented in this work appears to offer real advantages over the existing methods across a range of applications.
Working without replicates
DESeq allows analysis of experiments with no biological replicates in one or even both of the conditions. While one may not want to draw strong conclusions from such an analysis, it may still be useful for exploration and hypothesis generation.
If replicates are available only for one of the conditions, one might choose to assume that the variance-mean dependence estimated from the data for that condition holds as well for the unreplicated one.
If neither condition has replicates, one can still perform an analysis based on the assumption that for most genes, there is no true differential expression, and that a valid mean-variance relationship can be estimated from treating the two samples as if they were replicates. A minority of differentially abundant genes will act as outliers; however, they will not have a severe impact on the gamma-family GLM fit, as the gamma distribution for low values of the shape parameter has a heavy right-hand tail. Some overestimation of the variance may be expected, which will make that approach conservative.
We performed such an analysis with the fly RNA-Seq and the neural cell Tag-Seq data, by restricting both data sets to only two samples, one from each condition. For the neural cell data, the estimated variance function was, as expected, somewhat above the two functions estimated from the GNS and NS replicates.
Using it to test for differential expression still found 269 hits at FDR = 10%, of which 202 were among the 612 hits from the more reliable analysis with all available samples. In the case of the fly RNA-Seq data, however, only 90 of the 862 hits (11%) were recovered (with two new hits). These observations are explained by the fact that in the neural cell data, the variability between replicates was not much smaller than between conditions, making the latter a usable surrogate for the former. On the other hand, for the fly data, the variability between replicates was much smaller than between the conditions, indicating that the replication provided important and otherwise not available information on the experimental variation in the data (see also next Section).
Variance-stabilizing transformation
Given a variance-mean dependence, a variance-stabilizing transformation (VST) is a monotonous mapping such that for the transformed values, the variance is (approximately) independent of the mean. Using the variance-mean dependence w(q) estimated by DESeq, a VST is given by
Applying the transformation τ to the common-scale count data, kij/sj, yields values whose variances are approximately the same throughout the dynamic range. One application of VST is sample clustering, as in Figure Figure5;5; such an approach is more straightforward than, say, defining a suitable distance metric on the untransformed count data, whose choice is not obvious, and may not be easy to combine with available clustering or classification algorithms (which tend to be designed for variables with similar distributional properties).
ChIP-Seq
DESeq can also be used to analyze comparative ChIP-Seq assays. Kasowski et al. [20] analyzed transcription factor binding for HapMap individuals and counted for each sample how many reads mapped to pre-determined binding regions. We considered two individuals from their data set, HapMap IDs GM12878 and GM12891, for both of which at least four replicates had been done, and tested for differential occupation of the regions. The upper left two panels of Figure Figure66 which show comparisons within the same individual, indicate that type-I error was controlled by DESeq. No region was significant at 10% FDR using Benjamini-Hochberg adjustment. Differential occupation was found, however, when contrasting the two individuals, with 4,460 of 19,028 regions significant when only two replicates each were used and 8,442 when four replicates were used (upper right two panels).
Using an alternative approach, Kasowski et al. fitted generalized linear models (GLMs) of the Poisson family. This (lower row of Figure Figure6)6) resulted in an enrichment of small P values even for comparisons within the same individual, indicating that the variance was underestimated by the Poisson GLM, and literal use of the P values would lead to anti-conservative (overly optimistic) bias. Kasowski et al. addressed this and adjusted for the bias by using additional criteria for calling differential occupation.
Conclusions
Why is it necessary to develop new statistical methodology for sequence count data? If large numbers of replicates were available, questions of data distribution could be avoided by using non-parametric methods, such as rank-based or permutation tests. However, it is desirable (and possible) to consider experiments with smaller numbers of replicates per condition. In order to compare an observed difference with an expected random variation, we can improve our picture of the latter in two ways: first, we can use distribution families, such as normal, Poisson and negative binomial distributions, in order to determine the higher moments, and hence the tail behavior, of statistics for differential expression, based on observed low order moments such as mean and variance. Second, we can share information, for instance, distributional parameters, between genes, based on the notion that data from different genes follow similar patterns of variability. Here, we have described an instance of such an approach, and we will now discuss the choices we have made.
Choice of distribution
While for large counts, normal distributions might provide a good approximation of between-replicate variability, this is not the case for lower count values, whose discreteness and skewness mean that probability estimates computed from a normal approximation would be inadequate.
For the Poisson approximation, a key paper is the work by Marioni et al. [6], who studied the technical reproducibility of RNA-Seq. They extracted total RNA from two tissue samples, one from the liver and one from the kidneys of the same individual. From each RNA sample they took seven aliquots, prepared a library from each aliquot according to the protocol recommended by Illumina and sampled each library on one lane of a Solexa genome analyzer. For each gene, they then calculated the variance of the seven counts from the same tissue sample and found very good agreement with the variance predicted by a Poisson model. In line with our arguments in Section Model, Poisson shot noise is the minimum amount of variation to expect in a counting process. Thus, Marioni et al. concluded that the technical reproducibility of RNA-Seq is excellent, and that the variation between technical replicates is close to the shot noise limit. From this vantage point, Marioni et al. (and similarly Bullard et al. [22]) suggested to use the Poisson model (and Fisher's exact test, or a likelihood ratio test as an approximation to it) to test whether a gene is differentially expressed between their two samples. It is important to note that a rejection from such a test only informs us that the difference between the average counts in the two samples is larger than one would expect between technical replicates. Hence, we do not know whether this difference is due to the different tissue type, kidney instead of liver, or whether a difference of the same magnitude could have been found as well if one had compared two samples from different parts of the same liver, or from livers of two individuals.
Figure Figure11 shows that shot noise is only dominant for very low count values, while already for moderate counts, the effect of the biological variation between samples exceeds the shot noise by orders of magnitude.
This is confirmed by comparison of technical with biological replicates [1]. In Figure Figure77 we used DESeq to obtain variance estimates for the data of Nagalakshmi et al. [1]. The analysis indicates that the difference between technical replicates barely exceeds shot noise level, while biological replicates differ much more. Tests for differential expression that are based on a Poisson model, such as those discussed in References [6,7,20,22,23] should thus be interpreted with caution, as they may severely underestimate the effect of biological variability, in particular for highly expressed genes.
Consequently, it is preferable to use a model that allows for overdispersion. While for the Poisson distribution, variance and mean are equal, the negative binomial distribution is a generalization that allow for the variance to be larger. The most advanced of the published methods using this distribution is likely edgeR [8]. DESeq owes its basic idea to edgeR, yet differs in several aspects.
Sharing of information between genes
First, we discovered that the use of total read counts as estimates of sequencing depth, and hence for the adjustment of observed counts between samples (as recommended by Robinson et al. [8] and others) may result in high apparent differences between replicates, and hence in poor power to detect true differences.
DESeq uses the more robust size estimate Equation (5); in fact, edgeR's power increases when it is supplied with those size estimates instead. (Note: While this paper was under review, edgeR was amended to use the method of Oshlack and Robinson [13].)
For small numbers of replicates as often encountered in practice, it is not possible to obtain simultaneously reliable estimates of the variance and mean parameters of the NB distribution. EdgeR addresses this problem by estimating a single common dispersion parameter. In our method, we make use of the possibility to estimate a more flexible, mean-dependent local regression. The amount of data available in typical experiments is large enough to allow for sufficiently precise local estimation of the dispersion. Over the large dynamic range that is typical for RNA-Seq, the raw SCV often appears to change noticeably, and taking this into account allows DESeq to avoid bias towards certain areas of the dynamic range in its differential-expression calls (see Figure Figure22 and and44).
This flexibility is the most substantial difference between DESeq and edgeR, as simulations show that edgeR and DESeq perform comparably if provided with artificial data with constant SCV (Supplementary Note G in Additional file 1). EdgeR attempts to make up for the rigidity of the single-parameter noise model by allowing for an adjustment of the model-based variance estimate with the per-gene empirical variance. An empirical Bayes procedure, similar to the one originally developed for the limma package [24-26], determines how to combine these two sources of information optimally. However, for typical low replicate numbers, this so-called tagwise dispersion mode seems to have little effect (Figure (Figure4)4) or even reduces edgeR's power (Supplementary Note F in Additional file 1).
Third, we have suggested a simple and robust way of estimating the raw variance from the data. Robinson and Smyth [11] employed a technique they called quantile-adjusted conditional maximum likelihood to find an unbiased estimate for the raw SCV. The quantile adjustment refers to a rank-based procedure that modifies the data such that the data seem to stem from samples of equal library size. In DESeq, differing library sizes are simply addressed by linear scaling (Equations (2) and (3)), suggesting that quantile adjustment is an unnecessary complication. The price we pay for this is that we need to make the approximation that the sum of NB variables in Equation (10) is itself NB distributed. While it seems that neither the quantile adjustment nor our approximation pose reason for concern in practice, DESeq's approach is computationally faster and, perhaps, conceptually simpler.
Fourth, our approach provides useful diagnostics. Plots such as Supplementary Figure S3 in Additional file 2 are helpful to judge the reliability of the tests. In Figure Figure1b1b and and7,7, it is easy to see at which mean value biological variability dominates over shot noise; this information is valuable to decide whether the sequencing depth or the number of biological replicates is the limiting factor for detection power, and so helps in planning experiments. A heatmap as in Figure Figure55 is useful for data quality control.
Materials and methods
The R package DESeq
We implemented the method as a package for the statistical environment R [27] and distribute it within the Bioconductor project [28]. As input, it expects a table of count data. The data, as well as meta-data, such as sample and gene annotation, are managed with the S4 class CountDataSet, which is derived from eSet, Bioconductor's standard data type for table-like data. The package provides high-level functions to perform analyses such as shown in Section Application with only a few commands, allowing researchers with little knowledge of R to use it. This is demonstrated with examples in the documentation provided with the package (the package vignette). Furthermore, lower-level functions are supplied for advanced users who wish to deviate from the standard work flow. A typical calculation, such as the analyses shown in Section Applications, takes a few minutes of time on a personal computer.
All the analyses presented here have been performed with DESeq. Readers wishing to examine them in detail will find a Sweave document with the commented R code of the analysis code as Additional file 2 and the raw data in Additional file 3.
DESeq is available as a Bioconductor package from the Bioconductor repository [28] and from [36].
Abbreviations
ChIP-Seq: (high-throughput) sequencing of immunoprecipitated chromatin; ECDF: empirical cumulative distribution function; FDR: false-discovery rate; GLM: generalized linear model; RNA-Seq: (high-throughput) sequencing of RNA; SCV: squared coefficient of variation; NB: negative-binomial (distribution); VST: variance-stabilizing transformation.
Authors' contributions
SA and WH developed the method and wrote the manuscript. SA implemented the method and performed the analyses.
Supplementary Material
Supplement. Contains all Supplementary Notes and Supplementary Figures.
Supplement II. PDF file presenting the source code of all the analyses presented in this paper, with comments, as a Sweave document.
Raw data. Tarball containing the raw data for the presented analyses.
Acknowledgements
We are grateful to Paul Bertone for sharing the neural stem cells data ahead of publication, and to Bartek Wilczyński, Ya-Hsin Liu, Nicolas Delhomme and Eileen Furlong likewise for sharing the fly RNA-Seq data. We thank Nicolas Delhomme and Julien Gagneur for helpful comments on the manuscript. S. An. has been partially funded by the European Union Research and Training Network 'Chromatin Plasticity'.
References
- Nagalakshmi U, Wang Z, Waern K, Shou C, Raha D, Gerstein M, Snyder M. The transcriptional landscape of the yeast genome defined by RNA sequencing. Science. 2008;320:1344–1349. 10.1126/science.1158441. [Europe PMC free article] [Abstract] [CrossRef] [Google Scholar]
- Mortazavi A, Williams BA, McCue K, Schaeffer L, Wold B. Mapping and quantifying mammalian transcriptomes by RNA-Seq. Nat Methods. 2008;5:621–628. 10.1038/nmeth.1226. [Abstract] [CrossRef] [Google Scholar]
- Robertson G, Hirst M, Bainbridge M, Bilenky M, Zhao Y, Zeng T, Euskirchen G, Bernier B, Varhol R, Delaney A, Thiessen N, Griffith OL, He A, Marra M, Snyder M, Jones S. Genome-wide profiles of STAT1 DNA association using chromatin immunoprecipitation and massively parallel sequencing. Nat Methods. 2007;4:651–657. 10.1038/nmeth1068. [Abstract] [CrossRef] [Google Scholar]
- Licatalosi DD, Mele A, Fak JJ, Ule J, Kayikci M, Chi SW, Clark TA, Schweitzer AC, Blume JE, Wang X, Darnell JC, Darnell RB. HITS-CLIP yields genome-wide insights into brain alternative RNA processing. Nature. 2008;456:464–469. 10.1038/nature07488. [Europe PMC free article] [Abstract] [CrossRef] [Google Scholar]
- Smith AM, Heisler LE, Mellor J, Kaper F, Thompson MJ, Chee M, Roth FP, Giaever G, Nislow C. Quantitative phenotyping via deep barcode sequencing. Genome Res. 2009;19:1836–1842. 10.1101/gr.093955.109. [Europe PMC free article] [Abstract] [CrossRef] [Google Scholar]
- Marioni JC, Mason CE, Mane SM, Stephens M, Gilad Y. RNA-seq: An assessment of technical reproducibility and comparison with gene expression arrays. Genome Res. 2008;18:1509–1517. 10.1101/gr.079558.108. [Europe PMC free article] [Abstract] [CrossRef] [Google Scholar]
- Wang L, Feng Z, Wang X, Wang X, Zhang X. DEGseq: an R package for identifying differentially expressed genes from RNA-seq data. Bioinformatics. 2010;26:136–138. 10.1093/bioinformatics/btp612. [Abstract] [CrossRef] [Google Scholar]
- Robinson MD, Smyth GK. Moderated statistical tests for assessing differences in tag abundance. Bioinformatics. 2007;23(21):2881–2887. 10.1093/bioinformatics/btm453. [Abstract] [CrossRef] [Google Scholar]
- Whitaker L. On the Poisson law of small numbers. Biometrika. 1914;10:36–71. 10.1093/biomet/10.1.36. [CrossRef] [Google Scholar]
- Robinson MD, McCarthy DJ, Smyth GK. edgeR: a Bioconductor package for differential expression analysis of digital gene expression data. Bioinformatics. 2010;26:139–140. 10.1093/bioinformatics/btp616. [Europe PMC free article] [Abstract] [CrossRef] [Google Scholar]
- Robinson MD, Smyth GK. Small-sample estimation of negative binomial dispersion, with applications to SAGE data. Biostatistics. 2008;9:321–332. 10.1093/biostatistics/kxm030. [Abstract] [CrossRef] [Google Scholar]
- Cameron AC, Trivedi PK. Regression Analysis of Count Data. Cambridge University Press; 1998. [Google Scholar]
- Robinson MD, Oshlack A. A scaling normalization method for differential expression analysis of RNA-seq data. Genome Biol. 2010;11:R25. 10.1186/gb-2010-11-3-r25. [Europe PMC free article] [Abstract] [CrossRef] [Google Scholar]
- Loader C. Local Regression and Likelihood. Springer; 1999. [Google Scholar]
- McCullagh P, Nelder JA. Generalized Linear Models. 2. Chapman & Hall/CRC; 1989. [Google Scholar]
- locfit: Local regression, likelihood and density estimation. http://cran.r-project.org/web/packages/locfit/
- Agresti A. Categorical Data Analysis. 2. Wiley; 2002. [Google Scholar]
- Engström P, Tommei D, Stricker S, Smith A, Pollard S, Bertone P. Transcriptional characterization of glioblastoma stem cell lines using tag sequencing. 2010. in press .
- Morrissy AS, Morin RD, Delaney A, Zeng T, McDonald H, Jones S, Zhao Y, Hirst M, Marra MA. Next-generation tag sequencing for cancer gene expression profiling. Genome Res. 2009;19:1825–1835. 10.1101/gr.094482.109. [Europe PMC free article] [Abstract] [CrossRef] [Google Scholar]
- Kasowski M, Grubert F, Heffelfinger C, Hariharan M, Asabere A, Waszak SM, Habegger L, Rozowsky J, Shi M, Urban AE, Hong MY, Karczewski KJ, Huber W, Weissman SM, Gerstein MB, Korbel JO, Snyder M. Variation in transcription factor binding among humans. Science. 2010;328:232–235. 10.1126/science.1183621. [Europe PMC free article] [Abstract] [CrossRef] [Google Scholar]
- Benjamini Y, Hochberg Y. Controlling the false discovery rate: a practical and powerful approach to multiple testing. J Roy Stat Soc B. 1995;57:289–300. [Google Scholar]
- Bullard J, Purdom E, Hansen K, Dudoit S. Evaluation of statistical methods for normalization and differential expression in mRNA-Seq experiments. BMC Bioinformatics. 2010;11:94. 10.1186/1471-2105-11-94. [Europe PMC free article] [Abstract] [CrossRef] [Google Scholar]
- Bloom JS, Khan Z, Kruglyak L, Singh M, Caudy AA. Measuring differential gene expression by short read sequencing: quantitative comparison to 2-channel gene expression microarrays. BMC Genomics. 2009;10:221. 10.1186/1471-2164-10-221. [Europe PMC free article] [Abstract] [CrossRef] [Google Scholar]
- Smyth GK. In: Bioinformatics and Computational Biology Solutions Using R and Bioconductor. Gentleman R, Carey V, Dudoit S, R Irizarry WH, editor. New York: Springer; 2005. Limma: linear models for microarray data. pp. 397–420. full_text. [Google Scholar]
- Smyth GK. Linear models and empirical Bayes methods for assessing differential expression in microarray experiments. Stat Appl Genet Mol Biol. 2004;3:Article3. [Abstract] [Google Scholar]
- Lönnstedt I, Speed T. Replicated microarray data. Stat Sin. 2002;12:31–46. [Google Scholar]
- R: A Language and Environment for Statistical Computing. http://www.R-project.org
- Gentleman RC, Carey VJ, Bates DM, Bolstad B, Dettling M, Dudoit S, Ellis B, Gautier L, Ge Y, Gentry J, Hornik K, Hothorn T, Huber W, Iacus S, Irizarry R, Leisch F, Li C, Maechler M, Rossini AJ, Sawitzki G, Smith C, Smyth G, Tierney L, Yang JYH, Zhang J. Bioconductor: Open software development for computational biology and bioinformatics. Genome Biol. 2004;5:R80. 10.1186/gb-2004-5-10-r80. [Europe PMC free article] [Abstract] [CrossRef] [Google Scholar]
- Bliss CI, Fisher RA. Fitting the negative binomial distribution to biological data. Biometrics. 1953;9:176–200. 10.2307/3001850. [CrossRef] [Google Scholar]
- Clark SJ, Perry JN. Estimation of the negative binomial parameter κ by maximum quasi-likelihood. Biometrics. 1989;45:309–316. 10.2307/2532055. [CrossRef] [Google Scholar]
- Lawless JF. Negative binomial and mixed Poisson regression. Can J Stat. 1987;15:209–225. 10.2307/3314912. [CrossRef] [Google Scholar]
- Saha K, Paul S. Bias-corrected maximum likelihood estimator of the negative binomial dispersion parameter. Biometrics. 2005;61:179–285. 10.1111/j.0006-341X.2005.030833.x. [Abstract] [CrossRef] [Google Scholar]
- Fast and accurate computation of binomial probabilities. http://projects.scipy.org/scipy/raw-attachment/ticket/620/loader2000Fast.pdf (Note: This is a copy of the original paper, which is no longer available online.)
- Langmead B, Trapnell C, Pop M, Salzberg SL. Ultrafast and memory-efficient alignment of short DNA sequences to the human genome. Genome Biol. 2009;10:R25. 10.1186/gb-2009-10-3-r25. [Europe PMC free article] [Abstract] [CrossRef] [Google Scholar]
- HTSeq: Analysing high-throughput sequencing data with Python. http://www-huber.embl.de/users/anders/HTSeq/
- DESeq. http://www-huber.embl.de/users/anders/DESeq
Articles from Genome Biology are provided here courtesy of BMC
Full text links
Read article at publisher's site: https://doi.org/10.1186/gb-2010-11-10-r106
Read article for free, from open access legal sources, via Unpaywall: https://genomebiology.biomedcentral.com/counter/pdf/10.1186/gb-2010-11-10-r106
Open access at BioMedCentral
http://www.biomedcentral.com/1465-6906/11/R106/abstract
Open access at genomebiology.com
http://genomebiology.com/content/pdf/gb-2010-11-10-R106.pdf
Open access at genomebiology.com
http://genomebiology.com/2010/11/10/R106
Open access at genomebiology.com
http://genomebiology.com/2010/11/10/R106/abstract
Open access at BioMedCentral
http://www.biomedcentral.com/1465-6906/11/R106
Open access at BioMedCentral
http://www.biomedcentral.com/content/pdf/1465-6906-11-R106.pdf
Citations & impact
Impact metrics
Citations of article over time
Alternative metrics
Smart citations by scite.ai
Explore citation contexts and check if this article has been
supported or disputed.
https://scite.ai/reports/10.1186/gb-2010-11-10-r106
Article citations
Three modes of viral adaption by the heart.
Sci Adv, 10(46):eadp6303, 13 Nov 2024
Cited by: 0 articles | PMID: 39536108 | PMCID: PMC11559625
Transcriptomic profiling of backfat and muscle in Lijiang pigs with divergent body size across growth stages.
Sci Rep, 14(1):27677, 12 Nov 2024
Cited by: 0 articles | PMID: 39532937 | PMCID: PMC11557953
Identification of trait-associated microRNA modules in liver transcriptome of pig fed with PUFAs-enriched supplementary diet.
J Appl Genet, 15 Nov 2024
Cited by: 0 articles | PMID: 39546271
A phosphate starvation induced small RNA promotes Bacillus biofilm formation.
NPJ Biofilms Microbiomes, 10(1):115, 29 Oct 2024
Cited by: 0 articles | PMID: 39472585 | PMCID: PMC11522486
Theoretical framework for the difference of two negative binomial distributions and its application in comparative analysis of sequencing data.
Genome Res, 34(10):1636-1650, 29 Oct 2024
Cited by: 0 articles | PMID: 39406498 | PMCID: PMC11529838
Go to all (9,323) article citations
Other citations
Data
Data behind the article
This data has been text mined from the article, or deposited into data resources.
BioStudies: supplemental material and supporting data
Similar Articles
To arrive at the top five similar articles we use a word-weighted algorithm to compare words from the Title and Abstract of each citation.
Analysis of ChIP-Seq and RNA-Seq Data with BioWardrobe.
Methods Mol Biol, 1783:343-360, 01 Jan 2018
Cited by: 7 articles | PMID: 29767371 | PMCID: PMC6188658
Polyester: simulating RNA-seq datasets with differential transcript expression.
Bioinformatics, 31(17):2778-2784, 28 Apr 2015
Cited by: 164 articles | PMID: 25926345 | PMCID: PMC4635655
A flexible count data model to fit the wide diversity of expression profiles arising from extensively replicated RNA-seq experiments.
BMC Bioinformatics, 14:254, 21 Aug 2013
Cited by: 28 articles | PMID: 23965047 | PMCID: PMC3849762
Differential Expression Analysis of RNA-seq Reads: Overview, Taxonomy, and Tools.
IEEE/ACM Trans Comput Biol Bioinform, 17(2):566-586, 01 Oct 2018
Cited by: 13 articles | PMID: 30281477
Review