Skip to main content
  • Methodology article
  • Open access
  • Published:

Proportion statistics to detect differentially expressed genes: a comparison with log-ratio statistics

Abstract

Background

In genetic transcription research, gene expression is typically reported in a test sample relative to a reference sample. Laboratory assays that measure gene expression levels, from Q-RT-PCR to microarrays to RNA-Seq experiments, will compare two samples to the same genetic sequence of interest. Standard practice is to use the log2-ratio as the measure of relative expression. There are drawbacks to using this measurement, including unstable ratios when the denominator is small. This paper suggests an alternative estimate based on a proportion that is just as simple to calculate, just as intuitive, with the added benefit of greater numerical stability.

Results

Analysis of two groups of mice measured with 16 cDNA microarrays found similar results between the previously used methods and our proposed methods. In a study of liver and kidney samples measured with RNA-Seq, we found that proportion statistics could detect additional differentially expressed genes usually classified as missing by ratio statistics. Additionally, simulations demonstrated that one of our proposed proportion-based test statistics was robust to deviations from distributional assumptions where all other methods examined were not.

Conclusions

To measure relative expression between two samples, the proportion estimates that we propose yield equivalent results to the log2-ratio under most circumstances and better results than the log2-ratio when expression values are close to zero.

Background

Several different bioinformatics technologies exist to quantify gene expression. Regardless of technological platform, laboratory assays of gene expression first extract mRNA from a test sample and a control sample. These samples may be labeled with a tag or dye and hybridized to amplified cloned sequences that represent a gene of interest. The amount of mRNA in each sample is usually measured by examining the amount of dye remaining after hybridization. Researchers use Q-RT-PCR to measure expression when there are only one or a few genes of interest. Several lab protocols from various companies exist to quantify gene expression such as RT-PCR assays using intercalating dyes like SYBR Green, the TaqMan Gene Expression Assays, LightCycler, and QuantiGene [1–3]. When genome-wide levels of expression are of interest, microarrays can measure expression for thousands of genes of interest. Microarray platforms employ either cDNA clones [4, 5] or n-mer oligonucleotide probes for many genes at once [6].

More recently, sequence-based technologies provide more efficient and accurate expression measurements on a genome-wide scale. Evolving from early techniques such as Serial Analysis of Gene Expression (SAGE) to modern techniques such as Massively Parallel Signature Sequencing (MPSS) and RNA Sequencing (RNA-Seq), these approaches now rival microarray-based gene expression analysis for efficiency, cost, and accuracy [7]. Sequence-based techniques are also more flexible, allowing for gene expression measurements on a genome-wide level from any organism with a published genome sequence [8]. Sequencing employs systems such as the 454 or Illumina platform with the latter demonstrating greater depth and coverage [9]. To illustrate the central motive of this paper, Figure 1 demonstrates a two-color competitive hybridization assay of the kind used in TaqMan assays and cDNA microarrays. Other methods involve single-dye hybridization systems or intercalating dyes that bind to double-stranded DNA (dsDNA) product. The statistical models proposed below can be generalized to any scenario where gene expression is measured comparatively in a test sample and a reference sample.

Figure 1
figure 1

The competitive hybridization process for a two-color system: The number of PCR products equals the number of possible hybridizations. A proportion of the sequences will bind with matching red labeled strands and the remainder bind with the matching green labeled strands. Some sequences will not match (marked with X's) and should not hybridize.

Researchers commonly use the log2-ratio to measure relative mRNA expression between two samples. The estimate is as follows. Let R ij represent a summary expression value for gene j in the reference sample i where i = 1,..., n and j = 1,..., K. Let G ij represent a summary expression value for gene j in the test sample i. The value n is the number of paired samples or experiments and K is the number of genes studied. To summarize relative expression between two samples, the log2-ratio is

(1)

or other similar variants on the theme. The log2-ratio is commonly interpreted as the average "log-fold-change" in gene expression between the reference sample and the test sample. Its estimate will be denoted by . If r j = 1, then the ratio between the two samples is 21 = 2, meaning that the expression of gene j in the test sample is two-fold that of the reference sample on average. If r j = 2, then the ratio between the two samples is 22 = 4, meaning that on average the expression in the test sample is four-fold that of the reference sample. Other values of r j are interpreted similarly.

While the interpretation of the log2-ratio is appealing, the statistic has an important drawback. When expression in the reference sample is low, is numerically unstable because the denominators R ij are small. As R ij approaches zero, r j increases drastically, approaching infinity. When R ij = 0, then r j is undefined. Thus, when reference sample expression is low, we get extreme estimates or missing values for r j . This phenomenon is especially common when measuring gene expression in simple organisms. In bacteria, for example, transcription may be binary; either on or off. The log2-ratio is least reliable for these systems. This problem persists in human genomics research for certain experimental conditions and genes of interest.

This article proposes a new estimate to compare mRNA expression in two samples. This estimate is the proportion of mRNA in the test sample p j for each gene. The proportion takes the amount of mRNA in the test sample and compares it to the total amount of expressed mRNA represented by the sum of the test and reference samples. One formula for estimating the proportion is

(2)

The proportion is well-defined for all values of R ij and G ij . For example, when R ij = 0, then G ij /(G ij + R ij ) = 1. We can interpret the number as follows: mRNA expression is observed only in the test sample and not in the reference sample. Similarly, if G ij = 0, then G ij /(G ij + R ij ) = 0 and this means that mRNA expression is observed in the reference sample only. Figure 2 demonstrates the relationship between the log2-ratio and the proportion estimates, which follows a logistic function. The relationship is roughly linear near the center point but non-linear at the extreme values. A detailed description for the estimate of the proportion, , and an alternative derived from a maximum likelihood estimate, is in the Results section.

Figure 2
figure 2

The relationship between the log2-ratio r j and the proportion p j .

More generally, p j can be interpreted as the proportion of mRNA from gene j expressed in the test sample. As p j deviates from 0.5, then there is differential expression between the test and reference samples. As p j approaches one, then gene j is up-regulated in the test sample. As p j approaches zero, then gene j is down-regulated in the test sample. The proportion statistic p j can also be transformed into a percentage: p j × 100% for reporting. For example, if p j = 0.75 then we can say that 75% of the mRNA expressed in the experiment comes from the test sample. The proportion estimate can easily be used to test for differential expression between groups. Under the null hypothesis of no gene expression, p j = 0.5. The alternative hypothesis is differential expression, p j ≠ 0.5. The log2-ratio estimate requires a different hypothesis test. Under the null hypothesis, r j = 0 and under the alternative, r j ≠ 0.

Using a proportion p j to describe relative expression for gene j instead of the log2-ratio r j maintains the ability to interpret differential expression and test for differences. The added benefit of the proportion is the ability to preserve all data points, even for experiments with very low expression values. Typically when values of R ij are very small, researchers eliminate the jth probe of the ith experiment from their analysis. Eliminating missing data results in a loss of information and potential bias and loss of power. The proportion estimate does not require the removal of extreme, but legitimate, data points.

The Results section provides details that describe the estimation of statistics for p j . The section also provides several test statistics for hypothesis tests of p j . Estimation and testing are developed in the frequentist context but the Bayesian context can also be used, as described in the Appendix. The Results section compares the testing scenarios in simulations and two datasets. The first dataset consists of expression data from a cDNA microarray platform and the second dataset uses RNA-Seq. Both the log2-ratio and proportion statistics achieve roughly equivalent results under usual conditions, but one of the proportion statistics performs better across a variety of distributional assumptions. Proportion statistics also detect differentially expressed genes that would typically be classified as missing data.

Results

Parameter Estimates and Hypothesis Testing

We propose a new strategy for the comparison of expression values that is tied to the underpinnings of the hybridization process and its natural interpretation using a binomial distribution. Figure 1 illustrates the hybridization process in a way that justifies the use of a binomial distribution. The description is specific to a two-color hybridization platform. The same concept extends to any system where both test samples and reference samples are assayed.

For each gene sequence, suppose that researchers amplify sequences resulting in M ij clones, where j is the gene probe index and i is the sample number, in order to co-hybridize the extracted mRNA sequences from the reference and test samples. Usually M ij is in the millions, but the exact value will be unknown. For each probe, suppose it hybridizes to a test target with probability p j and to a reference target with probability 1 - p j . This reflects the proportion of available test sequences versus references sequences. We assume that each probe must hybridize to mRNA extracted from either the test or reference sample. Then, the number of hybridizing test target sequences Y ij follows a binomial distribution with size M ij and probability p j . We wish to estimate p j to calculate the proportion of hybridized test target sequences. The maximum likelihood estimate for p j is . In this scenario, Y ij = G ij and M ij = G ij + R ij where R ij represents the expression value for gene j in the reference sample i and G ij represents an expression value for gene j in the test sample i when there are i = 1,..., n paired experiments and j = 1,..., K genes. Therefore, to summarize n experiments the estimated proportion for each gene j is

(3)

To test for differential expression we set up a decision with the null hypothesis H0: p = 0.5 versus the alternative hypothesis H1: p ≠ 0.5. The test derived for this binomial distribution has a test statistic

(4)

The test statistic z j is compared to a quantile from the normal distribution z1-α/2. If the type I error is α = 0.05, then z0.975 = 1.96. If |z j | > 1.96, then gene j is declared differentially expressed between test and reference samples. The z1-α/2 quantile is replaced by a quantile when the variance estimate uses instead of p j . This test of binomial proportions, however, is not robust to deviations from the binomial distribution. Indeed, we do not believe that expression data will always follow a binomial distribution, but we include this derivation to motivate the choice of this statistic. Instead, we recommend an alternative test statistic that can be used whether distributional assumptions are met or not. The alternative test statistic simply uses a normal approximation to the binomial distribution and calculates a sample variance estimate. Then the test statistic for differential expression is

(5)

where we estimate the proportion and the sample variance in the usual way, . If |t j | > t1-α/2,n-1, then gene j is differentially expressed between test and reference samples. This test is valid for sufficiently large sample sizes (see Table 1).

Table 1 Simulation comparing test statistics for , , , limma/EBA, edgeR, and DESeq with a sample size of n = 20 under four distributional assumptions.

Calculating corresponding confidence intervals for each of the test statistics above is straightforward. Previous research suggests adjusting confidence intervals for binomial proportions. The most popular adjustment of these intervals uses the Agresti-Coull procedure [10, 11]. We recommend this procedure to estimate confidence intervals for both of the proportion estimates above.

The proposed statistics are evaluated within a frequentist framework. A Bayesian framework is provided in the Appendix.

Simulation Results

We ran a series of simulations to compare the inference behavior of proportion based statistics, and , to log-ratio based statistics, and . The proportion statistics and are introduced in equations 2 and 3 above and their test statistics are given in equations 4 and 5. The ratio-based statistics that have been used in the literature previously are described in equation 1 () and equation 6 in the Methods section (). In preliminary simulation exercises, we found that the performance of some test statistics was heavily dependent on the distribution used to generate the expression data. Thus, we generated expression data under four different distributions. The simulation results in Table 1 present a subset of the sample sizes and fold changes examined. More extensive tables are in Additional file 1.

The performance of the estimators under four different distributions is summarized in Table 2. The table was created after examination of the empirical type I error and power for each statistic in each simulation (Additional file 1). The proportion performs at or above the others with the exception of for the Poisson, although still performs adequately there (cp. Tables 1 and 2). The statistics and the DESeq analysis exhibit unacceptable performance under one or more of the distributional assumptions. Statistics , and limma/empirical Bayes (EBA) and edgeR analysis are always good or acceptable, depending on the distributional assumptions. The edgeR and DESeq analyses have type I errors less than 0.05 in many instances. On the average, the and EBA tests have moderately better type I error and power than , (Additional file 1). Although might be expected to outperform the other methods under the binomial assumption, detection under this assumption is easy and all methods performed equally well. In conclusion, the statistic and limma/EBA have the best inference in our simulations overall. The empirical Bayes approach results in better power than on the average under the Poisson and normal distributions.

Table 2 Comparison of estimators from the simulations.

Analysis of Gene Expression in Mice with apoAI Knockout

To examine the performance of our method on cDNA microarray data, we analyzed the expression values reported in Ge et al (2003) [12]. Since the apoAI experiment was a control-treatment experiment that used a third sample as a reference, this data exhibits how the methods of this paper can be extended to the case of a difference of two proportions. When testing for the difference between control and treatment, the p-values from and were very similar in magnitude. This was true for both raw p-values and p-values adjusted for multiple-testing. The order of the p-values was also similar, but not identical (see Figure 3). When using the limma/EBA method, the p-values from and were again similar in magnitude, although the order varied more after the 7th probe (Table 3). The top 8 most differentially expressed probes from the original analysis differed from those selected by using t-statistics in the 8th probe, although the top 9 probes for both sets are the same (Table 3). In the original analysis, the top 8 probes corresponded to four distinct genes, and were confirmed by real time quantitative PCR [13].

Figure 3
figure 3

Scatterplot of p-values for log 2 -ratio and proportion for the mouse data. The general ordering of the genes is similar, although not identical, using the two methods.

Table 3 Table of raw p-values for Welch t-statistics and limma methods using and from the apoAI control treatment expression data.

When using , there were 158 (2.5%) unanalyzable probes because one or more of the samples had both G ij = 0 and R ij = 0, which made undefined. The statistic was defined for all probes because G ij and R ij were never zero for all samples of a specific probe. For this data, none of the 158 unanalyzed probes were in the top eight when using , although if they were a potential discovery they would have been missed using . To avoid this problem, one may add an arbitrary constant to all probes before taking the log-ratio. If merely raw p-values were selected at α = 0.05, then would have selected 850, but there would have been 9 more significant p-values if an arbitrary 0.05 were added to the data to avoid zero denominators when using log-ratios. By comparison, would have selected 871 probes.

Therefore, is able to give comparable results to for this cDNA microarray experiment, with the slight advantage that it provided information for 158 more probes in the study, without an arbitrary constant.

Analysis of Differential Expression in Human Kidney and Liver Cells

To examine the performance of our methods on RNA-Seq data, we analyzed the expression values reported in Marioni et al (2008) [9]. This data compared the expression of human kidney and liver cells sampled from the same person. Concentrations of 3 pM of cDNA were sequenced using the Illumina platform in five lanes. The original paper analyzed the expression of 32,000 sequences and reported that 11,493 of the sequences were differentially expressed with q-values less than 0.001 (FDR < 0.1%) [14]. Supplemental Table 3 from Marioni et al (2008) provides the results of 17,708 sequences analyzed with both RNA-Seq technology and Affymetrix microarrays. They reported that 8,113 of Affyymetrix probe sets were differentially expressed with q-values less than 0.001.

In order to compare the methods in the original paper to those we are proposing, we used a type I error rate of α = 0.05/32000 for all tests. In this way, the threshold can be universally applied to all genes and methods while controlling the genomewide error rate.

Table 4 shows the total number of significant genes detected for all methods as well as the overlap between each. The least powerful method to detect differential expression was the test of while the most powerful method was the test of . Of our proposed methods, the statistic gave conclusions that overlapped most with the original methods in the paper, the likelihood ratio test (LRT) based on the maximum likelihood estimate [9]. In fact, found all of the differentially expressed genes found by the LRT. Tests conducted using the edgeR package gave the second largest overlap. Comparing the proposed methods with the Affymetrix data reported in the original paper [9], the most overlap in calls was with the tests, followed by the LRT using . If we look at the most recent methods developed for RNA-Seq data, the results of the DESeq package overlap most with , followed by the edgeR package, the LRT and then .

Table 4 Significant genes detected from the dataset in Marioni et al (2008).

Log2-ratio estimates produced much missing data in the RNA-Seq data analysis, with 8,947 sequences eliminated from analysis. Of these missing sequences, the proposed methods detected 4,171 () or 2,406 () significant calls (see Table 5). This means that using a test based on the log2-ratio may miss many possibly important differentially expressed genes. When using a LRT as suggested in Marioni et al (2008), 3,979 sequences were omitted from analysis because of missing data. The edgeR and DESeq packages did not generate any missing data. Of the 3,979 missing values generated by the LRT, our proposed methods detected 3,064 () or 2,208 () additional differentially expressed genes while the edgeR and DESeq packages detected an additional 235 and 197 genes. Since the true differential expression in this data is unknown, the differences between these methods are intriguing, but it is not clear whether one method is more accurate than another in this analysis. Overall, these findings suggest that test statistics based on a proportion statistic do not result in missing data, and more importantly, can detect possibly important differentially expressed genes that the log2-ratio based methods would miss.

Table 5 A summary of the missing values for each of the tests and the number of significant genes detected by other methods within those missing values.

Discussion

Although log2-ratios are widely used to compare two groups of expression data, there are limitations to using these statistics. The largest drawback to ratio statistics is that they are unstable as the denominator gets closer to zero. In addition, frequentist methods for constructing a corresponding variance and formally testing hypotheses of differential expression are unsatisfying and more complicated than typical scenarios [15, 16]. Due to these drawbacks, we proposed an alternative to testing for differential expression with all of the advantages of a log2-ratio statistic and none of its disadvantages.

We examined the proposed alternative, a proportion statistic, in four sets of simulations and two different sets of expression data. In simulations, the statistic , plus a constant and limma/EBA were robust to changes in distributional assumptions and the others were not. For the case of the Poisson distribution with rate parameter λ = 3, the statistic was underpowered, but otherwise and performed similarly well in simulations. The simulations suggest the use of in differential expression analyses because it uniformly preserved type I error and had competitive power. Note, however, that is not uniformly most powerful, and statistics derived from specific distributions can beat it when the distributional assumptions hold. The performance of the empirical Bayes analysis was competitive with in simulations but not in the analysis of the RNA-Seq dataset. Future research of interest may extend the test within an empirical Bayes framework, akin to what already exists for the log2-ratio. This may even further extend the clearly demonstrated feasibility of to detect differentially expressed genes.

Additionally, while the popular statistic performs sufficiently well under many simulation conditions, it suffers from problems with missing data in real data analysis problems when expression values are low. The addition of constants 0.05 and 0.5 appreciably improve simulation results and make the performance of nearly as good as (see Additional file 1). Nevertheless, this ad hoc procedure can be avoided using . In both the analysis of a cDNA microarray set and an RNA-Seq dataset, the log2-ratio based statistics led to missing values. Of these genes with missing ratio values, the proportion statistic was able to detect instances of statistically significant differential expression. We therefore recommend for general use over the other statistics discussed.

Conclusions

The use of the log2-ratio statistic to compare two expression values is challenged by denominators with near zero values. Thus, a reasonable alternative is to suggest a statistic that is not constrained by problems with very low expression values that still provides a meaningful test of differential expression. Using a proportion estimate instead of a ratio estimate does exactly that. The methods of this paper may only be used when data is naturally paired in test and reference samples, i.e. when log-ratios have traditionally been used. Our research provides several alternatives based on estimates of a proportion in both a frequentist and a Bayesian inference framework. We showed the performance of these alternatives and compared them to log2-ratio based tests in simulations and two gene expression datasets. In the gene expression analysis, all of the proportion methods performed better than ratio based methods for genes with low expression. For normal expression levels, inferential conclusions are similar, with the average proportion method, , plus a constant and the augmented log2-ratio method in limma/EBA, performing the best overall. The statistic has the added advantage that it does not require adjusting for an arbitrary constant that introduces bias in the estimate. Thus, tests of differential expression should consider proportion statistics over log2-ratios in future scientific studies.

Methods

This section describes the data generation process in our simulations and the data collection in the two datasets analyzed in this paper.

Simulations

The proposed test statistics were evaluated under four different distributions. Though sophisticated simulations can be used to mimic expression data, the simulations below use simple scenarios so as to examine the performance of test statistics under basic distributions and to compare the eight different methods clearly and meaningfully. The first set of simulated intensity values were sampled from an exponential distribution that mimics the values from a 16-bit TIFF image of a cDNA microarray with respect to center and spread. The reference sample was taken from an Exp(1/4000) and the test sample was taken from a c × Exp(1/4000) where c was the fold-change value, c = 1,2,3,4,5. The four statistics, , and , were calculated for each value of c and sample sizes n = 3, 5, 10, 15, 20, 25, 30, 40, 50. Additionally we evaluated the ratio statistic after shifting values for an arbitrarily small constant set at either 0.05 and 0.5. For further comparison, a standard implementation of the limma/empirical Bayes method of Smyth (2004) was perfomed [17]. For simulations of count data values, we evaluated methods that account for overdispersion in the tests of differential expression using the edgeR and DESeq packages in Bioconductor [18, 19]. The implementation in both packages fixes a constant library size for each sample so that normalization is not executed. Sample sizes larger than n = 50 give simulation results similar to those for sample sizes of 50. In order to compare results, the p-value for an independent t-test was computed, with a null hypothesis of no difference between the two sample means. The null hypothesis was rejected if the p-value was below α = 0.05 and the proportion of rejections out of 1000 simulations was recorded (Table 1 and Additional file 1). The null hypothesis of no differential expression is equivalent to a fold change of one, c = 1. When the fold change is greater than one, we are calculating the power to detect differential expression. In this way, type I error and power were compared across the different methods. The results would be equivalent when using reciprocal fold changes instead. The simulations for an exponential distribution were repeated for an Exp(1/400) distribution, to study the effects of changing the scale.

A second set of simulated sampled intensity values from a Binomial(M = 10000, p = 0.5) distribution were obtained. The choice of this distribution was motivated by the derivation behind the maximum likelihood estimate of the proportion . The size was chosen to mimic the values from a 16-bit TIFF image of a cDNA microarray with respect to center. Analogous simulations to the exponential above were conducted with respect to statistics, sample sizes, and fold changes. For the binomial distribution, fold-changes of 2, 3, 4, and 5 correspond to binomial probabilities of 2/3, 3/4, 4/5, and 5/6 respectively. The simulations were repeated for a Binomial(M = 100, p = 0.5) distribution, to study the effects of change in the size parameter. A third set of simulated sampled intensity values from a Poisson(λ = 3) distribution were obtained. This distribution is motivated by the derivation behind the likelihood ratio test used in Marioni et al (2008) [9]. The parameter λ = 3 was chosen to mimic the number of categories arising from a smooth histogram of values from the RNA-Seq data. The simulations were repeated for a Poisson(λ = 30) distribution, to study the effects of change in the rate parameter. Analogous simulations to the exponential above were conducted with respect to statistics, sample sizes, and fold changes.

A fourth set of simulated sampled intensity values from a Normal(μ = 5, σ = 1) distribution were obtained. This distribution was included since many analyses assume expression data to be normally distributed. The center was chosen to mimic values from cDNA data with mean 5,000 and standard deviation 1,000, scaled to Normal(μ = 5, σ = 1). Analogous simulations to the exponential above were conducted with respect to statistics, sample sizes, and fold changes. For the normal distribution, fold-changes of 2, 3, 4, and 5 correspond to test samples of Normal(c × μ, σ = 1). The simulations were repeated for a Normal(μ = 10, σ = 2) distribution, to study the impact of changing the parameters.

All simulations were conducted using R http://www.r-project.org and the code is available in Additional file 2.

Gene Expression Data from Mice using cDNA Microarrays

We examined our proposed approach in a well-known and often cited set of cDNA microarrays. We chose this set because many research groups have evaluated their methods on this data and consequently the differential expression behavior in this data are better understood. The Apo AI experiment used cDNA microarrays to measure gene expression in the livers of 8 inbred control mice versus 8 mice with the Apo AI gene "knocked out" [20]. For each microarray, the reference sample was created from the pooled cDNA of the eight control mice. The goal of the experiment was to detect differential expression in the liver between control mice and the genetic knockout strain [12]. Since the Apo AI gene plays a role in HDL metabolism, differentially expressed genes are likely associated with lipid metabolism. The data can be obtained as an Rdata object from http://www.bioconductor.org/help/course-materials/2005/BioC2005/labs/lab01/Data/apoai.zip on the Bioconductor website. Welch two-sample t-statistics for each of the 6,384 probes were calculated,

where X trt and X cont were either our proportion estimators, and or the usual log2-ratio estimators, and . Since the variability of the cDNA data resembles the exponential distribution, the assumptions for methods and do not hold and therefore they were not used. To account for multiple testing, the original analysis used the maxT step-down procedure based on the t-statistics and found eight significantly differentially expressed probe sequences [12]. In order to explore the performance of alternative methods with both of the test statistics, the limma/EBA method of Smyth (2004) was computed [17]. Although this method was developed for log2-ratio values, we used the same programs on the proportion values as well.

Gene Expression Data from Human Kidney and Liver Cells using RNA-Seq

In order to examine the performance of our new approach on a sequence-based technology, we analyzed a set of RNA-Seq data discussed in Marioni et al (2008) [9]. This set of data compared the expression of 32,000 sequences in human kidney and liver cells extracted from the same person. The expression was also measured using Affymetrix U133 oligonucleotide arrays. Data was obtained from Supplemental Table 2 in the original manuscript. To compare our methods with those reported in the Supplemental Table 3 of their manuscript, we extracted the same five lanes of Illumina sequencing data corresponding to 3 pM concentrations of cDNA. We calculated both of the proportion tests outlined in the Results section, the ratio-based test provided in the Background section, and compared them to the methods from the original paper and more recent methods that account for overdispersion [18, 19].

The methods to test for differential expression from RNA-Seq data in the original paper used a likelihood ratio test (LRT) for inference [9]. Their test assumes that the expression data follows a Poisson distribution where the rate of expression λ is equivalent in kidney (K) and liver (L) cells under the null hypothesis. For gene j, the likelihood ratio test compares H0 : λ Kj = λ Lj versus the alternative hypothesis that expression rates differ H1 : λ Kj ≠ λLj. The likelihood ratio test is

(6)

for gene j. The maximum likelihood estimate for the alternative hypothesis from the above LRT is denoted by . The original paper also tested for differential expression on the Affymetrix platform for the same tissue samples. The methods employed were an empirical Bayes analysis with a false discovery rate of 0.1% [17]. More recent developments that account for overdispersion in the tests of differential expression were implemented using the edgeR and DESeq packages in Bioconductor [18, 19].

Appendix: Bayesian Estimation and Inference

In order to compare our proposed methods to previously suggested test statistics in the data analysis sections, we evaluated the proportion statistics within a frequentist testing framework. It is also possible to conceive the model in a Bayesian framework. Given the binomial assumption presented in the Results section, a Bayesian analysis can be conducted. Let the beta distribution be denoted by β(a, b), with density

Where Γ (a) is the gamma function with parameter a. We denote the Bayesian estimator of p j by . Using a Beta prior for p j with parameters a and b, the posterior distribution of , is β (y + a, M - y + b), where and with density

[21]. To compare the performance of the Bayesian with frequentist statistics , and , credible intervals and confidence intervals can be constructed and coverage can be examined in simulations. For data where the difference of two proportions is required, the posterior distribution derived in [22] can be used.

References

  1. Canales R, Luo Y, Willey J, Austermiller B, Barbacioru C, Boysen C, Hunkapiller K, Jensen R, Knight C, Lee K, Ma Y, Maqsodi B, Papallo A, Peters E, Poulter K, Ruppel P, Samaha R, Shi L, Yang W, Zhang L, Goodsaid F: Evaluation of DNA microarray results with quantitative gene expression platforms. Nature Biotechnology 2006, 24: 1115–1122. 10.1038/nbt1236

    Article  CAS  PubMed  Google Scholar 

  2. Ramakers C, Ruijter J, Lekanne-Deprez R, Moorman A: Assumption-free analysis of quantitative real-time polymerase chain reaction (PCR) data. Neuroscience Letters 2003, 339: 62–66. 10.1016/S0304-3940(02)01423-4

    Article  CAS  PubMed  Google Scholar 

  3. Zipper H, Brunner H, Bernhagen J, Vitzthum F: Investigations on DNA intercalation and surface binding by SYBR Green I, its structure determination and methodological implications. Nucleic Acids Research 2004, 32: e103. 10.1093/nar/gnh101

    Article  PubMed Central  PubMed  Google Scholar 

  4. DeRisi J, Iyer V, Brown P: Exploring the metabolic and genetic control of gene expression on a genomic scale. Science 1997, 278: 680–686. 10.1126/science.278.5338.680

    Article  CAS  PubMed  Google Scholar 

  5. Shalon D, Smith S, Brown P: A DNA microarray system for analyzing complex DNA samples using two-color fluorescent probe hybridization. Genome Research 1996, 6: 639–645. 10.1101/gr.6.7.639

    Article  CAS  PubMed  Google Scholar 

  6. Irizarry R, Wu Z, Jaffee H: Comparison of Affymetrix GeneChip expression measures. Bioinformatics 2006, 22: 789–794. 10.1093/bioinformatics/btk046

    Article  CAS  PubMed  Google Scholar 

  7. Wang Z, Gerstein M, Snyder M: RNA-Seq: a revolutionary tool for transcriptomics. Nature Reviews Genetics 2009, 10: 57–63. 10.1038/nrg2484

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  8. Morazavi A, Williams B, McCue K, Schaeffer L, Wold B: Mapping and quantifying mammalian transcriptomes by RNA-Seq. Nature Methods 2008, 5: 621–628. 10.1038/nmeth.1226

    Article  Google Scholar 

  9. Marioni J, Mason C, Mane S, Stephens M, Gilad Y: RNA-Seq: an assessment of technical reproducibility and comparison with gene expression arrays. Genome Research 2008, 18: 1509–1517. 10.1101/gr.079558.108

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  10. Agresti A, Coull B: Approximate is better than "exact" for interval estimation of binomial proportions. American Statistician 1998, 52: 119–126. 10.2307/2685469

    Google Scholar 

  11. Brown L, Cai T, Dasgupta A: Interval estimation for binomial proportion. Statistical Science 2001, 16: 101–133.

    Google Scholar 

  12. Ge Y, Dudoit S, Speed T: Resampling-based multiple testing for microarray data analysis. Tech. rep., U. C. Berkeley Statistics Department 2003.

    Google Scholar 

  13. Dudoit S, Shaffer J, Boldrick C: Multiple hypothesis testing in microarray experiments. Statistical Science 2003, 18: 71–103. 10.1214/ss/1056397487

    Article  Google Scholar 

  14. Storey J, Tibshirani R: Statistical significance for genomewide studies. Proc Natl Acad Sci USA 2003, 100: 9440–9445. 10.1073/pnas.1530509100

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  15. Fieller E: The biological standardization of insulin. Suppl to J R Statist Soc 1940, 7: 1–64. 10.2307/2983630

    Article  Google Scholar 

  16. Kendall M, Stuart A: Advanced Theory of Statistics. London: Charles Griffin & Company; 1977.

    Google Scholar 

  17. Smyth G: Linear models and empirical bayes methods for assessing differential expression in microarray experiments. Stat Appl Genet Mol Biol 2004, 3: Article 3.

    Google Scholar 

  18. Anders S, Huber W: Differential expression analysis for sequence count data. Genome Biology 2010, 11: R106. 10.1186/gb-2010-11-10-r106

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  19. Robinson M, McCarthy D, Smyth G: edgeR: a Bioconductor package for differential expression analysis of digital gene expression data. Bioinformatics 2010, 26: 139–140. 10.1093/bioinformatics/btp616

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  20. Callow MJ, Dudoit S, Gong EL, Speed TP, Rubin EM: Microarray expression profiling identifies genes with altered expression in HDL deficient mice. Genome Research 2000, 10(12):2022–2029. 10.1101/gr.10.12.2022

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  21. Press S: Subjective and Objective Bayesian Statistics. Hoboken, NJ: Wiley; 2003.

    Google Scholar 

  22. Pham-Gia T, Turkkan N, Eng P: Bayesian analysis of the difference of two proportions. Communications in Statistics - Theory and Methods 1993, 22(6):1755–1771. 10.1080/03610929308831114

    Article  Google Scholar 

Download references

Acknowledgements

The authors would like to thank Suzanne Grindle in the Department of Microbiology at the University of Minnesota for her feedback, as well as that of the anonymous reviewers, which has resulted in improvements to the manuscript. Support for this research was provided by the Institute for Pure and Applied Mathematics at UCLA.

Author information

Authors and Affiliations

Authors

Corresponding authors

Correspondence to Tracy L Bergemann or Jason Wilson.

Additional information

Authors' contributions

TLB and JW contributed equally to the research. Both authors read and approved the final manuscript.

Electronic supplementary material

12859_2010_4625_MOESM1_ESM.PDF

Additional file 1:Additional materials. Additional tables for each of the simulation scenarios are provided in the file exprPropSupp2011.pdf. This file was generated using LaTeX. (PDF 126 KB)

12859_2010_4625_MOESM2_ESM.R

Additional file 2:Additional materials. The script written in R http://www.r-project.org to conduct simulations are provided in the file exprPropSimCode.R. (R 11 KB)

Authors’ original submitted files for images

Rights and permissions

This article is published under license to BioMed Central Ltd. This is an Open Access article distributed under the terms of the Creative Commons Attribution License (http://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

Bergemann, T.L., Wilson, J. Proportion statistics to detect differentially expressed genes: a comparison with log-ratio statistics. BMC Bioinformatics 12, 228 (2011). https://0-doi-org.brum.beds.ac.uk/10.1186/1471-2105-12-228

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://0-doi-org.brum.beds.ac.uk/10.1186/1471-2105-12-228

Keywords