systemPipeR 2.16.3
This workflow template is designed for analyzing VAR-Seq data by identifying
and annotating genomic variants (SNPs and Indels) via read alignment, GATK
variant calling, and SnpEff annotation. It is provided by systemPipeRdata, a
companion package to systemPipeR (H Backman and Girke 2016). Consistent with other
systemPipeR workflow templates, a single command initializes the necessary
working environment. This includes the expected directory structure for
executing systemPipeR workflows and parameter files for running the
command-line (CL) software utilized in specific analysis steps.
To facilitate easy testing, the template utilizes eight paired-end human
whole-exome FASTQ files from the 1000 Genomes Project. The dataset comprises
four male and four female samples (for details see below targets table),
which are downloaded at the beginning alongside the human reference genome
and annotations. A moderately sized exome dataset was selected to minimize
runtime, enabling users to execute the numerous steps of this relatively
complex workflow from start to finish without extensive computational
overhead.
Upon successful testing, users have the flexibility to apply this template to their own data or modify it to suit specific research needs. For more comprehensive information on designing and executing workflows, users want to refer to the main vignettes of systemPipeR and systemPipeRdata.
The Rmd file (systemPipeVARseq.Rmd) associated with this vignette serves a dual
purpose: it acts as a template for executing the workflow and as a framework
for generating a reproducible scientific analysis report. Thus, users
want to customize the text (and/or code) of this vignette to reflect
their specific experimental design and analysis results. This customization
typically involves removing the instructional content on how to use the
workflow and replacing it with detailed descriptions of the experimental
design, relevant metadata, and analysis findings.
In this section, users should describe the sources and versions of the
reference genome sequence and corresponding annotations. The standard
systemPipeR directory structure (detailed
here)
expects input data to be located in a subdirectory named data, while all
results are written to a separate results directory. The Rmd source file
for executing the workflow and rendering the report (in this case,
systemPipeVARseq.Rmd) is expected to reside in the parent directory.
To transition from testing to production, the provided test data should be deleted and replaced with the custom data in the corresponding locations.
Alternatively, a fresh environment skeleton can be created (named new
here)
or built from scratch. To perform a VAR-Seq analysis with new FASTQ files using
the same reference genome, the only requirements are the FASTQ files and a
corresponding experimental design file, known as the targets file. The
structure and utility of targets files is described in systemPipeR's main
vignette
here.
The default analysis steps included in this VAR-Seq workflow template are
outlined here. To visualize the workflow structure, the plotWF function
generates a topology graph (see below) that depicts the dependencies and
execution order of all analysis steps. Users can modify the existing steps, add
new ones or remove steps as needed.
Default analysis steps
BWA-MEM (or any other DNA aligner)GATK, substeps 1-10GATKSnpEffThe environment for this VAR-Seq workflow is auto-generated below with the
genWorkenvir function (selected under workflow="varseq"). It is fully
populated with the expected directories and parameter files. It also provides
the source Rmd of this vignette (systemPipeVARseq.Rmd). The name of the resulting workflow directory
can be specified under the mydirname argument. The default NULL uses the
name of the chosen workflow. An error is issued if a directory of the same
name and path exists already. After this, the user’s R session needs to be
directed into the resulting varseq directory (here with setwd).
library(systemPipeRdata)
genWorkenvir(workflow = "varseq", mydirname = "varseq")
setwd("varseq")
The sample data for testing the workflow are downloaded next, including FASTQ files, reference genome and annotation data. For instructional purposes, the input data download is currently executed separately rather than being incorporated as a workflow step. However, these downloads can be seamlessly integrated into the actual workflow if required.
targets <- read.delim(system.file("extdata", "workflows", "varseq",
"targetsPE_varseq.txt", package = "systemPipeRdata"), comment.char = "#")
source("VARseq_helper.R") # temp file
options(timeout = 3600) # increase time limit for downloads
commands <- varseq_example_fastq(targets)
for (cmd in commands) eval(parse(text = cmd))
download_ref(ref = "hg38.fa.gz")
download_tool(tool = "snpEff_latest")
targets fileThe targets file defines the input files (e.g. FASTQ or BAM) and optional
sample comparisons used in a data analysis workflow. It can also store any number
of additional descriptive information for each sample. The following shows
the first four lines of the targets file used in this workflow template.
Users should note that this specific file, named targetsPE_varseq.txt, is
located in the workflow’s root directory. For demonstration purposes, the
command below retrieves this file directly from the installed package.
targetspath <- system.file("extdata", "workflows", "varseq",
"targetsPE_varseq.txt", package = "systemPipeRdata")
targets <- read.delim(targetspath, comment.char = "#")
targets[1:4, -(5:8)]
## FileName1 FileName2
## 1 ./data/SRR769545_1.fastq.gz ./data/SRR769545_2.fastq.gz
## 2 ./data/SRR768527_1.fastq.gz ./data/SRR768527_2.fastq.gz
## 3 ./data/SRR070795_1.fastq.gz ./data/SRR070795_2.fastq.gz
## 4 ./data/SRR070790_1.fastq.gz ./data/SRR070790_2.fastq.gz
## SampleName Factor
## 1 HG00152 male
## 2 HG00234 male
## 3 HG00188 male
## 4 HG00190 male
To work with custom data, users need to generate a targets file containing
the paths to their own FASTQ files. Here
is a detailed description of the structure and utility of targets files.
After a workflow environment has been created with the above genWorkenvir
function call and the corresponding R session directed into the resulting directory (here varseq),
the SPRproject function is used to initialize a new workflow project instance. The latter
creates an empty SAL workflow management object (below sal) and at the same time a
linked project log directory (default name .SPRproject) that acts as a
flat-file database of a workflow. Additional details about this process and
the SAL workflow control class are provided in systemPipeR's main vignette
here
and here.
Next, the importWF function loads all the workflow steps defined in the
source Rmd file of this vignette (here systemPipeVARseq.Rmd) into the SAL workflow
management object. An overview of the workflow steps and their status information can be returned
at any stage of the load or run process by typing sal.
library(systemPipeR)
sal <- SPRproject()
# sal <- SPRproject(resume=TRUE, load.envir=TRUE) # to
# resume workflow if needed
sal <- importWF(sal, file_path = "systemPipeVARseq.Rmd", verbose = FALSE)
sal
After loading the workflow into sal, it can be executed from start to finish
(or partially) with the runWF command. Running the workflow will only be
possible if all dependent CL software is installed on the system where the
workflow will be executed. Their names and availability on a system can
be listed with listCmdTools(sal, check_path=TRUE). For more information
about the runWF command, refer to the help file and the corresponding
section in the main vignette
here.
Running workflows in parallel mode on computer clusters is a straightforward
process in systemPipeR. Users can simply append the resource parameters (such
as the number of CPUs) for a cluster run to the sal object after importing
the workflow steps with importWF using the addResources function. More
information about parallelization can be found in the corresponding section at
the end of this vignette here and in the main vignette
here.
sal <- runWF(sal)
Workflows can be visualized as topology graphs using the plotWF function.
This creates an interactive plot with run status information for each step.
plotWF(sal)
Figure 1: Toplogy graph of VAR-Seq workflow
Scientific and technical reports can be generated with the renderReport and
renderLogs functions, respectively. Scientific reports can also be generated
with the render function of the rmarkdown package. The latter allows to
include changes made to the Rmd file after workflow load into SAL, whereas
the former uses the original version. The technical reports are based on log
information that systemPipeR collects during workflow runs.
# Scientific report
sal <- renderReport(sal)
rmarkdown::render("systemPipeVARseq.Rmd", clean = TRUE, output_format = "BiocStyle::html_document")
# Technical (log) report
sal <- renderLogs(sal)
The statusWF function returns a status summary for each step in a SAL
workflow instance.
statusWF(sal)
While SAL objects are autosaved when working with workflows, it can be
sometimes safer to explicity save the object before closing R.
# sal <- write_SYSargsList(sal)
The data analysis steps of this workflow are defined by the following workflow code chunks.
They can be loaded into SAL interactively, by executing the code of each step in the
R console, or all at once with the importWF function used under the Quick start section.
R and CL workflow steps are declared in the code chunks of Rmd files with the
LineWise and SYSargsList functions, respectively, and then added to the SAL workflow
container with appendStep<-. Only code chunks with spr=TRUE in their argument line
will be recognized as workflow steps and loaded into the provided SAL workflow
container. The syntax and usage of workflow step defintions is described
here.
The first step loads the systemPipeR package.
cat(crayon::blue$bold("To use this workflow, following R packages are expected:\n"))
cat(c("'ggplot2', 'dplyr'\n"), sep = "', '")
### pre-end
appendStep(sal) <- LineWise(code = {
library(systemPipeR)
}, step_name = "load_SPR")
This step executes FastQC, a standard quality control tool for
high-throughput sequence data. It provides critical insights into
potential data issues, such as low-quality bases, sequence biases, and
contamination. These quality metrics are summarized in easy-to-interpret plots and
reports, enabling a rapid assessment of raw sequencing data quality. The
resulting analysis files (including one HTML report and one ZIP archive per
FASTQ file) are stored in the workflow’s results directory. The quality
reports are useful to determine whether adapter trimming, quality filtering
or other read preprocessing steps are required.
appendStep(sal) <- SYSargsList(step_name = "fastqc", targets = "targetsPE_varseq.txt",
wf_file = "fastqc/workflow_fastqc.cwl", input_file = "fastqc/fastqc.yml",
dir_path = "param/cwl", inputvars = c(FileName1 = "_FASTQ_PATH1_",
FileName2 = "_FASTQ_PATH2_"), dependency = "load_SPR")
The seeFastq utility, an integral component of the systemPipeR package,
provides an alternative approach for read quality assessment. By utilizing
the seeFastq and seeFastqPlot functions, this step generates and
visualizes a comprehensive suite of quality statistics for the workflow’s
FASTQ files. Evaluated metrics include per cycle quality box plots, base
proportions, base-level quality trends, relative k-mer diversity, length, and
occurrence distribution of reads, number of reads above quality cutoffs and
mean quality distribution. For easy comparison it can plot the metrics of all
FASTQ files next to each other. The plot can be exported to various image
formats, such as the fastqReport_varseq.png file generated in this example.
For a more in-depth explanation of these visual components and usage
instructions, refer to the package documentation (via ?seeFastq or
?seeFastqPlot).
appendStep(sal) <- LineWise(code = {
fastq1 <- getColumn(sal, step = "fastqc", "targetsWF", column = 1)
fastq2 <- getColumn(sal, step = "fastqc", "targetsWF", column = 2)
fastq <- setNames(c(rbind(fastq1, fastq2)), c(rbind(names(fastq1),
names(fastq2))))
fqlist <- seeFastq(fastq = fastq, batchsize = 1000, klength = 8)
png("./results/fastqReport_varseq.png", height = 650, width = 288 *
length(fqlist))
seeFastqPlot(fqlist)
dev.off()
}, step_name = "fastq_report", dependency = "fastqc")
The read preprocessing steps in this section are included primarily to demonstrate how various preprocessing tools can be integrated into the workflow. However, it is important to note that the resulting trimmed reads are not utilized in the subsequent analysis steps of this workflow demonstration. For pipelines involving GATK, while adapter trimming may be beneficial, quality trimming is explicitly discouraged. This is because GATK possesses internal trimming utilities and utilizes the original low-quality base information to improve the accuracy of its probabilistic models.
This step demonstrates the usage of Trimmomatic (Bolger, Lohse, and Usadel 2014),
a widely used tool for trimming and cleaning FASTQ files. The SYSargsList
function is utilized to process the configuration files (cwl/yml) that define
the command-line instructions for Trimmomatic. Users can retrieve the exact
command-line strings for this or any other workflow step using the cmdlist()
function. For further details, please consult the main vignette
here.
appendStep(sal) <- SYSargsList(step_name = "trimmomatic", targets = "targetsPE_varseq.txt",
wf_file = "trimmomatic/trimmomatic-pe.cwl", input_file = "trimmomatic/trimmomatic-pe.yml",
dir_path = "param/cwl", inputvars = c(FileName1 = "_FASTQ_PATH1_",
FileName2 = "_FASTQ_PATH2_", SampleName = "_SampleName_"),
dependency = c("load_SPR"), run_step = "optional")
Alternatively, the function preprocessReads allows to apply predefined or custom
read preprocessing functions to the FASTQ files referenced in a
SYSargsList container, such as quality filtering or adaptor trimming
routines. Internally, preprocessReads uses the FastqStreamer function from
the ShortRead package to stream through large FASTQ files in a
memory-efficient manner. The following example performs adaptor trimming with
the trimLRPatterns function from the Biostrings package.
The parameters for this step are defined in the corresponding cwl/yml files.
appendStep(sal) <- SYSargsList(step_name = "preprocessing", targets = "targetsPE_varseq.txt",
dir = TRUE, wf_file = "preprocessReads/preprocessReads-pe.cwl",
input_file = "preprocessReads/preprocessReads-pe.yml", dir_path = "param/cwl",
inputvars = c(FileName1 = "_FASTQ_PATH1_", FileName2 = "_FASTQ_PATH2_",
SampleName = "_SampleName_"), dependency = c("load_SPR"),
run_step = "optional")
The NGS reads from this project are aligned to the reference genome sequence utilizing BWA-MEM (Li 2013; Li and Durbin 2009), a short-read aligner known for its high tolerance of sequence variants. As noted previously, quality trimming is not recommended for GATK workflows; consequently, the untrimmed FASTQ files are employed for this alignment step, while the trimmed versions generated in the optional preprocessing step are disregarded.
Prior to performing BWA alignment and variant calling with GATK, it is necessary to generate the required index files. The following three steps build the BWA index, along with the FASTA sequence dictionary and the FASTA index, which are essential prerequisites for read mapping and downstream variant analysis.
Construct BWA index for reference genome.
appendStep(sal) <- SYSargsList(step_name = "bwa_index", dir = FALSE,
targets = NULL, wf_file = "gatk/workflow_bwa-index.cwl",
input_file = "gatk/gatk.yaml", dir_path = "param/cwl", dependency = "load_SPR")
Construct FASTA sequence dictionary of reference genome (.dict file) required by GATK.
appendStep(sal) <- SYSargsList(step_name = "fasta_index", dir = FALSE,
targets = NULL, wf_file = "gatk/workflow_fasta_dict.cwl",
input_file = "gatk/gatk.yaml", dir_path = "param/cwl", dependency = "bwa_index")
Create corresponding dictionary index.
appendStep(sal) <- SYSargsList(step_name = "faidx_index", dir = FALSE,
targets = NULL, wf_file = "gatk/workflow_fasta_faidx.cwl",
input_file = "gatk/gatk.yaml", dir_path = "param/cwl", dependency = "fasta_index")
This steps aligns the reads to the reference genome using BWA-MEM.
The parameter settings of the aligner are defined in the cwl/yml files
used in the following code chunk. The following shows how to construct the
alignment step and append it to the SAL workflow container.
appendStep(sal) <- SYSargsList(step_name = "bwa_alignment", targets = "targetsPE_varseq.txt",
wf_file = "gatk/workflow_bwa-pe.cwl", input_file = "gatk/gatk.yaml",
dir_path = "param/cwl", inputvars = c(FileName1 = "_FASTQ_PATH1_",
FileName2 = "_FASTQ_PATH2_", SampleName = "_SampleName_"),
dependency = c("faidx_index"))
This step generates an alignment summary file, here named alignStats_varseq.xls.
It provides a comprehensive breakdown of the sequencing data,
detailing the total number of reads per FASTQ file and the quantity of reads
successfully aligned to the reference genome, presented as both absolute
counts and percentages.
appendStep(sal) <- LineWise(code = {
bampaths <- getColumn(sal, step = "bwa_alignment", "outfiles",
column = "samtools_sort_bam")
fqpaths <- getColumn(sal, step = "bwa_alignment", "targetsWF",
column = "FileName1")
read_statsDF <- alignStats(args = bampaths, fqpaths = fqpaths,
pairEnd = TRUE)
write.table(read_statsDF, "results/alignStats_varseq.xls",
row.names = FALSE, quote = FALSE, sep = "\t")
}, step_name = "align_stats", dependency = "bwa_alignment", run_step = "optional")
The resulting alignStats_varseq.xls file can be included in the report as shown below (here restricted to the
first four rows).
read.table("results/alignStats_varseq.xls", header = TRUE)[1:4,
]
## FileName Nreads2x Nalign Perc_Aligned Nalign_Primary
## 1 HG00152 61846456 61550504 99.52147 61535987
## 2 HG00234 56509892 56394860 99.79644 56381398
## 3 HG00188 55973376 55916580 99.89853 55833569
## 4 HG00190 53488888 53425926 99.88229 53339831
## Perc_Aligned_Primary
## 1 99.49800
## 2 99.77262
## 3 99.75023
## 4 99.72133
The symLink2bam function creates symbolic links to view the BAM alignment files
in a genome browser such as IGV without moving these large files to a local
system. The corresponding URLs are written to a file with a path specified
under urlfile, here IGVurl.txt. To make the following code work, users need to
change the directory name (here <somedir>), and the url base and user names (here
<base_url> and <username>) to the corresponding names on their system.
appendStep(sal) <- LineWise(code = {
bampaths <- getColumn(sal, step = "bwa_alignment", "outfiles",
column = "samtools_sort_bam")
symLink2bam(sysargs = bampaths, htmldir = c("~/.html/", "<somedir>/"),
urlbase = "<base_url>/~<username>/", urlfile = "./results/IGVurl.txt")
}, step_name = "bam_urls", dependency = "bwa_alignment", run_step = "optional")
This section executes variant calling utilizing GATK, with configurations adapted from the GATK Best Practices guidelines here. The process includes ten integrated substeps, with all corresponding command-line parameter files located in the param/cwl/gatk directory. It is important to note that Base Quality Score Recalibration (BQSR) and Variant Quality Score Recalibration (VQSR) are not included in this default workflow configuration. These steps rely heavily on high-quality, species-specific known variant resources (often limited to model organisms like humans); their exclusion ensures the workflow remains broadly applicable to a diverse range of species.
This step converts raw fastq files into unmapped bam (ubam) format. This
process attaches essential Read Group (RG) metadata - such as sample ID and
sequencing platform - directly to the reads while preserving original base
qualities, which is critical for GATK’s downstream error modeling. It is
vital to accurately specify the sequencing platform, which defaults to
illumina. If a different platform is utilized, users must modify the
configuration file param/cwl/gatk/gatk_fastq2ubam.cwl accordingly to ensure
the variant caller applies the correct parameter adjustments in later stages.
appendStep(sal) <- SYSargsList(step_name = "fastq2ubam", targets = "targetsPE_varseq.txt",
wf_file = "gatk/workflow_gatk_fastq2ubam.cwl", input_file = "gatk/gatk.yaml",
dir_path = "param/cwl", inputvars = c(FileName1 = "_FASTQ_PATH1_",
FileName2 = "_FASTQ_PATH2_", SampleName = "_SampleName_"),
dependency = c("faidx_index"))
This step merges the aligned bam file (generated by the aligner) with the unmapped ubam file (from Step 1) to create a unified bam file. This process restores critical metadata and original sequence information - such as original base quality scores and read group tags - that are often discarded or altered by aligners like BWA. Retaining this “removed” information is essential for accurate downstream variant statistics and error modeling. While adhering to these data-merging steps is highly recommended for optimal results, variant calling can technically be performed without them, albeit with potentially reduced accuracy.
appendStep(sal) <- SYSargsList(step_name = "merge_bam", targets = c("bwa_alignment",
"fastq2ubam"), wf_file = "gatk/workflow_gatk_mergebams.cwl",
input_file = "gatk/gatk.yaml", dir_path = "param/cwl", inputvars = c(bwa_men_sam = "_bwasam_",
ubam = "_ubam_", SampleName = "_SampleName_"), rm_targets_col = c("preprocessReads_1",
"preprocessReads_2"), dependency = c("bwa_alignment",
"fastq2ubam"))
This step sorts the aligned bam files according to their genomic coordinates. Coordinate sorting is a mandatory prerequisite for many downstream analysis
tools, including MarkDuplicates and HaplotypeCaller. These tools require
reads to be ordered sequentially along the reference genome to efficiently
identify duplicates and call variants.
appendStep(sal) <- SYSargsList(step_name = "sort", targets = "merge_bam",
wf_file = "gatk/workflow_gatk_sort.cwl", input_file = "gatk/gatk.yaml",
dir_path = "param/cwl", inputvars = c(merge_bam = "_mergebam_",
SampleName = "_SampleName_"), rm_targets_col = c("bwa_men_sam",
"ubam", "SampleName_fastq2ubam", "Factor_fastq2ubam",
"SampleLong_fastq2ubam", "Experiment_fastq2ubam", "Date_fastq2ubam"),
dependency = c("merge_bam"))
This step identifies and marks PCR duplicates introduced during
library preparation and sequencing. The duplicate information (see
duplicate_metrics file) is not used in the subsequent steps. It is
generated here to assess the duplication rate and complexity of the
sequencing libraries.
appendStep(sal) <- SYSargsList(step_name = "mark_dup", targets = "sort",
wf_file = "gatk/workflow_gatk_markduplicates.cwl", input_file = "gatk/gatk.yaml",
dir_path = "param/cwl", inputvars = c(sort_bam = "_sort_",
SampleName = "_SampleName_"), rm_targets_col = c("merge_bam"),
dependency = c("sort"))
In this step, the HaplotypeCaller is executed in gVCF mode . The “g” denotes “genomic,” indicating that the generated file contains records for all sites, including non-variant blocks, rather than just the variant sites. By retaining information on homozygous reference sites, the gVCF format provides the essential data required for the subsequent cohort calling step. This allows the joint genotyping tool to accurately validate variants across the population by distinguishing between “no variant present” and “no data available.”
appendStep(sal) <- SYSargsList(step_name = "hap_caller", targets = "fix_tag",
wf_file = "gatk/workflow_gatk_haplotypecaller.cwl", input_file = "gatk/gatk.yaml",
dir_path = "param/cwl", inputvars = c(fixtag_bam = "_fixed_",
SampleName = "_SampleName_"), rm_targets_col = c("mark_bam"),
dependency = c("fix_tag"))
To facilitate efficient cohort-wide variant calling in the subsequent step, it is highly recommended to consolidate all single-sample gVCF files into a GenomicsDB workspace (see TileDB). This database, built upon the TileDB array framework, optimizes data storage and access speeds for large-scale analyses.
Note: For analyses involving non-diploid data or specific scenarios where
GenomicsDB is not suitable, users should utilize the CombineGVCFs function
from GATK as an alternative . If this method is chosen, the gvcf_db_folder
parameter in the param/cwl/gatk/gatk.yaml configuration file must be updated
to point to the resulting combined gVCF file path.
Important: Before initiating this step, ensure that all sample .g.vcf.gz
files and their corresponding tabix index (.tbi) files are successfully
generated and located within the results directory.
appendStep(sal) <- SYSargsList(step_name = "import", targets = NULL,
dir = FALSE, wf_file = "gatk/workflow_gatk_genomicsDBImport.cwl",
input_file = "gatk/gatk.yaml", dir_path = "param/cwl", dependency = c("hap_caller"))
This step performs joint genotyping — commonly referred to as cohort calling - utilizing the GenotypeGVCFs tool. By evaluating genomic information across the entire cohort simultaneously (accessed via the GenomicsDB or combined gVCF from the previous step), the algorithm leverages population-wide statistics to resolve ambiguous sites and improve calling accuracy. The output is a unified, multi-sample VCF file (default name: samples.vcf.gz) containing the raw variant calls for all samples, which serves as the input for subsequent filtering and annotation.
appendStep(sal) <- SYSargsList(step_name = "call_variants", targets = NULL,
dir = FALSE, wf_file = "gatk/workflow_gatk_genotypeGVCFs.cwl",
input_file = "gatk/gatk.yaml", dir_path = "param/cwl", dependency = c("import"))
Since Variant Quality Score Recalibration (VQSR) requires large datasets and highly curated known-variant training resources—which are often unavailable for non-model organisms. To be applicable to most organisms, this workflow employs hard filtering as the standard alternative.
This step applies fixed thresholds to specific variant annotations (e.g., QualByDepth, FisherStrand, ReadPosRankSum) to identify and remove low-confidence calls. The default filtering parameters are configured based on GATK’s generic hard-filtering recommendations. Users are encouraged to review these settings and adjust the corresponding parameter files to match the specific error profiles of their dataset. For more information on the requirements and logic behind VQSR versus hard filtering, please refer to the official GATK documentation.
appendStep(sal) <- SYSargsList(step_name = "filter", targets = NULL,
dir = FALSE, wf_file = "gatk/workflow_gatk_variantFiltration.cwl",
input_file = "gatk/gatk.yaml", dir_path = "param/cwl", dependency = c("call_variants"))
Following the joint genotyping and hard filtering stages, all variant calls for the cohort are consolidated within a single, multi-sample VCF file. This step separates this aggregate data, extracting variants for each individual sample and saving them into distinct files. Importantly, this process is configured to retain only those variants that successfully passed the filtering criteria (marked as PASS), ensuring that the final per-sample files contain only high-confidence calls ready for downstream interpretation.
appendStep(sal) <- SYSargsList(step_name = "create_vcf", targets = "hap_caller",
wf_file = "gatk/workflow_gatk_select_variant.cwl", input_file = "gatk/gatk.yaml",
dir_path = "param/cwl", inputvars = c(SampleName = "_SampleName_"),
dependency = c("hap_caller", "filter"))
This completes the variant calling phase.
The following section provides example code for inspecting and manipulating VCF files within R. Please note that this step is distinct from the automated pipeline and serves as a guide for downstream exploratory analysis.
To import VCF data into R, the readVcf function is utilized. This loads
the data into VCF or VRanges class objects, which provide highly
structured and efficient formats for handling variant data, facilitating
tasks such as custom SNP quality filtering and genomic annotation.
library(VariantAnnotation)
vcf_raw <- getColumn(sal, "create_vcf")
vcf <- readVcf(vcf_raw[1], "Homo sapiens")
vcf
vr <- as(vcf, "VRanges")
vr
The filterVars function facilitates flexible, post-hoc filtering of VCF files
based on user-defined quality parameters. This utility sequentially imports
each VCF file into the R environment, converts the data into an internal
VRanges object, applies the specified filtering logic, and exports the
remaining variants to a new, subsetted VCF file.
Filtering criteria are passed to the function as character strings. These strings are evaluated dynamically to subset the VRanges object using standard R indexing syntax (e.g., vr[filter, ]).
Example Scenario: The code below demonstrates filtering for variants that meet the following criteria: (1) Read Support: minimum total read depth >= x; (2) Allele Fraction: At least 80% of the reads support the called variant; (3) Upstream Status: the variant must have passed a specific subset of “soft filters” (e.g. PASS tags) inherited from the upstream GATK analysis.
Note: While the GATK pipeline (specifically Steps 9 and 10) typically performs the primary hard filtering, this R-based step is provided as an optional tool for exploratory data analysis or secondary fine-tuning without the need to re-execute the command-line workflow.
appendStep(sal) <- LineWise(code = {
vcf_raw <- getColumn(sal, "create_vcf")
library(VariantAnnotation)
filter <- "totalDepth(vr) >= 20 & (altDepth(vr) / totalDepth(vr) >= 0.8)"
vcf_filter <- suppressWarnings(filterVars(vcf_raw, filter,
organism = "Homo sapiens", out_dir = "results/vcf_filter"))
}, step_name = "filter_vcf", dependency = "create_vcf", run_step = "optional")
This validation code allows users to compare the VCF files before and after the
filtering process. It serves as a quality control measure to verify the impact
of the applied filters. Please ensure that the optional filter_vcf step has
been successfully executed before running this comparison.
copyEnvir(sal, "vcf_raw", globalenv())
copyEnvir(sal, "vcf_filter", globalenv())
length(as(readVcf(vcf_raw[1], genome = "Homo sapiens"), "VRanges")[,
1])
length(as(readVcf(vcf_filter[1], genome = "Homo sapiens"), "VRanges")[,
1])
While optional, this step is included in the default workflow configuration to provide insight into the quality control process. It facilitates a comparative analysis between the raw variant calls and the filtered set produced in Step 9. By generating summary statistics and visualizations, this step allows users to quantitatively assess the impact of the applied filtering criteria.
appendStep(sal) <- LineWise(code = {
# read in the cohort VCF file
vcf_all <- suppressWarnings(VariantAnnotation::readVcf("./results/samples_filter.vcf.gz",
"Homo sapiens"))
filter_values <- VariantAnnotation::filt(vcf_all)
filter_values[is.na(filter_values)] <- "" # ensure character comparisons work
overall_counts <- table(filter_values) |>
dplyr::as_tibble() |>
dplyr::arrange(dplyr::desc(n))
vcf_all_ft <- VariantAnnotation::geno(vcf_all)$FT
passes_per_sample <- apply(vcf_all_ft, 2, function(x) sum(x ==
"PASS", na.rm = TRUE))
fails_per_sample <- apply(vcf_all_ft, 2, function(x) sum(x !=
"PASS", na.rm = TRUE))
sample_filter_summary <- dplyr::tibble(sample = names(passes_per_sample),
passed = passes_per_sample, filtered = fails_per_sample)
write.table(overall_counts, file = "results/summary_filter_overall.tsv",
sep = "\t", quote = FALSE, row.names = FALSE)
write.table(sample_filter_summary, file = "results/summary_filter_per_sample.tsv",
sep = "\t", quote = FALSE, row.names = FALSE)
library(ggplot2)
source("VARseq_helper.R")
png("results/summary_filter_plot.png", width = 800, height = 600)
p_filter <- plot_summary_filter_plot(sample_filter_summary)
print(p_filter)
dev.off()
# clean up RAM
try(rm(vcf_all, vcf_all_ft, filter_values, passes_per_sample,
fails_per_sample), silent = TRUE)
invisible(gc())
}, step_name = "summary_filter", dependency = "filter")
In this required step, the workflow utilizes SnpEff to annotate the filtered variants. SnpEff is a robust tool designed to predict the functional effects of genetic variants on genes and proteins, providing essential biological context (e.g. amino acid changes, impact severity) for the identified mutations.
appendStep(sal) <- SYSargsList(step_name = "annotate_vcf", targets = "create_vcf",
dir = TRUE, wf_file = "gatk/snpeff.cwl", input_file = "gatk/gatk.yaml",
dir_path = "param/cwl", inputvars = c(SampleName = "_SampleName_",
vcf_raw = "_vcf_raw_"), dependency = c("create_vcf"))
Upon completion of the annotation process for each VCF file, the subsequent
step involves consolidating the results. All annotated VCFs can be imported and
organized into a single list containing large VRanges objects, facilitating
efficient downstream analysis and manipulation within R.
appendStep(sal) <- LineWise(code = {
vcf_anno <- getColumn(sal, "annotate_vcf", position = "outfiles",
column = "ann_vcf")
clean_vcf_file <- function(path) {
lines <- readLines(path, warn = FALSE)
if (!length(lines))
return(path)
header_start <- which(grepl("^##fileformat=", lines,
perl = TRUE))[1]
if (is.na(header_start) || header_start <= 1)
return(path)
writeLines(lines[header_start:length(lines)], path)
path
}
vcf_anno <- vapply(vcf_anno, clean_vcf_file, FUN.VALUE = character(1))
vr_from_vcf <- function(path) {
message("Importing annotated VCF: ", path)
vcf <- suppressWarnings(VariantAnnotation::readVcf(path,
"Homo sapiens"))
ft <- VariantAnnotation::geno(vcf)$FT
if (!is.null(ft) && !isTRUE(is.character(ft))) {
ft_vec <- as.character(ft)
ft_clean <- matrix(ft_vec, ncol = 1)
if (!is.null(dim(ft))) {
ft_clean <- matrix(ft_vec, nrow = nrow(ft), dimnames = dimnames(ft))
}
VariantAnnotation::geno(vcf)$FT <- ft_clean
}
suppressWarnings(as(vcf, "VRanges"))
}
vcf_vranges <- lapply(vcf_anno, vr_from_vcf)
}, step_name = "combine_var", dependency = "annotate_vcf")
To transform the variant objects into a human-readable summary, key annotation fields and essential variant metadata are extracted and reorganized into a long-format table. In this structured output, each row corresponds to a single variant annotation for a specific sample, facilitating easier inspection and downstream analysis.
appendStep(sal) <- LineWise(code = {
source("VARseq_helper.R")
summary_var <- extract_var_table(vcf_vranges)
utils::write.table(summary_var, file = "results/variant_summary_long.tsv",
sep = "\t", quote = FALSE, row.names = FALSE)
}, step_name = "summary_var", dependency = "combine_var")
This visualization step generates a summary plot displaying the frequency of variants categorized by their predicted functional consequence for each sample. This allows for a rapid assessment of the mutational profile and potential biological impact across the cohort.
appendStep(sal) <- LineWise(code = {
library(ggplot2)
effect_counts <- summary_var |>
dplyr::count(sample, effect, name = "n")
png("./results/var_consequence_log.png", width = 1000, height = 600)
p_var_consequence_log <- ggplot(effect_counts, aes(sample,
n, fill = effect)) + geom_col(position = "dodge", alpha = 0.8) +
geom_text(aes(label = scales::comma(n)), position = position_dodge(width = 0.9),
vjust = -0.2, size = 3) + scale_y_continuous(trans = "log10",
labels = scales::comma_format()) + labs(y = "Variant count (log10 scale)",
title = "Variant consequences (log scale)") + theme_minimal() +
theme(axis.text.x = element_text(angle = 45, hjust = 1))
print(p_var_consequence_log)
dev.off()
}, step_name = "plot_var_consequence", dependency = "summary_var")
This step provides a focused visualization of biologically significant variants. Leveraging the above summary table, it quantifies and plots the distribution of nonsynonymous changes and variants classified as HIGH impact across all samples. This enables researchers to identify samples with a high burden of potentially functional or pathogenic mutations.
appendStep(sal) <- LineWise(code = {
library(ggplot2)
plot_summary_data <- summary_var |>
dplyr::filter(consequence %in% c("nonsynonymous_variant",
"stop_gained", "frameshift_variant", "splice_acceptor_variant",
"splice_donor_variant", "start_lost", "stop_lost"),
effect == "HIGH") |>
dplyr::mutate(sample = factor(sample, levels = getColumn(sal,
step = "annotate_vcf", position = "targetsWF", column = "SampleName")),
sex = getColumn(sal, step = "annotate_vcf", position = "targetsWF",
column = "Factor")[sample])
png("./results/var_summary.png")
p_var_summary <- ggplot(plot_summary_data) + geom_bar(aes(x = sample,
fill = sex), alpha = 0.75) + scale_fill_brewer(palette = "Set2") +
theme_minimal()
print(p_var_summary)
dev.off()
}, step_name = "plot_var_stats", dependency = "summary_var")
To investigate potential disparities in the mutational burden between sample
groups (e.g., Male vs. Female), this step utilizes the plot_summary_data object
to generate a comparative boxplot . The visualization displays the distribution
of high-impact variants for each group and overlays a Wilcoxon rank-sum test
p-value, providing an immediate statistical assessment of the difference in
variant loads.
appendStep(sal) <- LineWise(code = {
source("VARseq_helper.R")
# change the sample and group columns as needed
p_summary_boxplot <- plot_summary_boxplot(plot_summary_data,
sample_col = "sample", group_col = "sex")
library(ggplot2)
png("./results/var_summary_boxplot.png")
print(p_summary_boxplot)
dev.off()
}, step_name = "plot_var_boxplot", dependency = "plot_var_stats")
The venn diagram utilities defined by the systemPipeR package can be used to
identify common and unique variants reported for different samples
and/or variant callers. The below generates a 3-way venn diagram
comparing 3 samples.
appendStep(sal) <- LineWise(code = {
top_n <- min(3, length(variant_tables))
selected_tables <- variant_tables[seq_len(top_n)]
if (is.null(names(selected_tables)) || any(!nzchar(names(selected_tables)))) {
names(selected_tables) <- paste0("Sample_", seq_along(selected_tables))
}
variant_sets <- lapply(selected_tables, function(df) {
if (!nrow(df))
return(character(0))
unique(paste0(df$seqnames, ":", df$start, "_", df$ref,
"/", df$alt))
})
vennset <- overLapper(variant_sets, type = "vennsets")
png("./results/vennplot_var.png")
vennPlot(vennset, mymain = "Venn Plot of First 3 Samples",
mysub = "", colmode = 2, ccol = c("red", "blue"))
dev.off()
}, step_name = "venn_diagram", dependency = "summary_var")
This section demonstrates how to visualize specific genomic variants in a
genome-browser style layout using the ggbio package. The resulting example
plot organizes the data into three synchronized panes: the variant location, the
corresponding read alignments, and the coverage depth. The input requirements for
this step are sorted and indexed BAM files generated in GATK Step 5, as well as
variant information from the create_vcf step.
appendStep(sal) <- LineWise(code = {
source("VARseq_helper.R")
first_high <- summary_var |>
dplyr::filter(effect == "HIGH") |>
head(n = 1)
library(ggbio)
library(VariantAnnotation)
mychr <- as.character(first_high$seqnames)
mystart <- as.numeric(first_high$start) - 500
myend <- as.numeric(first_high$end) + 500
bam_path <- getColumn(sal, "fix_tag")[first_high$sample]
vcf_path <- getColumn(sal, step = "create_vcf")[first_high$sample]
vcf <- suppressWarnings(readVcf(vcf_path, "Homo sapiens"))
ga <- readGAlignments(bam_path, use.names = TRUE, param = ScanBamParam(which = GRanges(mychr,
IRanges(mystart, myend))))
vcf_chr <- normalize_ft(simplify_info(vcf[seqnames(vcf) ==
mychr]))
vr <- suppressWarnings(as(vcf_chr, "VRanges"))
vr_region <- vr[start(vr) >= mystart & end(vr) <= myend]
if (!length(vr_region)) {
vr_region <- vr
}
p1 <- autoplot(ga, geom = "rect")
p2 <- autoplot(ga, geom = "line", stat = "coverage")
p3 <- autoplot(vr_region, type = "fixed") + xlim(mystart,
myend) + theme(legend.position = "none", axis.text.y = element_blank(),
axis.ticks.y = element_blank())
p1_3 <- tracks(place_holder = ggplot2::ggplot(), Reads = p1,
Coverage = p2, Variant = p3, heights = c(0, 0.3, 0.2,
0.1)) + ylab("")
ggbio::ggsave(p1_3, filename = "./results/plot_variant.png",
units = "in")
}, step_name = "plot_variant", dependency = "summary_var")
appendStep(sal) <- LineWise(code = {
sessionInfo()
}, step_name = "sessionInfo", dependency = "plot_variant")
The runWF function is the primary tool for executing workflows. It runs the
code of the workflow steps after loading them into a SAL workflow container.
The workflow steps can be loaded interactively one by one or in batch mode with
the importWF function. The batch mode is more convenient and is the intended
method for loading workflows. It is part of the standard routine for running
workflows introduced in the Quick start section.
sal <- runWF(sal)
The processing time of computationally expensive steps can be greatly
accelerated by processing many input files in parallel using several CPUs
and/or computer nodes of an HPC or cloud system, where a scheduling system is
used for load balancing. To simplify for users the configuration and execution
of workflow steps in serial or parallel mode, systemPipeR users for both the
same runWF function. Parallelization simply requires appending of the
parallelization parameters to the settings of the corresponding workflow steps
each requesting the computing resources specified by the user, such as the
number of CPU cores, RAM and run time. These resource settings are stored in
the corresponding workflow step of the SAL workflow container. After adding the
parallelization parameters, runWF will execute the chosen steps in parallel
mode as instructed.
The following example applies to an alignment step of a VAR-Seq workflow.
In the chosen alignment example, the parallelization
parameters are added to the alignment step (here bwa_alignment) of SAL via
a resources list. The given parameter settings will run 8 processes (Njobs) in
parallel using for each 4 CPU cores (ncpus), thus utilizing a total of 32 CPU
cores. The runWF function can be used with most queueing systems as it is based on
utilities defined by the batchtools package, which supports the use of
template files (*.tmpl) for defining the run parameters of different
schedulers. In the given example below, a conffile (see
.batchtools.conf.R samples here) and
a template file (see *.tmpl samples
here) need to be present
on the highest level of a user’s workflow project. The following example uses the sample
conffile and template files for the Slurm scheduler that are both provided by this
package.
The resources list can be added to analysis steps when a workflow is loaded into SAL.
Alternatively, one can add the resource settings with the addResources function
to any step of a pre-populated SAL container afterwards. For workflow steps with the same resource
requirements, one can add them to several steps at once with a single call to addResources by
specifying multiple step names under the step argument.
# wall time in mins, memory in MB
resources <- list(conffile = ".batchtools.conf.R", template = "batchtools.slurm.tmpl",
Njobs = 8, walltime = 120, ntasks = 1, ncpus = 4, memory = 1024,
partition = "short")
sal <- addResources(sal, c("bwa_alignment"), resources = resources)
sal <- runWF(sal)
systemPipeR workflows instances can be visualized with the plotWF function.
plotWF(sal, rstudio = TRUE)
The following commands can be used to check the workflow status. The first one gives a summary and the second one a more detailed outline.
sal
statusWF(sal)
systemPipeR consolidates all workflow execution logs into a central location
within the .SPRproject directory. This organization simplifies the inspection
of standard output (stdout) and error (stderr) streams generated by both
command-line and R steps. Additionally, this log data serves as the
foundation for generating systemPipeR's technical reports with the renderLogs
function.
sal <- renderLogs(sal)
To inspect the command-line tools utilized in this workflow, the
listCmdTools function can be used. Additionally, when using a module
environment is used one can verify the loaded modules with listCmdModules.
The following code block will generate a report listing the tools required for running this workflow. If the workflow is used for the first time or the user wishes to browse the workflow’s requirements, the code below will display the default toolset configuration.
if (file.exists(file.path(".SPRproject", "SYSargsList.yml"))) {
local({
sal <- systemPipeR::SPRproject(resume = TRUE)
systemPipeR::listCmdTools(sal)
systemPipeR::listCmdModules(sal)
})
} else {
cat(crayon::blue$bold("Tools and modules required by this workflow are:\n"))
cat(c("trimmomatic/0.39", "samtools/1.14", "gatk/4.2.0.0",
"bcftools/1.15", "bwa/0.7.17", "snpEff/5.3"), sep = "\n")
}
## Tools and modules required by this workflow are:
## trimmomatic/0.39
## samtools/1.14
## gatk/4.2.0.0
## bcftools/1.15
## bwa/0.7.17
## snpEff/5.3
This is the session information that will be included when rendering this report.
sessionInfo()
## R version 4.5.2 (2025-10-31)
## Platform: x86_64-pc-linux-gnu
## Running under: Ubuntu 24.04.3 LTS
##
## Matrix products: default
## BLAS: /home/biocbuild/bbs-3.22-bioc/R/lib/libRblas.so
## LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.12.0 LAPACK version 3.12.0
##
## locale:
## [1] LC_CTYPE=en_US.UTF-8 LC_NUMERIC=C
## [3] LC_TIME=en_GB LC_COLLATE=C
## [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] stats4 stats graphics grDevices utils
## [6] datasets methods base
##
## other attached packages:
## [1] magrittr_2.0.4 systemPipeRdata_2.14.2
## [3] systemPipeR_2.16.3 ShortRead_1.68.0
## [5] GenomicAlignments_1.46.0 SummarizedExperiment_1.40.0
## [7] Biobase_2.70.0 MatrixGenerics_1.22.0
## [9] matrixStats_1.5.0 BiocParallel_1.44.0
## [11] Rsamtools_2.26.0 Biostrings_2.78.0
## [13] XVector_0.50.0 GenomicRanges_1.62.1
## [15] IRanges_2.44.0 S4Vectors_0.48.0
## [17] Seqinfo_1.0.0 BiocGenerics_0.56.0
## [19] generics_0.1.4 BiocStyle_2.38.0
##
## loaded via a namespace (and not attached):
## [1] gtable_0.3.6 xfun_0.55
## [3] bslib_0.9.0 hwriter_1.3.2.1
## [5] ggplot2_4.0.1 remotes_2.5.0
## [7] htmlwidgets_1.6.4 latticeExtra_0.6-31
## [9] lattice_0.22-7 vctrs_0.6.5
## [11] tools_4.5.2 bitops_1.0-9
## [13] parallel_4.5.2 tibble_3.3.1
## [15] pkgconfig_2.0.3 Matrix_1.7-4
## [17] RColorBrewer_1.1-3 S7_0.2.1
## [19] cigarillo_1.0.0 lifecycle_1.0.5
## [21] stringr_1.6.0 compiler_4.5.2
## [23] farver_2.1.2 deldir_2.0-4
## [25] textshaping_1.0.4 codetools_0.2-20
## [27] htmltools_0.5.9 sass_0.4.10
## [29] yaml_2.3.12 pillar_1.11.1
## [31] crayon_1.5.3 jquerylib_0.1.4
## [33] DelayedArray_0.36.0 cachem_1.1.0
## [35] abind_1.4-8 tidyselect_1.2.1
## [37] digest_0.6.39 stringi_1.8.7
## [39] dplyr_1.1.4 bookdown_0.46
## [41] fastmap_1.2.0 grid_4.5.2
## [43] cli_3.6.5 SparseArray_1.10.8
## [45] S4Arrays_1.10.1 dichromat_2.0-0.1
## [47] scales_1.4.0 rmarkdown_2.30
## [49] pwalign_1.6.0 jpeg_0.1-11
## [51] interp_1.1-6 otel_0.2.0
## [53] png_0.1-8 kableExtra_1.4.0
## [55] evaluate_1.0.5 knitr_1.51
## [57] viridisLite_0.4.2 rlang_1.1.7
## [59] Rcpp_1.1.1 glue_1.8.0
## [61] xml2_1.5.1 BiocManager_1.30.27
## [63] formatR_1.14 svglite_2.2.2
## [65] rstudioapi_0.17.1 jsonlite_2.0.0
## [67] R6_2.6.1 systemfonts_1.3.1
This project is funded by awards from the National Science Foundation (ABI-1661152], and the National Institute on Aging of the National Institutes of Health (U19AG023122).
Bolger, Anthony M, Marc Lohse, and Bjoern Usadel. 2014. “Trimmomatic: A Flexible Trimmer for Illumina Sequence Data.” Bioinformatics 30 (15): 2114–20.
H Backman, Tyler W, and Thomas Girke. 2016. “systemPipeR: NGS workflow and report generation environment.” BMC Bioinformatics 17 (1): 388. https://doi.org/10.1186/s12859-016-1241-0.
Li, H, and R Durbin. 2009. “Fast and Accurate Short Read Alignment with Burrows-Wheeler Transform.” Bioinformatics 25 (14): 1754–60. https://doi.org/10.1093/bioinformatics/btp324.
Li, Heng. 2013. “Aligning Sequence Reads, Clone Sequences and Assembly Contigs with BWA-MEM.” arXiv [Q-bio.GN], March. http://arxiv.org/abs/1303.3997.