Skip to main content

MGMR: leveraging RNA-Seq population data to optimize expression estimation

Abstract

Background

RNA-Seq is a technique that uses Next Generation Sequencing to identify transcripts and estimate transcription levels. When applying this technique for quantification, one must contend with reads that align to multiple positions in the genome (multireads). Previous efforts to resolve multireads have shown that RNA-Seq expression estimation can be improved using probabilistic allocation of reads to genes. These methods use a probabilistic generative model for data generation and resolve ambiguity using likelihood-based approaches. In many instances, RNA-seq experiments are performed in the context of a population. The generative models of current methods do not take into account such population information, and it is an open question whether this information can improve quantification of the individual samples

Results

In order to explore the contribution of population level information in RNA-seq quantification, we apply a hierarchical probabilistic generative model, which assumes that expression levels of different individuals are sampled from a Dirichlet distribution with parameters specific to the population, and reads are sampled from the distribution of expression levels. We introduce an optimization procedure for the estimation of the model parameters, and use HapMap data and simulated data to demonstrate that the model yields a significant improvement in the accuracy of expression levels of paralogous genes.

Conclusions

We provide a proof of principal of the benefit of drawing on population commonalities to estimate expression. The results of our experiments demonstrate this approach can be beneficial, primarily for estimation at the gene level.

Introduction

With the rapid decline in the cost of sequencing, RNA-Seq has emerged as a legitimate competitor to mi-croarrays as a means of assessing global gene expression. Even as arrays currently enjoy a cost advantage, many new applications of information accessible only through sequencing further strengthen the case that sequencing may soon supplant arrays as the technology of choice for transcription analysis. One such application is fine-grained assessment of variation in expression and the sources for such variation, as exemplified by recent large-scale RNA-Seq studies [1, 2] of two different HapMap [3] populations. Such studies complement genomic DNA sequencing by elucidating the link between SNPs and expression.

Unfortunately, with any new technology come its limitations, and several studies have pointed out that RNA-Seq is not immune to bias [46]. Perhaps the most widely discussed hurdle to accurate estimation in the case of RNA-Seq is the problem of reads mapped to multiple locations in the target genome (or in the target transcript sequences). These reads, which are called multireads, can stem from either paralogous gene sequences or from different isoforms of the same gene that share exons.

Several methods have emerged to address the multiread problem for paralog and isoform estimation [710]. These methods are all based on probabilistic modeling that is optimized by an expectation maximization procedure. It has been repeatedly shown that by using such methods one can get better quantification of the expression levels compared to quantification based on naive approaches of read assignment.

In many applications, a set of samples is studied. For instance, one may be interested in comparing the expression levels in cases verses controls, or in tissues originating from different organs. In such cases, it is plausible that the commonality of expression patterns within each of the defined groups of studied samples may be used to improve the quantification results in each of the samples. We demonstrate that by analyzing expression profiles of a population together, one gets expression estimates more accurate than those obtained by estimating individual sample expression levels independently. We describe and implement a probabilistic model of the sequencing process that incorporates population commonalities, and demonstrate its advantages over existing methods in the population setting.

Methods

RNA-Seq multiread expression estimation

As we seek to extend the prevalent generative model of RNA-Seq [711], we begin by reviewing the basic elements of that model. Let G = (G1, ...,G M ) be the set of M transcribed regions considered and P = (P1, ...,P M ) be the proportions of RNA bases attributed to each transcript out of the total number of transcribed bases in a sequenced sample. Regions may be either genes or transcripts, depending on the level of transcription being investigated. We require P to satisfy ∑ gϵG P g = 1 and gϵG, 0 ≤ P g ≤ 1.

The model describes an RNA sequencing experiment where regions in G are randomly chosen according to the distribution P, start positions in these regions are chosen uniformly, and reads of length are generated by copying consecutive bases from each chosen region to produce a set of reads R = (r1,..., r ρ ). Sequencing is assumed to be error prone, leading to a certain probability of error for each read base. Based on the repetitions present in the set of regions and errors in alignment, reads may fail to map to the region from which they originate or may map to additional locations. Thus, we assign a probability of obtaining read r j given that it originated from region G k , P ( r j | G k ) ( 1 - ε ) ( - e r r o r j k ) ε e r r o r j k k . In this case we rely on the alignment of r j to G k to afford us the best match position instead of summing over all possible starting positions. k is the effective length of G k (i.e., the number of start positions from which a full length read can be derived) as defined in [11], ϵ is taken to be a constant per-base error rate, errors are assumed to be independent, and error jk is the number of mismatches in the best alignment of r j to G k .

This formulation leads to the likelihood of observing the data:

L ( P ; R ) = j = 1 ρ P ( r j | G , P ) = j = 1 ρ k = 1 M P ( G k ) P ( r j | G k )
(1)

This likelihood function is used to estimate P given the read alignments. Typically, one will use expectation maximization to find the P for which the likelihood is maximized. It is assumed that P(r j |G k ) is zero for all regions to which r j is not aligned.

Common population extension

To estimate expression levels in N individuals from a defined population, we modify the above model by assuming that samples are drawn from a common population. This is imposed by having P = [(P11, ...,P1M), .., (PN 1...,P N M )] be probability densities drawn from a common Dirichlet distribution, defined by a set of hyper-parameters specific to the population: [1, N], p i = (Pi 1,..., P iM ) ~ Dirichlet (α1,..., α M ).

For sample i, we denote the set of reads as R i = ( r i 1 , , r i ρ i ) , where each r ij is mapped to one or more regions in G. The output of a read alignment program defines the set of accepted regions for the read (in practice only alignments with up to 2 errors are accepted) and provides the number of errors in alignment for each read-region pair. This allows us to calculate P(r ij |G k ) as done above for one sample. For convenience we denote P(r ij |G k ) = q ijk (taken to be zero for all regions not mapped to), which is independent of α and P.

As before, our objective is to estimate P, but in this case we must optimize by estimating P and α together. We begin by writing the likelihood function:

L ( p 1 , , p N , α ; R ) = P r ( p 1 , , p N | α ) P r ( R | p 1 , , p N )
(2)

Since expression values are sampled from the Dirichlet distribution,

P r ( p 1 , , p N | α ) = i = 1 N P ( p i | α ) = i = 1 N C ( α ) k = 1 M P i k α k - 1
(3)

Where

C ( α ) Γ ( k α k ) k Γ ( α k )
(4)

and similar to (1) above,

P r ( R | p 1 , , p N ) = i = 1 N j = 1 ρ i k = 1 M P i k q i j k
(5)

This leads to

L ( p 1 , , p N , α ; R ) = i = 1 N C ( α ) k = 1 M P i k α k - 1 i = 1 N j = 1 ρ i k = 1 M P i k q i j k
(6)

Taking the log, we get

l o g [ L ( p 1 , , p N , α ; R ) ] = N l o g C ( α ) + k = 1 M ( α k - 1 ) i = 1 N l o g P i k + i = 1 N j = 1 p i ( l o g ( k = 1 M P i k q i j k ) )
(7)

Multi-Genome Multi-Read (MGMR) algorithm

We wish to estimate α and p 1 ,...,p n to maximize equation (7) above. For this purpose, we adopt an alternating iterative procedure of estimating α given the current estimate of p 1 ,...,p n and vice-versa until the total change in α becomes sufficiently small (or until a pre-set number of iterations have been executed).

Although for EM-based estimation methods convexity guarantees an optimal solution will be obtained, here (as shall be seen below) we have no such guarantee. Thus, we confine updates to be local by performing only one update for P and one for α. By one MGMR iteration, we refer to one EM-based P update followed by one α update.

Estimating P given α

If we assume α is given, we can write the EM steps to find p 1 ,...,p N :

E step Letting Match signify a matching between reads and regions, and Match(j) be the region from which read j originates, we get:

l o g [ L ( P , α ; R , Match ) ] = N l o g C ( α ) + k = 1 M ( α k - 1 ) i = 1 N l o g P i k + i = 1 N j = 1 ρ i ( l o g ( P i M a t c h ( j ) q i j M a t c h ( j ) ) )
(8)

which leads to

Q ( P , α | P ( t ) , α ( t ) ) = E M a t c h | R , P ( t ) , α ( t ) [ l o g ( L ) ]
(9)
= N l o g C ( α ( t ) ) + k = 1 M ( α k ( t ) - 1 ) i = 1 N l o g P i k + i = 1 N j = 1 ρ i k = 1 M ( l o g P i k + l o g q i j k ) * P i k ( t ) q i j k k = 1 M P i k ( t ) q i j k
(10)
= N l o g C ( α ( t ) ) + k = 1 M ( α k ( t ) - 1 ) i = 1 N l o g P i k + i = 1 N j = 1 ρ i k = 1 M a i j k l o g P i k + i = 1 N j = 1 ρ i k = 1 M a i j k l o g q i j k
(11)

where

a i j k P i k ( t ) q i j k k = 1 M P i k ( t ) q i j k
(12)

M step Given that each q ijk is fixed, the above reduces to maximizing

N l o g C ( α ( t ) ) + k = 1 M ( α k ( t ) - 1 ) i = 1 N l o g P i k + i = 1 N j = 1 ρ i k = 1 M a i j k * l o g P i k
(13)

Using Lagrange multipliers and differentiating, we see that this is maximized with

P i k ( t + 1 ) = α k ( t ) - 1 + j a i j k k ( α k ( t ) - 1 + j a i j k )
(14)

Estimating α given P

Given a new estimate for P(t), we can use a fixed point iteration [12] to get a new estimate of α

F ( α ) = N [ l o g Γ ( k α k ) - k l o g Γ ( α k ) ] + k = 1 M ( α k - 1 ) i = 1 N l o g P i k ( t ) + C o n s t ( P ( t ) )
(15)

By using the known bound Γ ( x ) Γ ( x ^ ) e x p ( ( x - x ^ ) Ψ ( x ) ) ( having Ψ ( x ) = d l o g Γ ( x ) d x ) , we can get a lower bound on F(α):

F ( α ) N [ ( k α k ) Ψ ( k α k ( t ) ) k = 1 M l o g Γ ( α k ) + k = 1 M α k l o g P ¯ k ( t ) + C o n s t ( P ( t ) )
(16)

where log P ̄ k = 1 N * i log P i k .

We maximize this bound with a fixed point iteration similar to EM, noting that for fixed values of P convergence is guaranteed, and that for the Dirichlet distribution the maximum is the only stationary point [12]. This leads to the update

α k ( t + ) = Ψ - 1 [ Ψ ( α k ( t ) ) + l o g P ̄ k ( t ) ]
(17)

Heuristics/Implementation

As we have found F(α) presented in equation (15) is non-convex even in 2 dimensions (Figure 1), we confine updates to be local by allowing only one update for both the α and P estimation steps at each MGMR iteration. For genes with EM expression estimates equaling zero in all samples we substitute 10-20 for their values in MGMR to avoid taking the log of zero. For P updates (e.g., equation 14), we avoid potentially negative P values by adding one to each alpha (thus ignoring -1 in the numerator and denominator). We implemented the algorithm in MATLAB, where the inputs required are read-gene map files for each sample as in SEQEM [7], and an initial P estimate matrix. Alphas are initialized as an M-length vector of ones.

Figure 1
figure 1

A mesh representation of F(α) [equation (15)] showing non-convex behavior. P is a 10 × 2 constant matrix and α is varied on [0:50,0:50]. The case shown is for N = 10, M = 2 (ten samples, two α parameters). Non-convex behavior is demonstrated by the values on the plane defined by α1 = .06 on the range [0,50] on the right.

Results

Experimental setup

As in [7, 9, 10], we examined MGMR's accuracy by comparing its estimates of known expression levels with those of existing methods, namely SEQEM [7] and RSEM [9, 10]. The initial "known" expression levels were estimates obtained from RNA-Seq samples; how these estimates were obtained is described below. In our case, we had to simulate a population sharing similar expression levels and the same set of gene regions. Our experiment differed in that we sought to use additional information to improve on the estimates of these existing methods. These methods were designed to estimate expression of single samples, and each had specific advantages which we disregarded in our comparison. For example, we ignored both SEQEM's ability to utilize SNP information and RSEM's ability to allow estimation on assembled transcripts by using only reference sequences.

Simulating data

To derive artificial reads, we first estimated expression on real biological samples using one method and then used the resulting distribution of expression values to generate simulated datasets for testing. Real samples were drawn from lymphoblastoid cells of the Yoruba in Ibadan (YRI) population [2, 3]. As MGMR requires initial expression estimates, the estimate derived from the method it was being compared with in each case was input to MGMR. Thus, the four initial estimates used were from SEQEM, MGMR(SEQEM) (namely, MGMR initialized by SEQEM's result), RSEM, and MGMR(RSEM) (namely, MGMR initialized by RSEM estimates). We denote these four estimates SEQEM-A, SEQEM-B, MGMR-A and MGMR-B, respectively. We simulated reads by randomly selecting start sites falling within gene boundaries and extracting sequences from those positions. Read lengths were defined for each experiment, and simulations were repeated multiple times to account for randomness in the sampling process.

To derive the sequence set for the SEQEM comparison, we expanded upon the procedure used in [7]. There, SEQEM was shown to improve estimation of paralogous gene expression on a set of exon sequences from 51 Homo Sapiens chromosome 1 paralogs from the HomoloGene [13] database. We extracted a larger set of sequences containing all HomoloGene paralogs in Homo Sapiens having at least one exon longer than twice the read length used that do not overlap in genomic coordinates. We required this minimal length because sequences were sampled from exons, and we needed to ensure enough positions existed for full length reads to be sampled from these exons. 285 such genes remained (for reads of length 35 bp), and these were the genes on which expression was tested and from which read sequences were derived. The SEQEM-A and SEQEM-B read sets were generated based on randomly selected exons from these genes and the expression levels from the SEQEM-A and SEQEM-B estimates taken on 20 YRI individuals. The read length of 35 bp corresponded to that of the YRI samples, and a coverage level of 20 was chosen, as this was the level at which SEQEM was shown to perform best in [7]. We performed a total of 30 repetitions of read simulations, where each repetition consisted of 20 samples (corresponding to the original 20 YRI samples used).

For the RSEM-A and RSEM-B read sets, the transcript set used was also obtained by filtering the HomoloGene database to avoid gene overlaps, but no length filtering was required: reads were now sampled directly from transcripts which all had effective lengths greater than the read length used. 524 transcripts corresponding to 265 genes survived this filtering. For these read sets, we produced 30 repetitions of 74 samples, where each consisted of 100 bp reads at a coverage level of 20. In all other respects the sampling process and read generation steps were identical to those performed for the SEQEM-A and SEQEM-B read sets.

Error measures

Accuracy was assessed by three error measures, the first two of which were applied in [7]: error rate, computed as 1 n i P i - Q i Q i , χ 2 difference, computed as i ( P i - Q i ) 2 Q i , and Kullback-Leibler divergence, computed as i P i log P i Q i . Here P is the estimated distribution generated by the tested algorithm and Q is the true distribution. Error measures were averaged over all repetitions per sample, and then over all samples.

Simulated data with priors based on real estimates - estimating paralogous gene expression

To test performance on paralogous gene estimates, we set out to compare independent sample SEQEM estimates with MGMR's common population estimates. Before applying SEQEM, we looked to address one criticism of it from [11], where it was suggested that SEQEM's estimation could be improved by incorporation of transcript length correction. Upon examination, we found the effect of this correction was an increase in accuracy, and thus we maintained it for subsequent tests. This improvement is documented in the appendix.

With this correction in place, we estimated expression levels on the SEQEM-A and SEQEM-B read sets, applying SEQEM and MGMR to each. Outputs were recorded at 1-10, 20, 30, 40, 50 and 100 iterations for MGMR and at 100 iterations for SEQEM. The results are shown in Figure 2. We observed that both error and variance levels dropped sharply within just a few iterations for MGMR, and converged to significantly better estimates on average than SEQEM. These trends were consistent across all three error measures [Table 1]. Variance seemed to diminish more with MGMR over time, as might be expected for a method that shares information across samples. Notably, MGMR outperformed SEQEM on estimates for samples based on SEQEM-A, where sample estimates were obtained independently (and thus we expect the variation inherent in the real samples to be maintained).

Figure 2
figure 2

Relative error measured on SEQEM-A and SEQEM-B data sets. MGMR outputs on SEQEM-A and SEQEM-B initializations were compared with SEQEM up to 100 iterations. MGMR outputs were recorded at 1-10, 20, 30, 40, 50 and 100 iterations. The first few iterations have been trimmed to allow a compact presentation.

Table 1 MGMR vs. SEQEM error at 100 iterations on SEQEM-A and SEQEM-B data sets

Simulated data with priors based on real samples - estimating transcript level expression

We also sought to examine whether MGMR can improve results in the more challenging setting of estimating transcript level expression. Here, we expect estimates to be noisier due to low expression values in the real samples, and we must contend with multiread mappings due to paralogous genes as well as to isoforms of particular genes sharing subsequences as a result of alternative splicing. In anticipation of this challenge, we used a larger set consisting of 74 sample of single-end YRI samples as the real data source and simulated 100 bp reads instead of 35 bp. This was expected to be a difficult case for estimation, as all genes in the set are paralogs and many have multiple isoforms, as described in the section "Simulating data."

Once expression estimation was performed on the YRI samples and read sets RSEM-A and RSEM-B were generated, we again performed expression estimates with RSEM and MGMR on each set. In this case, unfortunately, we found the results did not exhibit a consistent trend as before and overall appeared inconclusive. These results are summarized in Table 2. It remains to be seen why the error results differ according to the level of estimation (gene vs. transcript) performed.

Table 2 MGMR vs. RSEM error at 100 iterations on RSEM-A and RSEM-B data sets

Conclusion

As shown by the 1000 Genomes and HapMap projects, one of the drives of modern genetics and bioinformatics research is to characterize variation in populations. Because of cost and time constraints, such projects have only recently become feasible. In addition to such studies assessing genomic variation and its relation to disease phenotypes based on DNA, it is anticipated that RNA-Seq population studies will also grow in popularity to more directly assign functional significance to variant loci by means of transcription measures. Thus, it becomes essential to accurately measure the expression levels from each individual to characterize such variation. Here, we have shown that for one common study design an unexpected benefit can arise. When individuals in these studies are drawn from the same population, the estimates made on each can be made more accurate because of the commonalities among population members.

A shortcoming of the MGMR approach is that since it assumes commonality among the samples, outlier samples will be attracted towards the common denominator, and thus appear more similar to the group profile than they really are. In particular, if the data are subject to differential expression analysis, MGMR may reduce the number of differentially expressed genes.

We have investigated the efficacy of MGMR in tackling two typical experimental settings - inferring expression levels of paralogs at the gene level, and of isoforms (also drawn from a difficult set of paralogs). Although substantial gains were obtained in the first, more inquiry is required to demonstrate a benefit in the latter. It is worth noting that in each case at least a quarter of the regions considered showed improvement, as shown in Table 3. With these results, we submit a proof of concept that population structure can aid in estimation of expression levels for RNA-Seq samples.

Table 3 Proportion of genes for which MGMR improves estimates on different data sets

Abbreviations

E:

relative error rate

χ 2 :

Chi-squared error

KL:

Kullback-Liebler divergence

SD:

standard deviation

bp:

base pair

References

  1. Montgomery SB, Sammeth M, Gutierrez-Arcelus M, Lach RP, Ingle C, Nisbett J, Guigo R, Dermitzakis ET: Transcriptome genetics using second generation sequencing in a Caucasian population. Nature. 2010, 464: 773-777. 10.1038/nature08903.

    Article  CAS  PubMed  Google Scholar 

  2. Pickrell JK, Marioni JC, Pai AA, Degner JF, Engelhardt BE, Nkadori E, Veyrieras JB, Stephens M, Gilad Y, Pritchard JK: Understanding mechanisms underlying human gene expression variation with RNA sequencing. Nature. 2010, 464: 768-772. 10.1038/nature08872.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  3. Frazer KA et al.: A second generation human haplotype map of over 3.1 million SNPs. Nature. 2007, 449: 851-861. 10.1038/nature06258.

    Article  CAS  PubMed  Google Scholar 

  4. Robinson MD, Oshlack A: A scaling normalization method for differential expression analysis of RNA-seq data. Genome Biol. 2010, 11: R25-10.1186/gb-2010-11-3-r25.

    Article  PubMed Central  PubMed  Google Scholar 

  5. Bullard JH, Purdom E, Hansen KD, Dudoit S: Evaluation of statistical methods for normalization and differential expression in mRNA-Seq experiments. BMC Bioinformatics. 2010, 11: 94-10.1186/1471-2105-11-94.

    Article  PubMed Central  PubMed  Google Scholar 

  6. Oshlack A, Wakefield MJ: Transcript length bias in RNA-seq data confounds systems biology. Biol Direct. 2009, 4: 14-10.1186/1745-6150-4-14.

    Article  PubMed Central  PubMed  Google Scholar 

  7. Pasaniuc B, Zaitlen N, Halperin E: Accurate estimation of expression levels of homologous genes in RNA-seq experiments. J Comput Biol. 2011, 18: 459-468. 10.1089/cmb.2010.0259.

    Article  CAS  PubMed  Google Scholar 

  8. 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. Nat Biotechnol. 2010, 28: 511-515. 10.1038/nbt.1621.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  9. Li B, Ruotti V, Stewart RM, Thomson JA, Dewey CN: RNA-Seq gene expression estimation with read mapping uncertainty. Bioinformatics. 2010, 26: 493-500. 10.1093/bioinformatics/btp692.

    Article  PubMed Central  PubMed  Google Scholar 

  10. Li B, Dewey CN: RSEM: accurate transcript quantification from RNA-Seq data with or without a reference genome. BMC Bioinformatics. 2011, 12: 323-10.1186/1471-2105-12-323.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  11. Pachter L: Models for transcript quantification from RNA-Seq. ArXiv e-prints. 2011

    Google Scholar 

  12. Minka TP: Estimating a Dirichlet distribution. 2003, [http://research.microsoft.com/\~minka]

    Google Scholar 

  13. [http://www.ncbi.nlm.nih.gov/homologene/]

Download references

Acknowledgements

E.H. is a faculty fellow of the Edmond J. Safra Bioinformatics program at Tel-Aviv University. R.S. was supported in part by the European Community's Seventh Framework Programme (grant HEALTH-F4-2009-223575 for the TRIREME project) and by the Israel Science Foundation (grant 802/08).

This article has been published as part of BMC Bioinformatics Volume 13 Supplement 6, 2012: Proceedings of the Second Annual RECOMB Satellite Workshop on Massively Parallel Sequencing (RECOMB-seq 2012).

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Eran Halperin.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors' contributions

RR and EH developed the method. RS and EH designed the experiments. RR implemented the method and performed experiments. RR, EH, and RS analyzed results and wrote the manuscript. All authors read and approved the final manuscript.

Rights and permissions

Open Access This article is published under license to BioMed Central Ltd. This is an Open Access article is distributed under the terms of the Creative Commons Attribution License ( https://creativecommons.org/licenses/by/2.0 ), which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly cited.

Reprints and permissions

About this article

Cite this article

Rozov, R., Halperin, E. & Shamir, R. MGMR: leveraging RNA-Seq population data to optimize expression estimation. BMC Bioinformatics 13 (Suppl 6), S2 (2012). https://doi.org/10.1186/1471-2105-13-S6-S2

Download citation

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-13-S6-S2

Keywords