Skip to main content

wg-blimp: an end-to-end analysis pipeline for whole genome bisulfite sequencing data

Abstract

Background

Analysing whole genome bisulfite sequencing datasets is a data-intensive task that requires comprehensive and reproducible workflows to generate valid results. While many algorithms have been developed for tasks such as alignment, comprehensive end-to-end pipelines are still sparse. Furthermore, previous pipelines lack features or show technical deficiencies, thus impeding analyses.

Results

We developed wg-blimp (whole genome bisulfite sequencing methylation analysis pipeline) as an end-to-end pipeline to ease whole genome bisulfite sequencing data analysis. It integrates established algorithms for alignment, quality control, methylation calling, detection of differentially methylated regions, and methylome segmentation, requiring only a reference genome and raw sequencing data as input. Comparing wg-blimp to previous end-to-end pipelines reveals similar setups for common sequence processing tasks, but shows differences for post-alignment analyses. We improve on previous pipelines by providing a more comprehensive analysis workflow as well as an interactive user interface. To demonstrate wg-blimp’s ability to produce correct results we used it to call differentially methylated regions for two publicly available datasets. We were able to replicate 112 of 114 previously published regions, and found results to be consistent with previous findings. We further applied wg-blimp to a publicly available sample of embryonic stem cells to showcase methylome segmentation. As expected, unmethylated regions were in close proximity of transcription start sites. Segmentation results were consistent with previous analyses, despite different reference genomes and sequencing techniques.

Conclusions

wg-blimp provides a comprehensive analysis pipeline for whole genome bisulfite sequencing data as well as a user interface for simplified result inspection. We demonstrated its applicability by analysing multiple publicly available datasets. Thus, wg-blimp is a relevant alternative to previous analysis pipelines and may facilitate future epigenetic research.

Background

Since the development of DNA sequencing, a large number of studies on genetic variation have been conducted, while extensive research on the epigenetic level has only emerged in the recent past. Although most cells within an organism are identical in their genomic sequence, different tissues and cell types vary in their patterns of epigenetic modifications that confer their particular identity. DNA methylation is one of the most important epigenetic marks and occurs mainly at CpG dinucleotides. There are almost 28 million of such sites in the human genome, thus 450k arrays (which cover only 1.6% of all CpGs) are not sufficient to detect small differentially methylated regions (DMRs) [1]. As a result, data-intensive whole genome bisulfite sequencing (WGBS) is required to properly identify all CpG methylation levels. While the costs for generating these datasets have been very high, the continuous and sustained reduction of sequencing costs allows more and more WGBS datasets to be generated, creating the need for comprehensive and reproducible analysis tools. Many algorithms have already been established for different aspects of WGBS analyses such as alignment and DMR detection. However, choosing appropriate algorithms and integrating them into an end-to-end analysis workflow is not a trivial task due to combinatorial explosion of possible pipeline setups. Setting up an end-to-end WGBS analysis workflow is further hindered by different requirements of interacting tools, e.g. input and output formats or chromosome naming conventions. Previously developed end-to-end pipelines already consider these problems and only require users to supply their raw data and configuration. However, we find previous approaches to lack features required in common research settings, e.g. methylome segmentation, as well as technical limitations such as installation issues, as described in more detail in the “Results & discussion” section. As a result, we developed a pipeline approach to address these issues.

Implementation

We present here wg-blimp (whole genome bisulfite sequencing methylation analysis pipeline), a workflow for automated in silico processing of WGBS data. It consists of a comprehensive WGBS data analysis pipeline as well as a user interface for simplified inspection of datasets and potential sharing of results with other researchers. Figure 1 gives an overview of the analysis steps provided.

Fig. 1
figure 1

wg-blimp workflow overview. Users only need to provide FASTQ files and a reference genome, and wg-blimp will perform alignment, deduplication, QC checks, DMR calling, segmentation and annotation. Once the pipeline results are available, users can inspect results using a web interface

With FASTQ files and a reference genome as input, wg-blimp performs a complete workflow from alignment to DMR analysis, segmentation and annotation. We choose bwa-meth [2] for alignment as it provides efficient and robust mappings due to its internal usage of BWA-MEM [3]. We omit pre-alignment trimming of reads because of bwa-meth’s internal usage of soft-clipping to mask non-matching read subsequences. Alignments are deduplicated using the Picard toolkit [4]. Methylation calling is performed by MethylDackel [5] as it is the recommended tool for use with bwa-meth. Based on the methylation reports created by MethylDackel, wg-blimp computes global methylation statistics. Computing per-chromosome methylation is optional and enables estimation of C > T conversion rates, as unmethylated lambda DNA is commonly added to genomic DNA prior to bisulfite treatment.

For quality control (QC) we use FastQC [6] to evaluate read quality scores. Coverage reports containing information about overall and per-chromosome coverage are generated by Qualimap [7]. Qualimap also reports metrics such as GC content, duplication rate, and clipping profiles, thus enabling in-depth quality evaluation of each sample analysed. Quality reports by Picard, Qualimap and FastQC are aggregated into a single interactive HTML report using MultiQC [8].

Multiple algorithms are supported for DMR calling: metilene [9], bsseq [10] and camel [11] are frequently used tools. The application of more than one DMR calling tool is recommended, because these tools identify different, although overlapping sets of DMRs. Users may tune multiple parameters to control the number of DMR calls. Increasing the number of DMR calls usually coincides with an increased proportion of false positive calls. The parameters include the minimum number of CpG sites included in a region to be recognized as differentially methylated, minimum absolute difference in averaged methylation between the two groups compared, and minimum coverage per DMR. DMR calls by metilene also include q-values based on a Mann-Whitney U test that can be used for downstream filtering.

We further integrate detection of unmethylated regions (UMRs) and low-methylated regions (LMRs) to identifify active regulatory regions in an unbiased fashion. This segmentation is implemented using MethylSeekR [12] as it provides automatic inference of model parameters using only a user-defined false-discovery rate (FDR) and methylation cutoff. MethylSeekR also implements detection of regions of highly disordered methylation, termed partially methylated domains (PMDs). The presence of PMDs is influencing UMR/LMR detection and is often unknown a priori. As a result, wg-blimp preemptively performs the MethylSeekR workflow with and without PMD computation. Based on the metrics measured by MethylSeekR users may decide wether or not to consider PMDs when analysing UMRs and LMRs.

Resulting DMRs, UMRs, LMRs and PMDs are annotated for overlap with genes, promoters, CpG islands (CGIs) and repetitive elements as reported by Ensembl [13] and UCSC [14] databases. Average coverage per DMR is computed using mosdepth [15] to enable filtering of DMR calls in regions of low coverage.

We base the wg-blimp pipeline on the workflow execution system Snakemake [16] as it enables robust and scalable execution of analysis pipelines and prevents generation of faulty results in case of failure. Snakemake also provides run-time and memory usage logging, thus easing the search for bottlenecks and performance optimization. To minimize errors caused by changing software versions we utilize Bioconda [17] for dependency management and installation. We further provide a wg-blimp Docker container because API changes to Bioconda dependencies may temporarily break pipeline functions.

Once the analysis workflow completes, users may load the results into wg-blimp’s user interface. We implemented the interface using the R Shiny framework that enables seamless integration of R features into a reactive web app. The interface aggregates QC reports, pipeline parameters, and allows inspection and filtering of DMRs based on caller output and annotations (see Additional file 1: Figures S2-S4). UMRs and LMRs computed by MethylSeekR may also be accessed through wg-blimp’s Shiny interface, and users may dynamically choose whether or not to include PMDs (see Fig. 2). Since visualization of genomic data is often employed when inspecting analysis results, access links to alignment data for use with the Integrative Genomics Viewer (IGV) [18] are also provided, as IGV provides a bisulfite mode for use with WGBS data.

Fig. 2
figure 2

Segmentation tab of wg-blimp R Shiny GUI. Once the analysis pipeline completes, users may load results into wg-blimp’s R Shiny App. The tab depicted here displays MethylSeekR results and allows users to include or exclude PMD computation by toggling a single checkbox

Results & discussion

To evaluate wg-blimp’s relevance for WGBS experiments, we compared it to previous end-to-end pipelines and demonstrated its applicability by analysing three exemplary datasets.

Comparison to previous pipelines

Since wg-blimp only integrates published software, and exhaustive evaluation of all conceivable pipeline setups would result in combinatorial explosion, we focus here on a feature-wise comparison of pipelines, similar to [19]. We compared wg-blimp to BAT [20], bicycle [21], CpG_Me/DMRichR [10, 2224], ENCODE-DCC’s WGBS pipeline [25], Methy-Pipe [26], Nextflow methylseq (two available workflows) [27], PiGx [28] and snakePipes [19]. Pipelines were compared with regards to technical setup (installation, workflow management), WGBS read processing (adapter trimming, alignment, methylation calling, quality control), and post-alignment analyses (DMR detection, segmentation, annotation).

Table 1 gives an overview over each pipeline’s setup. Similar to snakePipes, wg-blimp utilizes Bioconda for installation. Using package managers such as Bioconda or workflow environments like Nextflow [29] not only simplifies installation for users but also provides straightforward update processes of both the pipeline itself as well as its dependencies. Thus, we recommend usage of such package managers to ensure stable runtime environments. For workflow management, we prefer using dedicated workflow management systems such as Snakemake or Nextflow over plain shell scripts, as these allow more scalable and robust execution. Users may also consider using cloud computing platforms such as DNAnexus (dnanexus.com). These platforms alleviate setting up own hardware for analysis, with the downside of users providing their data to third-party providers, thus posing potential data privacy risks.

Table 1 Comparison of WGBS end-to-end pipelines. Most pipelines use similar software for ”standard” WGBS analysis tasks such as alignment or QC. wg-blimp improves on existing pipelines by providing a more comprehensive workflow as well as an interactive user interface

For read processing, wg-blimp employs similar strategies as other pipelines, with popular alignment and methylation calling tools being bwa-meth/MethylDackel and Bismark [24]. However, wg-blimp deviates from other pipelines by skipping read trimming, which is handled by BWA-MEM’s soft-clipping. For QC we recommend using MultiQC as it produces HTML quality reports in a compact and scalable way. We omitted the details about which metrics are collected by MultiQC for each pipeline, as the pipelines investigated use common tools such as Picard or sambamba [30] (with the exception of BAT, bicycle and Methy-Pipe).

While most of the pipelines investigated use similar tools for read processing, setups differ for post-alignment analyses. For DMR detection, we pursue a similar setup as snakePipes and BAT by providing multiple DMR callers. wg-blimp and PiGx are the only workflows to perform methylome segmentation. We prefer MethylSeekR over methylKit for segmentation because of its consideration of PMDs.

We further added functionality over other pipelines by implementing an interactive R Shiny GUI. Users may load one or more analysis runs into the Shiny App, thus providing a straightforward way to create a central repository for analysis results to share with fellow researchers. This not only makes distributing individual files unnecessary but also enables a more concise inspection of results. For example, users may switch between segmentation with and without consideration of PMDs using MethylSeekR by toggling a single checkbox instead of having to inspect multiple files. An example of wg-blimp’s interface displaying MethylSeekR results is given in Fig. 2. More GUI features are discussed in detail in the Supplementary Material.

We applied the pipelines to a public WGBS dataset to assess run times for performing an end-to-end WGBS analysis, as described in detail in the Supplementary Material. In brief, wg-blimp showed a run time comparable to other pipelines using bwa-meth/MethylDackel for alignment and methylation calling. We encountered technical issues with several pipelines when running these analyses. As a result we recommend users to perform test runs prior to using published pipelines in active research environments.

While we provide additional functionality over previous WGBS pipelines, we would like to emphasize that wg-blimp should not be seen as a replacement for previous approaches, but rather as an extension to the landscape of available workflows. snakePipes, for example, not only provides a WGBS analysis workflow, but is also capable of performing integrative analyses on ChIP-seq, RNA-seq, ATAC-seq, Hi-C and single-cell RNA-seq data. As a result, snakePipes should be preferred over wg-blimp in experiments that aim at integrating different epigenomic assays. In contrast, we prefer wg-blimp over snakePipes for WGBS-only experiments that aim at determining active regulatory regions due to its implementation of segmentation and simplified dataset inspection through its GUI. Thus, when deciding which analysis workflow to choose for a WGBS experiment, we believe there is no ”one-fits-all” solution, and we deem wg-blimp one suitable option to consider for future WGBS analyses.

Application to published datasets

We applied wg-blimp to three exemplary publicly available WGBS datasets. Two of these datasets were utilized to demonstrate wg-blimp’s DMR calling capabilities and a third to demonstrate methylome segmentation. All analyses were executed on a server equipped with two Intel Xeon E5-2695 v4 CPU’s, 528 GB of memory and Debian 9 as operating system (OS). 64 threads were allocated for each analysis.

DMR detection

One of the DMR datasets consists of two pairs of isogenic human monocyte and macrophage samples [31], the other of two pairs of isogenic human blood and sperm samples (each generated from pools of DNA from six men) [32]. We chose these two datasets to demonstrate wg-blimp’s capability of calling DMRs for cases where few (monocytes vs. macrophages) or many (blood vs. sperm) DMRs are expected due to the degree of relatedness between compared groups.

For the monocyte/macrophage dataset we chose hg38 as reference and used a coverage of at least 5 ×, at least 4 CpG sites overlapping, and a minimum absolute difference of 0.3 as thresholds for DMR calling. We detected 6,189 DMRs in total, with 4,078 DMRs overlapping genes and 886 DMRs overlapping promoter regions. We were able to recover 112 of the original 114 DMRs reported, even though [31] used hg19 as reference genome and only BSmooth for DMR calling. Most of these DMRs are outside of CpG islands (6,009 DMRs) and lose DNA methylation during differentiation (5,765 DMRs), which is consistent with the original findings [31]. Excluding indexing of the reference genome, the whole analysis workflow from FASTQ files to annotated DMRs took 38.87 hours in total. A maximum memory usage of 216.07 GB was reached for bsseq DMR calling (Supplementary Material). bwa-meth alignment was the most time consuming step with a run time of 27.81 hours for a single sample using 16 threads.

For the blood/sperm dataset we used wg-blimp to determine soma-germ cell specific methylation differences. We found 410,247 DMRs (≥ 4 CpGs, ≥ 0.3 absolute difference, ≥5× coverage), of which 192,953 overlap with genes, 58,183 with promoters and 10,150 with CpG islands. As expected, the number of DMRs is much higher compared to the monocyte/macrophage dataset. Executing the whole workflow required 30.61 hours in total with a maximum memory usage of 208.83 GB.

Methylome segmentation

We applied wg-blimp to a single WGBS sequencing run of H1 embryonic stem cells (ESCs) [33, 34] (SRA accession SRP072141) to demonstrate segmentation using MethylSeekR. We chose H1 embyronic stem cells to compare our integrated segmentation to the results of the original MethylSeekR authors that, among other cell types, also analyzed H1 ESCs [12]. FDR cutoff was set to 5% and methylation cutoff to 50% (default values). PMDs were not considered because alpha distribution values did not suggest PMD presence in this methylome (see Supplementary Material). In total, 18,930 UMRs and 31,748 LMRs were detected.

To evaluate segmentation results, we computed each segment center’s distance to the nearest transcription start site (TSS) as reported by Ensembl [13]. Figure 3 depicts separability of UMRs and LMRs with regards to TSS distances. As expected, most UMRs are in close proximity of a TSS, indicating activity in regulatory regions. Our results are in line with the original findings that also found no PMD presence and UMRs mostly overlapping promoter regions for H1 ESCs [12], despite differences in reference genomes and sequencing strategies.

Fig. 3
figure 3

Distance from UMR/LMR centers to closest TSS for H1 ESCs. UMRs/LMRs were automatically inferred using wg-blimp’s MethylSeekR integration. UMRs and LMRs show a clear separation, with most UMRs being located in close proximity of TSSs

Excluding reference genome indexing, executing the whole wg-blimp workflow from alignment to segmentation required 11.05 hours to complete. Alignment was the most time consuming step with a run time of 5.72 hours. Maximum memory usage of 168.76 GB was reached by MethylSeekR.

Conclusions

wg-blimp implements a WGBS analysis workflow, improving on previous WGBS pipelines by providing simple installation and usage as well as a more extensive set of features. In addition to the analysis workflow wg-blimp includes a reactive R Shiny web interface for simplified inspection and sharing of results. wg-blimp is capable of producing coherent results, as demonstrated by analysing three publicly available datasets. We believe wg-blimp to be an apt alternative to previous WGBS analysis pipelines and hope to ease handling WGBS datasets for fellow researchers, and thus benefit the field of epigenetic research.

Availability and requirements

Project name: wg-blimp Project home page:https://github.com/MarWoes/wg-blimp Operating system(s): UNIX Programming language: Python, R Other requirements: Conda or Docker installation License: AGPL-3.0 Any restrictions to use by non-academics: AGPL-3.0 conditions apply

Availability of data and materials

wg-blimp source code is available at the following GitHub repository: https://github.com/MarWoes/wg-blimp.

Abbreviations

CGI:

CpG island

DMR:

differentially methylated region

ESC:

embryonic stem cell

FDR:

false-discovery rate

LMR:

low-methylated region

PMD:

partially methylated domain

QC:

quality control

TSS:

transcription start site

UMR:

unmethylated region

WGBS:

whole genome bisulfite sequencing

References

  1. Schröder C, Leitão E, Wallner S, Schmitz G, Klein-Hitpass L, Sinha A, Jöckel K-H, Heilmann-Heimbach S, Hoffmann P, Nöthen MM, et al.Regions of common inter-individual dna methylation differences in human monocytes: genetic basis and potential function. Epigenetics Chromatin. 2017; 10(1):37. https://doi.org/10.1186/s13072-017-0144-2.

  2. Pedersen BS, Eyring K, De S, Yang IV, Schwartz DA. Fast and accurate alignment of long bisulfite-seq reads. arXiv preprint arXiv:1401.1129. 2014.

  3. Li H. Aligning sequence reads, clone sequences and assembly contigs with bwa-mem. arXiv preprint arXiv:1303.3997. 2013.

  4. Broad Institute. Picard toolkit. 2019. http://broadinstitute.github.io/picard/. Accessed 13 Nov 2019.

  5. Ryan DP. MethylDackel. 2019. https://github.com/dpryan79/methyldackel. Accessed 13 Nov 2019.

  6. Andrews S. FastQC: A quality control tool for high throughput sequence data. 2019. http://www.bioinformatics.bbsrc.ac.uk/projects/fastqc. Accessed 13 Nov 2019.

  7. Okonechnikov K, Conesa A, García-Alcalde F. Qualimap 2: advanced multi-sample quality control for high-throughput sequencing data. Bioinformatics. 2015; 32(2):292–4.

    PubMed  PubMed Central  Google Scholar 

  8. Ewels P, Magnusson M, Lundin S, Käller M. MultiQC: summarize analysis results for multiple tools and samples in a single report. Bioinformatics. 2016; 32(19):3047–8. https://doi.org/10.1093/bioinformatics/btw354.

    Article  CAS  Google Scholar 

  9. Jühling F, Kretzmer H, Bernhart SH, Otto C, Stadler PF, Hoffmann S. metilene: Fast and sensitive calling of differentially methylated regions from bisulfite sequencing data. Genome Res. 2016; 26(2):256–62.

    Article  Google Scholar 

  10. Hansen KD, Langmead B, Irizarry RA. BSmooth: from whole genome bisulfite sequencing reads to differentially methylated regions. Genome Biol. 2012; 13(10):83.

    Article  Google Scholar 

  11. Schröder C. Bioinformatics from genetic variants to methylation. PhD thesis: Technische Universität Dortmund; 2018. https://doi.org/10.17877/de290r-19925. https://eldorado.tu-dortmund.de/handle/2003/37940.

  12. Burger L, Gaidatzis D, Schübeler D, Stadler MB. Identification of active regulatory regions from DNA methylation data. Nucleic Acids Res. 2013; 41(16):155. https://doi.org/10.1093/nar/gkt599.

    Article  Google Scholar 

  13. Cunningham F, Achuthan P, Akanni W, Allen J, Amode MR, Armean IM, Bennett R, Bhai J, Billis K, Boddu S, et al.Ensembl 2019. Nucleic Acids Res. 2018; 47(D1):745–51.

    Article  Google Scholar 

  14. Haeussler M, Zweig AS, Tyner C, Speir ML, Rosenbloom KR, Raney BJ, Lee CM, Lee BT, Hinrichs AS, Gonzalez JN, et al.The UCSC Genome Browser database: 2019 update. Nucleic Acids Res. 2018; 47(D1):853–8. https://doi.org/10.1093/nar/gky1095.

    Article  Google Scholar 

  15. Pedersen BS, Quinlan AR. Mosdepth: quick coverage calculation for genomes and exomes. Bioinformatics. 2017; 34(5):867–8. https://doi.org/10.1093/bioinformatics/btx699.

  16. Köster J, Rahmann S. Snakemake–a scalable bioinformatics workflow engine. Bioinformatics (Oxford, England). 2012; 28(19):2520–2. https://doi.org/10.1093/bioinformatics/bts480.

  17. Grüning B, Dale R, Sjödin A, Chapman BA, Rowe J, Tomkins-Tinch CH, Valieris R, Köster J. Bioconda: sustainable and comprehensive software distribution for the life sciences. Nat Methods. 2018; 15:475–6.

    Article  Google Scholar 

  18. Robinson JT, Thorvaldsdóttir H, Wenger AM, Zehir A, Mesirov JP. Variant review with the integrative genomics viewer. Cancer Res. 2017; 77(21):31–4. https://doi.org/10.1158/0008-5472.CAN-17-0337.

  19. Bhardwaj V, Heyne S, Sikora K, Rabbani L, Rauer M, Kilpert F, Richter AS, Ryan DP, Manke T. snakePipes: facilitating flexible, scalable and integrative epigenomic analysis. Bioinformatics. 2019. https://doi.org/10.1093/bioinformatics/btz436.

  20. Kretzmer H, Otto C, Hoffmann S. BAT: Bisulfite analysis toolkit [version 1; peer review: 3 approved]. F1000Research. 2017; 6(1490). https://doi.org/10.12688/f1000research.12302.1.

  21. Graña O, López-Fernández H, Fdez-Riverola F, González Pisano D, Glez-Peña D. Bicycle: a bioinformatics pipeline to analyze bisulfite sequencing data. Bioinformatics. 2017; 34(8):1414–5. https://doi.org/10.1093/bioinformatics/btx778.

    Article  Google Scholar 

  22. Laufer BI, Hwang H, Ciernia AV, Mordaunt CE, LaSalle JM. Whole genome bisulfite sequencing of down syndrome brain reveals regional dna hypermethylation and novel disorder insights. Epigenetics. 2019; 14(7):672–84. https://doi.org/10.1080/15592294.2019.1609867.

    Article  Google Scholar 

  23. Korthauer K, Chakraborty S, Benjamini Y, Irizarry RA. Detection and accurate false discovery rate control of differentially methylated regions from whole genome bisulfite sequencing. Biostatistics. 2018; 20(3):367–83. https://doi.org/10.1093/biostatistics/kxy007.

    Article  Google Scholar 

  24. Krueger F, Andrews SR. Bismark: a flexible aligner and methylation caller for Bisulfite-Seq applications. Bioinformatics. 2011; 27(11):1571–2. https://doi.org/10.1093/bioinformatics/btr167.

    Article  CAS  Google Scholar 

  25. Davis CA, Hitz BC, Sloan CA, Chan ET, Davidson JM, Gabdank I, Hilton JA, Jain K, Baymuradov UK, Narayanan AK, Onate KC, Graham K, Miyasato SR, Dreszer TR, Strattan JS, Jolanki O, Tanaka FY, Cherry JM. The Encyclopedia of DNA elements (ENCODE): data portal update. Nucleic Acids Res. 2017; 46(D1):794–801. https://doi.org/10.1093/nar/gkx1081.

    Article  Google Scholar 

  26. Jiang P, Sun K, Lun FMF, Guo AM, Wang H, Chan KCA, Chiu RWK, Lo YMD, Sun H. Methy-pipe: An integrated bioinformatics pipeline for whole genome bisulfite sequencing data analysis. PLOS ONE. 2014; 9(6):1–11. https://doi.org/10.1371/journal.pone.0100360.

    Google Scholar 

  27. Ewels P., Hammarén R., Peltzer A., Hüther P., F. S., Tommaso P. D., Garcia M., Alneberg J., Wilm A.Alessia nf-core/methylseq: nf-core/methylseq version 1.3. Zenodo. 2019. https://doi.org/10.5281/zenodo.2555454.

  28. Gosdschan A, Wreczycka K, Osberg B, Wurmus R. PiGx. 2019. https://github.com/BIMSBbioinfo/pigx_bsseq. Accessed 13 Nov 2019.

  29. Di Tommaso P, Chatzou M, Floden EW, Barja PP, Palumbo E, Notredame C. Nextflow enables reproducible computational workflows. Nat Biotechnol. 2017; 35(4):316.

    Article  CAS  Google Scholar 

  30. Tarasov A, Vilella AJ, Cuppen E, Nijman IJ, Prins P. Sambamba: fast processing of NGS alignment formats. Bioinformatics. 2015; 31(12):2032–4. https://doi.org/10.1093/bioinformatics/btv098.

    Article  CAS  Google Scholar 

  31. Wallner S., Schröder C., Leitão E., Berulava T., Haak C., Beißer D., Rahmann S., Richter A. S., Manke T., Bönisch U., et al. Epigenetic dynamics of monocyte-to-macrophage differentiation. Epigenetics Chromatin. 2016; 9(1):33. https://doi.org/10.1186/s13072-016-0079-z.

    Article  Google Scholar 

  32. Laurentino S, Cremers J-F, Horsthemke B, Tuettelmann F, Czeloth K, Zitzmann M, Pohl E, Rahmann S, Schroeder C, Berres S, Redmann K, Krallmann C, Schlatt S, Kliesch S, Gromoll J. Healthy ageing men have normal reproductive function but display germline-specific molecular changes. medRxiv. 2019. https://doi.org/10.1101/19006221.

  33. Jenkinson G., Pujadas E., Goutsias J., Feinberg A. P.Potential energy landscapes identify the information-theoretic nature of the epigenome. Nat Genet. 2017; 49(5):719.

    Article  CAS  Google Scholar 

  34. Schlaeger TM, Daheron L, Brickler TR, Entwisle S, Chan K, Cianci A, DeVine A, Ettenger A, Fitzgerald K, Godfrey M, et al.A comparison of non-integrating reprogramming methods. Nat Biotechnol. 2015; 33(1):58.

    Article  CAS  Google Scholar 

Download references

Acknowledgements

We thank Professor Martin Dugas for support.

Funding

This work was supported by the German Federal Ministry of Education and Research under the project Number 01KU1216 (Deutsches Epigenom Programm, DEEP) and the German Research Foundation (Clinical Research Unit CRU326 ’Male Germ Cells’: DFG grants TU 298/5-1 and HO 949/23-1 as well as DFG grant GR 1547/19-1). The funding bodies had no role in the design of the study and collection, analysis, and interpretation of data and in writing the manuscript.

Author information

Authors and Affiliations

Authors

Contributions

MW developed the software and prepared the final version of the manuscript. EL, BH and SL reviewed analysis output and provided feedback for subsequent improvement of the software. SL further provided novel data to test the pipeline with. SR and CS tested the software and provided feedback for subsequent improvement of the software. CS provided suggestions for best-practise WGBS analysis. All authors provided feedback on the manuscript and read and approved the final version of the manuscript.

Corresponding author

Correspondence to Marius Wöste.

Ethics declarations

Ethics approval and consent to participate

Not applicable.

Consent for publication

Not applicable.

Competing interests

The authors declare that they have no competing interests.

Additional information

Publisher’s Note

Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Supplementary information

Additional file 1

Supplementary Material

Rights and permissions

Open Access This article is licensed under a Creative Commons Attribution 4.0 International License, which permits use, sharing, adaptation, distribution and reproduction in any medium or format, as long as you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons licence, and indicate if changes were made. The images or other third party material in this article are included in the article’s Creative Commons licence, unless indicated otherwise in a credit line to the material. If material is not included in the article’s Creative Commons licence and your intended use is not permitted by statutory regulation or exceeds the permitted use, you will need to obtain permission directly from the copyright holder. To view a copy of this licence, visit http://creativecommons.org/licenses/by/4.0/. The Creative Commons Public Domain Dedication waiver (http://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated in a credit line to the data.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Wöste, M., Leitão, E., Laurentino, S. et al. wg-blimp: an end-to-end analysis pipeline for whole genome bisulfite sequencing data. BMC Bioinformatics 21, 169 (2020). https://doi.org/10.1186/s12859-020-3470-5

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/s12859-020-3470-5

Keywords