UGP Variant Pipeline 1.1.6

From Utah Genome Project Wiki
Jump to navigation Jump to search

Utah Genome Project

Nov. 2014 
Variant Calling Pipeline  Version 1.1.6

Software Versions

  • cApTUrE is a lightweight NGS pipeline, created for the
 Utah Genome Project (UGP)
  • GenomeAnalysisTK-3.3-2
  • Picard : Version: 1.112
  • FastQC v0.10.1
  • Samtools Version: 0.1.19
  • BWA Version: 0.7.5

Data Source

Data sets used for the variant calling pipeline come from the Broad GSA (GATK) group as the 'GATK resource bundle 2.5' version 2.8

wget -r ftp://gsapubftp-anonymous@ftp.broadinstitute.org/bundle/2.5/b37

Reference Genome (GRCh37):

  • human_g1k_v37_decoy.fasta

Call region file generated from NCBI

  • GRCh37 GFF3

VCF files for RealignerTargetCreator knowns and dbsnp for BaseRecalibrator.

  • known_indel: /data/GATK_Bundle/Mills_and_1000G_gold_standard.indels.b37.vcf
  • known_indel: /data/GATK_Bundle/1000G_phase1.indels.b37.vcf
  • known_dbsnp: /data/GATK_Bundle/dbsnp_137.b37.vcf

Background Files

  • We have created 1000Genomes (BWA mem/GATK 3.0+) background files to be ran concurrently with the GenotypeGVCFs step.

Groups Currently completed:

  • CEU
  • GBR
  • FIN

Version 1.0.5 background files have been updated to show only the indviduals of each group, not the file names.

This is a complete list of the background individuals for run completed > 1.0.5 [1]

If you would like a copy of the current files, we have made a public AWS s3 bucket
Using s3cmd execute the following command: 
s3cmd get s3://ugp-1k-backgrounds --recursive

Resource files for VariantRecalibrator_SNP

  • hapmap_3.3.b37.vcf
  • 1000G_omni2.5.b37.vcf
  • 1000G_phase1.snps.high_confidence.b37.vcf

Resource files for VariantRecalibrator_INDEL

  • Mills_and_1000G_gold_standard.indels.b37.vcf
  • 1000G_phase1.indels.b37.vcf

Sequencing

This pipeline is designed for 100 bp (or greater) Illumina HiSeq PE exome or WGS sequence data with Sanger/Illumina 1.9 quality encoding, and uses Illumina naming convention found here [2]

Validate File Integrity with md5sum

An md5sum signature should be provided for each FastQ file by the sequencing center. After the file has been downloaded, locally check the md5sum to be sure that no data corruption occurred during the file transfer.

md5sum file.fastq > file_local.md5
diff file_local.md5 file_provided.md5
Now the pipeline runs md5_check to validation the results and will quit if errors are found. 

If the md5sum signature differs from that provided for the file:

  • Check to be sure you have the correct file.
  • Check if the md5sum was calculated on that compressed or uncompressed file by the provider and be sure to do the same with the local copy.
  • Try the download again.
  • Contact the sequence provider.

FastQ File Analyses

fastqc Sample1_L1_R1.txt

From the sumamry.txt report we check

  • FAIL sections

From the fastqc_data.txt file we check the following values:

  • Encoding (must be Sanger / Illumina 1.9)
  • Total Sequences (Currently set to 30000000)
  • Filtered Sequences (Currently set to less then 5)
  • Sequence length (must be >= 100 bp)
  • %GC (45 < x < 55)
  • Total Duplicate Percentage (Currently set to 60.0)

The pipeline now runs fastqc_check and output these result into QC-report.txt.

Indexing

The following indexing is required using BWA, Picard and SamTools. GATK requires all three. However this step only needs to be done once "per-machine".

  • BWA
bwa index -a bwtsw human_g1k_v37_decoy.fasta
  • Picard
java -jar CreateSequenceDictionary.jar R=human_g1k_v37_decoy.fasta O=human_g1k_v37_decoy.dic
  • SamTools
samtools faidx human_g1k_v37_decoy.fasta

Alignment

Align reads to the genome with bwa.

The 'BWA-mem' program will find the reference coordinates of the input reads (independent of their mate-pair). The following parameters are those used by the 1KG project and GATK for aligning Illumina data.

bwa mem -M -R "read group" human_g1k_v37_decoy.fasta Sample1_L1_R1.fq Sample1_L1_R2.fq | samtools view -bSho BAM_FILE -

BAM File Analyses and Processing

Alignment BAM files are improved in various ways to help increase the quality and speed of subsequent variant calling steps.

Merge lane level BAMs to individual

  • This step only needs to run if you have multiple lanes per sample.
java -Xmx10g -XX:ParallelGCThreads=10 -Djava.io.tmpdir=/tmp MergeSamFiles.jar
    INPUT=[Lane 1 bam file]
    INPUT=[Lane 2 bam file]
    INPUT=[ ... ]
    OUTPUT=Sample1.bam                          
    VALIDATION_STRINGENCY: LENIENT
    MAX_RECORDS_IN_RAM: 5000000
    CREATE_INDEX: True
    SORT_ORDER: coordinate
    ASSUME_SORTED: True 
    USE_THREADING: True
    2> MergeSamFiles.report

Mark Duplicates

Remove PCR/Optical duplicate reads

java -Xmx10g -XX:ParallelGCThreads=10 -Djava.io.tmpdir=/tmp MarkDuplicates.jar
   INPUT=[bam files]
   OUTPUT=[dedup bam files]
   METRICS_FILE=lane1_dup_metrics.txt  
   VALIDATION_STRINGENCY: LENIENT
   MAX_RECORDS_IN_RAM: 5000000
   CREATE_INDEX: True
   ASSUME_SORTED: True       
   2> MarkDuplicates.log

Currently all duplicates are flagged to allow GATK to handle them.

BAM Quality Control

  • CollectMultipleMetrics
java -Xmx10g -XX:ParallelGCThreads=10 -Djava.io.tmpdir=/tmp 
   CollectMultipleMetrics.jar 
   I=[dedup bam files]
  O=[dedup bam files Metrics]
   R= human_g1k_v37_decoy.fasta                                                    
   VALIDATION_STRINGENCY=LENIENT                                             
   PROGRAM: QualityScoreDistribution
  &> Picard_CollectMultipleMetrics.log
  • idxstats
samtools idxstats [dedup bam files] > dedup-bamfile.stats

Now the pipeline will take idxstats ouput and check for unmapped reads.

Local Realignment of Indels

  • RealignerTargetCreator
java -Xmx10g -Djava.io.tmpdir=/tmp GenomeAnalysisTK.jar                            
   -T RealignerTargetCreator
   -I [bam files]
   -R human_g1k_v37_decoy.fasta                              
   -known /data/GATK_Bundle/Mills_and_1000G_gold_standard.indels.b37.vcf
   -known /data/GATK_Bundle/1000G_phase1.indels.b37.vcf
   -o bam_file_realign.intervals
   -nt 24                                              
   &> RealignerTargetCreator.log
  • IndelRealigner
java -Xmx10g -Djava.io.tmpdir=/tmp GenomeAnalysisTK.jar
   -T IndelRealigner 
   -R human_g1k_v37_decoy.fasta
   -I [bam files]
   -targetIntervals  realign.intervals
   -known Mills_and_1000G_gold_standard.indels.b37.vcf
   -known 1000G_phase1.indels.b37.vcf
   -o [dedup_realign bam files]

BaseRecalibration & PrintReads

  • BaseRecalibrator
java -Xmx10g -Djava.io.tmpdir=/tmp GenomeAnalysisTK.jar
  -T BaseRecalibrator
  -I [bam files]
  -R human_g1k_v37_decoy.fasta
  -knownSites /data/GATK_Bundle/dbsnp_137.b37.vcf
  -o [sorted_Dedup_realign_recal_data.table files]
  &> GATK_BaseRecalibrator.log
  
  • PrintReads
java -Xmx10g -Djava.io.tmpdir=/tmp GenomeAnalysisTK.jar
  -T PrintReads                       
  -I Sample1.realign.bam              
  -o Sample1.recal.bam                
  -R human_g1k_v37_decoy.fasta              
  -BQSR recalibration_report.grp      

Variant Calling

HaplotypeCaller

  • Now HaplotypeCaller handels SNP and INDEL calls.
java -Xmx10g -Djava.io.tmpdir=/tmp GenomeAnalysisTK.jar
  -T HaplotypeCaller                  
  -I [bam files]
  -o [raw.snps.indels.gvcf files]             
  -R human_g1k_v37_decoy.fasta
  -variant_index_type LINEAR
  -stand_call_conf 30.0
  -stand_emit_conf 30.0
  -emitRefConfidence GVCF
  -variant_index_parameter 128000
  --min_base_quality_score 20
  -L NCBI Ref_GRCh37 exon.region.list
  &> GATK_HaplotypeCaller.log

CombineGVCFs

java -Xmx10g -Djava.io.tmpdir=/tmp GenomeAnalysisTK.jar
  -T CombineGVCFs
  -R human_g1k_v37_decoy.fasta
  -variant [all gvcf files created by HaplotypeCaller]
  &> GATK_CombineGVCF.log

GenotypeGVCFs

java -Xmx10g -Djava.io.tmpdir=/tmp GenomeAnalysisTK.jar
  -T GenotypeGVCFs
  -R human_g1k_v37_decoy.fasta
  -variant [sampe_mergeGvcf.vcf]
  -variant [1000G pre-combined .gvcf files]
  -o [sample+background_genotyped.vcf]
  &> GATK_GenotypeGVCF.log
  -o [sampe_mergeGvcf.vcf]

VariantRecalibrator

  • SNP Recalibration
java -Xmx10g -Djava.io.tmpdir=/tmp GenomeAnalysisTK.jar
  -T VariantRecalibrator
  -R human_g1k_v37_decoy.fasta
  -resource:hapmap,known=false,training=true,truth=true,prior=15.0 /data/GATK_Bundle/hapmap_3.3.b37.vcf 
  -resource:omni,known=false,training=true,truth=true,prior=12.0 /data/GATK_Bundle/1000G_omni2.5.b37.vcf 
  -resource:1000G,known=false,training=true,truth=false,prior=10.0 /data/GATK_Bundle/1000G_phase1.snps.high_confidence.b37.vcf 
  -an QD -an MQRankSum -an ReadPosRankSum -an FS
  -input [sample+background_genotyped.vcf]
  -recalFile [sample_snp_recal]
  -tranchesFile [sample_snp_tranches]
  -rscriptFile [sample_snp_plots.R]
  -mode SNP 
  &> GATK_VariantRecalibrator_SNP.log
  • INDEL Recalibration
java -Xmx10g -Djava.io.tmpdir=/tmp GenomeAnalysisTK.jar
  -T VariantRecalibrator
  -R human_g1k_v37_decoy.fasta
  -resource:mills,known=false,training=true,truth=true,prior=12.0 /data/GATK_Bundle/Mills_and_1000G_gold_standard.indels.b37.vcf 
  -resource:1000G,known=false,training=true,truth=true,prior=10.0 /data/GATK_Bundle/1000G_phase1.indels.b37.vcf 
  -an MQRankSum -an ReadPosRankSum -an FS
  -numBadVariants: 5000
  -mode INDEL
  -input [sample+background_genotyped.vcf]
  -recalFile [sample_indel_recal]
  -tranchesFile [sample_indel_tranches]
  -rscriptFile [sample_indel_plots.R]
  -mode INDEL

ApplyRecalibration

  • SNP Apply
java -Xmx10g -Djava.io.tmpdir=/tmp GenomeAnalysisTK.jar
  -T ApplyRecalibration
  -input [genotyped.vcf]
  -o [recal_SNP.vcf]
  -R human_g1k_v37_decoy.fasta
  -ts_filter_level 99.0
  -excludeFiltered
  -tranchesFile [sample.snp.tranches]
  -recalFile [sample.snp.recal]
  -mode SNP 
  &> ApplyRecalibration_SNP.report
  • INDEL Apply
java -Xmx10g -Djava.io.tmpdir=/tmp GenomeAnalysisTK.jar
  -T ApplyRecalibration
  -input [genotyped.vcf]
  -o [recal_INDEL.vcf]
  -R human_g1k_v37_decoy.fasta
  -ts_filter_level 99.0
  -excludeFiltered
  -tranchesFile [sample.indel.tranches]
  -recalFile [sample.indel.recal]
  -mode INDEL
  &> ApplyRecalibration_INDEL.report

CombineVarients

These command will combine INDEL and SNP files into a single VCF file.

  • CombineVarients
java -Xmx10g -Djava.io.tmpdir=/tmp GenomeAnalysisTK.jar
  -T CombineVariants
  -R human_g1k_v37_decoy.fasta
  --variant cleaned_recal_SNP.file
  --variant cleaned_recal_INDEL.file
  -o [sample+background_Final.vcf]
  &> CombineVarients.report

Variant File QC

Quality Metrics on variants

  • Ti/Tv Ratio (2.1 for WGS ~2.8 for exome)
  • HapMap concordance
  • SNV/Indel Counts
  • Rare variant enrichment
  • DP
  • Q
  • GQ