Skip to main content
Advertisement
  • Loading metrics

ROTS: An R package for reproducibility-optimized statistical testing

Abstract

Differential expression analysis is one of the most common types of analyses performed on various biological data (e.g. RNA-seq or mass spectrometry proteomics). It is the process that detects features, such as genes or proteins, showing statistically significant differences between the sample groups under comparison. A major challenge in the analysis is the choice of an appropriate test statistic, as different statistics have been shown to perform well in different datasets. To this end, the reproducibility-optimized test statistic (ROTS) adjusts a modified t-statistic according to the inherent properties of the data and provides a ranking of the features based on their statistical evidence for differential expression between two groups. ROTS has already been successfully applied in a range of different studies from transcriptomics to proteomics, showing competitive performance against other state-of-the-art methods. To promote its widespread use, we introduce here a Bioconductor R package for performing ROTS analysis conveniently on different types of omics data. To illustrate the benefits of ROTS in various applications, we present three case studies, involving proteomics and RNA-seq data from public repositories, including both bulk and single cell data. The package is freely available from Bioconductor (https://www.bioconductor.org/packages/ROTS).

“This is a PLOS Computational Biology Software paper.”

Introduction

Differential expression analysis between two groups of samples is perhaps the most common type of analysis that is performed on various types of omics data. The aim of differential expression analysis is to detect features (e.g. genes or proteins) showing statistically significant changes between the groups. A commonly used approach has been the Student’s t-test, which has been later shown not to be the most optimal solution in many cases [1, 2]. Although a number of alternative test statistics have therefore been introduced [35], a major practical challenge remains that the different statistics perform well in different datasets [69] and there is no general agreement on how to make an appropriate choice of the statistic a priori.

To address this need, we have introduced a reproducibility-optimized test statistic (ROTS) that optimizes the choice of the statistic directly from the data instead of using a fixed predefined statistic [10]. This is done by maximizing the overlap of top-ranked features in group-preserving bootstrap datasets among a family of t-type statistics. In particular, ROTS optimizes the ranks of the features because usually the final ranking determines if the differentially expressed features are selected for further validation studies.

The ROTS method has already been used in various applications, such as microarrays [10], mass spectrometry proteomics [11] as well as bulk and single-cell RNA-seq [9, 12], and its competitive performance has been shown against other tools for differential expression analysis. Here we introduce a Bioconductor R package ROTS for performing differential expression analysis using the ROTS method and demonstrate the applicability of the method in three diverse case studies. The R package together with detailed documentation is freely available from Bioconductor.

Design and implementation

Algorithm

ROTS optimizes the reproducibility of top-ranked features in group-preserving bootstrap datasets among a family of modified t-statistics: (1) where is the absolute difference between the group averages, α1 and α2 are non-negative parameters to be optimized, and s is the pooled standard error [10]. Special cases of ROTS are the ordinary t-statistic (α1 = 0, α2 = 1) and the signal log-ratio (α1 = 1, α2 = 0). The optimal statistic is determined by maximizing the reproducibility Z-score: (2) over a lattice α1 ∈ {0, 0.01, …, 5}, α2 ∈ {0, 1}, k ∈ {1, 2, …, G}. Here, Rk (dα) is the observed reproducibility of statistic dα at top list size k in bootstrap datasets, is the corresponding null reproducibility in randomized datasets permuted over samples, sk (dα) is the standard deviation of the bootstrap distribution, and G is the total number of features in the data. Reproducibility is defined as the average overlap of k top-ranked features over pairs of bootstrapped datasets.

The final ROTS output is calculated from the original data using the optimized parameters α1 and α2 giving the highest reproducibility Z-score. The false discovery rate (FDR) is estimated by randomly permuting the sample labels.

Software features

The ROTS package is freely available from Bioconductor (https://www.bioconductor.org/packages/ROTS) and runs in R environment. Both the package and the R environment can be used on Windows, MacOS or UNIX platforms. After installing the package, the differential expression analysis can be performed within R. A preprocessed and appropriately normalized data matrix is required for input with columns representing different samples and rows representing the features. It can be various types of omics data, such as gene expression microarray data, RNA-seq data or mass spectrometry based proteomics data. As an example, an excerpt from a typical expression matrix of a label-free proteomics study is shown in Table 1, containing log scaled protein abundances of three replicates from two sample groups of the shotgun ‘profiling standard sample set’ [13].

thumbnail
Table 1. Example layout of expression data to be used as input for ROTS, where columns represent different samples and rows represent the features.

https://doi.org/10.1371/journal.pcbi.1005562.t001

To perform differential expression analysis on an expression matrix (here data), only one line of code is required after loading the package:

library(ROTS)

rots.out <- ROTS(data, groups = c(0,0,0,1,1,1), B = 1000, K = 500)

Here the vector groups defines the columns of the data matrix belonging to the two different sample groups under comparison, B denotes the number of bootstraps to perform, and K is the maximum top list size to consider in reproducibility optimization. Setting this number to a smaller value may improve the running time drastically. However, we recommend that the value should always be considerably higher than the number of features expected to be differentially expressed.

The generated ROTS object (here rots.out) contains the test statistics and additional details for all the features in the input data, including the optimized parameters a1 and a2. If the reported top list size k (rots.out$k) is close to the given parameter K, it suggests that the maximum top list size to be tested might have been too small, and increasing it should be considered. The reproducibility value (rots.out$R) and the reproducibility Z-score (rots.out$Z) are also included. All the results including p-values (rots.out$pvalue), false discovery rates (rots.out$FDR) or fold changes (rots.out$logfc) can be exported by the user and used for further external analysis, such as gene-set or pathway enrichment analysis.

The ROTS package includes also versatile built-in options for visualization that can be accessed using the standard R plot function. The type of plot can be selected using the type parameter of the function. Fig 1A shows an example of a volcano plot (type=‘volcano’), which visualizes the relationship between fold changes and p-values (i.e. magnitude of change and statistical significance). It can be used to select the most promising candidate features for further validation studies. Fig 1B shows an example of an MA plot (type=‘ma’), which shows the relationship between the average intensities (A) and intensity ratios (M) calculated across and between the sample groups for each feature, respectively. It can be used, for instance, to assess the quality of normalization used in preprocessing the data. Fig 1C illustrates the ROTS reproducibility Z-score as a function of top list size k (type=‘reproducibility’). It can be used to look for possible alternative peaks of Z-score, which could suggest, for example, subgroups of differentially expressed features or artifacts from data normalization. Fig 1D illustrates a histogram of p-values (type=‘pvalue’), which enables assessing the overall performance of the hypothesis testing. Under the null hypothesis, p-values are uniformly distributed, but if there is a large number of differentially expressed features present, the distribution of p-values is likely skewed towards smaller values. Fig 1E shows an example of a principal component analysis (PCA) of the differentially expressed features defined based on a user-specified FDR cutoff (type=‘pca’). It is a transformation, where the data is projected into a new coordinate system of principal components retaining the highest variance. It can be used as a tool to evaluate similarities between samples or groups. By setting the FDR parameter to 1, the principal components are calculated using all the features. Fig 1F illustrates a heatmap with hierarchical clustering of samples and features to visualize the expression levels of differentially expressed features as colours (type=‘heatmap’).

thumbnail
Fig 1. Visualizations provided by ROTS.

(A) Volcano plot of the features, where the differentially expressed features are coloured red. (B) MA plot of the features, where the differentially expressed features are coloured red. (C) ROTS reproducibility Z-score as function of top list size. The highest score is marked with red dot together with its value. (D) Histogram of p-values. (E) Principal component analysis (PCA) plot of the differentially expressed features. (F) Heatmap and hierarchical clustering of the samples (columns) and the differentially expressed features (rows) using euclidean distance and the complete-linkage agglomerative clustering method.

https://doi.org/10.1371/journal.pcbi.1005562.g001

For additional details and examples of using the ROTS package, the reader is referred to the package manual and the three case studies discussed below.

Results

The benefits of ROTS over other state-of-the-art tools have already been shown in various applications [912]. Here, we used three new case studies to further demonstrate the performance of the ROTS method in different study settings, including label-free quantitative proteomics and both bulk and single-cell RNA-seq studies.

Case study 1: Quantitative label-free proteomics

The ROTS method has previously been benchmarked in label-free shotgun proteomics using spike-in mixtures and complex mouse liver samples, where it has shown competitive performance against other state-of-the-art methods [11]. Here, the performance of ROTS with quantitative mass spectrometry based proteomics data is illustrated in another published benchmark spike-in study, where the truly differentially expressed proteins are known.

The data are from an inter-laboratory spike-in study of the Clinical Proteomic Tumor Analysis Consortium (CPTAC technology assessment study 6) [1416]. It contains a mixture of 48 human proteins (Sigma UPS1) spiked into a yeast proteome (S. cerevisiae) background at different concentration levels ranging from 0.25 to 20 fmol/μL to create five distinct sample groups each with three technical replicates. From the different datasets available, we processed Orbitrap raw files produced at site 86, from which a total of 736 proteins were quantified using the Progenesis software with peptide identifications from the Mascot search algorithm in Proteome Discoverer software. Threshold for peptide identifications was set to FDR < 0.01 and relative protein quantitation was done using non-conflicting peptides, followed by median normalization. Progenesis was unable to align one of the three replicates in one of the sample groups (sample group E). Only the sample groups with all three replicates (sample groups from A to D) were used here for performance benchmarking.

Fig 2 shows the performance of ROTS on the CPTAC data together with other popular methods for differential expression analysis, including significance analysis of microarrays (SAM) [3], Limma [5] and the Student’s t-test. Performance was measured using receiver operating characteristic (ROC) curves, which were created by merging the results from the six possible individual pairwise comparisons involving sample groups from A to D. Overall, ROTS produced a significantly better ROC-curve compared to all other tested methods (DeLong’s test p < 0.001 for each method), which supports the applicability of ROTS in proteomics studies to distinguish differentially expressed proteins.

thumbnail
Fig 2. Performance of ROTS and current state-of-the-art methods for proteomics in the spike-in proteomics data from the Clinical Proteomic Tumor Analysis Consortium (CPTAC technology assessment study 6).

Performance was evaluated using receiver operating characteristic (ROC) curves and the areas under the curves (AUC).

https://doi.org/10.1371/journal.pcbi.1005562.g002

Case study 2: Bulk RNA-seq

Similarly as with proteomics data, the ROTS method has been extensively benchmarked against other software packages in bulk RNA-seq data [12]. Besides systematically outperforming other methods in spike-in data, ROTS has also been used to successfully identify prognostic markers for clear cell renal cell carcinoma, which confirms the clinical relevance of estimating differential gene expression accurately with ROTS [12]. Here, the performance of ROTS in bulk RNA-seq data is illustrated using a published benchmark spike-in study.

The data are from the sequencing quality control (SEQC) project [17], which includes four distinct sample groups (A, B, C and D) each with five technical replicates sequenced using Illumina HiSeq 2000 platform. For groups A and B, 92 synthetic polyadenylated transcripts provided by the External RNA Control Consortium (ERCC) [18] have been spiked into the Universal Human Reference RNA (UHRR) and Human Brain Reference RNA (HBRR) respectively, so that their concentrations were controlled to have different fold changes of 0.5, 0.67, 1 or 4 between the groups A and B. Samples C and D were then obtained by mixing samples A and B using different ratios: 75% of sample A and 25% of sample B for sample C and vice versa for sample D. For performance benchmarking, we downloaded the count table from GEO with accession number GSE47774. The trimmed mean of M-values (TMM) normalization [20] with voom transformation [19] was applied before differential expression analysis. In total, four comparisons were considered: A vs B, A vs D, B vs C, and C vs D.

Fig 3 shows the performance of ROTS in the bulk RNA-seq data together with other state-of-the-art methods, including edgeR [21, 22], Differential Expression analysis for Sequence count data (DESeq) [23] and Limma [5]. Similarly as with proteomics, the performance was measured using ROC-curves, which were created by merging the results from the individual pairwise comparisons. Again, ROTS showed improved performance over the other tested methods (DeLong’s test p < 0.001 for each method), confirming the applicability of ROTS in bulk RNA-seq studies to detect differentially expressed genes.

thumbnail
Fig 3. Performance of ROTS and current state-of-the-art methods for bulk RNA-seq in the spike-in data from the SEQC project.

Performance was evaluated using receiver operating characteristic (ROC) curves and the areas under the curves (AUC).

https://doi.org/10.1371/journal.pcbi.1005562.g003

Case study 3: Single-cell RNA-seq

Recently, performance of the ROTS method in comparison to other state-of-the-art methods has also been tested in single-cell RNA-seq data. ROTS showed good performance without requiring any single-cell-specific modifications, whereas no systematic benefits of the recent single-cell-specific methods were found [9]. Here, we further demonstrate the utility of the ROTS method also in the increasingly popular single-cell RNA-seq data.

The data are from a previously published single-cell study on innate lymphoid cells (ILC), containing single cell samples sequenced using Illumina HiSeq 2000 platform [24]. Similarly as in our recent study [9], we compared different cell populations. The count table was downloaded from GEO with accession number GSE70580. However, unlike in our previous study, where we compared ILC1 and ILC2 cells against ILC3 cells, the comparison here was performed between ILC1 and ILC2 cells. After excluding cells with total expression < 10000, the data contained 127 ILC1 cells and 139 ILC2 cells. With ROTS we performed TMM normalization and with the other tested methods the guidelines of their respective manuals were followed.

Fig 4 shows the performance of ROTS in the single-cell RNA-seq data together with other state-of-the art tools, including Single Cell Differential Expression (SCDE) [25], Model-based Analysis of Single-cell Transcriptomics (MAST) [26] and Limma [5]. First, we investigated the precision and recall of the findings when the number of cells was reduced to 90, 70, 50 or 30 cells in both groups. Ten subsets of each size were generated. Overall, ROTS showed the highest precision in finding the genes detected in the full data as differentially expressed (FDR < 0.05) also in the reduced datasets (Fig 4A). Notably, it also had the highest recall, indicating that the findings from the reduced data covered the findings from the full data better than with the other tested methods (Fig 4B). Finally, to investigate whether the methods tended to find a large number of false positives, we generated artificial mock datasets by randomly dividing the 139 ILC2 cells into two groups of similar size ten times. These artificial sets should not differ from one another since all the cells are from the same population. Also the investigation of the mock comparisons ranked ROTS as the top performing method (Fig 4C). These results further confirm the applicability of ROTS for single-cell RNA-seq studies.

thumbnail
Fig 4. Precision, recall, and false positive ratios of ROTS and current state-of-the-art methods for single-cell RNA-seq in the innate lymphoid cell data.

(A) Precision of the findings in reduced data. Precision was defined as the ratio between the number of common detections in the reduced and full data, and the total number of detections in the reduced data. Median values over ten randomly generated subsets are indicated by lines across the different numbers of cells per group. (B) Recall of the findings in reduced data. Recall was defined as the ratio between the number of common detections in the reduced and full data, and the total number of detections in the full data. Median values over ten randomly generated subsets are indicated by lines across the different numbers of cells per group. (C) False positive ratios of the findings in ten randomly generated mock datasets. The false positive ratio was defined as the ratio between the number of differentially expressed genes in the mock comparison and the average number of differentially expressed genes in the actual comparison. Limma was visualized separately because of the different scale compared to the other methods and jittering was used to separate overlapping points.

https://doi.org/10.1371/journal.pcbi.1005562.g004

Availability and future directions

ROTS has been successfully applied in multiple studies in a diversity of applications and the results on different types of omics data have shown its overall robustness. A major benefit of ROTS is its ability to automatically select an appropriate test statistic for a specific data under study by maximizing the reproducibility of the differentially expressed features. Therefore, it would be beneficial to integrate ROTS into various existing workflows to perform the differential expression analysis. Besides being able to select a test statistic, ROTS could possibly aid also in selecting, for instance, an appropriate normalization method based on the data. While ROTS is based on a modified t-statistic, it is possible to further extend the method by allowing multiple sample groups by using, for example, a modified F-statistic. Finally, to enhance the running time of the algorithm, parallelization within the package or improved heuristics could be implemented for optimizing the parameters.

The R package ROTS is freely available from Bioconductor (https://www.bioconductor.org/packages/ROTS) and it conveniently allows to perform statistical testing and result visualization using simple commands. A complete reference manual for the package and a vignette with examples are also available from Bioconductor.

Author Contributions

  1. Conceptualization: LLE.
  2. Formal analysis: TS FS MKJ TF.
  3. Funding acquisition: LLE.
  4. Investigation: TS FS MKJ TF LLE.
  5. Methodology: TS FS LLE.
  6. Project administration: LLE.
  7. Software: TS FS LLE.
  8. Supervision: LLE.
  9. Visualization: TS FS MKJ TF.
  10. Writing – original draft: TS.
  11. Writing – review & editing: TS FS MKJ TF LLE.

References

  1. 1. Mukherjee S, Roberts SJ. A theoretical analysis of gene selection. Proceedings / IEEE Computational Systems Bioinformatics Conference, CSB IEEE Computational Systems Bioinformatics Conference. 2004; p. 131–41.
  2. 2. Qin LX, Kerr KF, Contributing Members of the Toxicogenomics Research Consortium. Empirical evaluation of data transformations and ranking statistics for microarray analysis. Nucleic acids research. 2004;32(18):5471–9. pmid:15479783
  3. 3. Tusher VG, Tibshirani R, Chu G. Significance analysis of microarrays applied to the ionizing radiation response. Proceedings of the National Academy of Sciences of the United States of America. 2001;98(9):5116–21. pmid:11309499
  4. 4. Breitling R, Armengaud P, Amtmann A, Herzyk P. Rank products: a simple, yet powerful, new method to detect differentially regulated genes in replicated microarray experiments. FEBS letters. 2004;573(1–3):83–92. pmid:15327980
  5. 5. Smyth GK. Linear models and empirical bayes methods for assessing differential expression in microarray experiments. Statistical Applications in Genetics and Molecular Biology. 2005;3(1):1–25.
  6. 6. Soneson C, Delorenzi M. A comparison of methods for differential expression analysis of RNA-seq data. BMC Bioinformatics. 2013;14. pmid:23497356
  7. 7. Rapaport F, Khanin R, Liang Y, Pirun M, Krek A, Zumbo P, Mason CE, Socci ND, Betel D. Comprehensive evaluation of differential gene expression analysis methods for RNA-seq data. Genome Biology. 2013;14(9). pmid:24020486
  8. 8. Seyednasrollah F, Laiho A, Elo LL. Comparison of software packages for detecting differential expression in RNA-seq studies. Briefings in Bioinformatics. 2015;16(1):59–70. pmid:24300110
  9. 9. Jaakkola MK, Seyednasrollah F, Mehmood A, Elo LL. Comparison of methods to detect differentially expressed genes between single-cell populations. Briefings in Bioinformatics. 2016;(February):bbw057.
  10. 10. Elo LL, Filén S, Lahesmaa R, Aittokallio T. Reproducibility-optimized test statistic for ranking genes in microarray studies. IEEE/ACM transactions on computational biology and bioinformatics / IEEE, ACM. 2008;5(3):423–31.
  11. 11. Pursiheimo A, Vehmas AP, Afzal S, Suomi T, Chand T, Strauss L, et al. Optimization of Statistical Methods Impact on Quantitative Proteomics Data. Journal of Proteome Research. 2015;14(10):4118–4126. pmid:26321463
  12. 12. Seyednasrollah F, Rantanen K, Jaakkola P, Elo LL. ROTS: reproducible RNA-seq biomarker detector-prognostic markers for clear cell renal cell cancer. Nucleic acids research. 2016;44(1):e1. pmid:26264667
  13. 13. Bruderer R, Bernhardt OM, Gandhi T, Miladinović SM, Cheng LY, Messner S, et al. Extending the Limits of Quantitative Proteome Profiling with Data-Independent Acquisition and Application to Acetaminophen-Treated Three-Dimensional Liver Microtissues. Mol. Cell. Proteomics. 2015;14:1400–1410. pmid:25724911
  14. 14. Tabb DL, Vega-Montoto L, Rudnick Pa, Variyath AM, Ham AJL, Bunk DM, et al. Repeatability and reproducibility in proteomic identifications by liquid chromatography-tandem mass spectrometry. Journal of proteome research. 2010;9(2):761–76. pmid:19921851
  15. 15. Rudnick PA, Clauser KR, Kilpatrick LE, Tchekhovskoi DV, Neta P, Blonder N, et al. Performance Metrics for Liquid Chromatography-Tandem Mass Spectrometry Systems in Proteomics Analyses. Molecular & Cellular Proteomics. 2010;9(2):225–241.
  16. 16. Paulovich AG, Billheimer D, Ham AJL, Vega-Montoto L, Rudnick PA, Tabb DL, et al. Interlaboratory study characterizing a yeast performance standard for benchmarking LC-MS platform performance. Molecular & cellular proteomics: MCP. 2010;9(2):242–54.
  17. 17. SEQC/MAQC-III Consortium. A comprehensive assessment of RNA-seq accuracy, reproducibility and information content by the Sequencing Quality Control Consortium. Nature biotechnology. 2014;32(9):903–14. pmid:25150838
  18. 18. Jiang L, Schlesinger F, Davis CA, Zhang Y, Li R, Salit M, et al. Synthetic spike-in standards for RNA-seq experiments. Genome research. 2011;21(9):1543–51. pmid:21816910
  19. 19. Law CW, Chen Y, Shi W, Smyth GK. voom: Precision weights unlock linear model analysis tools for RNA-seq read counts. Genome biology. 2014;15(2):R29. pmid:24485249
  20. 20. Robinson MD, Oshlack A. A scaling normalization method for differential expression analysis of RNA-seq data. Genome biology. 2010;11(3):R25. pmid:20196867
  21. 21. Robinson MD, McCarthy DJ, Smyth GK. edgeR: a Bioconductor package for differential expression analysis of digital gene expression data. Bioinformatics (Oxford, England). 2010;26(1):139–40.
  22. 22. McCarthy DJ, Chen Y, Smyth GK. Differential expression analysis of multifactor RNA-Seq experiments with respect to biological variation. Nucleic acids research. 2012;40(10):4288–97. pmid:22287627
  23. 23. Anders S, Huber W. Differential expression analysis for sequence count data. Genome biology. 2010;11(10):R106. pmid:20979621
  24. 24. Björklund ÅK, Forkel M, Picelli S, Konya V, Theorell J, Friberg D, et al. The heterogeneity of human CD127+ innate lymphoid cells revealed by single-cell RNA sequencing. Nature immunology. 2016;17(4):451–460. pmid:26878113
  25. 25. Kharchenko PV, Silberstein L, Scadden DT. Bayesian approach to single-cell differential expression analysis. Nature methods. 2014;11(7):740–2. pmid:24836921
  26. 26. Finak G, McDavid A, Yajima M, Deng J, Gersuk V, Shalek AK, et al. MAST: a flexible statistical framework for assessing transcriptional changes and characterizing heterogeneity in single-cell RNA sequencing data. Genome biology. 2015;16(1):278. pmid:26653891