require(knitr) opts_chunk$set(error=FALSE, message=FALSE, warning=FALSE)
BiocStyle::markdown()
This package provides a R / Bioconductor resource to re-create plots and extend the analyses of Korthauer and Kimes et al. (2019). In this paper, methods controlling the False Discovery Rate (FDR) were applied to a collection of simulated and biological data sets to generate the benchmarking summaries provided with this package. Here, we give an example of how to load summary objects, plot results, and apply a new method to the dataset.
The package can be installed from R (version >= 3.6) using the
BiocManager
package,
available on CRAN.
if (!requireNamespace("BiocManager", quietly = TRUE)) install.packages("BiocManager") BiocManager::install("benchmarkfdrData2019")
suppressPackageStartupMessages({ library(ExperimentHub) library(benchmarkfdrData2019) library(SummarizedBenchmark) library(dplyr) library(ggplot2) library(rlang) })
In addition to the r Biocpkg("ExperimentHub")
and r Biocpkg("benchmarkfdrData2019")
packages, we also load the r Biocpkg("SummarizedBenchmark")
package. Benchmarking
results made available with this package for all case studies and simulations described
in Korthauer and Kimes et al. (2019) were created using the SummarizedBenchmark
package and are stored as SummarizedBenchmark objects.
However, note that the objects were generated using the fdrbenchmark
branch of the corresponding SummarizedBenchmark
GitHub repository, and do not include
all of the features described in newer versions of the package (e.g. available on Bioconductor).
In this vignette, we use the release version of the SummarizedBenchmark
package
available on Bioconductor.
However, the fdrbenchmark
version of the SummarizedBenchmark
package can be
installed from GitHub, again, using the BiocManager
package.
BiocManager::install("areyesq89/SummarizedBenchmark", ref = "fdrbenchmark")
The data are available for downloaded from the Bioconductor
ExperimentHub
web resource. The complete list of resources availble with the
benchmarkfdrData2019
package can be queried using the following
command.
hub <- ExperimentHub() bfdrData <- query(hub, "benchmarkfdrData2019") bfdrData
The above command only returns the metadata associated with each data object available on ExperimentHub. Individual resources must be retrieved from ExperimentHub before they can be loaded in R. Here, we retrieve and load two resource objects to illustrate the analyses that can be performed using the data available with this package.
First, we load the benchmark results for a ChIP-seq case study where differential
binding was tested using the r Biocpkg("csaw")
package with region width used
as the independent covariate. The resource is stored with the title "cbp-csaw-benchmark"
.
First, we determine the corresponding ExperimentHub ID for the resource.
cbp_id <- bfdrData$ah_id[bfdrData$title == "cbp-csaw-benchmark"] cbp_id
Using the ID, we can now access the metadata associated with the resource by
subsetting bfdrData
using single brackets ([
). Using double brackets ([[
)
will retrieve the resource from the ExperimentHub server.
bfdrData[cbp_id]
chipres <- bfdrData[[cbp_id]]
chipres
Next, we load the benchmark results from a yeast in silico RNA-seq experiment where differential expression was tested using DESeq2 with a strong (simulated) independent and informative covariate. Unlike the ChIP-seq analysis above, with the in silico experiment, we know ground truth, and therefore can evaluate FDR control as well as the true positive rate (TPR) at nominal FDR significance thresholds.
Since the in silico experiments were repeated 100 times, the data object is
a list of 100 SummarizedBenchmark objects for each replication. The resource
is stored with the title "yeast-results-de5"
. Here, we demonstrate an alternative approach
to retrieving the resource from the ExperimentHub server. Rather than subset bfdrData
using double brackets ([[
), we retrieve the resource by calling the
resource name as a function (yeast-results-de5()
). This functionality is available
for all resources available with this package (including the ChIP-seq resource
loaded above).
yeast_id <- bfdrData$ah_id[bfdrData$title == "yeast-results-de5"] bfdrData[yeast_id] yeastres <- `yeast-results-de5`() length(yeastres) yeastres[[1]]
To be able to work with the latest release of the SummarizedBenchmark
package,
we must fill in a missing slot of the SummarizedBenchmark objects.
chipres@BenchDesign <- BenchDesign() yeastres <- lapply(yeastres, function(x) { x@BenchDesign <- BenchDesign(); x })
The SummarizedBenchmark objects include the original p-values, informative covariate, and corrected significance values for the various methods compared in Korthauer and Kimes et al. (2019).
SummarizedBenchmark objects are an extension of the Bioconductor SummarizedExperiment class, with results organized as a rectangular "assay", with associated row and column metadata. Here, the rows of the objects correspond to individual hypothesis tests and the columns correspond to the approaches used for multiple testing correction.
We can take a look at the names of the methods included in the ChIP-seq results object.
colnames(chipres)
Notice that the results include the IHW and BL methods multiple times.
These ihw-
and bl-
columns correspond to separate runs of the
methods with different parameter settings. Briefly, the IHW method requires specifying an
alpha FDR threshold while running the method. Here, the method was run with alpha values of
0.01, 0.02, .., 0.10
. The BL method was run with spline degrees of freedom 2, 3, 4, 5
.
The corrected significance returned by each method is included in the single assay, "bench"
(corresponding to the benchmarked results).
dim(assay(chipres, "bench")) head(assay(chipres, "bench"))
The ASH (ashq
) results are NA
as the method was not applied to the data.
Given the multiple-testing-corrected results provided in the "bench"
assay of the
SummarizedBenchmark objects, we can take a look at several performance metrics
to compare the various methods. For the ChIP-seq case study, we can take a look at the
number of rejections at various significance cutoffs. With the in silico yeast
experiments, since truth is known, we can also look at FDR and TPR, as well as other
related metrics.
SummarizedBenchmark objects include functionality to easily add and evaluate metrics
for data stored as assays. This is performed by first adding performance metrics
with addPerformanceMetric
, followed by a call to estimatePerformanceMetrics
.
While custom performance metrics can be defined by users, the package fortunately
includes several default metrics that can be added by name.
availableMetrics()
We will add the "rejections"
metric to the "bench"
assay and compute the number
of rejections for each method at cutoffs between 0.01 and 0.10.
chipres <- addPerformanceMetric(chipres, evalMetric = "rejections", assay = "bench")
Next, we compute the number of rejections and organize this as a tidy data.frame.
chipdf <- estimatePerformanceMetrics(chipres, alpha = seq(0.01, 0.10, by = .01), tidy = TRUE) dim(chipdf) head(chipdf)
Each row in the data.frame corresponds to a method + metric + cutoff
combination
(e.g. "unadjusted" + "rejections" + "alpha = 0.01"
). This information is stored in
the "label"
, "performanceMetric"
, and "alpha"
columns, with the corresponding
metric value in the "value"
column. All other columns contain method metadata,
such as the package version, when the method was evaluated.
We will now clean up the IHW and BL methods which, as described above, include multiple parameter settings.
## subset IHW chipdf <- dplyr:::filter(chipdf, !(grepl("ihw", label) & param.alpha != alpha)) chipdf <- dplyr:::mutate(chipdf, label = gsub("(ihw)-a\\d+", "\\1", label)) ## subset BL chipdf <- dplyr:::filter(chipdf, ! label %in% paste0("bl-df0", c(2, 4, 5)))
We only keep a subset of the columns and drop NA values.
chipdf <- dplyr::select(chipdf, label, performanceMetric, alpha, value) chipdf <- dplyr::filter(chipdf, !is.na(value)) head(chipdf)
We now plot the number of rejections.
ggplot(chipdf, aes(x = alpha, y = value, color = label)) + geom_point() + geom_line() + scale_color_viridis_d("Method") + scale_x_continuous(breaks = seq(0, 1, .01), limits = c(0, .11)) + ylab("Rejections") + theme_bw() + ggtitle("Number of rejections across multiple-testing methods", "ChIP-seq CBP differential analysis with informative covariate")
We can similarly add performance metrics to each replication of the yeast in silico experiment and aggregate across replicates. We demonstrate this process using a subset of the 100 replications in the interest of computational cost.
yeastres10 <- yeastres[1:10]
As with the ChIP-seq results, we can add and evaluate performance
metrics using addPerformanceMetric
and estimatePerformanceMetrics
.
However, note that the yeast in silico results already include
several default performance metrics.
names(performanceMetrics(yeastres10[[1]])[["qvalue"]])
We can skip the process of adding performance metrics and just use these metrics.
yeastdf <- lapply(yeastres10, estimatePerformanceMetrics, alpha = seq(0.01, 0.10, by = .01), tidy = TRUE)
Finally, we merge the 10 replications to a single data.frame.
yeastdf <- dplyr::bind_rows(yeastdf, .id = "rep")
As above, we clean IHW and BL results, remove NA
values, and only keep
a subset of useful columns.
## subset IHW yeastdf <- dplyr:::filter(yeastdf, !(grepl("ihw", label) & param.alpha != alpha)) yeastdf <- dplyr:::mutate(yeastdf, label = gsub("(ihw)-a\\d+", "\\1", label)) ## subset BL yeastdf <- dplyr:::filter(yeastdf, ! label %in% paste0("bl-df0", c(2, 4, 5))) yeastdf <- dplyr::select(yeastdf, rep, label, performanceMetric, alpha, value) yeastdf <- dplyr::filter(yeastdf, !is.na(value)) head(yeastdf)
Finally, we summarize across replications for each method, for each metric, at each nominal threshold.
yeastdf <- dplyr::group_by(yeastdf, label, performanceMetric, alpha) yeastdf <- dplyr::summarize(yeastdf, meanValue = mean(value), seValue = sd(value) / sqrt(n())) yeastdf <- dplyr::ungroup(yeastdf)
Now, we can plot the average and standard errors across replicates for each method. Here, we will just plot FDR and TPR.
yeastdf %>% dplyr::filter(performanceMetric %in% c("FDR", "TPR")) %>% ggplot(aes(x = alpha, y = meanValue, color = label, ymin = meanValue - seValue, ymax = meanValue + seValue)) + geom_point() + geom_errorbar(width = .01 / 4, alpha = 1/4) + geom_line(alpha = 1/2) + scale_color_viridis_d("Method") + scale_x_continuous(breaks = seq(0, 1, .01), limits = c(0, .11)) + facet_wrap(~ performanceMetric, scales = 'free_y', nrow = 1) + ylab("average across replicates") + theme_bw() + geom_abline(aes(intercept = i_, slope = s_), color = 'red', linetype = 2, data = tibble(performanceMetric = 'FDR', i_ = 0, s_ = 1)) + ggtitle("FDR and TPR across multiple-testing methods", "yeast in silico experiment with informative covariate")
We have also included a red line to the FDR plot to assess whether methods are appropriately controlling the FDR at the nominal thresholds.
The summary objects made available with this packages were constructed using an older version
of the SummarizedBenchmark
package. Since then, functions have been added to the package
for updating benchmark comparisons and adding new methods to an existing SummarizedBenchmark
object. Unfortuntately, these functions cannot be used with the current objects made
available with this package.
However, the summary objects include both unadjusted p-values (as the unadjusted
column) and
corresponding independent covariate values (as the ind_covariate
rowData column). These values
can be used to apply new methods which only depend on these inputs.
dat <- tibble(pval = assay(chipres)[, "unadjusted"], covariate = rowData(chipres)$ind_covariate) dat
To analyze this data using the SummarizedBenchmark
package, we can
construct a new BenchDesign object with any collection of new methods
to benchmark, and the above data as input. More details on the
SummarizedBenchmark package and the BenchDesign class can be found in
the package vignettes.
As an illustration of how a new method could be applied to this data, we will re-apply the Benjamini-Hochberg correction and show that the results that we obtain in this re-analysis match the results reported in the loaded SummarizedBenchmark object.
We construct a BenchDesign with a single method, newBH
, and the data given above.
bh_method <- BDMethod(x = p.adjust, params = rlang::quos(p = pval, method = "BH")) new_design <- BenchDesign(newBH = bh_method, data = dat) new_design
To evaluate the benchmark experiment stored in the BenchDesign object, we call
buildBench
.
new_res <- buildBench(new_design) new_res
Now that we have a SummarizedBenchmark object, we can evaluate performance metrics as before.
new_res <- addPerformanceMetric(new_res, evalMetric = "rejections", assay = "default") new_df <- estimatePerformanceMetrics(new_res, alpha = seq(0.01, 0.10, by = 0.01), tidy = TRUE)
Finally, we subset on columns of interest and examine how many tests would be rejected using BH in our re-analysis.
new_df <- dplyr::select(new_df, label, value, performanceMetric, alpha) new_df
We verify that this matches the number of rejections reported in the results from above.
dplyr::filter(chipdf, label == "bh")
Since the results are now just data.frame objects with similar columns, they can be combined to compare new results with previous results.
sessionInfo()
Add the following code to your website.
For more information on customizing the embed code, read Embedding Snippets.