Contents

1 Overview

The EpiCompare package is designed to facilitate the comparison of epigenomic datasets for quality control and benchmarking purposes. The package combines several downstream analysis tools for epigenomic data and generates a single report that collates all results of the analysis. This allows users to conduct downstream analysis of multiple epigenomic datasets simultaneously and compare the results in a simple and efficient way.

1.1 Introduction

For many years, ChIP-seq has been the standard method for epigenomic profiling, but it suffers from a host of limitations. Recently, many other epigenomic technologies (e.g. CUT&Run, CUT&Tag and TIP-seq etc.), designed to overcome these constraints, have been developed. To better understand the performance of these novel approaches, it is important that we systematically compare these technologies and benchmark against a “gold-standard”.

There are many tools in R (e.g. ChIPseeker) that can be used to conduct downstream analysis and comparison of epigenomic datasets. However, these are often scattered across different packages and difficult to use for researchers with none or little computational experience.

EpiCompare is designed to provide a simple and comprehensive way of analysing and comparing epigenomic datasets. It combines many useful downstream analysis tools, which can easily be controlled by users and it collates the results in a single report. This allows researchers to systematically compare different epigenomic technologies.

While the main functionality of EpiCompare is to contrast epigenomic technologies, it can also be used to compare datasets generated using different experimental conditions and data analysis workflows of one technology. This can help researchers to establish a consensus regarding the optimal use of the method.

Currently, EpiCompare only works for human genome as it uses human-based hg19 and/or hg38 genome references.

2 Data

The EpiCompare package contains a small subset of histone mark H3K27ac profile data obtained/generated from:

It also contains human genome hg19 and hg38 blacklisted regions obtained from ENCODE. The ENCODE blacklist includes regions of the genome that have anomalous and/or unstructured signals independent of the cell-line or experiment. Removal of ENCODE blacklist is recommended for quality measure.

These dataset will be used to showcase EpiCompare functionality

3 Installation

To install the package, run the following:

if (!require("BiocManager", quietly = TRUE))
    install.packages("BiocManager")

BiocManager::install("EpiCompare") 

4 Running EpiCompare

In this example analysis, we will compare CUT&Run and CUT&Tag of histone mark H3K27ac against ENCODE ChIP-seq.

4.1 Load package and example datasets

Once installed, load the package:

library(EpiCompare)

Load example datasets used in this analysis:

data("encode_H3K27ac") # ENCODE ChIP-seq
data("CnT_H3K27ac") # CUT&Tag
data("CnR_H3K27ac") # CUT&Run
data("hg19_blacklist") # hg19 genome blacklist 
data("CnT_H3K27ac_picard") # CUT&Tag Picard summary output
data("CnR_H3K27ac_picard") # CUT&Run Picard summary output

4.2 Prepare input data

4.2.1 Peaklist

EpiCompare accepts datasets both as GRanges object and as paths to BED files. Peakfiles (GRanges or paths) that you would like to analyse must be listed and named (see below).

# To import BED files as GRanges object
peak_GRanges <-ChIPseeker::readPeakFile("/path/to/peak/file.bed",as = "GRanges")
# EpiCompare also accepts paths (to BED files) as input 
peak_path <- "/path/to/BED/file1.bed"
# Create named peak list
peaklist <- list(peak_GRanges, peak_path)
names(peaklist) <- c("sample1", "sample2")

In this example, we will use built-in data, which have been converted into GRanges object previously (CnT_H3K27ac and CnR_H3K27ac).

peaklist <- list(CnT_H3K27ac, CnR_H3K27ac) # create list of peakfiles 
names(peaklist) <- c("CnT", "CnR") # set names 

4.2.2 Blacklist

ENCODE blacklist contains regions of the genome that have anomalous and/or unstructured signals independent of the cell-line or experiment. Removal of these regions from peakfiles is recommended for quality measure.

EpiCompare has three built-in blacklist files, hg19, hg38 and mm10, downloaded from ENCODE. Run ?hg19_blacklist for more information.

In this example analysis, since all peakfiles (encode_H3K27ac, CnT_H3K27ac, CnR_H3K27ac) were generated using human genome reference build hg19, hg19_blacklist will be used. For hg38, use data(hg38_blacklist).

Please ensure that you specify the correct blacklist.

4.2.3 Picard summary files

Note that this is OPTIONAL. If you want the report to include metrics on DNA fragments (e.g. mapped fragments and duplication rate), please input summary files from Picard.

Picard MarkDuplicates can be used to mark duplicate reads that are found within the alignment. This tool outputs a metrics file with the ending .MarkDuplicates.metrics.txt. To import this text file into R as data frame, use:

picard <- read.table("/path/to/Picard/.MarkDuplicates.metrics.txt", header = TRUE, fill = TRUE)

In this example. we will use built-in data, which have been converted into data frame previously (CnT_H3K27ac_picard and CnR_H3K27ac_picard). The files must be listed and named:

# create list of Picard summary
picard <- list(CnT_H3K27ac_picard, CnR_H3K27ac_picard) 
names(picard) <- c("CnT", "CnR") # set names 

4.2.4 Reference file

This is OPTIONAL. If reference peak file is provided, stat_plot and chromHMM_plot of overlapping peaks are included in the report (see Optional plots section below).

Reference file must be listed and named. In this example, we will use built-in data (encode_H3K27ac), which has been converted to GRanges previously:

reference_peak <- list("ENCODE_H3K27ac" = encode_H3K27ac)

4.2.5 Output Directory

When running EpiCompare(), please ensure that you specify output_dir. All outputs (figures and HTML report) will be saved in the specified output_dir.

4.3 Run EpiCompare

Running EpiCompare is done using the function, EpiCompare() . Users can choose which analyses to run and include in the report by setting parameters to TRUE or FALSE.

EpiCompare(peakfiles = peaklist,
           genome_build = "hg19",
           blacklist = hg19_blacklist,
           picard_files = picard,
           reference = reference_peak,
           upset_plot = FALSE,
           stat_plot = FALSE,
           chromHMM_plot = FALSE,
           chromHMM_annotation = "K562",
           chipseeker_plot = FALSE,
           enrichment_plot = FALSE,
           tss_plot = FALSE,
           interact = FALSE,
           save_output = FALSE,
           output_filename = "EpiCompare_test",
           output_timestamp = FALSE,
           output_dir = tempdir())
## NOTE: The following EpiCompare features are NOT being used: 
##  - upset_plot=
##  - stat_plot=
##  - chromHMM_plot=
##  - chipseeker_plot=
##  - enrichment_plot=
##  - tss_plot=
##  - precision_recall_plot=
##  - corr_plot=
##  - add_download_button=
## processing file: EpiCompare.Rmd
## output file: EpiCompare.knit.md
## /usr/bin/pandoc +RTS -K512m -RTS EpiCompare.knit.md --to html4 --from markdown+autolink_bare_uris+tex_math_single_backslash --output /tmp/RtmpxgcIjF/EpiCompare_test.html --lua-filter /home/biocbuild/bbs-3.19-bioc/R/site-library/rmarkdown/rmarkdown/lua/pagebreak.lua --lua-filter /home/biocbuild/bbs-3.19-bioc/R/site-library/rmarkdown/rmarkdown/lua/latex-div.lua --self-contained --variable bs3=TRUE --section-divs --table-of-contents --toc-depth 3 --variable toc_float=1 --variable toc_selectors=h1,h2,h3 --variable toc_collapsed=1 --variable toc_smooth_scroll=1 --variable toc_print=1 --template /home/biocbuild/bbs-3.19-bioc/R/site-library/rmarkdown/rmd/h/default.html --no-highlight --variable highlightjs=1 --number-sections --variable theme=bootstrap --css custom.css --mathjax --variable 'mathjax-url=https://mathjax.rstudio.com/latest/MathJax.js?config=TeX-AMS-MML_HTMLorMML' --include-in-header /tmp/RtmpxgcIjF/rmarkdown-str25f445122e57ae.html --variable code_folding=hide --variable code_menu=1
## 
## Output created: /tmp/RtmpxgcIjF/EpiCompare_test.html
## [1] "Done in 0.13 min."
## All outputs saved to: /tmp/RtmpxgcIjF
## [1] "/tmp/RtmpxgcIjF/EpiCompare_test.html"

4.3.1 Optional plots

By default, these plots will not be included in the report unless set TRUE.

  • upset_plot : Upset plot showing the number of overlapping peaks between samples. EpiCompare uses UpSetR package.
  • stat_plot : A reference peakfile must be included for this plot. The plot displays distribution of statistical significance (q-values) of sample peaks that are overlapping/non-overlapping with the reference dataset.
  • chromHMM_plot : ChromHMM annotation of peaks. If reference is provided, ChromHMM annotation of overlapping and non-overlapping peaks with the reference is also included in the report.
  • chipseeker_plot : ChIPseeker functional annotation of peaks.
  • enrichment_plot : KEGG pathway and GO enrichment analysis of peaks.
  • tss_plot : Peak frequency around (+/- 3000bp) transcriptional start site. Note that it may take awhile to generate this plot for large sample sizes.

4.3.2 Other options

  • chromHMM_annotation : Cell-line annotation for ChromHMM. Default is K562. Options are:
    • “K562” = K-562 cells
    • “Gm12878” = Cellosaurus cell-line GM12878
    • “H1hesc” = H1 Human Embryonic Stem Cell
    • “Hepg2” = Hep G2 cell
    • “Hmec” = Human Mammary Epithelial Cell
    • “Hsmm” = Human Skeletal Muscle Myoblasts
    • “Huvec” = Human Umbilical Vein Endothelial Cells
    • “Nhek” = Normal Human Epidermal Keratinocytes
    • “Nhlf” = Normal Human Lung Fibroblasts
  • interact : By default, all heatmaps (percentage overlap and ChromHMM heatmaps) in the report will be interactive. If set FALSE, all heatmaps will be static. N.B. If interact=TRUE, interactive heatmaps will be saved as html files, which may take time for larger sample sizes.
  • output_filename : By default, the report is named EpiCompare.html. You can specify the filename of the report here.
  • output_timestamp : By default FALSE. If TRUE, the filename of the report includes the date.

4.4 Output

EpiCompare outputs

  • An HTML report consisting of three sections:
      1. General Metrics: Metrics on peaks (percentage of blacklisted and non-standard peaks, and peak widths) and fragments (duplication rate) of samples.
      1. Peak Overlap: Percentage and statistical significance of overlapping and non-overlapping peaks. Also includes upset plot.
      1. Functional Annotation: Functional annotation (ChromHMM, ChIPseeker and enrichment analysis) of peaks. Also includes peak enrichment around TSS.
  • EpiCompare_file containing all plots generated by EpiCompare if save_output = TRUE.

Both outputs are saved in the specified output_dir.

5 Future Enhancements

In the current version, EpiCompare only recognizes certain BED formats. We hope to improve this. Moreover, if there are other downstream analysis tools that may be suitable in EpiCompare, feel free to report this through Github.

6 Code used to generate the example report

An example report comparing ATAC-seq, DNase-seq and ChIP-seq of K562 can be found here.

Code used to generate this:

## Load data
# ATAC-seq data: https://www.encodeproject.org/files/ENCFF558BLC/ 
atac1_hg38 <- ChIPseeker::readPeakFile("/path/to/bed/ENCFF558BLC.bed", as="GRanges")
# Dnase-seq data: https://www.encodeproject.org/files/ENCFF274YGF/
dna1_hg38 <- ChIPseeker::readPeakFile("/path/to/bed/ENCFF274YGF.bed", as="GRanges")
# Dnase-seq data: https://www.encodeproject.org/files/ENCFF185XRG/
dna2_hg38 <- ChIPseeker::readPeakFile("/path/to/bed/ENCFF185XRG.bed", as="GRanges")
# ChIP-seq data: https://www.encodeproject.org/files/ENCFF038DDS/
chip_hg38 <- ChIPseeker::readPeakFile("/path/to/bed/ENCODE_H3K27ac_hg38_ENCFF038DDS.bed", as="GRanges")

## Peaklist
peaklist <- list("ATAC_ENCFF558BLC" = atac1_hg38_unique,
                 "Dnase_ENCFF274YGF" = dna1_hg38,
                 "ChIP_ENCFF038DDS" = chip_hg38)

## Reference
reference <- list("Dnase_ENCFF185XRG_reference"=dna2_hg38)

## Blacklist
data("hg38_blacklist")

## Run Epicompare
EpiCompare(peakfiles = peaklist,
           genome_build = "hg38",
           genome_build_output = "hg38",
           blacklist = hg38_blacklist,
           reference = reference,
           picard_files = NULL,
           upset_plot = T,
           stat_plot = T,
           save_output = F,
           chromHMM_plot = T,
           chromHMM_annotation = "K562",
           chipseeker_plot = T,
           enrichment_plot = T,
           tss_plot = T,
           precision_recall_plot =T,
           corr_plot = T,
           interact = T,
           output_dir = "/path/")

7 Session Information

utils::sessionInfo()
## R Under development (unstable) (2024-03-18 r86148)
## Platform: x86_64-pc-linux-gnu
## Running under: Ubuntu 22.04.4 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.19-bioc/R/lib/libRblas.so 
## LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.10.0
## 
## locale:
##  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
##  [3] LC_TIME=en_US.UTF-8        LC_COLLATE=en_US.UTF-8    
##  [5] LC_MONETARY=en_US.UTF-8    LC_MESSAGES=en_US.UTF-8   
##  [7] LC_PAPER=en_US.UTF-8       LC_NAME=C                 
##  [9] LC_ADDRESS=C               LC_TELEPHONE=C            
## [11] LC_MEASUREMENT=en_US.UTF-8 LC_IDENTIFICATION=C       
## 
## time zone: America/New_York
## tzcode source: system (glibc)
## 
## attached base packages:
## [1] stats     graphics  grDevices utils     datasets  methods   base     
## 
## other attached packages:
## [1] EpiCompare_1.7.5 BiocStyle_2.31.0
## 
## loaded via a namespace (and not attached):
##   [1] splines_4.4.0                          
##   [2] BiocIO_1.13.0                          
##   [3] bitops_1.0-7                           
##   [4] ggplotify_0.1.2                        
##   [5] filelock_1.0.3                         
##   [6] tibble_3.2.1                           
##   [7] polyclip_1.10-6                        
##   [8] XML_3.99-0.16.1                        
##   [9] lifecycle_1.0.4                        
##  [10] lattice_0.22-5                         
##  [11] MASS_7.3-60.2                          
##  [12] magrittr_2.0.3                         
##  [13] plotly_4.10.4                          
##  [14] sass_0.4.9                             
##  [15] rmarkdown_2.26                         
##  [16] jquerylib_0.1.4                        
##  [17] yaml_2.3.8                             
##  [18] BRGenomics_1.15.1                      
##  [19] plotrix_3.8-4                          
##  [20] cowplot_1.1.3                          
##  [21] DBI_1.2.2                              
##  [22] RColorBrewer_1.1-3                     
##  [23] lubridate_1.9.3                        
##  [24] abind_1.4-5                            
##  [25] zlibbioc_1.49.3                        
##  [26] GenomicRanges_1.55.4                   
##  [27] purrr_1.0.2                            
##  [28] ggraph_2.2.1                           
##  [29] BiocGenerics_0.49.1                    
##  [30] RCurl_1.98-1.14                        
##  [31] yulab.utils_0.1.4                      
##  [32] tweenr_2.0.3                           
##  [33] rappdirs_0.3.3                         
##  [34] GenomeInfoDbData_1.2.11                
##  [35] IRanges_2.37.1                         
##  [36] S4Vectors_0.41.4                       
##  [37] enrichplot_1.23.1                      
##  [38] ggrepel_0.9.5                          
##  [39] tidytree_0.4.6                         
##  [40] ChIPseeker_1.39.0                      
##  [41] codetools_0.2-19                       
##  [42] DelayedArray_0.29.9                    
##  [43] DOSE_3.29.2                            
##  [44] ggforce_0.4.2                          
##  [45] tidyselect_1.2.1                       
##  [46] aplot_0.2.2                            
##  [47] farver_2.1.1                           
##  [48] viridis_0.6.5                          
##  [49] base64enc_0.1-3                        
##  [50] matrixStats_1.2.0                      
##  [51] stats4_4.4.0                           
##  [52] BiocFileCache_2.11.1                   
##  [53] GenomicAlignments_1.39.4               
##  [54] jsonlite_1.8.8                         
##  [55] tidygraph_1.3.1                        
##  [56] tools_4.4.0                            
##  [57] treeio_1.27.0                          
##  [58] TxDb.Hsapiens.UCSC.hg19.knownGene_3.2.2
##  [59] Rcpp_1.0.12                            
##  [60] glue_1.7.0                             
##  [61] gridExtra_2.3                          
##  [62] SparseArray_1.3.4                      
##  [63] xfun_0.42                              
##  [64] DESeq2_1.43.4                          
##  [65] qvalue_2.35.0                          
##  [66] MatrixGenerics_1.15.0                  
##  [67] GenomeInfoDb_1.39.9                    
##  [68] dplyr_1.1.4                            
##  [69] withr_3.0.0                            
##  [70] BiocManager_1.30.22                    
##  [71] fastmap_1.1.1                          
##  [72] boot_1.3-30                            
##  [73] fansi_1.0.6                            
##  [74] caTools_1.18.2                         
##  [75] digest_0.6.35                          
##  [76] mime_0.12                              
##  [77] timechange_0.3.0                       
##  [78] R6_2.5.1                               
##  [79] gridGraphics_0.5-1                     
##  [80] seqPattern_1.35.0                      
##  [81] colorspace_2.1-0                       
##  [82] GO.db_3.18.0                           
##  [83] gtools_3.9.5                           
##  [84] RSQLite_2.3.5                          
##  [85] utf8_1.2.4                             
##  [86] tidyr_1.3.1                            
##  [87] generics_0.1.3                         
##  [88] data.table_1.15.2                      
##  [89] rtracklayer_1.63.1                     
##  [90] bsplus_0.1.4                           
##  [91] graphlayouts_1.1.1                     
##  [92] httr_1.4.7                             
##  [93] htmlwidgets_1.6.4                      
##  [94] S4Arrays_1.3.6                         
##  [95] scatterpie_0.2.1                       
##  [96] downloadthis_0.3.3                     
##  [97] pkgconfig_2.0.3                        
##  [98] gtable_0.3.4                           
##  [99] blob_1.2.4                             
## [100] impute_1.77.0                          
## [101] XVector_0.43.1                         
## [102] shadowtext_0.1.3                       
## [103] htmltools_0.5.7                        
## [104] bookdown_0.38                          
## [105] fgsea_1.29.0                           
## [106] scales_1.3.0                           
## [107] Biobase_2.63.0                         
## [108] png_0.1-8                              
## [109] ggfun_0.1.4                            
## [110] knitr_1.45                             
## [111] tzdb_0.4.0                             
## [112] reshape2_1.4.4                         
## [113] rjson_0.2.21                           
## [114] nlme_3.1-164                           
## [115] curl_5.2.1                             
## [116] cachem_1.0.8                           
## [117] stringr_1.5.1                          
## [118] BiocVersion_3.19.1                     
## [119] KernSmooth_2.23-22                     
## [120] parallel_4.4.0                         
## [121] HDO.db_0.99.1                          
## [122] AnnotationDbi_1.65.2                   
## [123] restfulr_0.0.15                        
## [124] pillar_1.9.0                           
## [125] grid_4.4.0                             
## [126] vctrs_0.6.5                            
## [127] gplots_3.1.3.1                         
## [128] dbplyr_2.5.0                           
## [129] evaluate_0.23                          
## [130] magick_2.8.3                           
## [131] readr_2.1.5                            
## [132] GenomicFeatures_1.55.4                 
## [133] cli_3.6.2                              
## [134] locfit_1.5-9.9                         
## [135] compiler_4.4.0                         
## [136] Rsamtools_2.19.4                       
## [137] rlang_1.1.3                            
## [138] crayon_1.5.2                           
## [139] labeling_0.4.3                         
## [140] plyr_1.8.9                             
## [141] fs_1.6.3                               
## [142] stringi_1.8.3                          
## [143] genomation_1.35.0                      
## [144] viridisLite_0.4.2                      
## [145] gridBase_0.4-7                         
## [146] BiocParallel_1.37.1                    
## [147] munsell_0.5.0                          
## [148] Biostrings_2.71.4                      
## [149] lazyeval_0.2.2                         
## [150] GOSemSim_2.29.1                        
## [151] Matrix_1.6-5                           
## [152] BSgenome_1.71.2                        
## [153] hms_1.1.3                              
## [154] patchwork_1.2.0                        
## [155] bit64_4.0.5                            
## [156] ggplot2_3.5.0                          
## [157] KEGGREST_1.43.0                        
## [158] highr_0.10                             
## [159] SummarizedExperiment_1.33.3            
## [160] AnnotationHub_3.11.3                   
## [161] igraph_2.0.3                           
## [162] memoise_2.0.1                          
## [163] bslib_0.6.1                            
## [164] ggtree_3.11.1                          
## [165] fastmatch_1.1-4                        
## [166] bit_4.0.5                              
## [167] ape_5.7-1