Workflows
What is a Workflow?Filters
VGP Workflow #1
This workflow produces a Meryl database and Genomescope outputs that will be used to determine parameters for following workflows, and assess the quality of genome assemblies. Specifically, it provides information about the genomic complexity, such as the genome size and levels of heterozygosity and repeat content, as well about the data quality.
Inputs
- Collection of Hifi long reads in FASTQ format
Outputs
- Meryl Database of kmer counts
- GenomeScope
- Linear plot
...
VGP Workflow #1
This workflow collects the metrics on the properties of the genome under consideration by analyzing the k-mer frequencies. It provides information about the genomic complexity, such as the genome size and levels of heterozygosity and repeat content, as well about the data quality. It uses reads from two parental genomes to partition long reads from the offspring into haplotype-specific k-mer databases.
Inputs
- Collection of Hifi long reads in FASTQ format
- Paternal short-read ...
Generic variation analysis on WGS PE data
This workflows performs paired end read mapping with bwa-mem followed by sensitive variant calling across a wide range of AFs with lofreq and variant annotation with snpEff. The reference genome can be provided as a GenBank file.
GROMACS dcTMD free energy calculation
Perform an ensemble of targeted MD simulations of a user-specified size using the GROMACS PULL code and calculate dcTMD free energy and friction profiles for the resulting dissocation pathway. Note that pathway separation is not performed by the workflow; the user is responsible for checking the ensemble themselves.
The input protein (PDB) and ligand (SDF) files provided are parameterized by the 'Protein-ligand complex parameterization' subworkflow.
Note ...
Protein-ligand complex parameterization
Parameterizes an input protein (PDB) and ligand (SDF) file prior to molecular dynamics simulation with GROMACS.
This is a simple workflow intended for use as a subworkflow in more complex MD workflows. It is used as a subworkflow by the GROMACS MMGBSA and dcTMD workflows.
COVID-19: variation analysis on ARTIC ONT data
This workflow for ONT-sequenced ARTIC data is modeled after the alignment/variant-calling steps of the ARTIC pipeline. It performs, essentially, the same steps as that pipeline’s minion command, i.e. read mapping with minimap2 and variant calling with medaka. Like the Illumina ARTIC workflow it uses ivar for primer trimming. Since ONT-sequenced reads have a much ...
COVID-19: variation analysis on WGS SE data
This workflows performs single end read mapping with bowtie2 followed by sensitive variant calling across a wide range of AFs with lofreq and variant annotation with snpEff 4.5covid19.
COVID-19: variation analysis on WGS PE data
This workflows performs paired end read mapping with bwa-mem followed by sensitive variant calling across a wide range of AFs with lofreq and variant annotation with snpEff 4.5covid19.