Differential Analysis of Count Data - The Deseq2 Package: Michael Love, Simon Anders, Wolfgang Huber
Differential Analysis of Count Data - The Deseq2 Package: Michael Love, Simon Anders, Wolfgang Huber
February 4, 2014
Abstract
A basic task in the analysis of count data from RNA-Seq is the detection of differentially
expressed genes. The count data are presented as a table which reports, for each sample, the
number of sequence fragments that have been assigned to each gene. Analogous data also arise
for other assay types, including comparative ChIP-Seq, HiC, shRNA screening, mass spectrometry.
An important analysis question is the quantification and statistical inference of systematic changes
between conditions, as compared to within-condition variability. The package DESeq2 provides
methods to test for differential expression by use of negative binomial generalized linear models;
the estimates of dispersion and logarithmic fold changes incorporate data-driven prior distributions
1 . This vignette explains the use of the package and demonstrates typical work flows.
1
Other Bioconductor packages with similar aims are edgeR, baySeq and DSS.
1
Differential analysis of count data – the DESeq2 package 2
Contents
1 Standard workflow 3
1.1 Quick start . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 3
1.2 Input data . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 3
1.2.1 Why raw counts? . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 3
1.2.2 SummarizedExperiment input . . . . . . . . . . . . . . . . . . . . . . . . . . . 3
1.2.3 Count matrix input . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 4
1.2.4 HTSeq input . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 5
1.2.5 Note on factor levels . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 6
1.2.6 About the pasilla dataset . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 6
1.3 Differential expression analysis . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 6
1.4 Exploring and exporting results . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 7
1.4.1 MA-plot . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 7
1.4.2 More information on results columns . . . . . . . . . . . . . . . . . . . . . . . 7
1.4.3 Exporting results . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 8
1.5 Multi-factor designs . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 8
4.4 Contrasts . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 26
4.5 Independent filtering and multiple testing . . . . . . . . . . . . . . . . . . . . . . . . . 27
4.5.1 Filtering criteria . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 27
4.5.2 Why does it work? . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 27
4.5.3 Diagnostic plots for multiple testing . . . . . . . . . . . . . . . . . . . . . . . . 28
6 Session Info 31
1 Standard workflow
1.1 Quick start
Here we show the most basic steps for a differential expression analysis. These steps imply you have a
SummarizedExperiment object se with a column condition.
Now that we have a matrix of counts and the column information, we can construct a DESeqDataSet:
dds <- DESeqDataSetFromMatrix(countData = countData,
colData = colData,
design = ~ condition)
colData(dds)$condition <- factor(colData(dds)$condition,
levels=c("untreated","treated"))
dds
class: DESeqDataSet
dim: 14470 7
exptData(0):
assays(1): counts
rownames(14470): FBgn0000003 FBgn0000008 ... FBgn0261574 FBgn0261575
rowData metadata column names(0):
colnames(7): treated1fb treated2fb ... untreated3fb untreated4fb
colData names(2): condition type
The reason for the importance of the specifying the base level is that the function model.matrix
is used by the DESeq2 package to build model matrices, and these matrices will be used to compare
all other levels to the base level. See 3.2 for examples on how to compare factor levels to other levels
than the base level.
Extracting results of other variables is discussed in section 1.5. All the values calculated by the
DESeq2 package are stored in the DESeqDataSet object, and access to these values is discussed in
Section 3.7.
Differential analysis of count data – the DESeq2 package 7
Figure 1: MA-plot. These plots show the log2 fold changes from the treatment over the mean of
normalized counts, i.e. the average of counts normalized by size factors. The left plot shows the
“unshrunken” log2 fold changes, while the right plot, produced by the code above, shows the shrinkage
of log2 fold changes resulting from the incorporation of zero-centered normal prior. The shrinkage is
greater for the log2 fold change estimates from genes with low counts and high dispersion, as can be
seen by the narrowing of spread of leftmost points in the right plot.
plotMA(dds,ylim=c(-2,2),main="DESeq2")
mcols(res, use.names=TRUE)
DataFrame with 6 rows and 2 columns
type
<character>
baseMean intermediate
Differential analysis of count data – the DESeq2 package 8
log2FoldChange results
lfcSE results
stat results
pvalue results
padj results
description
<character>
baseMean the base mean over all rows
log2FoldChange log2 fold change (MAP): condition treated vs untreated
lfcSE standard error: condition treated vs untreated
stat Wald statistic: condition treated vs untreated
pvalue Wald test p-value: condition treated vs untreated
padj BH adjusted p-values
The variable condition and the factor level treated are combined as“condition treated vs untreated”.
For a particular gene, a log2 fold change of −1 for condition_treated_vs_untreated means that
the treatment induces a change in observed expression level of 2−1 = 0.5 compared to the untreated
condition. If the variable of interest is continuous-valued, then the reported log2 fold change is per unit
of change of that variable.
The results for particular genes can be set to NA, for either one of the following reasons:
1. If within a row, all samples have zero counts, this is recorded in mcols(dds)$allZero and log2
fold change estimates, p-value and adjusted p-value will all be set to NA.
2. If a row contains a sample with an extreme count then the p-value and adjusted p-value are set to
NA. These outlier counts are detected by Cook’s distance. Customization of this outlier filtering
is described in Section 3.3, along with a method for replacing outlier counts and refitting.
3. If a row is filtered by automatic independent filtering, then only the adjusted p-value is set to NA.
Description and customization of independent filtering is decribed in Section 3.6.
colData(dds)
DataFrame with 7 rows and 3 columns
condition type sizeFactor
<factor> <factor> <numeric>
treated1fb treated single-read 1.512
treated2fb treated paired-end 0.784
treated3fb treated paired-end 0.896
untreated1fb untreated single-read 1.050
untreated2fb untreated single-read 1.659
untreated3fb untreated paired-end 0.712
untreated4fb untreated paired-end 0.784
We can account for the different types of sequencing, and get a clearer picture of the differences
attributable to the treatment. As condition is the variable of interest, we put it at the end of the
formula. Here we
It is also possible to retrieve the log2 fold changes, p-values and adjusted p-values of the type
variable. The function results takes an argument name, which is a combination of the variable, the
level (numeratoFr of the fold change) and the base level (denominator of the fold change). In addition,
there might be minor changes made by the make.names function on column names, e.g. changing -
(a dash) to . (a period). The function resultsNames will tell you the names of all available results.
resultsNames(dds)
[1] "Intercept" "type_single.read_vs_paired.end"
[3] "condition_treated_vs_untreated"
resType <- results(dds, "type_single.read_vs_paired.end")
head(resType)
Differential analysis of count data – the DESeq2 package 10
dispersions already estimated will be used to perform transformations, or if not present, they will be
estimated using the current design formula. This setting should be used for transforming data for
downstream analysis.
The two functions return SummarizedExperiment objects, as the data are no longer counts. The
assay function is used to extract the matrix of normalized values.
library("vsn")
par(mfrow=c(1,3))
notAllZero <- (rowSums(counts(dds))>0)
meanSdPlot(log2(counts(dds,normalized=TRUE)[notAllZero,] + 1),
Differential analysis of count data – the DESeq2 package 12
Figure 2: VST and log2. Graphs of the variance stabilizing transformation for sample 1, in blue, and
of the transformation f (n) = log2 (n/s1 ), in black. n are the counts and s1 is the size factor for the
first sample.
ylim = c(0,2.5))
meanSdPlot(assay(rld[notAllZero,]), ylim = c(0,2.5))
meanSdPlot(assay(vsd[notAllZero,]), ylim = c(0,2.5))
2
http://en.wikipedia.org/wiki/Quality_%28business%29
Differential analysis of count data – the DESeq2 package 13
Figure 3: Per-gene standard deviation (taken across samples), against the rank of the mean, for the
shifted logarithm log2 (n + 1) (left), the regularized log transformation (center) and the variance stabi-
lizing transformation (right).
library("RColorBrewer")
library("gplots")
select <- order(rowMeans(counts(dds,normalized=TRUE)),decreasing=TRUE)[1:30]
hmcol <- colorRampPalette(brewer.pal(9, "GnBu"))(100)
Figure 4: Heatmaps showing the expression data of the 30 most highly expressed genes. The data is of
raw counts (left), from regularized log transformation (center) and from variance stabilizing transfor-
mation (right).
Figure 5: Sample-to-sample distances. Heatmap showing the Euclidean distances between the
samples as calculated from the regularized log transformation.
Differential analysis of count data – the DESeq2 package 15
Figure 6: PCA plot. PCA plot. The 7 samples shown in the 2D plane spanned by their first
two principal components. This type of plot is useful for visualizing the overall effect of experimental
covariates and batch effects.
A heatmap of this distance matrix gives us an overview over similarities and dissimilarities between
samples (Figure 5):
3.2 Contrasts
A contrast is a linear combination of factor level means, which can be used to test if combinations
of variables are different than zero. The simplest use case for contrasts is the case of a factor with
three levels, say A,B and C, where A is the base level. While the standard DESeq2 workflow generates
p-values for the null hypotheses that the log2 fold change of B vs A is zero, and that the log2 fold
change of C vs A is zero, a contrast is needed to compare if the log2 fold change of C vs B is zero.
Here we show how to make all three pairwise comparisons using the parathyroid dataset which was
built in Section 1.2.2. The three levels of the factor treatment are: Control, DPN and OHT. The
samples are also split according to the patient from which the cell cultures were derived, so we include
this in the design formula.
First we run DESeq and show how to extract one of the two comparisons of the treatment factor
with the base level: the comparison of DPN vs Control or the comparison of OHT vs Control.
Differential analysis of count data – the DESeq2 package 17
Using the contrast argument of the results function, we can specify a test of OHT vs DPN.
The contrast argument takes a character vector of length three, containing the name of the factor, the
name of the numerator level, and the name of the denominator level, where we test the log2 fold change
of numerator vs denominator. Here we extract the results for the log2 fold change of OHT vs DPN for
the treatment factor.
mcols(resCtrst)
DataFrame with 6 rows and 2 columns
type description
<character> <character>
1 intermediate the base mean over all rows
2 results log2 fold change (MAP): treatment.OHT.vs.DPN
3 results standard error: treatment.OHT.vs.DPN
4 results Wald statistic: treatment.OHT.vs.DPN
5 results Wald test p-value: treatment.OHT.vs.DPN
6 results BH adjusted p-values
For advanced users, a numeric contrast vector can also be provided with one element for each element
provided by resultsNames, i.e. columns of the model matrix. Note that the following contrast is the
same as specified by the character vector in the previous code chunk.
The formula that is used to generate the contrasts can be found in Section 4.4.
of genetically differing samples, and genuine, but rare biological events. In many cases, users appear
primarily interested in genes that show a consistent behaviour, and this is the reason why by default,
genes that are affected by such outliers are set aside by DESeq2 . The function calculates, for every
gene and for every sample, a diagnostic test for outliers called Cook’s distance. Cook’s distance is a
measure of how much a single sample is influencing the fitted coefficients for a gene, and a large value
of Cook’s distance is intended to indicate an outlier count. DESeq2 automatically flags genes with
Cook’s distance above a cutoff and sets their p-values and adjusted p-values to NA.
The default cutoff depends on the sample size and number of parameters to be estimated. The
default is to use the 99% quantile of the F (p, m − p) distribution (with p the number of parameters
including the intercept and m number of samples). The default can be modified using the cooksCut-
off argument to the results function. The outlier removal functionality can be disabled by setting
cooksCutoff to FALSE or Inf. If the removal of a sample would mean that a coefficient cannot
be fitted (e.g. if there is only one sample for a given group), then the Cook’s distance for this sam-
ple is not counted towards the flagging. The Cook’s distances are stored as a matrix available in
assays(dds)[["cooks"]]. These values are the same as those produced by the cooks.distance
function of the stats package, except using the fitted dispersion and taking into account the size factors.
With many degrees of freedom –i. e., many more samples than number of parameters to be estimated–
it might be undesirable to remove entire genes from the analysis just because their data include a single
count outlier. An alternate strategy is to replace the outlier counts with the trimmed mean over all
samples, adjusted by the size factor for that sample. This approach is conservative, it will not lead
to false positives, as it replaces the outlier value with the value predicted by the null hypothesis. The
DESeq function (or nbinomWaldTest and nbinomLRT) calculates Cook’s distance for every gene and
sample. After an initial fit has been performed, the following function replaces count outliers by the
trimmed mean. Here we demonstrate with the pasilla dataset, although there are not many extra
degrees of freedom for this dataset.
are equal to zero. The likelihood ratio test can also be specified using the test argument to DESeq,
which substitutes nbinomWaldTest with nbinomLRT. In this case, the user provides the full formula
(the formula stored in design(dds)), and a reduced formula, e.g. one which does not contain the
variable of interest. The degrees of freedom for the test is obtained from the number of parameters
in the two models. The Wald test and the likelihood ratio test share many of the same genes with
adjusted p-value < .1 for this experiment.
As we already have an object dds with dispersions calculated for the design formula type +
condition, we only need to run the function nbinomLRT, with a reduced formula including only the
type of sequencing, in order to test the log2 fold change attributable to the condition:
Figure 7: Dispersion plot. The dispersion estimate plot shows the gene-wise estimates (black), the
fitted values (red), and the final maximum a posteriori estimates used in testing (blue).
less than seen here, depending on the sample size, the number of coefficients, the row mean and the
variability of the gene-wise estimates.
plotDispEsts(dds)
attr(res,"filterThreshold")
45%
6.85
plot(attr(res,"filterNumRej"),type="b",
ylab="number of rejections")
Figure 8: Independent filtering. The results function maximizes the number of rejections (adjusted
p-value less than a significance level), over theta, the quantiles of a filtering statistic (in this case, the
mean of normalized counts).
library(genefilter)
rv <- rowVars(counts(dds,normalized=TRUE))
resFiltByVar <- results(dds, filter=rv)
table(rowMean=(res$padj < .1), rowVar=(resFiltByVar$padj < .1))
rowVar
rowMean FALSE TRUE
FALSE 6315 6
TRUE 0 1481
mcols(dds,use.names=TRUE)[1:4,1:4]
DataFrame with 4 rows and 4 columns
baseMean baseVar allZero dispGeneEst
Differential analysis of count data – the DESeq2 package 24
These steps then replace estimateSizeFactors in the steps described in Section 3.1. Normaliza-
tion factors, if present, will always be used in the place of size factors.
The methods provided by the cqn or EDASeq packages can help correct for GC or length biases.
They both describe in their vignettes how to create matrices which can be used by DESeq2 . From the
formula above, we see that normalization factors should be on the scale of the counts, like size factors,
and unlike offsets which are typically on the scale of the predictors (i.e. the logarithmic scale for the
negative binomial GLM). At the time of writing, the transformation from the matrices provided by these
packages should be:
Kij ∼ NB(µij , αi )
µij = sj qij
log2 (qij ) = xj. βi
where counts Kij for gene i, sample j are modeled using a negative binomial distribution with fitted
mean µij and a gene-specific dispersion parameter αi . The fitted mean is composed of a sample-specific
size factor sj 3 and a parameter qij proportional to the expected true concentration of fragments for
sample j. The coefficients βi give the log2 fold changes for gene i for each column of the model matrix
X. Dispersions are estimated using a Cox-Reid adjusted profile likelihood, as first implemented for
RNA-Seq data in edgeR [6, 7]. For further details on dispersion estimation and inference, please see
the manual pages for the functions DESeq and estimateDispersions. For access to the calculated
values see Section 3.7
Figure 9: Cook’s distance. Plot of the maximum Cook’s distance per gene over the rank of the Wald
statistics for the condition. The two regions with small Cook’s distances are genes with a single count
in one sample. The horizontal line is the default cutoff used for 7 samples and 3 estimated parameters.
implementation of Cook’s distance see Section 3.3 and the manual page for the results function.
Below we plot the maximum value of Cook’s distance for each row over the rank of the test statistic
to justify its use as a filtering criterion.
W <- mcols(dds)$WaldStatistic_condition_treated_vs_untreated
maxCooks <- apply(assays(dds)[["cooks"]],1,max)
idx <- !is.na(W)
plot(rank(W[idx]), maxCooks[idx], xlab="rank of Wald statistic",
ylab="maximum Cook's distance per gene",
ylim=c(0,5), cex=.4, col=rgb(0,0,0,.3))
m <- ncol(dds)
p <- 3
abline(h=qf(.99, p, m - p))
4.4 Contrasts
Contrasts can be calculated for a DESeqDataSet object for which the GLM coefficients have already
been fit using the Wald test steps (DESeq with test="Wald" or using nbinomWaldTest). The vector
of coefficients β is left multiplied by the contrast vector c to form the numerator of the test statistic.
Differential analysis of count data – the DESeq2 package 27
The denominator is formed by multiplying the covariance matrix Σ for the coefficients on either side
by the contrast vector c. The square root of this product is an estimate of the standard error for the
contrast. The contrast statistic is then compared to a normal distribution as are the Wald statistics for
the DESeq2 package.
ct β
W =√
ct Σc
plot(res$baseMean+1, -log10(res$pvalue),
log="x", xlab="mean of normalized counts",
ylab=expression(-log[10](pvalue)),
ylim=c(0,30),
cex=.4, col=rgb(0,0,0,.3))
Figure 10: Mean counts as a filter statistic. The mean of normalized counts provides an indepen-
dent statistic for filtering the tests. It is independent because the information about the variables in the
design formula is not used. By filtering out genes which fall on the left side of the plot, the majority of
the low p-values are kept.
use
FALSE TRUE
6512 7958
h1 <- hist(res$pvalue[!use], breaks=0:50/50, plot=FALSE)
h2 <- hist(res$pvalue[use], breaks=0:50/50, plot=FALSE)
colori <- c(`do not pass`="khaki", `pass`="powderblue")
Figure 11: Histogram of p-values for all tests (res$pvalue). The area shaded in blue indicates the
subset of those that pass the filtering, the area in khaki those that do not pass.
plot(seq(along=which(showInPlot)), resFilt$pvalue[orderInPlot][showInPlot],
pch=".", xlab = expression(rank(p[i])), ylab=expression(p[i]))
abline(a=0, b=alpha/length(resFilt$pvalue), col="red3", lwd=2)
Schweder and Spjøtvoll [12] suggested a diagnostic plot of the observed p-values which permits estima-
tion of the fraction of true null hypotheses. For a series of hypothesis tests H1 , . . . , Hm with p-values
pi , they suggested plotting
(1 − pi , N (pi )) for i ∈ 1, . . . , m, (2)
where N (p) is the number of p-values greater than p. An application of this diagnostic plot to res-
Filt$pvalue is shown in the right panel of Figure 12. When all null hypotheses are true, the p-values are
each uniformly distributed in [0, 1], Consequently, the cumulative distribution function of (p1 , . . . , pm )
is expected to be close to the line F (t) = t. By symmetry, the same applies to (1 − p1 , . . . , 1 − pm ).
When (without loss of generality) the first m0 null hypotheses are true and the other m − m0 are false,
the cumulative distribution function of (1 − p1 , . . . , 1 − pm0 ) is again expected to be close to the line
F0 (t) = t. The cumulative distribution function of (1 − pm0 +1 , . . . , 1 − pm ), on the other hand, is
Differential analysis of count data – the DESeq2 package 30
expected to be close to a function F1 (t) which stays below F0 but shows a steep increase towards 1
as t approaches 1. In practice, we do not know which of the null hypotheses are true, so we can only
observe a mixture whose cumulative distribution function is expected to be close to
m0 m − m0
F (t) = F0 (t) + F1 (t). (3)
m m
Such a situation is shown in the right panel of Figure 12. If F1 (t)/F0 (t) is small for small t, then the
mixture fraction mm0 can be estimated by fitting a line to the left-hand portion of the plot, and then
noting its height on the right. Such a fit is shown by the red line in the right panel of Figure 12.
plot(1-resFilt$pvalue[orderInPlot],
(length(resFilt$pvalue)-1):0, pch=".",
xlab=expression(1-p[i]), ylab=expression(N(p[i])))
abline(a=0, slope, col="red3", lwd=2)
Figure 12: Left: illustration of the Benjamini-Hochberg multiple testing adjustment procedure [11].
The black line shows the p-values (y-axis) versus their rank (x-axis), starting with the smallest p-value
from the left, then the second smallest, and so on. Only the first 2300 p-values are shown. The red
line is a straight line with slope α/n, where n = 7958 is the number of tests, and α = 0.1 is a target
false discovery rate (FDR). FDR is controlled at the value α if the genes are selected that lie to the
left of the rightmost intersection between the red and black lines: here, this results in 1481 genes.
Right: Schweder and Spjøtvoll plot, as described in the text. For both of these plots, the p-values
resFilt$pvalues from Section 4.5.1 were used as a starting point. Analogously, one can produce
these types of plots for any set of p-values, for instance those from the previous sections.
Differential analysis of count data – the DESeq2 package 31
5.3 How do I use the variance stabilized or rlog transformed data for dif-
ferential testing?
The variance stabilizing and rlog transformations are provided for applications other than differential
testing, for example clustering of samples or other machine learning applications. For differential testing
we recommend the DESeq function applied to raw counts as outlined in Section 1.3.
6 Session Info
R version 3.0.2 Patched (2013-12-18 r64488), x86_64-unknown-linux-gnu
Locale: LC_CTYPE=en_US.UTF-8, LC_NUMERIC=C, LC_TIME=en_US.UTF-8, LC_COLLATE=C,
LC_MONETARY=en_US.UTF-8, LC_MESSAGES=en_US.UTF-8, LC_PAPER=en_US.UTF-8,
LC_NAME=C, LC_ADDRESS=C, LC_TELEPHONE=C, LC_MEASUREMENT=en_US.UTF-8,
LC_IDENTIFICATION=C
Base packages: base, datasets, grDevices, graphics, methods, parallel, stats, utils
Other packages: Biobase 2.22.0, BiocGenerics 0.8.0, DESeq2 1.2.10, GenomicRanges 1.14.4,
IRanges 1.20.6, RColorBrewer 1.0-5, Rcpp 0.11.0, RcppArmadillo 0.4.000.2, XVector 0.2.0,
genefilter 1.44.0, gplots 2.12.1, parathyroidSE 1.0.4, pasilla 0.2.19, vsn 3.30.0
Differential analysis of count data – the DESeq2 package 32
Loaded via a namespace (and not attached): AnnotationDbi 1.24.0, BiocInstaller 1.12.0,
BiocStyle 1.0.0, DBI 0.2-7, DESeq 1.14.0, KernSmooth 2.23-10, RSQLite 0.11.4, XML 3.98-1.1,
affy 1.40.0, affyio 1.30.0, annotate 1.40.0, bitops 1.0-6, caTools 1.16, gdata 2.13.2,
geneplotter 1.40.0, grid 3.0.2, gtools 3.2.1, lattice 0.20-24, limma 3.18.10, locfit 1.5-9.1,
preprocessCore 1.24.0, splines 3.0.2, stats4 3.0.2, survival 2.37-7, tools 3.0.2, xtable 1.7-1,
zlibbioc 1.8.0
References
[1] Felix Haglund, Ran Ma, Mikael Huss, Luqman Sulaiman, Ming Lu, Inga-Lena Nilsson, Anders
Höög, Christofer C. Juhlin, Johan Hartman, and Catharina Larsson. Evidence of a Functional
Estrogen Receptor in Parathyroid Adenomas. Journal of Clinical Endocrinology & Metabolism,
September 2012.
[3] Robert Tibshirani. Estimating transformations for regression via additivity and variance stabiliza-
tion. Journal of the American Statistical Association, 83:394–405, 1988.
[4] Wolfgang Huber, Anja von Heydebreck, Holger Sültmann, Annemarie Poustka, and Martin Vingron.
Parameter estimation for the calibration and variance stabilization of microarray data. Statistical
Applications in Genetics and Molecular Biology, 2(1):Article 3, 2003.
[5] Simon Anders and Wolfgang Huber. Differential expression analysis for sequence count data.
Genome Biology, 11:R106, 2010.
[6] D. R. Cox and N. Reid. Parameter orthogonality and approximate conditional inference. Journal
of the Royal Statistical Society, Series B, 49(1):1–39, 1987.
[7] Davis J McCarthy, Yunshun Chen, and Gordon K Smyth. Differential expression analysis of multi-
factor RNA-Seq experiments with respect to biological variation. Nucleic Acids Research, 40:4288–
4297, January 2012.
[8] Hao Wu, Chi Wang, and Zhijin Wu. A new shrinkage estimator for dispersion improves differential
expression detection in RNA-seq data. Biostatistics, September 2012.
[9] R. Dennis Cook. Detection of Influential Observation in Linear Regression. Technometrics, February
1977.
[10] Richard Bourgon, Robert Gentleman, and Wolfgang Huber. Independent filtering increases detec-
tion power for high-throughput experiments. PNAS, 107(21):9546–9551, 2010.
[11] Y. Benjamini and Y. Hochberg. Controlling the false discovery rate: a practical and powerful
approach to multiple testing. Journal of the Royal Statistical Society B, 57:289–300, 1995.
Differential analysis of count data – the DESeq2 package 33
[12] T. Schweder and E. Spjotvoll. Plots of P-values to evaluate many tests simultaneously. Biometrika,
69:493–502, 1982.