Abstract
RNA-sequencing (RNA-seq) is a flexible technology for measuring genome-wide expression that is rapidly replacing microarrays as costs become comparable. Current differential expression analysis methods for RNA-seq data fall into two broad classes: (1) methods that quantify expression within the boundaries of genes previously published in databases and (2) methods that attempt to reconstruct full length RNA transcripts. The first class cannot discover differential expression outside of previously known genes. While the second approach does possess discovery capabilities, statistical analysis of differential expression is complicated by the ambiguity and variability incurred while assembling transcripts and estimating their abundances. Here, we propose a novel method that first identifies differentially expressed regions (DERs) of interest by assessing differential expression at each base of the genome. The method then segments the genome into regions comprised of bases showing similar differential expression signal, and then assigns a measure of statistical significance to each region. Optionally, DERs can be annotated using a reference database of genomic features. We compare our approach with leading competitors from both current classes of differential expression methods and highlight the strengths and weaknesses of each. A software implementation of our method is available on github (https://github.com/alyssafrazee/derfinder).
Keywords: Bioinformatics, Differential expression, False discovery rate, Genomics, RNA sequencing
1. Introduction
Microarrays revolutionized the way we measure gene expression by providing, for the first time, genome-wide transcript-level measurements, where transcript is used here to refer to the molecule associated with expression at the RNA level. However, assigning only one measurement to each known gene has greatly over-simplified the biological process in two ways. The first is that we have not yet discovered or annotated all regions of the genome capable of expressing transcripts. Secondly, most genes produce not one but several transcripts through the process of alternative splicing (Mortazavi and others, 2008; Trapnell and others, 2010; Katz and others, 2010). In principle, RNA-sequencing (RNA-seq) provides measurements of transcript expression from which we can obtain a more complete picture of reality. While microarrays rely on hybridization to predefined probes, by explicitly sequencing transcripts, RNA-seq is potentially capable of measuring expression in regions not previously annotated (Guttman and others, 2010; Clark and others, 2011), and to measure multiple transcripts for individual genes (Trapnell and others, 2010; Mortazavi and others, 2008). This flexibility, coupled with rapidly declining sequencing costs, has led to explosive growth in the use of RNA-seq technology (Stein and others, 2010).
The most common goal among investigators using either microarrays or RNA-seq is detecting differential expression, for example: discovering transcripts showing different average expression levels across two populations. A major difference between the two technologies is that in microarrays, measurement units are fixed in advance: only the abundances of the specific RNA sequences that correspond to probes on the microarrays are measured. With this approach, differential expression is relatively straightforward to quantify: measurements from the same probe are compared across samples. In contrast, RNA-seq reads out short sequences of molecules produced by shearing and reading RNA transcripts (the measurements produced are referred to as reads). Unlike with a microarray, across-sample comparisons are not straightforward as measurement units are not defined in advance. Therefore, reads must be summarized into units of expression before differential expression analysis can be performed. Different summarization approaches can lead to very different statistical inference.
Here, we group the most popular differential expression analysis approaches into two categories based on the ways that the reads are summarized. We refer to these two categories as (1) annotate-then-identify and (2) assemble-then-identify. The first category counts the number of reads that fall within previously identified boundaries of known genes. The second class seeks to assemble full transcripts directly from the reads. In either case, differential expression analysis is then performed on the resulting measurements at the gene or transcript level. In Section 2, we describe the limitations with the existing approaches and propose a new intermediate class of differential expression methods which we refer to as identify-then-annotate. In Section 3, we propose a specific implementation of the identify-then-annotate class of methods, which we call Differentially Expressed Region Finder (DER Finder). And in Section 4, using an example dataset, we show that identify-then-annotate models provide a good compromise between current RNA-seq analysis methods.
2. Differential expression analysis review
In this section, we review existing approaches to differential expression analysis with RNA-seq data and discuss how the philosophy behind DER Finder fits into this context. RNA-seq generates millions or billions of short sequences from individual mRNA molecules. Analyzing these sequence reads requires several steps: First, each read must be matched to the position it originates from in the genome in a process called alignment. Then, the number of reads aligned to specific regions must be summarized into quantitative measurements. The measurements are then normalized for the total number of reads measured for a particular sample and statistical models are applied to the summarized units. Oshlack and others (2010) describe this RNA-seq data analysis process in much more detail. Based on the summarization step, current statistical methods for the analysis of RNA-seq data can be grouped into two major classes. The methods in the first class, which we call annotate-then-identify, summarize the reads by counting the number that fall within pre-specified exons or genes. The exon and gene specifications, collectively called the annotation, are obtained from databases of previously identified genomic features.
Once the reads have been summarized at the exon or gene level, the statistical problem is very similar to statistical analysis of microarray data, with some deviations because the raw measurements take the form of counts. Note that the results from this step can be naturally summarized into matrices like those produced by microarray experiments, where rows are genes or exons and columns are samples. Therefore, many of the earliest statistical methods for analysis of RNA-seq data fall into this category because they were natural extensions of methods developed for microarrays. Two of the most widely used annotate-then-identify methods are EdgeR (Robinson and others, 2010; McCarthy and others, 2012) and DESeq (Anders and Huber, 2010); Alexa-seq (Griffith and others, 2010), DEXSeq (Anders and others, 2012), and a method developed by Wang and others (2012) are further examples of annotate-then-identify pipelines focusing on differential expression analysis of genomic structures that may indicate splicing or transcriptional differences between groups.
The annotate-then-identify approach provides a straightforward and interpretable analysis and that tested statistical methodology is available once raw read counts have been summarized into a gene-level matrix. However, one disadvantage is that it relies heavily on the accuracy of annotation databases of gene and exon boundaries, and current annotation may be unreliable or hard to interpret (Klimke and others, 2011). As shown in Fig. 1(a), the annotated transcript structure at individual genomic loci can be complex. Biologically, the distinct but overlapping regions in vertical columns represent a single exon used slightly differently in multiple transcripts. This complexity requires the analyst to make important counting decisions in advance, since each distinct use of an exon (represented by a box in Fig. 1(b)) represents a distinct potential counting region for annotate-then-identify methods. It is well known that different choices in how to count (all regions, only non-overlapping regions, or other choices) may lead to dramatically different results (Oshlack and others, 2010; Bullard and others, 2010), especially for genes whose transcripts have a low degree of similarity. In the case shown in Fig. 1, using a union model might allow for discovery of whole-gene differential expression, but it may mask a differential expression signal if, say, just one of the transcripts is overexpressed. Also, there is no “correct” gene model to use, so methods requiring this choice are at a disadvantage to those that do not. DER Finder does not require a gene model: if just a few transcripts or exons are differentially expressed, even in a complex scenario like Fig. 1 shows, the gene will simply be flagged as displaying a complicated differential expression pattern. This type of result is not possible in a gene-model-based approach. A second disadvantage of annotate-then-identify methods is that they do not allow for discovery of novel or previously uncharacterized exons or genes, since they rely on previously constructed databases.
The methods in the second class, which we call assemble-then-identify, attempt to assemble the full sequences of the mRNA molecules from which the short reads originated. These methods rely less heavily on annotation databases of exon or gene boundaries. Another advantage is that assemble-then-identify methods aim to fully quantify all the potential isoforms of mRNA molecules emanating from each gene. However, the short length of typical sequencing reads leads to inevitable ambiguity when attempting to assemble and quantify abundances of individual mRNA molecules: it is virtually impossible to determine which of many possible sets of assembled transcripts truly generated the observed RNA-seq data. This ambiguity also leads to varying and structured covariances between transcript measurements within genes, which complicates statistical analysis. There is also an increased computational cost associated with assembling full transcripts, quantifying their abundances, and performing transcript-level statistical tests, when compared with the more direct annotate-then-identify approach. The most widely used algorithm in this category is Cufflinks/Cuffdiff (Trapnell and others, 2010, 2012); others include Scripture (Guttman and others, 2010), and IsoLasso (Li and others, 2011). In our experience, the computational cost of transcriptome assembly is non-trivial: running Cufflinks (the transcript assembly step) took approximately 5 h on 4 standard cores for each sample, running Cuffmerge (merging 15 assemblies in preparation for DE analysis) took 1 h 39 min on 4 standard cores, and running Cuffdiff (assigning reads to transcripts and identifying DE) took about 42 h on 4 standard cores, comparing a 9-sample group with a 6-sample group. For comparison, alignment with Tophat took about 30 h per sample on 4 standard cores. Other researchers (Patro and others, 2013) have confirmed that assembly with tools other than Cufflinks also took several hours, and Cufflinks is one of the fastest assembly algorithms. Many of these tools allow the user to avoid the assembly problem by testing known transcripts for differential expression, but they then suffer from the previously mentioned shortcomings of annotate-then-identify methods.
Here, we propose an intermediate class of methods which we call identify-then-annotate. These methods first summarize the reads by counting the number of reads with alignments overlapping each individual base in the genome. Then we form a base-by-base statistic to identify bases that are differentially expressed between groups. Consecutive bases showing a common differential expression signature are grouped into DERs. The unit of statistical analysis is then the DER, which can be evaluated for statistical significance using permutation or bootstrap approaches. DERs can then be compared with previous databases of exons and genes to identify: (1) regions of differential expression corresponding to known exons or genes and (2) novel regions of differential expression. Currently, the closest analysis framework to an identify-then-annotate method is to combine pipelines: use an existing tool (e.g. rnaSeqMap Leśniewska and Okoniewski, 2011 or an assembler like Cufflinks) to identify expressed genomic regions, then test those regions for differential expression using existing statistical methods (e.g. Anders and Huber, 2010). Another identify-then-annotate pipeline has been proposed in the form of maximum mean discrepancy (Stegle and others, 2010) but does not have a software implementation available and is designed to test known genes for differential transcript expression—not to be run on an entire genome. We propose a new identify-then-annotate model that builds on the ideas behind the combining-pipelines approach: we feature a full statistical framework for expression detection and differential expression analysis.
The proposed identify-then-annotate model (1) allows for detection of differential expression in regions outside of known exons or genes, (2) allows for direct evaluation of differential expression of known genes and exons, (3) does not incur the added ambiguity and computational cost of assembly from short reads, and (4) can nonetheless detect differential splicing patterns and other expression differences between populations. Also, an identify-then-annotate tool can be used to address several commonly posed research questions at once, including differential expression, splicing analysis, and detection of novel features. For example, we could analyze differential expression of known features with annotate-then-identify tools, then use an assembly tool to detect novel features, then re-run the annotate-then-identify tool to analyze differential expression of the novel features—but an identify-then-annotate tool would address all of these issues at once. The primary disadvantage is that the proposed class of methods does not allow for direct quantification of alternative transcription. However, regions of potential alternative transcription can be easily identified where a subset of exons for a gene overlaps DERs but another subset does not, and those regions could be explored further with other tools.
3. DER Finder methodology
3.1. Base-level statistics
The first step in DER Finder is quantifying the evidence for differential expression at the nucleotide level. Since RNA-seq produces reads from mRNA transcripts, rather than directly from the genome, reads must be aligned using a strategy that accounts for reads that span intron-exon boundaries, called junction reads. In identify-then-annotate approaches like DER Finder, these junction reads are treated identically to reads that map directly to the genome when computing coverage. Tophat (Trapnell and others, 2009) is an example of an aligner that appropriately handles junction reads. The user must make choices about mapping parameters to use during the alignment step: for example, some reads will map to more than one genomic location (due to, e.g. repetitive regions or pseudogenes). Non-unique read alignments can either be discarded, in which case repetitive regions would not appear to be expressed at all, or kept, which would allow all repetitive regions to appear expressed but would not allow those regions to be distinguished from each other. Whatever alignment strategy and corresponding parameters are used, the result is ultimately a large matrix with rows corresponding to bases and columns corresponding to samples; entries of this matrix are the number of aligned reads from a particular sample that overlap a particular nucleotide. We refer to this matrix as the coverage matrix.
To quantify differential expression while accounting for biological variability and possible confounders, we fit a linear regression model to each row of the coverage matrix. Specifically, we let
(3.1) |
where is coverage for sample at location , is a Box–Cox style transformation (e.g. a log transformation) that makes the linear assumption acceptable, represents the baseline gene expression (coverage) level at location , is an indicator as to whether sample falls into category with category 1 being the reference group (e.g. when , we have the case/control scenario, where is a 0/1 indicator variable for whether sample is a case or a control), is the parameter of interest quantifying differential expression between category and the reference category at location (e.g. in the case/control scenario, if is a log transform, then represents the log fold change in expression for cases compared with controls), () are the values of potential confounders for sample , which may include sample-specific guanine/cytosine content effect (Hansen and others, 2012; Risso and others, 2011), sex or other demographic variables, or processing data, represents the effect of confounder on gene expression at location , and represents residual measurement error at location . Including confounders in this model is optional. We recommend setting to be some measurement of library size for sample (e.g. median or 75th percentile of coverage for the sample across all bases).
Our goal is to segment the genome into contiguous regions where for at least one for all . Instead of modeling as a functions (for example, with wavelet models or splines), we adopt a modular approach in which we first estimate for each location and then divide the estimates into regions in a separate step. To estimate along the genome and obtain test statistics from testing the null hypothesis that any of the , we can use methods for estimating regularized linear contrasts (Smyth and others, 2004), which take a shrinkage approach that is appropriate for small sample sizes and borrows information across bases. Details of this approach are available in supplementary material available at Biostatistics online.
3.2. Identifying candidate DERs with segmentation
In this section, we refer to the aforementioned test statistic resulting from the test for whether any as . (For ease of notation, we omit the subscript in the discussion that follows). For most experiments, we expect the function to be a step function that is mostly 0, since most of the genome is not differentially expressed. We do not expect to be smooth because gene expression usually has a clear-cut start and end location. Hidden Markov models (HMMs) are a natural way of modeling , and we describe the specifics of our implementation here.
We assume that there is an underlying Markov process along the genome with three hidden states: if , if and , and if . State corresponds to regions producing practically no gene expression. This state will be the most common, as most bases will not be covered by any reads because abundant gene expression is confined to a relatively small fraction of the genome. State corresponds to regions for which gene expression is observed but does not differ between populations. We are interested in finding regions in the differentially expressed state, .
We assume that is a first-order Markov chain with hidden state probabilities . We treat the transition matrix as fixed. As defaults, we set the retain state probabilities as very high with low transition probabilities between states, due to the sparsity of genes in the genome. The hidden state probabilities can be roughly estimated based on the relative frequencies of bases covered or not covered by genes, along with a prior estimate of the number of differentially expressed genes. DER Finder results are largely robust to changes in the prior estimates for (see Section 2.3 of supplementary material available at Biostatistics online).
Conditional on the hidden state of each base , we then assume that follows a normal distribution. Specifically, . When , there is little expression observed for base , so we model the distribution as , where is an arbitrary, very small positive number, to restrict values to very close to zero. We estimate empirically by calculating the fraction of bases where the average coverage is less than a threshold .
The model parameters for states and (, , , and ) can be estimated using a standard two-groups mixture model, first proposed for the analysis of differential expression in microarray experiments (Efron, 2008). We assume that the statistics from these two states are drawn from a mixture , where . (Estimates for and are scaled by the estimate of to obtain estimates for the overall state probabilities, and , such that .) Each mixture component is again assumed to be normal and can be estimated using the empirical null distribution. We can then directly estimate the most likely path of unobserved states based on the observed statistics using standard estimation techniques for HMMs. Details on the specific form of the test statistics, the parameters of the HMM, and validity of HMM assumptions are available in Sections 1–2 of supplementary material available at Biostatistics online.
3.3. Statistical significance
The HMM essentially segments the genome into regions, where a region is defined as a set of contiguous bases having the same predicted latent state. A region of bases with predicted latent state is referred to as a candidate DER. Beyond the segmentation step in the DER Finder pipeline, all analysis is done on the region level rather than the base level. Region-level analysis ensures that the number of statistical tests is not unreasonably large (as it would be if we did a formal test at every base) and makes it such that variations in read coverage at individual bases that can arise due to technical artifacts in RNA-seq data will not affect the final results.
After segmenting the genome into regions, we assign a -value to each candidate DER using a permutation procedure. In calculating the -values for each candidate DER, we consider the size of the individual statistics within each region, since regions with very large test statistics are more likely to be truly differentially expressed. We apply an approach similar to Jaffe and others (2012): first, we calculate the average base-level test statistic within each potential DER . Note that is the region-level test statistic for region . In the simple case–control scenario with no confounders, we can assign -values to DERs with the following permutation procedure:
Permute the values of the covariate of interest () for all samples.
Re-calculate the base-level statistics using (3.1). Denote these null statistics by .
Re-run the HMM on the s to identify a set of null DERs, indexed by and denoted by DER.
To form region-level null test statistics, calculate the average base-level statistic within each null DER
Steps 1–4 are repeated times, and the empirical -value for region is , where is the number of null DERs for permutation . This quantity is the percent of null DERs with average statistic as or more extreme than the observed statistic for candidate DER calculated on the observed data. Standard false discovery rate calculations can then be applied to adjust these -values for multiple testing.
In the case where confounders or additional covariates are included in model (3.1), a straightforward bootstrap extension of this permutation approach can be derived. After assigning statistical significance to each region, the DERs can be annotated using a reference database of known genomic features; an example of an annotation procedure can be found in supplementary material available at Biostatistics online.
4. Results: comparison on real data
Our method is designed for differential expression with biological replicates, but many published experiments do not include such replicates (Hansen and others 2011). We therefore designed an analysis comparing brain tissue between nine human males and six human females to assess the competing methods: the Y chromosome was tested for differential expression between sexes using DER Finder, Edge R, and DESeq (using previously annotated exons) and Cufflinks/Cuffdiff. Specific details of the experiment can be found in Section 4 of supplementary material available at Biostatistics online.
Two sets of results were obtained: one analysis compared males to females, and the other compared a randomly selected set of five of the males to the other four males. We expect virtually all genomic features of the Y chromosome (barring the pseudoautosomal region, pseudogenes, and other irregularities) to be differentially expressed between males and females, since females do not have a Y chromosome, and no genomic features to be differentially expressed between control males.
4.1. DER Finder results
DER Finder identified 534 Y-chromosome regions as differentially expressed () between males and females. Six of these regions were classified as underexpressed in males, which we know to be an artifact, but the other 528 were identified as overexpressed in males as expected. Additionally, we found 333 novel differentially transcribed regions (). These novel transcribed regions ranged in length from 1 to 3814 bases. These regions may indicate noise from the method, but they also may point to regions that should be examined further, either because they have interesting mapability characteristics or because they might truly be expressed and not yet annotated. The 534 DERs pointed to 411 differentially expressed exons, using the criteria outlined in Table 1 of supplementary material available at Biostatistics online. These 411 exons came from 33 different genes, which means we found those 33 genes to be differentially expressed or indicate an event of interest. In comparing males with each other, we did not identify any differential expression on the Y chromosome: the minimum -value for the regions found to be differentially expressed in the HMM step was 0.86.
4.2. Cufflinks/Cuffdiff results
Of 808 assembled transcripts tested for differential expression on the Y chromosome between males and females, the Tophat–Cufflinks–Cuffdiff pipeline found no differentially expressed transcripts. The minimum -value for these assembled transcripts was 0.45. While 736 of these transcripts showed non-zero abundance in males and zero abundance in females, these differences were not found to be statistically significant using the Cuffdiff methodology. Similar, too-conservative results were reported in supplementary material available at Biostatistics online of the manuscript accompanying the release of Cuffdiff version 2 (Trapnell and others 2012). In the comparison of normal males, none of the 818 assembled transcripts were called differentially expressed: the minimum -value was 0.63.
4.3. EdgeR and DESeq results
Both of these methods tested 433 exons on the Y chromosome for differential expression between males and females. The other annotated exons on the Y chromosome did not have any reads mapping to them or the counting model did not allow any reads to be counted for them. Of these 433 exons, EdgeR classified 113 and DESeq classified 115 as differentially expressed between males and females (). Ninety-seven exons were found by both EdgeR and DESeq. When comparing the males with each other, neither method found any exons to be differentially expressed: all -values were 1 except for 2 exons with in EdgeR.
4.4. Comparison of results across methods
DER Finder exhibits performance comparable with that of EdgeR and DESeq, while all three methods outperform Cufflinks/Cuffdiff. DER Finder also has major advantages over EdgeR and DESeq: DER Finder is agnostic to annotation, which means it can identify differential expression signal in two important cases: (a) the case where a feature may be slightly mis-annotated or where the read mappings do not quite match up with the feature's annotation and (b) the case where differential expression exists in regions that do not overlap annotated features. Both these scenarios occurred in the dataset studied. Fig. 2(a) illustrates a case where the location or length of an exon may be incorrectly annotated. In that example, the mis-annotation caused the exon's expression to be underestimated when counting reads overlapping it. As a result, the statistical tests used in EdgeR and DESeq did not have enough power to call this Y-chromosome exon differentially expressed (both tools report ) between males and females. DER finder more accurately reported the shown DER as overlapping 61.3% of an annotated exon with a -value 0.001. Also, DER Finder can find regions of interest that fall outside of annotated exons (Fig. 2(b)). Closer inspection of the illustrated region using the UCSC Genome Browser (build: hg19, tracks: UCSC genes, RefSeq genes, Human ESTs, Spliced ESTs) reveals no annotated genes in the region, but shows that the expression is supported by six ESTs, providing evidence that the signal here is truly biological rather than simply background noise. Section 5 of supplementary material available at Biostatistics online discusses other advantages of DER Finder over identify-then-annotate methods. Additional analysis of the agreement between DER Finder's results and those of Cufflinks/Cuffdiff, EdgeR, and DESeq can also be found in Section 6 of supplementary material available at Biostatistics online. DER Finder's ability to find differential expression signal even in the presence of wrong or missing annotation is a key advantage over annotate-then-identify methods.
To assess whether the tools give reasonable results and to compare overall performance of the three methods, plots (Dudoit and others 2002) were used to show the relationship between each unit's average expression (denoted with ) and the magnitude of differential expression it exhibits (denoted with ). The unit is a region for DER Finder, an exon for EdgeR and DESeq, or a transcript for Cufflinks. The plots resulting from the Y-chromosome experiment (Fig. 3) reveal that DER Finder, EdgeR, and DESeq all produce reasonable results, but the findings from Cufflinks are somewhat problematic. While there does seem to be more overexpression of transcripts in males in the male/female differential expression analysis done by Cufflinks, we observe several extreme fold changes in the opposite direction, and the male-to-male comparison also produced these extreme fold changes. These problems do not exist in the other methods, whose plots illustrate high fold changes found between males and females and very little change found between males, as expected.
Finally, to get a sense of each method's accuracy, we evaluated the tables of DERs between sexes and between males produced by each method. We gathered all resulting regions—both negative results, from the male vs. male comparison, and positive results, from the male vs. female comparison—and ordered them by the value of their test statistic. An algorithm ranking all positive results ahead of the negative ones is preferred. Fig. 4 shows, at each percentile of the differential expression test statistic, the percent of regions that are positive. This is analogous to finding the percentage of findings that were truly positive at different significance cutoffs, assuming all tests in the sex comparison should be positives and tests in the male comparison should be negatives. We find that EdgeR, DESeq, and DER Finder perform comparably: all or most of the top 20% of regions, ranked by test statistic, came from comparisons between sexes. Cufflinks does much worse: only about 60% of the top 20% of their top transcripts came from the male-to-female comparison. DER Finder performs just slightly better than EdgeR and DESeq in addition to having other advantages over these methods, as discussed earlier.
5. Discussion
We propose DER Finder as a specific implementation of a new class of methods for differential expression analysis of RNA-seq data. The new class deals with identified challenges by (a) not relying on existing annotation when calling differential expression and (b) avoiding the immensely difficult problem of full transcript assembly by putting differential expression into a more straightforward framework. We have built on the ideas behind the approach of combining pipelines (e.g. rnaSeqMap combined with DESeq) to create a full pipeline for statistical analysis of differential expression. DER Finder outperforms Cufflinks/Cuffdiff and performs comparably with EdgeR and DESeq, while having the added advantages of sensitivity even in the presence of incorrect annotation and transcript discovery capability. We have also considered DER Finder's performance in other scenarios: a simulation study is presented in Section 7 of supplementary material available at Biostatistics online that addresses experimental design questions and examines DER Finder's accuracy. An identify-then-annotate method like DER Finder is an important step in developing new ways to analyze RNA-seq data, so further properties of these types of methods are worth investigating.
6. Software
All software and code used in this analysis is available on github (https://github.com/alyssafrazee/derfinder).
Supplementary material
Supplementary material is available at http://biostatistics.oxfordjournals.org.
Funding
R.A.I. was partially supported by NIH Ro1 HG005220. J.T.L. and K.D.H. were partially funded by NIH Ro1 GM105705-01. J.T.L. was partially funded by NIH P50 MH-094268 Silvo O. Conte Center. S.S. was provided by the Stanley Brain Research Institute. Funding to pay the Open Access publication charges for this article was provided by Jeffrey Leek's discretionary fund.
Supplementary Material
Acknowledgements
We acknowledge helpful discussions with Geo Pertea and Steven Salzberg. Postmortem brain tissue was donated by The Stanley Medical Research Institute's brain collection. We also thank Ms Ou Chen for her technical assistance with high throughput sequencing. Conflict of Interest: None declared.
References
- Anders S., Huber W. Differential expression analysis for sequence count data. Genome Biology. 2010;11:R106. doi: 10.1186/gb-2010-11-10-r106. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Anders S., Reyes A., Huber W. Detecting differential usage of exons from RNA-seq data. Genome Research. 2012;22(10):2008–2017. doi: 10.1101/gr.133744.111. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Bullard J., Purdom E., Hansen K. D., Dudoit S. Evaluation of statistical methods for normalization and differential expression in mRNA-seq experiments. BMC Bioinformatics. 2010;11 doi: 10.1186/1471-2105-11-94. R package version 1.8.0. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Clark M. B., Amaral P. P., Schlesinger F. J., Dinger M. E., Taft R. J., Rinn J. L., Ponting C. P., Stadler P. F., Morris K. V., Morillon A. The reality of pervasive transcription. PLoS Biology. 2011;9(7):e1000625. doi: 10.1371/journal.pbio.1000625. and others. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Dudoit S., Yang Y. H., Callow M. J., Speed T. P. Statistical methods for identifying differentially expressed genes in replicated cDNA microarray experiments. Statistica Sinica. 2002;12(1):111–140. [Google Scholar]
- Efron B. Microarrays, empirical Bayes and the two-groups model. Statistical Science. 2008;23(1):1–22. [Google Scholar]
- Griffith M., Griffith O. L., Mwenifumbo J., Goya R., Morrissy A. S., Morin R. D., Corbett R., Tang M. J., Hou Y., Pugh T. J. Alternative expression analysis by RNA sequencing. Nature Methods. 2010;7(10):843–847. doi: 10.1038/nmeth.1503. and others. [DOI] [PubMed] [Google Scholar]
- Guttman M., Garber M., Levin J. Z., Donaghey J., Robinson J., Adiconis X., Fan L., Koziol M. J., Gnirke A., Nusbaum C. Ab initio reconstruction of transcriptomes of pluripotent and lineage committed cells reveals gene structures of thousands of lincRNAs. Nature Biotechnology. 2010;28(5):503–510. doi: 10.1038/nbt.1633. and others. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Hansen K. D., Irizarry R. A., Zhijin Wu. Removing technical variability in RNA-seq data using conditional quantile normalization. Biostatistics. 2012;13(2):204–216. doi: 10.1093/biostatistics/kxr054. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Hansen K. D., Wu Z., Irizarry R. A., Leek J. T. Sequencing technology does not eliminate biological variability. Nature Biotechnology. 2011;29(7):572–573. doi: 10.1038/nbt.1910. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Jaffe A. E., Murakami P., Lee H., Leek J. T., Fallin M. D., Feinberg A. P., Irizarry R. A. Bump hunting to identify differentially methylated regions in epigenetic epidemiology studies. International Journal of Epidemiology. 2012;41(1):200–209. doi: 10.1093/ije/dyr238. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Katz Y., Wang E. T., Airoldi E. M., Burge C. B. Analysis and design of RNA sequencing experiments for identifying isoform regulation. Nature Methods. 2010;7(12):1009–1015. doi: 10.1038/nmeth.1528. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Klimke W., O'Donovan C., White O., Brister J. R., Clark K., Fedorov B., Mizrachi I., Pruitt K. D., Tatusova T. Solving the problem: genome annotation standards before the data deluge. Standards in Genomic Sciences. 2011;5(1):168. doi: 10.4056/sigs.2084864. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Leśniewska A., Okoniewski M. J. rnaSeqMap: a Bioconductor package for RNA sequencing data exploration. BMC Bioinformatics. 2011;12(1):200. doi: 10.1186/1471-2105-12-200. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Li W., Feng J., Jiang T. Isolasso: a lasso regression approach to RNA-seq based transcriptome assembly. Journal of Computational Biology. 2011;18(11):1693–1707. doi: 10.1089/cmb.2011.0171. [DOI] [PMC free article] [PubMed] [Google Scholar]
- McCarthy D. J., Chen Y., Smyth G. K. Differential expression analysis of multifactor RNA-seq experiments with respect to biological variation. Nucleic Acids Research. 2012;40(10):4288–4297. doi: 10.1093/nar/gks042. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Mortazavi A., Williams B. A., McCue K., Schaeffer L., Wold B. Mapping and quantifying mammalian transcriptomes by RNA-Seq. Nature Methods. 2008;5(7):621–628. doi: 10.1038/nmeth.1226. [DOI] [PubMed] [Google Scholar]
- Oshlack A., Robinson M. D., Young M. D. From RNA-seq reads to differential expression results. Genome Biology. 2010;11(12):220. doi: 10.1186/gb-2010-11-12-220. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Patro R., Mount S. M., Kingsford C. Sailfish: alignment-free isoform quantification from RNA-seq reads using lightweight algorithms. 2013 doi: 10.1038/nbt.2862. Preprint, arXiv:1308.3700. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Risso D., Schwartz K., Sherlock G., Dudoit S. GC-content normalization for RNA-seq data. BMC Bioinformatics. 2011;12(1):480. doi: 10.1186/1471-2105-12-480. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Robinson M. D., McCarthy D. J., Smyth G. K. edgeR: a Bioconductor package for differential expression analysis of digital gene expression data. Bioinformatics. 2010;26(1):139–140. doi: 10.1093/bioinformatics/btp616. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Smyth G. K. Linear models and empirical Bayes methods for assessing differential expression in microarray experiments. Statistical Applications in Genetics and Molecular Biology. 2004;3(1):3. doi: 10.2202/1544-6115.1027. [DOI] [PubMed] [Google Scholar]
- Stegle O., Drewe P., Bohnert R., Borgwardt K., Rätsch G. Statistical tests for detecting differential RNA-transcript expression from read counts. Nature Precedings. 2010 [Google Scholar]
- Stein L. D. The case for cloud computing in genome informatics. Genome Biology. 2010;11(5):207. doi: 10.1186/gb-2010-11-5-207. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Trapnell C., Hendrickson D. G., Sauvageau M., Goff L., Rinn J. L., Pachter L. Differential analysis of gene regulation at transcript resolution with RNA-seq. Nature Biotechnology. 2012;31(1):46–53. doi: 10.1038/nbt.2450. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Trapnell C., Pachter L., Salzberg S. L. TopHat: discovering splice junctions with RNA-Seq. Bioinformatics. 2009;25(9):1105–1111. doi: 10.1093/bioinformatics/btp120. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Trapnell C., Williams B. A., Pertea G., Mortazavi A., Kwan G., van Baren M. J., Salzberg S. L., Wold B. J., Pachter L. Transcript assembly and quantification by RNA-Seq reveals unannotated transcripts and isoform switching during cell differentiation. Nature Biotechnology. 2010;28(5):511–515. doi: 10.1038/nbt.1621. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Wang W., Qin Z., Feng Z., Wang X., Zhang X. Identifying differentially spliced genes from two groups of RNA-seq samples. Gene. 2012;518:164–170. doi: 10.1016/j.gene.2012.11.045. [DOI] [PubMed] [Google Scholar]
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.