- MycoSNP is a portable workflow for performing whole genome sequencing analysis of fungal organisms, including Candida auris.
- This method prepares the reference, performs quality control, and calls variants using a reference.
- MycoSNP generates several output files that are compatible with downstream analytic tools, such as those for used for phylogenetic tree-building and gene variant annotations.
This document describes the output produced by the pipeline.
The directories listed below will be created in the results directory after the pipeline has finished. All paths are relative to the top-level results directory.
results/
├── combined
├── fastq
├── input
├── multiqc
├── pipeline_info
├── reference
├── samples
└── stats
The pipeline is built using Nextflow and processes data using the following steps:
- CDCgov/mycosnp: Output
- BWA Reference
- BWA Pre-process
- GATK Variants
- Variant Annotation
- Summary Files
- Pipeline Information
Output files
reference/bwa/bwa
reference.amb
reference.ann
reference.bwt
reference.pac
reference.sa
reference/dict
reference.dict
reference/fai
reference.fa.fai
reference/masked
reference.fa
Prepares a reference FASTA file for BWA alignment and GATK variant calling by masking repeats in the reference and generating the BWA index.
- Genome repeat identification and masking (
nucmer
) - BWA index generation (
bwa
) - FAI and DICT file creation (
Picard
,Samtools
)
Prepares samples (paired-end FASTQ files) for GATK variant calling by aligning the samples to a BWA reference index and ensuring that the BAM files are correctly formatted. This step also provides different quality reports for sample evaluation.
- Combine FASTQ file lanes if they were provided with multiple lanes.
- Filter unpaired reads from FASTQ files (
SeqKit
). - Down sample FASTQ files to a desired coverage or sampling rate (
SeqTK
). - Trim reads and assess quality (
FaQCs
). - Generate a QC report by extracting data from FaQCs report data.
- Align FASTQ reads to a reference (
BWA
). - Sort BAM files (
SAMTools
). - Mark and remove duplicates in the BAM file (
Picard
). - Clean the BAM file (
Picard "CleanSam"
). - Fix mate information in the BAM file (
Picard "FixMateInformation"
). - Add read groups to the BAM file (
Picard "AddOrReplaceReadGroups"
). - Index the BAM file (
SAMTools
). - FastQC - Filtered reads QC.
- Qualimap mapping quality report.
- MultiQC - Aggregate report describing results and QC from the whole pipeline
Important output files from this section:
File | Path |
---|---|
Trimmed Reads | (samples/<sampleID>/faqcs/*.fastq.gz) |
Bam files | (samples/<sampleID>/finalbam) |
QC Report | (stats/qc_report) |
MultiQC | (multiqc/) |
Calls variants, generates a multi-FASTA file, and creates phylogeny.
- Call variants (
GATK HaplotypeCaller
). - Combine gVCF files from the HaplotypeCaller into a single VCF (
GATK CombineGVCFs
). - Call genotypes using the (
GATK GenotypeGVCFs
). - Filter the variants (
GATK VariantFiltration
) [default (but customizable) filter: 'QD < 2.0 || FS > 60.0 || MQ < 40.0 || DP < 10']. - Run a customized VCF filtering script (
Broad Institute
). - Split the filtered VCF file by sample.
- Select only SNPs from the VCF files (
GATK SelectVariants
). - Split the VCF file with SNPs by sample.
- Create a multi-fasta file from the VCF SNP positions using a custom script (
Broad
). - Create distance matrix file using muti-fasta file (
snp-dists
). - Create phylogeny from multi-fasta file (
rapidNJ
,FastTree2
,quicksnp
,RaxML(optional)
,IQTree(optional)
)
Important output files from this section:
File | Path |
---|---|
Individual VCF Files from HaplotypeCaller | (samples/variant_calling/haplotypecaller) |
Filtered selected variants combined | (combined/finalfiltered) |
Filtered selected variants individual | (combined/splitvcf) |
Selected SNP fasta file | (combined/vcf-to-fasta) |
Phylogeny files | (combined/phylogeny/) |
Annotate variants within the FKS1 gene using the filtered vcf file and provide output in the form of a report (currently for C.auris B11205 reference only)
- snpEff annotation(
snpeff
) - Create a report file using the snpeff annotated vcf file (
snpeffr
)
Important output files from this section:
File | Path |
---|---|
Annotated vcf file from SnpEff | (combined/snpeff) |
Customised report of variants in FKS1 | (combined/snpeff) |
Output files
fastqc/
*_fastqc.html
: FastQC report containing quality metrics.*_fastqc.zip
: Zip archive containing the FastQC report, tab-delimited data file and plot images.
FastQC gives general quality metrics about your sequenced reads. It provides information about the quality score distribution across your reads, per base sequence content (%A/T/G/C), adapter contamination and overrepresented sequences. For further reading and documentation see the FastQC help pages.
NB: The FastQC plots displayed in the MultiQC report shows untrimmed reads. They may contain adapter sequence and potentially regions with low quality.
The QC report values are generated from FAQCS text file outputs. The following is an example table:
Sample Name | Reads Before Trimming | GC Before Trimming | Average Q Score Before Trimming | Reference Length Coverage Before Trimming | Reads After Trimming | Paired Reads After Trimming | Unpaired Reads After Trimming | GC After Trimming | Average Q Score After Trimming | Reference Length Coverage After Trimming | Mean Coverage Depth | Reads Mapped |
---|---|---|---|---|---|---|---|---|---|---|---|---|
ERR2172265 | 367402 | 52.44% | 34.64 | 16.58 | 367396 (100.00 %) | 367390 (100.00 %) | 6 (0.00 %) | 52.45% | 34.64 | 16.58 | 15.59 | 352513 (96.43%) |
QC Metric | Source |
---|---|
Reads Before Trimming | FAQCS |
GC Before Trimming | FAQCS |
Average Q Score Before Trimming | FAQCS |
Reference Length Coverage Before Trimming | FAQCS |
Reads After Trimming | FAQCS |
Paired Reads After Trimming | FAQCS |
Unpaired Reads After Trimming | FAQCS |
GC After Trimming | FAQCS |
Average Q Score After Trimming | FAQCS |
Reference Length Coverage After Trimming | FAQCS |
Mean Coverage Depth | Qualimap |
Reads Mapped | Qualimap |
Output files
multiqc/
multiqc_report.html
: a standalone HTML file that can be viewed in your web browser.multiqc_data/
: directory containing parsed statistics from the different tools used in the pipeline.multiqc_plots/
: directory containing static images from the report in various formats.
MultiQC is a visualization tool that generates a single HTML report summarising all samples in your project. Most of the pipeline QC results are visualised in the report and further statistics are available in the report data directory.
Results generated by MultiQC collate pipeline QC from supported tools e.g. FastQC. The pipeline has special steps which also allow the software versions to be reported in the MultiQC output for future traceability. For more information about how to use MultiQC reports, see http://multiqc.info.
Output files
pipeline_info/
- Reports generated by Nextflow:
execution_report.html
,execution_timeline.html
,execution_trace.txt
andpipeline_dag.dot
/pipeline_dag.svg
. - Reports generated by the pipeline:
pipeline_report.html
,pipeline_report.txt
andsoftware_versions.yml
. Thepipeline_report*
files will only be present if the--email
/--email_on_fail
parameter's are used when running the pipeline. - Reformatted samplesheet files used as input to the pipeline:
samplesheet.valid.csv
.
- Reports generated by Nextflow:
Nextflow provides excellent functionality for generating various reports relevant to the running and execution of the pipeline. This will allow you to troubleshoot errors with the running of the pipeline, and also provide you with other information such as launch commands, run times and resource usage.