Skip to main content
NIHPA Author Manuscripts logoLink to NIHPA Author Manuscripts
. Author manuscript; available in PMC: 2015 Nov 27.
Published in final edited form as: J Am Stat Assoc. 2015 Nov 7;110(511):975–986. doi: 10.1080/01621459.2015.1040880

IsoDOT Detects Differential RNA-isoform Expression/Usage with respect to a Categorical or Continuous Covariate with High Sensitivity and Specificity

Wei Sun 1, Yufeng Liu 2, James J Crowley 3, Ting-Hued Chen 4, Hua Zhou 5, Haitao Chu 6, Shunping Huang 7, Pei-Fen Kuan 8, Yuan Li 9, Darla R Miller 10, Ginger D Shaw 11, Yichao Wu 12, Vasyl Zhabotynsky 13, Leonard McMillan 14, Fei Zou 15, Patrick F Sullivan 16, Fernando Pardo-Manuel de Villena 17
PMCID: PMC4662594  NIHMSID: NIHMS671677  PMID: 26617424

Abstract

We have developed a statistical method named IsoDOT to assess differential isoform expression (DIE) and differential isoform usage (DIU) using RNA-seq data. Here isoform usage refers to relative isoform expression given the total expression of the corresponding gene. IsoDOT performs two tasks that cannot be accomplished by existing methods: to test DIE/DIU with respect to a continuous covariate, and to test DIE/DIU for one case versus one control. The latter task is not an uncommon situation in practice, e.g., comparing the paternal and maternal alleles of one individual or comparing tumor and normal samples of one cancer patient. Simulation studies demonstrate the high sensitivity and specificity of IsoDOT. We apply IsoDOT to study the effects of haloperidol treatment on the mouse transcriptome and identify a group of genes whose isoform usages respond to haloperidol treatment.

Keywords: RNA-seq, isoform, penalized regression, differential isoform expression, differential isoform usage


In the genomes of higher eukaryotes, the DNA sequence of a gene often includes multiple exons that are separated by introns. A multi-exon gene may encode several RNA isoforms, each with a unique subset of exons. Recent studies have shown that more than 90% of human genes have multiple RNA isoforms which may be differentially expressed across tissues or developmental stages [Wang et al., 2008, Pan et al., 2008], and about 75% of human genes produce multiple RNA isoforms within a given cell type [Djebali et al., 2012]. Therefore, study of RNA-isoform expression and its regulation is of great importance to understand the functional complexity of a living organism, the evolutionary changes in transcriptome [Barbosa-Morais et al., 2012], and the genomic basis of human diseases [Wang and Cooper, 2007].

Gene expression has traditionally been measured by microarrays or exon arrays, most of which provide just a handful of probes per gene and poor resolution to distinguish multiple isoforms. [Purdom et al., 2008, Richard et al., 2010]. RNA sequencing (RNA-seq), on the other hand, provides much better data for this purpose [Wang et al., 2009]. In RNA-seq, fragments of RNA molecules (typically 200-500 bps long) are reverse transcribed and amplified, followed by sequencing of one or both ends (single vs paired-end). Each sequence is referred to as a read, which could be 30 - 150 bps or even longer. Reads are then mapped to a reference genome and the number of fragments overlapping each gene is counted. The expression of the j-th gene in the i-th sample is measured by a normalized fragment count after adjusting for read-depth of the i-th sample and the length of the j-th gene [Mortazavi et al., 2008].

The primary challenge with studying RNA isoforms is that we cannot directly observe the expression of each RNA isoform. More specifically, an RNA-seq fragment may be compatible with more than one RNA isoform, and thus we cannot unambiguously assign it to an RNA isoform. Several methods have been developed to address this challenge [Jiang and Wong, 2009, Salzman et al., 2011, Richard et al., 2010, Xing et al., 2006, Trapnell et al., 2010, Roberts et al., 2011, Li et al., 2010, Katz et al., 2010, Pachter, 2011, Chen, 2012]. Moreover, the annotation of RNA isoforms may not be complete or accurate and thus one may need to reconstruct transcriptome annotation using RNA-seq data [Denoeud et al., 2008]. Simultaneous transcriptome reconstruction and isoform abundance estimation can be achieved using different approaches, including penalized regression methods [Xia et al., 2011, Bohnert and Rätsch, 2010, Li et al., 2011b,a], where each possible isoform is treated as a covariate in a regression problem. Interested readers are referred to Ala-mancos et al. [2014] for a comprehensive list of relevant statistical/computational methods.

Differential isoform expression (DIE) and differential isoform usage (DIU) are related but distinct concepts. DIE assesses the difference of absolute expression in isoform level. In contrast, DIU assesses the difference of relative expression in isoform level. For example, if the expression of two isoforms of one gene are 10 and 20 in control and 50 and 100 in case, then there is DIE but no DIU because the relative expression of the first isoform is 1/3 in both case and control. Although many methods have been developed to estimate RNA isoform expression, only a few methods have been developed to assess DIE or DIU while modeling biological variability and accounting for the uncertainty of isoform expression estimation. These methods include BitSeq [Glaus et al., 2012], Cuffdiff2 [Trapnell et al., 2013], and EBseq [Leng et al., 2013]. All three methods are designed for two-group or multi-group comparisons with multiple samples per group. BitSeq (Bayesian Inference of Transcripts from Sequencing data) adopts a two-stage approach. The first stage is isoform expression estimation within each sample using a Bayesian MCMC method. The second stage is to assess differential expression of each isoform using the posterior samples from the first stage. Cuffdiff2 employs a likelihood-based approach for isoform expression estimation and relevant hypothesis testing. For each gene, Cuffdiff2 first estimates expectation and covariance of the expression of multiple isoforms, and then uses these estimates to assess differential expression of this gene or DIU of its isoforms. For differential expression, Cuffdiff2 constructs a test statistic of log fold change, standardized by its standard error. Cuffdiff2 offers two tests for DIU: one for all the isoforms sharing a transcription starting site (TSS) and one for differential usage of TSSs. The test statistic for DIU is the square root of the Jensen-Shannon divergence, divided by its standard error. While both BitSeq and Cuffdiff2 first estimate isoform expression and then perform hypothesis testing, EB-Seq uses isoform expression estimates from other methods. For two-group or multi-group comparisons, EBSeq assumes the (rounded) isoform expression estimate follows a negative binomial distribution with group-specific mean and overdispersion. EBSeq stratifies all isoforms into multiple categories to allow category-specific mean-variance relations. These isoform categories are constructed based on the difficulty of isoform expression estimation. For example, genes with one, two, or more isoforms may form three categories.

BitSeq, Cuffdiff2, and EBseq all address an important issue for differential isoform expression (DIE): to account for the uncertainty inherent in the isoform expression estimation process. However, there are two types of commonly encountered tasks that cannot be accomplished by these methods: to assess DIE with respect to a continuous variable, e.g., age or additive coding of genotype (i.e., 0, 1, 2, for genotype AA, AB, and BB), and to assess DIE across two groups with only one sample per group, which is not an uncommon situation in real data studies. For example, one may wish to compare isoform expression between the paternal and maternal alleles of an individual or between normal and cancer tissues of a patient. In such situations, the RNA-seq data allow a valid statistical test, although the population for statistical inference is limited to the tested case and control (i.e., what happens if we collect more RNA-seq fragments from this case and this control) rather than the general case and control populations (i.e., what happens if we collect more samples from case or control population). BitSeq and EBseq cannot compare two groups with one case and one control. Cuffdiff2 provides an ad-hoc implementation for this problem. Specifically, when there is one case and one control, Cuffdiff2 estimates isoform expression variance by combining case and control, which implicitly assumes most isoforms are not differentially expressed. Therefore it is expected that Cuffdiff2 would yield conservative p-values and limited power in this situation, which is confirmed in our simulation studies.

In this paper, we develop a statistical method named IsoDOT, which assesses DIE or DIU using RNA-seq data and addresses the aforementioned two tasks that cannot be accomplished by existing methods. IsoDOT treats all the RNA isoforms of a gene (or a transcript cluster of a few overlapping genes) as a unit and tests whether any of these RNA isoforms is associated with a covariate of interest. Alternative strategies would be to assess differential expression or differential usage of each exon set or each RNA isoform. For testing at the exon set level, the number of tests is much larger than gene-level testing, which increases the burden on multiple testing correction. In fact, multiple testing correction is also more challenging because multiple exon sets of the same gene often have correlated expression. For isoform-level testing, the major challenge is to incorporate the uncertainty in isoform expression estimation into the testing step. It is possible that two isoforms are very similar and thus available data cannot distinguish them. Therefore differential expression testing for these two isoforms separately is problematic. By performing testing per transcript cluster, IsoDOT bypasses the limitation of exon-set-level or RNA-isoform-level testing. After transcript clusters with significant DIE or DIU are identified, one may follow up on these transcript clusters to identify differentially expressed exon sets [Anders et al., 2012] or isoforms [Glaus et al., 2012, Trapnell et al., 2013, Leng et al., 2013].

Materials and Methods

An overview

We assume that the locations and sizes of all the exons of a gene are known. If needed, one can use existing software (e.g., TopHat [Trapnell et al., 2009]) to detect previously unknown exons. The inputs of our method are the bam files of all samples. From each bam file, we derive the number of RNA-seq fragments overlapping each exon set (an exon set includes one or more adjacent or non-adjacent exons) and the distribution of RNA-seq fragments' lengths (Figure 1(a)). IsoDOT estimates RNA isoform expression across all samples, and outputs two p-values per gene: one for testing differential isoform expression (DIE) and one for testing differential isoform usage (DIU). The DIE test asks whether the absolute expression of any isoform of a gene is associated with the covariate of interest. In contrast, the DIU test asks, after adjusting for total expression of the corresponding gene, whether the relative expression of any isoform of this gene is associated with the covariate of interest.

Figure 1.

Figure 1

(a) IsoDOT work flow. The dash line indicates that known isoform annotation (i.e., transcriptome annotation) is optional, (b) A gene with 3 exons and 3 possible isoforms. (c) A matrix of input data. Each row corresponding to an exon set. The column “Count” is the number of RNA-seq fragments at each exon set, and the columns “isoform k” for k = 1,2,3 give the effective lengths of each exon set within each isoform, and specifically, ηA,k is the effective length of exon set A for the k-th isoform. NB(μ,φ) indicates a negative binomial distribution with mean μ, and dispersion parameter φ.

As part of IsoDOT, we have developed a penalized regression method, named IsoDetector, to estimate RNA isoform expression. In contrast to existing methods [Xia et al., 2011, Bohnert and Ratsch, 2010, Li et al., 2011b,a], IsoDetector employs penalized negative binomial regression with a log penalty. The negative binomial distribution is commonly used to model RNA-seq data, and previous studies have shown that it can account for variation in RNA-seq fragment counts across biological replicates [Langmead et al., 2010]. Many popular methods for differential expression testing, such as DEseq [Anders and Huber, 2010] and edgeR [Robinson et al., 2010], adopt such an assumption. More specifically, the negative binomial distribution assumption, denoted by N B(μ,φ), implies that the RNA-seq fragment count across biological replicates follows a negative binomial distribution with mean value μ and variance μ + μ2φ, where φ is an over-dispersion parameter. Therefore, the variance of a negative binomial distribution can be arbitrarily large for a large value of φ. The Log penalty, which can be interpreted as an iterative adaptive Lasso penalty [Tibshirani, 1996, Zou, 2006, Sun et al., 2010], is flexible enough to handle a broad class of penalization problems [Chen et al., 2014]. IsoDOT can test DIE/DIU against any categorical or continuous covariate at any sample size, with or without known isoform annotation. Our simulation and real data analysis demonstrate that IsoDOT performs very well with human or mouse RNA-seq data, but it can of course be applied to RNA-seq data from any species with a reference genome.

Two exons of a gene may overlap partially. In such situations, we split them into three exons: the part unique to the first or the second exon, and the part that belongs to both exons. Multiple genes may overlap on one or more exons, and we consider these genes as a transcript cluster, though any isoform of this transcript cluster can only be produced from one gene.

Isoform estimation in a single sample

We study the isoforms of each transcript cluster separately, and the following discussion applies to a specific transcript cluster. Denote the number of exons of a transcript cluster by k. Let A be an exon set, i.e., a subset of the k exons. Let yiA be the number of sequence fragments that overlap and only overlap with all the exons of A in the i-th sample, where 1 ≤ in, and n is the sample size. A sequence fragment overlaps with an exon if the “sequenced portion” of this fragment overlaps with at least 1 bp of the exon. For example, if a fragment is sequenced by a paired-end read where the first end overlaps with exon 1 and 2 and the second end overlaps with exon 4, then this fragment is assigned to exon set A = {1,2,4}.

To illustrate the main feature of our method, we consider a gene (which is a transcript cluster itself) with 3 exons and 3 isoforms (Figure 1(b)). Denote its expression at sample i by yi = (yi{1}, yi{2}, yi{3}, yi{1,2}, yi{2,3}, yi{1,3}, yi{1,2,3})T. We assume yiA follows a negative binomial distribution ψ(μiA) with unknown mean μiA and dispersion parameter φ. Let μi be a column vector concatenating the μiA's, then μi = E(yi). We model μi by:

μi=Xiβ=u=1pxiuβu,βu0, (1)

where βu is proportional to the transcript abundance of the u-th isoform, Xi = (xi1, …, xip), and xiu for 1 ≤ up represents the effective lengths of all the exon sets for the u-th isoform in the i-th sample. Intuitively, effective length is the “usable length” for the data generation mechanism, i.e., the number of positions where a randomly selected sequence fragment can be sampled. The effective length of an exon set varies across the underlying isoforms. For example, isoforms 1 and 3 of the gene shown in Figure 1(b-c) do not include exon 2, and thus the effective length of exon set {2} is 0 for isoforms 1 and 3. In contrast, the effective length of exon 2 is nonzero for isoform 2, since it includes exon 2. In addition, effective length is also a function of the sample-specific RNA-seq fragment length distribution. The desired average length of RNA-seq fragments is often chosen during RNA-seq library preparation. However, the true fragment length distribution can be estimated from observed RNA-seq data. See Supplementary Materials Section A for details. In this example, the design matrix includes the effective lengths of all exon sets for isoforms 1, 2, and 3. Next, we recast the isoform estimation problem to a negative binomial regression problem with fragment counts yi as response and effective lengths Xi as covariates:

yi~ψ(μi,ϕ),andμi=Xiβ. (2)

Equation (2) should be understood such that yiA's are independent of each other and yiA follows a negative binomial distribution ψ(μiA). The independence assumption is reasonable because the fragment counts across exon sets should be independent given isoform configurations.

The regression problem presented in equation (2) is challenging because there can be a large number of possible isoforms and their effective lengths (e.g., the columns of the design matrix Xi) may be linearly dependent or significantly correlated. To address this difficulty, we first select a set of candidate isoforms, and then apply a penalized negative binomial regression to select the final set of isoforms from these candidate isoforms. The candidate isoforms can be selected using observed RNA-seq data (Supplementary Materials Section B) or a transcriptome annotation database (e.g., Ensembl [Flicek et al., 2011]).

In our analysis, we skip the exon sets that have zero or negligible effective lengths across all the candidate isoforms because these exon sets are not informative for isoform expression estimation. For example, the exon set {2,3} or {1,2,3} in the example shown in Figure 1 (c) are not included in the analysis. The number of candidate isoforms, denoted by p, can be much larger than the number of (informative) exon sets, denoted by m, and there may be high correlations among the effective lengths of the candidate isoforms. Therefore, selecting the final set of isoforms from the candidate isoforms is a challenging variable selection problem. Lasso penalty has been applied in previous studies. However, the selection consistency of Lasso requires an irrepresentability condition on the design matrix [Zou, 2006, Zhao and Yu, 2006], which posits that there are weak correlations between the “important covariates”, which have non-zero effects and the “unimportant covariates”, which have zero effects. This irrepresentability condition is often not satisfied for the isoform selection problem due to high correlations among candidate isoforms. We employ a Log penalty [Mazumder et al., 2011] for this challenging variable selection problem, which does not require the irrepresentability condition and can be interpreted as iterative adaptive Lasso [Sun et al., 2010, Chen et al., 2014]. The algorithm for fitting this penalized negative binomial regression is outlined in Supplementary Materials Section C.

Isoform estimation in multiple samples

To estimate isoform expression in multiple samples, we have to account for read-depth difference across samples. Let ti be a read-depth measurement for the i-th sample. For example, ti can be the total number of RNA-seq fragments in the i-th sample, or the 75 percentile of the number of RNA-seq fragments per gene in the i-th sample [Bullard et al., 2010]. We first consider a case without any covariate associated with isoform expression. To account for read-depth variation, we modify equation (1) to

μi=tiXiγ=u=1ptixiuγu, (3)

where γu is proportional to relative expression of the u-th isoform, after normalizing by ti.

Let yT=(y1T,,ynT), μT=(μ1T,,μnT), and ZT=(t1X1T,,tnXnT), where y and μ, are vectors of length nm and Z is a matrix of size nm × p. Recall that p is the number of candidate isoforms, n is sample size, and m is the total number of exon sets. Then the isoform selection problem can be written as a negative binomial regression problem

y~ψ(μ,ϕ)andμ=Zγ,whereγj0for1jp. (4)

After imposing a penalty, we solve this regression problem using the method described in Supplementary Materials Section C.

Next we consider isoform estimation given a continuous covariate g = (g1, …, gn)T. We assume the expression of an isoform u for sample i, denoted by γiu, is a linear function of covariate gi: γiu = au + ugi. This linear model is an appropriate choice when gi represents SNP genotype [Sun, 2012], which is the focus of our empirical data analysis. In this linear model setup, a complex set of constraints is needed for au and u so that γiu ≥ 0 for any value of gi. Therefore we reformulate the problem as follows. Without loss of generality, we scale the value of gi to be within the range of [0,1] with the minimum and maximum values being exactly 0 and 1, respectively. For example, if gi corresponds to a SNP with additive effect, we can set gi = 0, 0.5, or 1 for genotype AA, AB, or BB. Let bu = u + au, then γiu = au + (buau)gi = au(1 − gi) + bugi. Under this model, we have

γiu0for anygi[0,1]au0andbu0.

Let a = (a1,…, ap)T and b = (b1,…, bp)T, we have

μi=tiXi[a(1gi)+bgi]. (5)

By concatenating a and b into a vector: θ = (a1, …, ap,b1, …,bp)T, we can rewrite equation (5) as μi = Wiθ, where Wi = [tiXi(1 − gi), tiXigi] is an m × 2p matrix. Let WT=(W1T,,WnT), then the isoform expression estimation problem reduces to a negative binomial regression problem with non-negative coefficients

y~ψ(μ,ϕ)andμ=Wθ,whereθj0for1j2p. (6)

After imposing a penalty, we solve the resulting penalized regression problem by the coordinate ascend method described in Supplementary Materials Section C.

Finally we consider the general situation with q covariates, denoted by g1,…, gq, where gv = (g1v, …,gnv)T for v = 1, …,q. Without loss of generality, we assume 0 ≤ giv ≤ 1 for 1 ≤ in and 1 ≤ vq. Then we model γiu by γiu=qau+v=1q(bvuau)giv=auv=1q(1giv)+v=1qbuvgiv. This is simply a multiple linear regression model where each covariate gv has its own effect. Let a = (a1,…, ap)T and bv = (b1v,…, bpv)T, then

μi=tiXi[av=1q(1giv)+b1gi1++bqgiq]. (7)

By concatenating a, b1, b2, …, bq into a vector: θ=(aT,b1T,,bqT)T, we rewrite the above equation as μi = Wiθ, where Wi=[tiXiv=1q(1giv),tiXigi1,,tiXigiq] is an m × (q + 1)p matrix. Let WT=(W1T,,WnT), then we form an negative binomial regression problem

y~ψ(μ,ϕ)andμ=Wθ,forθj0,1j(q+1)p. (8)

After imposing a penalty on each θj, we can solve the resulting penalized regression problem by the coordinate ascend method described in Supplementary Materials Section C.

When studying multiple samples, it is possible that an exon set is only expressed in a subset of samples. Therefore, when examining the fragment counts of this exon set across all samples, there are more 0's than expected by a negative binomial distribution. In such case, we introduce a zero-inflated component and employ the zero-inflated negative binomial distribution [Rashid et al., 2011] to model RNA-seq fragment count data.

Testing for differential isoform expression (DIE)

We have described the statistical model to estimate RNA isoform expression in multiple samples given one or more covariate. Building on this model, we assess differential isoform expression with respect to a set of covariates denoted by V using a likelihood ratio test. Specifically, the null hypothesis (H0) is that buv = au for u = 1, …,p and vV and the alternative hypothesis (H1) is that buvau for at least one pair of (u, v), where u = 1, …,p and vV. It is helpful to understand this test by considering two special cases. First, we assume there is only one numerical covariate. Under H0, we solve the isoform estimation problem by a penalized negative binomial regression with expected value μi = tiXia. Under alternative, μi = tiXi[a(1 − gi) + bgi]. Therefore the number of parameters is p under H0 and 2p under H1. The asymptotic Chi-square distribution with degree of freedom p does not apply because the models are estimated, under both H0 and H1, by penalized regression. In the second special case, we assume the only variable of interest is a categorical variable with d categories. This categorical variable can be coded as d − 1 binary variables, dented by gi1,…, gi,d−1. The expected values of fragment counts across exon sets under H0 and H1 are μi = (d − 1)tiXia and μi=tiXi[av=1d1(1giv)+b1gi1++bd1gi,d1], respectively. Therefore the number of parameters under H0 and H1 are p and dp, respectively. Again, the asymptotic Chi-square distribution with degree of freedom (d − 1)p does not apply because the models are estimated, under both H0 and H1, by penalized regression.

We use likelihood ratio (LR) statistic as our test statistic:

LR=2(10),

where 0 and 1 are the log likelihoods under null and alternative, respectively. Because of penalized estimation, the null distribution of this test statistic no longer follows the standard asymptotic distribution. We obtain the null distribution by parametric bootstrap or permutation. The parametric bootstrap approach proceeds as follows. (1) Fit the penalized negative binomial regression under null. (2) Sample fragment counts based on the fitted null model. (3) Using the sampled counts to refit models under null and alternative and calculate the LR statistic. (4) Repeat steps (1)-(3) a large number of times as needed [Jiang and Salzman, 2012]. (5) Calculate the p-value as the proportion of the bootstrapped LR statistics that are larger than Inline graphic Inline graphic. This parametric bootstrap procedure yields valid p-values regardless of the sample size n. However, since the sampling population is all the RNA-seq fragments from the studied samples, small p-values only imply a significant difference of the studied samples and should not be generalized to other individuals.

If sample size is sufficiently large (e.g., ≥ 5 cases vs. ≥ 5 controls), we can obtain valid statistical inference for the corresponding population (instead of studied samples) by calculating permutation p-values. Specifically, the null model is fitted without the covariate of interest, and thus its log likelihood l0 remains unchanged across permutations. In each permutation, we permute the covariate of interest and refit the alternative model, and then calculate the likelihood ratio test statistic. We repeat this process a large number of times to obtain a null distribution of the likelihood ratio statistic.

Testing for differential isoform usage (DIU)

All the previous discussion, including RNA isoform expression estimation and differential isoform expression testing, focus on absolute expression of RNA isoforms, which is RNA isoform expression after correcting for read-depth variation across samples. Another measure of RNA isoform expression, which may be more interesting in many situations, is the relative expression with respect to the total expression of the corresponding gene or transcript cluster. This is because a gene may have higher or lower expression overall, and it may also switch the usage of some RNA isoforms. For example, a gene may predominately use one isoform in one tissue and switch to another isoform in another tissue. Such relative expression of an RNA isoform is referred to the isoform usage. For a transcript cluster of interest, we denote the total number of RNA-seq fragments in the i-th sample by ri. Recall that in the previous discussions of DIE, ti denotes a read-depth measurement for the i-th sample. To assess DIU, we apply the same procedure as assessing DIE, except that we replace ti by ri.

Results and Discussions

Simulation for case-control comparison

We simulated ∼1 million 76 + 76 bps paired-end RNA-seq reads for a single case and control sample respectively using Flux Simulator (http://flux.sammeth.net/simulator.html) and the Ensembl transcriptome annotations (version 67, http://useast.ensembl.org/info/data/ftp/index.html) for chromosome 1 (chr1) and chromosome 18 (chr18) for the mouse genome. We simulated the data such that all genes from chr1 were equivalently expressed and all genes from chr18 were differentially expressed, either in terms of total expression or isoform usage (Supplementary Figure 2). These simulated RNA-seq reads were mapped to the reference genome using Tophat [Trapnell et al., 2009]. Next, we counted the number of RNA-seq fragments per exon set. It was important to consider all exon sets rather than just exon or exon junctions because many RNA-seq fragments overlap with more than two exons. For example, in this simulated dataset, ∼27% of the paired-end reads overlapped 3 or more exons (Supplementary Figure 3). In addition, we confirmed that the number of sequence fragments per exon set was proportional to the effective length of the exon set (Supplementary Figure 4).

The dimension of this problem (i.e., the number of exon sets m versus the number of candidate isoforms p) was illustrated in Supplementary Figures 5-6. Given transcriptome annotation, p < m for the vast majority of transcript clusters, and without transcriptome annotation, we restricted the number of candidate isoforms so that approximately p < 10m. In either case, there were strong correlations among the candidate isoforms (Supplementary Figures 7-8), therefore necessitating the use of penalized regression in IsoDetector. After applying penalized regression, most transcription clusters included 10 or fewer isoforms, with or without transcriptome annotation (Supplementary Figures 9-10).

We compared isoform abundance estimates from IsoDetector and Cufflinks (v2.0.0) [Trapnell et al., 2010, 2013] using the case sample. The conclusions from the control sample were similar (results not shown). We focused on 1,062 transcript clusters (corresponding to 5,185 transcripts) that had at least 2 exons with ≥5 sequence fragments overlapping each exon. Most of these transcript clusters included 1-2 genes and 1-42 transcripts, and most of the 5,185 transcripts harbored 6-500 RNA-seq fragments (Figure 2a). If transcriptome annotation was unavailable, the isoforms selected by IsoDetector were more similar to the true ones than Cufflinks (Figure 2b). The two methods had similar accuracy in terms of transcript abundance estimation, either with (Figure 2c-2d) or without (Figure 2e-2f) transcriptome annotation.

Figure 2.

Figure 2

(a) A summary of the RNA-seq data and annotation of the simulated case sample. (d) Density curves of the distance between each de novo transcript and its closest transcript from transcriptome annotation. The distance is defined as the ratio of the number of unmatched base pairs over the total number of base pairs covered by either isoform. A base pair is “matched” if it corresponds to an exon or intron location for both isoforms. (c-d) Comparison of true transcript abundance vs. estimates from IsoDetector or Cufflinks when we use known isoform annotation. Both X and Y-axes are in log10 scale. “n” is the number of transcripts with status “OK” for either IsoDetector or Cufflinks. (e-f) Comparison of true transcript abundance vs. estimates from IsoDetector or Cufflinks when we do not use any isoform annotation.

We next compared the power of IsoDOT to that of Cuffdiff (v2.0.0) [Trapnell et al., 2013] in terms of testing for differential expression or differential isoform usage. Cuffdiff results were obtained from three files: gene_exp.diff (differential expression), splicing.diff (differential usage of the isoforms sharing a transcription start site (TSS)), and promoters.diff (differential usage of TSSs). The majority of the genes in file gene_exp.diff have status “OK” and they were used in the following comparison. However, no gene has status “OK” in file splicing.diff or promoters.diff. In these two files, all the genes with meaningful p-values have status “NOTEST”, indicating that Cuffdiff recommends users not to trust these testing results. The reason is as follows. For a two group comparison with one case and one control, Cuffdiff combines the case and the control to estimate variance of biological replicates, which leads to a very conservative p-value since this approach implicitly assumes the case and the control have the same expected value. Nonetheless, these genes with status “NOTEST” were used in the following comparison because they are the only genes that we can use. A gene could have multiple p-values in splicing.diff. In favor of Cuffdiff for power comparison, we used the smallest p-value for each gene. Based on our simulation setup, power was defined as the proportion of the genes from chr18 that had significant DIE or DIU. IsoDOT had substantially higher power than Cuffdiff (Figure 3), attributed to the correct type I error control of IsoDOT (Supplementary Figure 11). The poor performance of Cuffdiff is not simply a calibration issue because IsoDOT still performs better than Cuffdiff when we compare two methods using ROC curves (Supplementary Figure 12). Instead, the poor performance of Cuffdiff is because it tries to estimate variance across biological replicates when there is no biological replicate at all. IsoDOT can perform a valid test because it does not try to estimate variance of biological replicates. Instead, it tries to estimate the variance due to resampling of RNA-seq reads. To be fair, Cuffdiff does recommend such test with one case versus one control and we include Cuffdiff in our comparison because it is the only method that allows for such testing. In conclusion, this simulation illustrated that IsoDOT worked well in this challenging situation of comparing one case vs. one control.

Figure 3.

Figure 3

Compare the power of IsoDOT and Cuffdiff for detesting genes with differential isoform usage (a-b) or differential isoform expression (c-d), while transcriptome annotation is known (a,c) or not (b,d).

Simulation for isoform usage eQTL

To illustrate the performance of IsoDOT in testing differential isoform usage with respect to a continuous covariate, we applied IsoDOT to map isoform usage eQTL (gene expression quantitative trait locus) using simulated RNA-seq data and real genotype data. We downloaded genotype data from 60 European HapMap samples [Thorisson et al., 2005] and selected 949,537 SNPs with minor allele frequency (MAF) > 0.05 for the following analysis. We defined transcription clusters based on Ensembl annotation (version 66, http://useast.ensembl.org/info/data/ftp/index.html), and selected 200 transcript clusters that satisfied the following two conditions for our simulation studies. (1) Each transcript cluster has > 1 annotated RNA-isoforms, and (2) Each transcript cluster has ≥ 1 SNP in the gene body (any intronic or exonic regions) or within 1000bp of the gene body. For each selected transcript cluster, we simulated RNA-seq fragment counts across exon sets under null (H0) and alternative (H1), respectively. Specifically, for each gene, we randomly selected 50% of the isoforms to have zero expression and set the expression of the other 50% of isoforms by drawing γu (equation (4)) from a uniform distribution U[0.5, 1].

Next, we used these simulated data to assess differential isoform usage of each transcript cluster with respect to each of the nearby SNPs (within 1000bp of the gene body) and kept the most significant eQTL per transcript cluster. For each transcript cluster, up to 1000 permutations were carried out to correct for multiple testing across the multiple nearby SNPs. Under H0, the permutation p-values followed a uniform distribution; and under H1, the permutation p-values were obviously enriched with small values (Figure 4(a)). In this simulation, we had ∼ 80%/40% power to detect local isoform usage eQTL for permutation p-value cutoffs 0.05 and 0.005, respectively (Figure 4(b)). Therefore, this simulation demonstrates that IsoDOT correctly controls type I error and has power to detect differential isoform usage with respect to a continuous covariate.

Figure 4.

Figure 4

Simulation results for testing isoform-usage eQTL on 200 transcription clusters. (a) The qq-plot for p-values distributions against expected uniform distribution. (b) Power (H1) or type I error (H0) for different p-value cutoffs.

Haloperdiol treatment effect on mouse transcriptome

Haloperidol is a drug used to treat schizophrenia, acute psychotic states, and delirium. A major adverse side effect of chronic haloperidol treatment is tardive dyskinesia (TD). TD can be modeled in mice be examining haloperidol-induced vacuous chewing movements (VCMs) [Crowley et al., 2012]. We applied IsoDOT to analyze RNA-seq data for mice treated with haloperidol vs. placebo with particular interest in identifying genes responding to haloperidol treatment and/or responsible for VCM. RNA-seq data were collected from whole brains from four mice: two C57BL/6J mice treated with haloperidol or placebo and two 129S1Sv/ImJ×PWK/PhJ F1 mice treated with haloperidol or placebo. Each RNA-seq fragment was sequenced on both ends by 93 or 100bp, and 20-27 million RNA-seq reads were collected for each mouse (Supplementary Table 1). See Supplementary Materials Section D for additional details of the experiment.

We first studied differential isoform expression/usage between two C57BL/6J mice. RNA-seq reads were mapped to the mm9 reference genome using TopHat [Trapnell et al., 2009]. At FDR of 5%, IsoDOT identified 86 or 88 genes with differential isoform usage (DIU), with or without transcriptome annotation, respectively. For the test of differential isoform expression (DIE), also at FDR of 5%, IsoDOT identified 332 or 206 genes with or without transcriptome annotation, respectively. We sought to gain some insight of these four gene lists by applying functional category enrichment analysis [Sherman et al., 2009] on the top 100 genes in each list. Only those DIU genes identified with transcriptome annotation were significantly associated with biologically relevant categories such as neuron projection (Supplementary Figure 13-16). This implied that DIU, rather than DIE, might be more relevant to haloperidol treatment in C57BL/6J mice. The gene lists identified without transcriptional annotation did not show functional enrichment, which implied larger sample size or higher read-depth were needed to detect DIE or DIU without transcriptome annotation. According to Cuffdiff manual, it is not recommended to run Cuffdiff with sample size one versus one. However, we still evaluated the performance of Cuffidff in this dataset for comparison purpose. Using the results reported by Cuffdiff, no gene has q-value smaller than 0.05 (with or without annotation, alternative promoter or alternative splicing), and functional category enrichment analysis [Sherman et al., 2009] on the top 100 genes reported by Cuffdiff identified no significantly enriched functional category (Supplementary Figure 17).

Several DIU genes identified by IsoDOT can be potential targets for follow up studies (Supplementary Table 2). For example, Utrn (utrophin, Figure 5) and Dmd (dystrophin) are both involved in neuron projection and could be candidates underlying the VCM side effect. Grin2b (glutamate receptor, ionotropic, NMDA2B, Supplementary Figure 18) or its human ortholog is involved in Alzheimer's disease, Huntington's disease, and amyotrophic lateral sclerosis (ALS), which are potentially relevant to the VCM side effect of haloperidol treatment. In addition, our previous studies had prioritized several other glutamate receptors such as Grin1 and Grin2a as candidates that response to haloperidol treatment using independent data and methods [Crowley et al., 2012].

Figure 5.

Figure 5

Differential isoform usage of gene Utrn between a mouse with haloperidol treatment and a mouse with placebo. The top panel shows the read-depth of RNA-seq reads in two conditions. Two annotated isoforms and all the exons are illustrated in middle panel. The expression of each isoform under two conditions are shown in the bottom panel.

Similar studies were conducted for the two F1 mice of 129S1Sv/ImJ×PWK/PhJ. To better map RNA-seq reads, we first built two pseudogenomes for 129S1Sv/ImJ and PWK/PhJ by incorporating Sanger SNPs and indels [Keane et al., 2011] into the reference genome and mapped RNA-seq reads to the two pseudogenomes separately. Next, alignments were remapped back to the reference coordinate system and the observed genetic variants were annotated for each RNA-seq fragment. IsoDOT identified much less DIU or DIE genes in these two F1 mice than in the two C57BL/6J mice. At FDR 0.2, no DIU genes were identified and 85 DIE gene were identified. Six of these 85 genes were involved in actin-binding, though this functional category was not significantly overrepresented.

The greater level of DIE and DIU in C57BL/6J than 129S1Sv/ImJ×PWK/PhJ following chronic haloperidol treatment was consistent with behavioral phenotype data which showed that C57BL6/J mice had greater susceptibility to haloperidol-induced VCM (Supplementary Figure 19) [Crowley et al., 2012]. Therefore, some of the C57BL/6J transcriptional changes detailed in this study might contribute to the development of haloperidol-induced VCM.

Allele-specific differential isoform usage

About 37.2% of the RNA-seq fragments from the two 129S1Sv/ImJ×PWK/PhJ F1 mice were only mapped to the paternal or maternal allele or were mapped to one allele with fewer mismatches, and hence they were allele-specific RNA-seq fragments. There was no genome-wide bias, i.e., ∼50% of the allele-specific RNA-seq fragments were mapped to each parental strain (Supplementary Table 1). Using these allele-specific RNA-seq fragments, we applied IsoDOT to assess differential isoform usage between maternal and paternal alleles. At a liberal FDR cutoff 0.2, no DIU gene was identified, and 19 or 30 DIE genes were identified from the haloperidol/placebo treated F1 mice, respectively. The genes with significant differential isoform usage in the haloperidol treated mice, but not the placebo treated mice might indicate genetic×treatment interactions. Supplementary Table 3 listed 23 such genes with DIU p-values < 0.01 in the haloperidol treated mice, and DIU p-values > 0.1 in the placebo treated mice. Among them, Synpo and Snap25 are associated with neuron functions. Snap25 is known to be associated with schizophrenia and/or haloperidol treatment at DNA [Müller et al., 2005], RNA [Sommer et al., 2010], and protein levels [Thompson et al., 1998, Honer et al., 2002]. To the best of our knowledge, this is the first report that the differential isoform usage of Snap25 is associated with genetic×haloperidol treatment interaction.

Software and data availability

An R package of IsoDOT is available at http://www.bios.unc.edu/∼weisun/software/isoform.htm. Testing differential isoform expression/usage is computationally intensive. Using IsoDOT with up to 1,000 parametric bootstraps, it will take on average 1-3 minutes to test differential isoform usage for a gene on a single processor. Parallel computation is needed and straightforward for genome-wide study. We are also actively working on implementing our method using Graphics Processing Unit (GPU) using the massively parallel algorithm described in Supplementary Materials Section E. Simulated RNA-seq data can be downloaded from http://www.bios.unc.edu/∼weisun/software/isoform_files/. The RNA-seq data of mouse haloperidol treatment experiment are available from NCBI GEO (GSExxx).

Discussion

We have developed a new statistical method named IsoDOT to assess differential isoform expression or usage from RNA-seq data with respect to categorical or continuous covariates. The resampling based approach is the basis of our hypothesis testing method. Two components of our method, the negative binomial distribution assumption and the Log penalty for penalized estimation are important for the success of this resampling based approach. First, the negative binomial distribution is a well-accepted choice for modeling RNA-seq fragment data across biological replicates. For the completeness of our paper, we also demonstrate that the negative binomial distribution provides a good fit of RNA-seq fragment counts, while the Poisson distribution assumption leads to a severe underestimate of variance (Supplementary Figure 20). Replacing the Log penalty with the Lasso penalty in IsoDOT leads to inaccurate type I error control and/or reduced power (Supplementary Figure 21). The limitation of Lasso is especially apparent when we do not use isoform annotation, where the number of candidate isoforms is much larger than sample size. This is consistent with previous findings that Lasso tends to select more false positives and has larger bias in effect estimates than the Log penalty [Chen et al., 2014].

Some biases should be accounted for to obtain better estimates of RNA isoform abundance. For example, the RNA-seq reads may not be uniformly distributed along the transcript, and DNA sequence features such as GC content may affect the abundance of RNA-seq reads. Such biases, if they exist, affect both the likelihoods under the null and alternative hypotheses and do not alter our Type I error rate. Furthermore, it may have limited impact on power because we calculate p-values through resampling approaches. For example, if the last exon of a gene tends to have a larger number of RNA-seq reads, our method may overestimate the expression of the isoform harboring the last exon. However, such over-estimation occurs under both the null and alternative hypotheses and, therefore, does not lead to inflated or deflated type I error. Systematically accounting for such biases are among our future plans to improve IsoDOT?s performance.

A major strength of IsoDOT is that it allows the assessment of differential isoform usage between one case and one control sample. This is especially important for paired samples, e.g., maternal and paternal alleles of one individual. When there are multiple paired samples, we can combine the p-values of multiple pairs using meta-analysis via Fisher's method or Stouffer's Z-score [Hunter et al., 1982]. In the preliminary study reported in this paper, we have identified several interesting genes (Utrn, Dmd, Grin2b, Snap25) whose isoform usage may respond to haloperidol treatment and are perhaps related to its side effects. In the near future, we plan to extend this study to include a much larger number of mice with diverse genetic backgrounds including mice from the Collaborative Cross [Churchill et al., 2004, Consortium, 2012].

Recently developed sequencing techniques can now deliver longer reads, including 2 × 250 bp reads from Illumina's MiSeq or 400 bp reads from Ion Torrent. Our methods can handle these longer sequencing reads without any difficulty. In fact, when the RNA-seq reads are long enough, transcriptome reconstruction becomes much easier. However, until all the isoforms of a transcript cluster can be unambiguously reconstructed and all the RNA-seq fragments can be assigned to an isoform with (almost) 100% certainty, testing differential isoform expression/usage remains a challenging problem where methods and software such as IsoDOT are needed. Another recently developed RNA-seq technique is to deliver “stranded” sequences so that RNA-seq from sense and antisense strands are separated. For the analysis of such stranded RNA-seq data, the only step in the IsoDOT pipeline that needs to be modified is to count the RNA-seq fragments for sense and anti-sense strands separately.

Supplementary Material

Supplemental

Acknowledgments

This work was partially supported by NIH grants GM105785, CA167684, CA149569, MH101819, GM074175, P50 HG006582 and K01MH094406.

Contributor Information

Wei Sun, Email: weisun@email.unc.edu, Department of Biostatistics, Department of Genetics, UNC Chapel Hill, NC 27599.

Yufeng Liu, Department of Statistics and Operations Research, Department of Genetics, Department and Biostatistics, UNC Chapel Hill.

James J. Crowley, Department of Genetics, UNC Chapel Hill.

Ting-Hued Chen, National Cancer Institute.

Hua Zhou, Department of Statistics, NC State University.

Haitao Chu, Department of Biostatistics, University of Minnesota.

Shunping Huang, SAS Institute Inc.

Pei-Fen Kuan, Department of Applied Mathematics and Statistics, Stony Brook University.

Yuan Li, Department of Statistics, NC State University.

Darla R. Miller, Department of Genetics, Lineberger Comprehensive Cancer Center, UNC Chapel Hill.

Ginger D. Shaw, Department of Genetics, Lineberger Comprehensive Cancer Center, UNC Chapel Hill.

Yichao Wu, Department of Statistics, NC State University.

Vasyl Zhabotynsky, Department of Biostatistics, UNC Chapel Hill.

Leonard McMillan, Department of Computer Science, UNC Chapel Hill.

Fei Zou, Department of Biostatistics, UNC Chapel Hill.

Patrick F. Sullivan, Department of Genetics, Department of Psychiatry, Department of Epidemiology, UNC Chapel Hill.

Fernando Pardo-Manuel de Villena, Department of Genetics, UNC Chapel Hill.

References

  1. Alamancos Gael P, Agirre Eneritz, Eyras Eduardo. Spliceosomal Pre-mRNA Splicing. Springer; 2014. Methods to study splicing from high-throughput RNA sequencing data; pp. 357–397. [DOI] [PubMed] [Google Scholar]
  2. Anders Simon, Huber Wolfgang. Differential expression analysis for sequence count data. Genome Biol. 2010;11(10):R106. doi: 10.1186/gb-2010-11-10-r106. [DOI] [PMC free article] [PubMed] [Google Scholar]
  3. Anders Simon, Reyes Alejandro, Huber Wolfgang. 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]
  4. Barbosa-Morais NL, Irimia M, Pan Q, Xiong HY, Gueroussov S, Lee LJ, Slobodeniuc V, Kutter C, Watt S, Çolak R, et al. The evolutionary landscape of alternative splicing in vertebrate species. Science. 2012;338(6114):1587–1593. doi: 10.1126/science.1230612. [DOI] [PubMed] [Google Scholar]
  5. Bohnert R, Rätsch G. rquant. web: a tool for RNA-seq-based transcript quantitation. Nucleic acids research. 2010;38(suppl 2):W348–W351. doi: 10.1093/nar/gkq448. [DOI] [PMC free article] [PubMed] [Google Scholar]
  6. Bullard James H, Purdom Elizabeth, Hansen Kasper D, Dudoit Sandrine. Evaluation of statistical methods for normalization and differential expression in mrna-seq experiments. BMC bioinformatics. 2010;11(1):94. doi: 10.1186/1471-2105-11-94. [DOI] [PMC free article] [PubMed] [Google Scholar]
  7. Chen L. Statistical and computational methods for high-throughput sequencing data analysis of alternative splicing. Statistics in Biosciences. 2012:1–18. doi: 10.1007/s12561-012-9064-7. [DOI] [PMC free article] [PubMed] [Google Scholar]
  8. Chen TH, Sun W, Fine J. Designing penalty functions in high dimensional problems: The role of tuning parameters. UNC; Chapel Hill: 2014. [DOI] [PMC free article] [PubMed] [Google Scholar]
  9. Churchill GA, Airey DC, Allayee H, Angel JM, Attie AD, Beatty J, Beavis WD, Belknap JK, Bennett B, Berrettini W, et al. The collaborative cross, a community resource for the genetic analysis of complex traits. Nature genetics. 2004;36(11):1133–1137. doi: 10.1038/ng1104-1133. [DOI] [PubMed] [Google Scholar]
  10. C.C. Consortium. The genome architecture of the collaborative cross mouse genetic reference population. Genetics. 2012;190:389–401. doi: 10.1534/genetics.111.132639. [DOI] [PMC free article] [PubMed] [Google Scholar]
  11. Crowley JJ, Adkins DE, Pratt AL, Quackenbush CR, van den Oord EJ, Moy SS, Wilhelmsen KC, Cooper TB, Bogue MA, McLeod HL, et al. Antipsychotic-induced vacuous chewing movements and extrapyramidal side effects are highly heritable in mice. The pharmacogenomics journal. 2012;12(2):147. doi: 10.1038/tpj.2010.82. [DOI] [PMC free article] [PubMed] [Google Scholar]
  12. Denoeud F, Aury JM, Da Silva C, Noel B, Rogier O, Delledonne M, Morgante M, Valle G, Wincker P, Scarpelli C, et al. Annotating genomes with massive-scale RNA sequencing. Genome Biol. 2008;9(12):R175. doi: 10.1186/gb-2008-9-12-r175. [DOI] [PMC free article] [PubMed] [Google Scholar]
  13. Djebali S, Davis CA, Merkel A, Dobin A, Lassmann T, Mortazavi A, Tanzer A, Lagarde J, Lin W, Schlesinger F, et al. Landscape of transcription in human cells. Nature. 2012;489(7414):101–108. doi: 10.1038/nature11233. [DOI] [PMC free article] [PubMed] [Google Scholar]
  14. Flicek P, Amode MR, Barrell D, Beal K, Brent S, Chen Y, Clapham P, Coates G, Fairley S, Fitzgerald S, et al. Ensembl 2011. Nucleic acids research. 2011;39(suppl 1):D800. doi: 10.1093/nar/gkq1064. [DOI] [PMC free article] [PubMed] [Google Scholar]
  15. Glaus Peter, Honkela Antti, Rattray Magnus. Identifying differentially expressed transcripts from RNA-seq data with biological variation. Bioinformatics. 2012;28(13):1721–1728. doi: 10.1093/bioinformatics/bts260. [DOI] [PMC free article] [PubMed] [Google Scholar]
  16. Honer WG, Falkai P, Bayer TA, Xie J, Hu L, Li HY, Arango V, Mann JJ, Dwork AJ, Trimble WS. Abnormalities of snare mechanism proteins in anterior frontal cortex in severe mental illness. Cerebral Cortex. 2002;12(4):349–356. doi: 10.1093/cercor/12.4.349. [DOI] [PubMed] [Google Scholar]
  17. Hunter JE, Schmidt FL, Jackson GB. Meta-analysis. Sage Publ.; 1982. [Google Scholar]
  18. Jiang H, Salzman J. Statistical properties of an early stopping rule for resampling-based multiple testing. Biometrika. 2012;99(4):973–980. doi: 10.1093/biomet/ass051. [DOI] [PMC free article] [PubMed] [Google Scholar]
  19. Jiang H, Wong WH. Statistical inferences for isoform expression in RNA-Seq. Bioinformatics. 2009;25(8):1026. doi: 10.1093/bioinformatics/btp113. [DOI] [PMC free article] [PubMed] [Google Scholar]
  20. Katz Y, Wang ET, Airoldi EM, Burge CB. 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]
  21. Keane TM, Goodstadt L, Danecek P, White MA, Wong K, Yalcin B, Heger A, Agam A, Slater G, Goodson M, et al. Mouse genomic variation and its effect on phenotypes and gene regulation. Nature. 2011;477(7364):289–294. doi: 10.1038/nature10413. [DOI] [PMC free article] [PubMed] [Google Scholar]
  22. Langmead B, Hansen KD, Leek JT. Cloud-scale RNA-sequencing differential expression analysis with Myrna. Genome biology. 2010;11(8):R83. doi: 10.1186/gb-2010-11-8-r83. [DOI] [PMC free article] [PubMed] [Google Scholar]
  23. Leng Ning, Dawson John A, Thomson James A, Ruotti Victor, Rissman Anna I, Smits Bart MG, Haag Jill D, Gould Michael N, Stewart Ron M, Kendziorski Christina. EBSeq: an empirical bayes hierarchical model for inference in RNA-seq experiments. Bioinformatics. 2013;29(8):1035–1043. doi: 10.1093/bioinformatics/btt087. [DOI] [PMC free article] [PubMed] [Google Scholar]
  24. Li B, Ruotti V, Stewart RM, Thomson JA, Dewey CN. RNA-seq gene expression estimation with read mapping uncertainty. Bioinformatics. 2010;26(4):493–500. doi: 10.1093/bioinformatics/btp692. [DOI] [PMC free article] [PubMed] [Google Scholar]
  25. Li JJ, Jiang CR, Hu Y, Brown BJ, Huang H, Bickel PJ. Sparse linear modeling of RNA-seq data for isoform discovery and abundance estimation. Proc Natl Acad Sci USA. 2011a doi: 10.1073/pnas.1113972108. in press. [DOI] [PMC free article] [PubMed] [Google Scholar]
  26. Li W, Feng J, Jiang T. Isolasso: a lasso regression approach to RNA-seq based transcriptome assembly. Research in Computational Molecular Biology. 2011b:168–188. doi: 10.1089/cmb.2011.0171. [DOI] [PMC free article] [PubMed] [Google Scholar]
  27. Mazumder Rahul, Friedman Jerome H, Hastie Trevor. Sparsenet: Coordinate descent with nonconvex penalties. Journal of the American Statistical Association. 2011;106(495):1125–1138. doi: 10.1198/jasa.2011.tm09738. [DOI] [PMC free article] [PubMed] [Google Scholar]
  28. Mortazavi Ali, Williams Brian A, McCue Kenneth, Schaeffer Lorian, Wold Barbara. Mapping and quantifying mammalian transcriptomes by RNA-seq. Nature methods. 2008;5(7):621–628. doi: 10.1038/nmeth.1226. [DOI] [PubMed] [Google Scholar]
  29. Müller DJ, Klempan TA, De Luca V, Sicard T, Volavka J, Czobor P, Sheitman BB, Lindenmayer JP, Citrome L, McEvoy JP, et al. The snap-25 gene may be associated with clinical response and weight gain in antipsychotic treatment of schizophrenia. Neuroscience letters. 2005;379(2):81. doi: 10.1016/j.neulet.2004.12.037. [DOI] [PubMed] [Google Scholar]
  30. Pachter L. Models for transcript quantification from RNA-seq. Arxiv preprint arXiv:1104.3889. 2011 [Google Scholar]
  31. Pan Q, Shai O, Lee LJ, Frey BJ, Blencowe BJ. Deep surveying of alternative splicing complexity in the human transcriptome by high-throughput sequencing. Nature genetics. 2008;40(12):1413–1415. doi: 10.1038/ng.259. [DOI] [PubMed] [Google Scholar]
  32. Purdom E, Simpson Ken M, Robinson Mark D, Conboy JG, Lapuk AV, Speed Terence P. Firma: a method for detection of alternative splicing from exon array data. Bioinformatics. 2008;24(15):1707–1714. doi: 10.1093/bioinformatics/btn284. [DOI] [PMC free article] [PubMed] [Google Scholar]
  33. Rashid Naim U, Giresi Paul G, Ibrahim Joseph G, Sun Wei, Lieb Jason D. Zinba integrates local covariates with dna-seq data to identify broad and narrow regions of enrichment, even within amplified genomic regions. Genome Biology. 2011;12(7):R67. doi: 10.1186/gb-2011-12-7-r67. [DOI] [PMC free article] [PubMed] [Google Scholar]
  34. Richard H, Schulz MH, Sultan M, Nürnberger A, Schrinner S, Balzereit D, Dagand E, Rasche A, Lehrach H, Vingron M, et al. Prediction of alternative isoforms from exon expression levels in RNA-seq experiments. Nucleic Acids Research. 2010;38(10):e112–e112. doi: 10.1093/nar/gkq041. [DOI] [PMC free article] [PubMed] [Google Scholar]
  35. Roberts A, Trapnell C, Donaghey J, Rinn JL, Pachter L, et al. Improving RNA-seq expression estimates by correcting for fragment bias. Genome biology. 2011;12(3):R22. doi: 10.1186/gb-2011-12-3-r22. [DOI] [PMC free article] [PubMed] [Google Scholar]
  36. Robinson Mark D, McCarthy Davis J, Smyth Gordon 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]
  37. Salzman J, Jiang H, Wong WH. Statistical modeling of RNA-seq data. Statistical Science. 2011;26(1):62–83. doi: 10.1214/10-STS343. [DOI] [PMC free article] [PubMed] [Google Scholar]
  38. Sherman BT, Lempicki RA, et al. Systematic and integrative analysis of large gene lists using david bioinformatics resources. Nature protocols. 2009;4(1):44. doi: 10.1038/nprot.2008.211. [DOI] [PubMed] [Google Scholar]
  39. Sommer JU, Schmitt A, Heck M, Schaeffer EL, Fendt M, Zink M, Nieselt K, Symons S, Petroianu G, Lex A, et al. Differential expression of presynaptic genes in a rat model of postnatal hypoxia: relevance to schizophrenia. European archives of psychiatry and clinical neuroscience. 2010;260:81–89. doi: 10.1007/s00406-010-0159-1. [DOI] [PMC free article] [PubMed] [Google Scholar]
  40. Sun W, Ibrahim JG, Zou F. Genomewide Multiple-Loci Mapping in Experimental Crosses by Iterative Adaptive Penalized Regression. Genetics. 2010;185(1):349. doi: 10.1534/genetics.110.114280. [DOI] [PMC free article] [PubMed] [Google Scholar]
  41. Sun Wei. A statistical framework for eqtl mapping using RNA-seq data. Biometrics. 2012;68(1):1–11. doi: 10.1111/j.1541-0420.2011.01654.x. [DOI] [PMC free article] [PubMed] [Google Scholar]
  42. Thompson PM, Sower AC, Perrone-Bizzozero NI. Altered levels of the synaptosomal associated protein snap-25 in schizophrenia. Biological psychiatry. 1998;43(4):239–243. doi: 10.1016/S0006-3223(97)00204-7. [DOI] [PubMed] [Google Scholar]
  43. Thorisson GA, Smith AV, Krishnan L, Stein LD. The international HapMap project web site. Genome research. 2005;15(11):1592. doi: 10.1101/gr.4413105. [DOI] [PMC free article] [PubMed] [Google Scholar]
  44. Tibshirani R. Regression shrinkage and selection via the lasso. Journal of the Royal Statistical Society Series B (Methodological) 1996;58(1):267–288. [Google Scholar]
  45. Trapnell C, Pachter L, Salzberg SL. TopHat: discovering splice junctions with RNA-Seq. Bioinformatics. 2009;25(9):1105. doi: 10.1093/bioinformatics/btp120. [DOI] [PMC free article] [PubMed] [Google Scholar]
  46. Trapnell C, Williams BA, Pertea G, Mortazavi A, Kwan G, van Baren MJ, Salzberg SL, Wold BJ, 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]
  47. Trapnell Cole, Hendrickson David G, Sauvageau Martin, Goff Loyal, Rinn John L, Pachter Lior. Differential analysis of gene regulation at transcript resolution with RNA-seq. Nature biotechnology. 2013;31(1):46–53. doi: 10.1038/nbt.2450. [DOI] [PMC free article] [PubMed] [Google Scholar]
  48. Wang ET, Sandberg R, Luo S, Khrebtukova I, Zhang L, Mayr C, Kingsmore SF, Schroth GP, Burge CB. Alternative isoform regulation in human tissue transcriptomes. Nature. 2008;456(7221):470–476. doi: 10.1038/nature07509. [DOI] [PMC free article] [PubMed] [Google Scholar]
  49. Wang GS, Cooper TA. Splicing in disease: disruption of the splicing code and the decoding machinery. Nature Reviews Genetics. 2007;8(10):749–761. doi: 10.1038/nrg2164. [DOI] [PubMed] [Google Scholar]
  50. Wang Z, Gerstein M, Snyder M. RNA-Seq: a revolutionary tool for transcriptomics. Nature Reviews Genetics. 2009;10(1):57–63. doi: 10.1038/nrg2484. [DOI] [PMC free article] [PubMed] [Google Scholar]
  51. Xia Z, Wen J, Chang CC, Zhou X. Nsmap: A method for spliced isoforms identification and quantification from RNA-seq. BMC bioinformatics. 2011;12(1):162. doi: 10.1186/1471-2105-12-162. [DOI] [PMC free article] [PubMed] [Google Scholar]
  52. Xing Y, Yu T, Wu YN, Roy M, Kim J, Lee C. An expectation-maximization algorithm for probabilistic reconstructions of full-length isoforms from splice graphs. Nucleic acids research. 2006;34(10):3150. doi: 10.1093/nar/gkl396. [DOI] [PMC free article] [PubMed] [Google Scholar]
  53. Zhao P, Yu B. On model selection consistency of lasso. The Journal of Machine Learning Research. 2006;7:2541–2563. [Google Scholar]
  54. Zou H. The adaptive lasso and its oracle properties. Journal of the American Statistical Association. 2006;101(476):1418–1429. [Google Scholar]

Associated Data

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

Supplementary Materials

Supplemental

RESOURCES