diff gatk4_Mutect2.xml @ 1:fd2d6e035c3f draft

"planemo upload for repository https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/gatk4 commit 5d2fd48454149b3cfa39aaba71e3b19f89087516"
author iuc
date Mon, 18 Nov 2019 13:45:47 -0500
parents f41a1e03538b
children 3be27a9a7313
line wrap: on
line diff
--- a/gatk4_Mutect2.xml	Wed Oct 30 15:33:59 2019 -0400
+++ b/gatk4_Mutect2.xml	Mon Nov 18 13:45:47 2019 -0500
@@ -1,4 +1,4 @@
-<tool id="gatk4_mutect2" name="GATK4 Mutect2" version="@WRAPPER_VERSION@0" profile="18.05">
+<tool id="gatk4_mutect2" name="GATK4 Mutect2" version="@WRAPPER_VERSION@1" profile="18.05">
     <description>- Call somatic SNVs and indels via local assembly of haplotypes</description>
     <macros>
         <import>macros.xml</import>
@@ -62,16 +62,6 @@
                 #end if
             #end if
 
-            #if $optional.population_callset
-                #set datatype = $optional.population_callset.datatype
-                #if $optional.population_callset.is_of_type("vcf_bgzip")
-                    ln -s '$optional.population_callset' population_callset.vcf.gz &&
-                    tabix population_callset.vcf.gz &&
-                #else
-                    ln -s '$optional.population_callset' population_callset.vcf &&
-                #end if
-            #end if
-
             #if $optional.alleles
                 #set datatype = $optional.alleles.datatype
                 #if $optional.alleles.is_of_type("vcf_bgzip")
@@ -90,34 +80,6 @@
 
         #include source=$gatk_bam_input#
 
-        ## COMMON PARAMETERS ##
-
-        #if str($common.common_parameters) == 'yes'
-
-            #if $common.read_filter
-                #for $filter in str($common.read_filter).split(',')
-                    --read-filter="$filter"
-                #end for
-            #end if
-
-            #if $common.disable_read_filter
-                #for $filter in str($common.disable_read_filter).split(',')
-                    --disable-read-filter="$filter"
-                #end for
-            #end if
-
-            --verbosity="ERROR"
-            --read-validation-stringency="$common.read_validation_stringency"
-            --interval-set-rule="$common.interval_set_rule"
-            $common.lenient
-            $common.disable_tool_default_read_filters
-            $common.add_output_sam_program_record
-            $common.add_output_vcf_command_line
-
-        #end if
-
-        ## END COMMON PARAMETERS ##
-
         ## OPTIONAL PARAMETERS ##
 
         #if str($optional.optional_parameters) == 'yes'
@@ -172,26 +134,71 @@
                 --alleles alleles.vcf
             #end if
 
+            #if $optional.f1r2_max_depth:
+                --f1r2-max-depth="$optional.f1r2_max_depth"
+            #end if
+
+            #if $optional.f1r2_max_depth:
+                --f1r2-median-mq="$optional.f1r2_median_mq"
+            #end if
+
+            #if $optional.f1r2_max_depth:
+                --f1r2-min-bq="$optional.f1r2_min_bq"
+            #end if
+
+            #if $optional.interval_merging_rule:
+                --interval-merging-rule="$optional.interval_merging_rule"
+            #end if
+
+            #if $optional.interval_set_rule:
+                --interval-set-rule="$optional.interval_set_rule"
+            #end if
+
+            #if $optional.pcr_indel_qual:
+                --pcr-indel-qual="$optional.pcr_indel_qual"
+            #end if
+
+            #if $optional.pcr_snv_qual:
+                --pcr-snv-qual="$optional.pcr_snv_qual"
+            #end if
+
+            #if $optional.read_filter
+                #for $filter in str($optional.read_filter).split(',')
+                    --read-filter="$filter"
+                #end for
+            #end if
+
+            #if $optional.disable_read_filter
+                #for $filter in str($optional.disable_read_filter).split(',')
+                    --disable-read-filter="$filter"
+                #end for
+            #end if
+
             --base-quality-score-threshold="$optional.base_quality_score_threshold"
             --af-of-alleles-not-in-resource="$optional.af_of_alleles_not_in_resource"
             --downsampling-stride="$optional.downsampling_stride"
             --gcs-max-retries="$optional.gcs_max_retries"
             --initial-tumor-lod="$optional.initial_tumor_lod"
-            --interval-merging-rule="$optional.interval_merging_rule"
             --max-population-af="$optional.max_population_af"
             --max-reads-per-alignment-start="$optional.max_reads_per_alignment_start"
             --min-base-quality-score="$optional.min_base_quality_score"
             --native-pair-hmm-threads="\${GALAXY_SLOTS:-1}"
             --normal-lod="$optional.normal_lod"
+            --read-validation-stringency="$optional.read_validation_stringency"
             --tumor-lod-to-emit="$optional.tumor_lod_to_emit"
+            --verbosity="ERROR"
+            $optional.lenient
             $optional.annotate_with_num_discovered_alleles
+            $optional.add_output_sam_program_record
             $optional.disable_bam_index_caching
             $optional.disable_sequence_dictionary_validation
             $optional.genotype_germline_sites
             $optional.genotype_pon_sites
+            $optional.ignore_itr_artifacts
+            $optional.mitochondria_mode
             $optional.native_pair_hmm_use_double_precision
             $optional.sites_only_vcf_output
-            $optional.use_new_qual_calculator
+            $optional.add_output_vcf_command_line
         #end if
 
         ## END OPTIONAL PARAMETERS ##
@@ -200,12 +207,20 @@
 
         #if str($advanced.advanced_parameters) == 'yes'
 
-            #if $advanced.input_prior
-                --input-prior="$advanced.input_prior"
+            #if $advanced.kmer_size
+                --kmer-size="$advanced.kmer_size"
             #end if
 
-            #if $advanced.kmer_size
-                --kmer-size="$advanced.kmer_size"
+            #if $advanced.gvcf_lod_band
+                --gvcf-lod-band="$advanced.gvcf_lod_band"
+            #end if
+
+            #if $advanced.emit_ref_confidence
+                --emit-ref-confidence="$advanced.emit_ref_confidence"
+            #end if
+
+            #if $advanced.max_unpruned_variants
+                --max-unpruned-variants="$advanced.max_unpruned_variants"
             #end if
 
             --active-probability-threshold="$advanced.active_probability_threshold"
@@ -219,22 +234,26 @@
             --min-assembly-region-size="$advanced.min_assembly_region_size"
             --min-dangling-branch-length="$advanced.min_dangling_branch_length"
             --min-pruning="$advanced.min_pruning"
+            --minimum-allele-fraction="$advanced.minimum_allele_fraction"
             --num-pruning-samples="$advanced.num_pruning_samples"
             --pair-hmm-gap-continuation-penalty="$advanced.pair_hmm_gap_continuation_penalty"
             --pair-hmm-implementation="$advanced.pair_hmm_implementation"
             --pcr-indel-model="$advanced.pcr_indel_model"
             --phred-scaled-global-read-mismapping-rate="$advanced.phred_scaled_global_read_mismapping_rate"
+            --pruning-lod-threshold="$advanced.pruning_lod_threshold"
             --smith-waterman="$advanced.smith_waterman"
-            $advanced.all_site_pls
             $advanced.allow_non_unique_kmers_in_ref
-            $advanced.consensus
+            $advanced.disable_adaptive_pruning
             $advanced.disable_tool_default_annotations
-            $advanced.do_not_run_physical_phasing
+            $advanced.disable_tool_default_read_filters
             $advanced.dont_increase_kmer_sizes_for_cycles
             $advanced.dont_trim_active_regions
             $advanced.dont_use_soft_clipped_bases
             $advanced.enable_all_annotations
-            $advanced.genotype_filtered_alleles
+            $advanced.force_active
+            $advanced.force_call_filtered_alleles
+            $advanced.independent_mates
+            $advanced.recover_all_dangling_branches
             $advanced.use_filtered_reads_for_annotations
 
         #end if
@@ -265,85 +284,17 @@
         <expand macro="gatk_bam_req_params"/>
         <expand macro="gzip_vcf_params"/>
         <expand macro="ref_sel"/>
-        <conditional name="common">
-            <param name="common_parameters" type="select" label="Common parameters">
-                <option value="no">Use internal defaults</option>
-                <option value="yes">Specify parameters</option>
-            </param>
-            <when value="yes">
-                <expand macro="gatk_excl_ints"/>
-                <expand macro="seq_dict_sel"/>
-                <param name="add_output_sam_program_record" argument="--add-output-sam-program-record" type="boolean" truevalue="--add-output-sam-program-record" falsevalue="" optional="true" checked="true" label="Add Output Sam Program Record" help="If true, adds a PG tag to created SAM/BAM/CRAM files."/>
-                <param name="add_output_vcf_command_line" argument="--add-output-vcf-command-line" type="boolean" truevalue="--add-output-vcf-command-line" falsevalue="" optional="true" checked="true" label="Add Output Vcf Command Line" help="If true, adds a command line header line to created VCF files."/>
-                <param name="disable_read_filter" argument="--disable-read-filter" type="select" multiple="true" value="" label="Disable Read Filter" help="Read filters to be disabled before analysis">
-                    <option value="GoodCigarReadFilter">Good cigar string</option>
-                    <option value="MappedReadFilter">Mapped read</option>
-                    <option value="MappingQualityAvailableReadFilter">Mapping quality available</option>
-                    <option value="MappingQualityNotZeroReadFilter">Mapping quality not zero</option>
-                    <option value="NonChimericOriginalAlignmentReadFilter">Non-chimeric original alignment</option>
-                    <option value="NonZeroReferenceLengthAlignmentReadFilter">Non-zero reference length alignment</option>
-                    <option value="NotDuplicateReadFilter">Not a duplicate read</option>
-                    <option value="NotSecondaryAlignmentReadFilter">Not a secondary alignment</option>
-                    <option value="PassesVendorQualityCheckReadFilter">Passes vendor quality check</option>
-                    <option value="WellformedReadFilter">Well-formed read</option>
-                </param>
-                <param name="disable_tool_default_read_filters" argument="--disable-tool-default-read-filters" type="boolean" truevalue="--disable-tool-default-read-filters" falsevalue="" optional="true" checked="false" label="Disable Tool Default Read Filters" help="Disable all tool default read filters (WARNING: many tools will not function correctly without their default read filters on)"/>
-                <param name="interval_set_rule" argument="--interval-set-rule" type="select" optional="true" label="Interval Set Rule" help="Set merging approach to use for combining interval inputs">
-                    <option selected="true" value="UNION">Union</option>
-                    <option value="INTERSECTION">Intersection</option>
-                </param>
-                <param name="lenient" argument="--lenient" type="boolean" truevalue="--lenient" falsevalue="" optional="true" checked="false" label="Lenient" help="Lenient processing of VCF files"/>
-                <param name="read_filter" argument="--read-filter" type="select" multiple="true" value="" label="Read Filter" help="Read filters to be applied before analysis">
-                    <option value="AlignmentAgreesWithHeaderReadFilter">Alignment agrees with header</option>
-                    <option value="AllowAllReadsReadFilter">Allow all reads</option>
-                    <option value="AmbiguousBaseReadFilter">Ambiguous base</option>
-                    <option value="CigarContainsNoNOperator">Cigar contains no NO operator</option>
-                    <option value="FirstOfPairReadFilter">First of pair</option>
-                    <option value="GoodCigarReadFilter">Good cigar string</option>
-                    <option value="HasReadGroupReadFilter">Has read group</option>
-                    <option value="MappedReadFilter">Mapped read</option>
-                    <option value="MappingQualityAvailableReadFilter">Mapping quality available</option>
-                    <option value="MappingQualityNotZeroReadFilter">Mapping quality not zero</option>
-                    <option value="MatchingBasesAndQualsReadFilter">Matching bases and quals</option>
-                    <option value="MateDifferentStrandReadFilter">Mate different strand</option>
-                    <option value="MateOnSameContigOrNoMappedMateReadFilter">Mate on same contig or no mapped mate</option>
-                    <option value="MateUnmappedAndUnmappedReadFilter">Mate unmapped and mapped</option>
-                    <option value="MetricsReadFilter">Metrics</option>
-                    <option value="NonChimericOriginalAlignmentReadFilter">Non-chimeric original alignment</option>
-                    <option value="NonZeroFragmentLengthReadFilter">Non-zero fragment length</option>
-                    <option value="NonZeroReferenceLengthAlignmentReadFilter">Non-zero reference length alignment</option>
-                    <option value="NotDuplicateReadFilter">Not duplicate</option>
-                    <option value="NotOpticalDuplicateReadFilter">Not optical duplicate</option>
-                    <option value="NotSecondaryAlignmentReadFilter">Not a secondary alignment</option>
-                    <option value="NotSupplementaryAlignmentReadFilter">Not a supplementary alignment</option>
-                    <option value="OverclippedReadFilter">Overclipped</option>
-                    <option value="PairedReadFilter">Paired</option>
-                    <option value="PassesVendorQualityCheckReadFilter">Passes vendor quality check</option>
-                    <option value="PrimaryLineReadFilter">Primary line</option>
-                    <option value="ProperlyPairedReadFilter">Properly paired</option>
-                    <option value="ReadLengthEqualsCigarLengthReadFilter">Read length equals cigar length</option>
-                    <option value="SecondOfPairReadFilter">Second of pair</option>
-                    <option value="SeqIsStoredReadFilter">Sequence is stored</option>
-                    <option value="SoftClippedReadFilter">Soft clipped</option>
-                    <option value="ValidAlignmentStartReadFilter">Valid alignment start</option>
-                    <option value="ValidAlignmentEndReadFilter">Valid alignment end</option>
-                    <option value="WellformedReadFilter">Well-formed read</option>
-                </param>
-                <param name="read_validation_stringency" argument="--read-validation-stringency" type="select" optional="true" label="Read Validation Stringency" help="Validation stringency for all SAM/BAM/CRAM/SRA files read by this program.  The default stringency value SILENT can improve performance when processing a BAM file in which variable-length data (read, qualities, tags) do not otherwise need to be decoded.">
-                    <option selected="true" value="SILENT">Silent</option>
-                    <option value="STRICT">Strict</option>
-                    <option value="LENIENT">Lenient</option>
-                </param>
-            </when>
-            <when value="no" />
-        </conditional>
         <conditional name="optional">
             <param name="optional_parameters" type="select" label="Optional parameters">
                 <option value="no">Use internal defaults</option>
                 <option value="yes">Specify parameters</option>
             </param>
             <when value="yes">
+                <expand macro="gatk_excl_ints"/>
                 <expand macro="gatk_ints"/>
+                <expand macro="seq_dict_sel"/>
+                <param name="add_output_sam_program_record" argument="--add-output-sam-program-record" type="boolean" truevalue="--add-output-sam-program-record" falsevalue="" optional="true" checked="true" label="Add Output Sam Program Record" help="If true, adds a PG tag to created SAM/BAM/CRAM files."/>
+                <param name="add_output_vcf_command_line" argument="--add-output-vcf-command-line" type="boolean" truevalue="--add-output-vcf-command-line" falsevalue="" optional="true" checked="true" label="Add Output Vcf Command Line" help="If true, adds a command line header line to created VCF files."/>
                 <param name="af_of_alleles_not_in_resource" argument="--af-of-alleles-not-in-resource" type="float" optional="true" value="-1.0" label="Af Of Alleles Not In Resource" help="Population allele fraction assigned to alleles not found in germline resource.  Please see docs/mutect/mutect2.pdf fora derivation of the default value."/>
                 <param name="annotate_with_num_discovered_alleles" argument="--annotate-with-num-discovered-alleles" type="boolean" truevalue="--annotate-with-num-discovered-alleles" falsevalue="" optional="true" checked="false" label="Annotate With Num Discovered Alleles" help="If provided, we will annotate records with the number of alternate alleles that were discovered (but not necessarily genotyped) at a given site"/>
                 <param argument="--annotation" type="select" multiple="true" label="Annotations" help="One or more specific annotations to add to variant calls">
@@ -440,10 +391,62 @@
                 </param>
                 <param name="pedigree" argument="--pedigree" type="data" optional="true" format="vcf,vcf_bgzip" label="Pedigree" help="Pedigree file for determining the population &quot;founders&quot;. If a file is provided here, a pedigree-based annotation must be added above."/>
                 <param name="base_quality_score_threshold" argument="--base-quality-score-threshold" type="integer" optional="true" value="18" label="Base Quality Score Threshold" help="Base qualities below this threshold will be reduced to the minimum (6)"/>
+                <param name="callable_depth" argument="--callable-depth" type="integer" optional="true" value="10" label="Minimum depth to be considered callable" help="Does not affect genotyping"/>
                 <param name="contamination_fraction_to_filter" argument="--contamination-fraction-to-filter" type="float" optional="true" value="0.0" label="Contamination Fraction To Filter" help="Fraction of contamination in sequencing data (for all samples) to aggressively remove"/>
                 <param name="disable_bam_index_caching" argument="--disable-bam-index-caching" type="boolean" truevalue="--disable-bam-index-caching" falsevalue="" optional="true" checked="false" label="Disable Bam Index Caching" help="If true, don&amp;apos;t cache bam indexes, this will reduce memory requirements but may harm performance if many intervals are specified.  Caching is automatically disabled if there are no intervals specified."/>
+                <param name="disable_read_filter" argument="--disable-read-filter" type="select" multiple="true" value="" label="Disable Read Filter" help="Read filters to be disabled before analysis">
+                    <option value="GoodCigarReadFilter">Good cigar string</option>
+                    <option value="MappedReadFilter">Mapped read</option>
+                    <option value="MappingQualityAvailableReadFilter">Mapping quality available</option>
+                    <option value="MappingQualityNotZeroReadFilter">Mapping quality not zero</option>
+                    <option value="NonChimericOriginalAlignmentReadFilter">Non-chimeric original alignment</option>
+                    <option value="NonZeroReferenceLengthAlignmentReadFilter">Non-zero reference length alignment</option>
+                    <option value="NotDuplicateReadFilter">Not a duplicate read</option>
+                    <option value="NotSecondaryAlignmentReadFilter">Not a secondary alignment</option>
+                    <option value="PassesVendorQualityCheckReadFilter">Passes vendor quality check</option>
+                    <option value="WellformedReadFilter">Well-formed read</option>
+                </param>
+                <param name="read_filter" argument="--read-filter" type="select" multiple="true" value="" label="Read Filter" help="Read filters to be applied before analysis">
+                    <option value="AlignmentAgreesWithHeaderReadFilter">Alignment agrees with header</option>
+                    <option value="AllowAllReadsReadFilter">Allow all reads</option>
+                    <option value="AmbiguousBaseReadFilter">Ambiguous base</option>
+                    <option value="CigarContainsNoNOperator">Cigar contains no NO operator</option>
+                    <option value="FirstOfPairReadFilter">First of pair</option>
+                    <option value="GoodCigarReadFilter">Good cigar string</option>
+                    <option value="HasReadGroupReadFilter">Has read group</option>
+                    <option value="MappedReadFilter">Mapped read</option>
+                    <option value="MappingQualityAvailableReadFilter">Mapping quality available</option>
+                    <option value="MappingQualityNotZeroReadFilter">Mapping quality not zero</option>
+                    <option value="MatchingBasesAndQualsReadFilter">Matching bases and quals</option>
+                    <option value="MateDifferentStrandReadFilter">Mate different strand</option>
+                    <option value="MateOnSameContigOrNoMappedMateReadFilter">Mate on same contig or no mapped mate</option>
+                    <option value="MateUnmappedAndUnmappedReadFilter">Mate unmapped and mapped</option>
+                    <option value="MetricsReadFilter">Metrics</option>
+                    <option value="NonChimericOriginalAlignmentReadFilter">Non-chimeric original alignment</option>
+                    <option value="NonZeroFragmentLengthReadFilter">Non-zero fragment length</option>
+                    <option value="NonZeroReferenceLengthAlignmentReadFilter">Non-zero reference length alignment</option>
+                    <option value="NotDuplicateReadFilter">Not duplicate</option>
+                    <option value="NotOpticalDuplicateReadFilter">Not optical duplicate</option>
+                    <option value="NotSecondaryAlignmentReadFilter">Not a secondary alignment</option>
+                    <option value="NotSupplementaryAlignmentReadFilter">Not a supplementary alignment</option>
+                    <option value="OverclippedReadFilter">Overclipped</option>
+                    <option value="PairedReadFilter">Paired</option>
+                    <option value="PassesVendorQualityCheckReadFilter">Passes vendor quality check</option>
+                    <option value="PrimaryLineReadFilter">Primary line</option>
+                    <option value="ProperlyPairedReadFilter">Properly paired</option>
+                    <option value="ReadLengthEqualsCigarLengthReadFilter">Read length equals cigar length</option>
+                    <option value="SecondOfPairReadFilter">Second of pair</option>
+                    <option value="SeqIsStoredReadFilter">Sequence is stored</option>
+                    <option value="SoftClippedReadFilter">Soft clipped</option>
+                    <option value="ValidAlignmentStartReadFilter">Valid alignment start</option>
+                    <option value="ValidAlignmentEndReadFilter">Valid alignment end</option>
+                    <option value="WellformedReadFilter">Well-formed read</option>
+                </param>
                 <param name="disable_sequence_dictionary_validation" argument="--disable-sequence-dictionary-validation" type="boolean" truevalue="--disable-sequence-dictionary-validation" falsevalue="" optional="true" checked="false" label="Disable Sequence Dictionary Validation" help="If specified, do not check the sequence dictionaries from our inputs for compatibility. Use at your own risk!"/>
                 <param name="downsampling_stride" argument="--downsampling-stride" type="integer" optional="true" value="1" label="Downsampling Stride" help="Downsample a pool of reads starting within a range of one or more bases."/>
+                <param name="f1r2_max_depth" argument="--f1r2-max-depth" type="integer" optional="true" value="200" label="Sites with depth higher than this value will be grouped" />
+                <param name="f1r2_median_mq" argument="--f1r2-median-mq" type="integer" optional="true" value="50" label="Skip sites with median mapping quality below this value" />
+                <param name="f1r2_min_bq" argument="--base-quality-score-threshold" type="integer" optional="true" value="20" label="Exclude bases below this quality from pileup" />
                 <param name="founder_id" argument="--founder-id" type="text" optional="true" value="" label="Founder Id" help="Samples representing the population &amp;quot;founders&amp;quot;"/>
                 <param name="gcs_max_retries" argument="--gcs-max-retries" type="integer" optional="true" value="20" label="Gcs Max Retries" help="If the GCS bucket channel errors out, how many times it will attempt to re-initiate the connection"/>
                 <param name="genotype_germline_sites" argument="--genotype-germline-sites" type="boolean" truevalue="--genotype-germline-sites" falsevalue="" optional="true" checked="false" label="Genotype Germline Sites" help="(EXPERIMENTAL) Call all apparent germline site even though they will ultimately be filtered."/>
@@ -452,32 +455,38 @@
                 <param name="germline_resource" argument="--germline-resource" type="data" optional="true" format="vcf,vcf_bgzip" label="Germline Resource" help="Population vcf of germline sequencing containing allele fractions."/>
                 <param name="heterozygosity" argument="--heterozygosity" type="float" optional="true" value="0.001" label="Heterozygosity" help="The expected heterozygosity value used to compute prior probability that a locus is non-reference. The default priors are for provided for humans: het = 1e-3 which means that the probability of N samples being hom-ref at a site is: 1 - sum_i_2N (het / i) Note that heterozygosity as used here is the population genetics concept: http://en.wikipedia.org/wiki/Zygosity#Heterozygosity_in_population_genetics That is, a hets value of 0.01 implies that two randomly chosen chromosomes from the population of organisms would differ from each other (one being A and the other B) at a rate of 1 in 100 bp. Note that this quantity has nothing to do with the likelihood of any given sample having a heterozygous genotype, which in the GATK is purely determined by the probability of the observed data P(D | AB) under the model that there may be a AB het genotype. The posterior probability of this AB genotype would use the het prior, but the GATK only uses this posterior probability in determining the prob. that a site is polymorphic. So changing the het parameters only increases the chance that a site will be called non-reference across all samples, but doesn't actually change the output genotype likelihoods at all, as these aren't posterior probabilities at all. The quantity that changes whether the GATK considers the possibility of a het genotype at all is the ploidy, which determines how many chromosomes each individual in the species carries."/>
                 <param name="heterozygosity_stdev" argument="--heterozygosity-stdev" type="float" optional="true" value="0.01" label="Heterozygosity Stdev" help="Standard deviation of heterozygosity for SNP and indel calling."/>
+                <param name="ignore_itr_artifacts" argument="--ignore-itr-artifacts" type="boolean" truevalue="--ignore-itr-artifacts" falsevalue="" optional="true" checked="false" label="Turn off read transformer that clips artifacts associated with end repair insertions near inverted tandem repeats" />
                 <param name="indel_heterozygosity" argument="--indel-heterozygosity" type="float" optional="true" value="0.000125" label="Indel Heterozygosity" help="Heterozygosity for indel calling.  See the GATKDocs for heterozygosity for full details on the meaning of this population genetics concept"/>
                 <param name="initial_tumor_lod" argument="--initial-tumor-lod" type="float" optional="true" value="2.0" label="Initial Tumor Lod" help="LOD threshold to consider pileup active."/>
+                <param name="interval_exclusion_padding" argument="--interval-exclusion-padding" type="integer" value="0" label="Interval exclusion padding" help="Amount of padding (in bp) to add to each interval you are excluding" />
+                <param name="interval_padding" argument="--interval-padding" type="integer" value="0" label="Interval padding" help="Amount of padding (in bp) to add to each interval you are including" />
                 <param name="interval_merging_rule" argument="--interval-merging-rule" type="select" optional="true" label="Interval Merging Rule" help="Interval merging rule for abutting intervals">
                     <option selected="true" value="ALL">All</option>
                     <option value="OVERLAPPING_ONLY">Overlapping only</option>
                 </param>
+                <param name="interval_set_rule" argument="--interval-set-rule" type="select" optional="true" label="Interval Set Rule" help="Set merging approach to use for combining interval inputs">
+                    <option selected="true" value="UNION">Union</option>
+                    <option value="INTERSECTION">Intersection</option>
+                </param>
+                <param name="lenient" argument="--lenient" type="boolean" truevalue="--lenient" falsevalue="" optional="true" checked="false" label="Lenient" help="Lenient processing of VCF files"/>
                 <param name="max_population_af" argument="--max-population-af" type="float" optional="true" value="0.01" label="Max Population Af" help="Maximum population allele frequency in tumor-only mode."/>
                 <param name="max_reads_per_alignment_start" argument="--max-reads-per-alignment-start" type="integer" optional="true" value="50" label="Max Reads Per Alignment Start" help="Maximum number of reads to retain per alignment start position. Reads above this threshold will be downsampled. Set to 0 to disable."/>
                 <param name="min_base_quality_score" argument="--min-base-quality-score" type="integer" optional="true" value="10" label="Min Base Quality Score" help="Minimum base quality required to consider a base for calling"/>
+                <param name="mitochondria_mode" argument="--mitochondria-mode" type="boolean" truevalue="--mitochondria-mode" falsevalue="" label="Mitochondria mode sets emission and initial LODs to 0" />
                 <param name="native_pair_hmm_use_double_precision" argument="--native-pair-hmm-use-double-precision" type="boolean" truevalue="--native-pair-hmm-use-double-precision" falsevalue="" optional="true" checked="false" label="Native Pair Hmm Use Double Precision" help="use double precision in the native pairHmm. This is slower but matches the java implementation better"/>
                 <param name="normal_lod" argument="--normal-lod" type="float" optional="true" value="2.2" label="Normal Lod" help="LOD threshold for calling normal variant non-germline."/>
                 <param name="normal_sample" argument="--normal-sample" type="text" optional="true" value="" label="Normal Sample" help="BAM sample name of normal.  May be URL-encoded as output by GetSampleName with -encode argument."/>
-                <param name="num_reference_samples_if_no_call" argument="--num-reference-samples-if-no-call" type="integer" optional="true" value="0" label="Num Reference Samples If No Call" help="Number of hom-ref genotypes to infer at sites not present in a panel"/>
-                <param name="output_mode" argument="--output-mode" type="select" optional="true" label="Output Mode" help="Specifies which type of calls we should output">
-                    <option selected="true" value="EMIT_VARIANTS_ONLY">Variants only</option>
-                    <option value="EMIT_ALL_CONFIDENT_SITES">All confident sites</option>
-                    <option value="EMIT_ALL_SITES">All sites</option>
+                <param name="panel_of_normals" argument="--panel-of-normals" type="data" optional="true" format="vcf,vcf_bgzip" label="Panel Of Normals" help="VCF file of sites observed in normal."/>
+                <param name="pcr_indel_qual" argument="--pcr-indel-qual" type="integer" optional="true" value="40" label="Phred-scaled PCR indel qual for overlapping fragments" />
+                <param name="pcr_snv_qual" argument="--pcr-snv-qual" type="integer" optional="true" value="40" label="Phred-scaled PCR SNV qual for overlapping fragments" />
+                <param name="sites_only_vcf_output" argument="--sites-only-vcf-output" type="boolean" truevalue="--sites-only-vcf-output" falsevalue="" optional="true" checked="false" label="Sites Only Vcf Output" help="If true, don&apos;t emit genotype fields when writing vcf file output."/>
+                <param name="read_validation_stringency" argument="--read-validation-stringency" type="select" optional="true" label="Read Validation Stringency" help="Validation stringency for all SAM/BAM/CRAM/SRA files read by this program.  The default stringency value SILENT can improve performance when processing a BAM file in which variable-length data (read, qualities, tags) do not otherwise need to be decoded.">
+                    <option selected="true" value="SILENT">Silent</option>
+                    <option value="STRICT">Strict</option>
+                    <option value="LENIENT">Lenient</option>
                 </param>
-                <param name="panel_of_normals" argument="--panel-of-normals" type="data" optional="true" format="vcf,vcf_bgzip" label="Panel Of Normals" help="VCF file of sites observed in normal."/>
-                <param name="sites_only_vcf_output" argument="--sites-only-vcf-output" type="boolean" truevalue="--sites-only-vcf-output" falsevalue="" optional="true" checked="false" label="Sites Only Vcf Output" help="If true, don&apos;t emit genotype fields when writing vcf file output."/>
-                <param name="population_callset" argument="--population-callset" type="data" optional="true" format="" label="Population Callset" help="Callset to use in calculating genotype priors"/>
-                <param name="sample_ploidy" argument="--sample-ploidy" type="integer" optional="true" value="2" label="Sample Ploidy" help="Ploidy (number of chromosomes) per sample. For pooled data, set to (Number of samples in each pool * Sample Ploidy)."/>
                 <param name="sites_only_vcf_output" argument="--sites-only-vcf-output" type="boolean" truevalue="--sites-only-vcf-output" falsevalue="" optional="true" checked="false" label="Sites Only Vcf Output" help="If true, don&amp;apos;t emit genotype fields when writing vcf file output."/>
-                <param name="standard_min_confidence_threshold_for_calling" argument="--standard-min-confidence-threshold-for-calling" type="float" optional="true" value="10.0" label="Standard Min Confidence Threshold For Calling" help="The minimum phred-scaled confidence threshold at which variants should be called"/>
                 <param name="tumor_lod_to_emit" argument="--tumor-lod-to-emit" type="float" optional="true" value="3.0" label="Tumor Lod To Emit" help="LOD threshold to emit tumor variant to VCF."/>
-                <param name="use_new_qual_calculator" argument="--use-new-qual-calculator" type="boolean" truevalue="--use-new-qual-calculator" falsevalue="" optional="true" checked="false" label="Use New Qual Calculator" help="If provided, we will use the new AF model instead of the so-called exact model"/>
             </when>
             <when value="no" />
         </conditional>
@@ -488,31 +497,40 @@
             </param>
             <when value="yes">
                 <param name="active_probability_threshold" argument="--active-probability-threshold" type="float" optional="true" value="0.002" label="Active Probability Threshold" help="Minimum probability for a locus to be considered active."/>
-                <param name="all_site_pls" argument="--all-site-pls" type="boolean" truevalue="--all-site-pls" falsevalue="" optional="true" checked="false" label="All Site Pls" help="Annotate all sites with PLs"/>
                 <param name="allow_non_unique_kmers_in_ref" argument="--allow-non-unique-kmers-in-ref" type="boolean" truevalue="--allow-non-unique-kmers-in-ref" falsevalue="" optional="true" checked="false" label="Allow Non Unique Kmers In Ref" help="Allow graphs that have non-unique kmers in the reference"/>
                 <param name="assembly_region_padding" argument="--assembly-region-padding" type="integer" optional="true" value="100" label="Assembly Region Padding" help="Number of additional bases of context to include around each assembly region"/>
                 <param name="bam_writer_type" argument="--bam-writer-type" type="select" optional="true" label="Bam Writer Type" help="Which haplotypes should be written to the BAM">
                     <option selected="true" value="CALLED_HAPLOTYPES">Called haplotypes</option>
                     <option value="ALL_POSSIBLE_HAPLOTYPES">All possible haplotypes</option>
                 </param>
-                <param name="consensus" argument="--consensus" type="boolean" truevalue="--consensus" falsevalue="" optional="true" checked="false" label="Consensus" help="1000G consensus mode"/>
-                <param name="disable_tool_default_annotations" argument="--disable-tool-default-annotations" type="boolean" truevalue="--disable-tool-default-annotations" falsevalue="" optional="true" checked="false" label="Disable Tool Default Annotations" help="Disable all tool default annotations"/>
-                <param name="do_not_run_physical_phasing" argument="--do-not-run-physical-phasing" type="boolean" truevalue="--do-not-run-physical-phasing" falsevalue="" optional="true" checked="false" label="Do Not Run Physical Phasing" help="Disable physical phasing"/>
+
+                <param name="disable_adaptive_pruning" argument="--disable-adaptive-pruning" type="boolean" truevalue="--disable-adaptive-pruning" falsevalue="" optional="true" checked="false" label="Disable adaptive pruning" help="Disable the adaptive algorithm for pruning paths in the graph"/>
+                <param name="disable_tool_default_annotations" argument="--disable-tool-default-annotations" type="boolean" truevalue="--disable-tool-default-annotations" falsevalue="" optional="true" checked="false" label="Disable Default Annotations" help="Disable all tool default annotations"/>
+                <param name="disable_tool_default_read_filters" argument="--disable-tool-default-read-filters" type="boolean" truevalue="--disable-tool-default-read-filters" falsevalue="" optional="true" checked="false" label="Disable default read filters" help="WARNING: many tools will not function correctly without their default read filters on"/>
                 <param name="dont_increase_kmer_sizes_for_cycles" argument="--dont-increase-kmer-sizes-for-cycles" type="boolean" truevalue="--dont-increase-kmer-sizes-for-cycles" falsevalue="" optional="true" checked="false" label="Dont Increase Kmer Sizes For Cycles" help="Disable iterating over kmer sizes when graph cycles are detected"/>
                 <param name="dont_trim_active_regions" argument="--dont-trim-active-regions" type="boolean" truevalue="--dont-trim-active-regions" falsevalue="" optional="true" checked="false" label="Dont Trim Active Regions" help="If specified, we will not trim down the active region from the full region (active + extension) to just the active interval for genotyping"/>
                 <param name="dont_use_soft_clipped_bases" argument="--dont-use-soft-clipped-bases" type="boolean" truevalue="--dont-use-soft-clipped-bases" falsevalue="" optional="true" checked="false" label="Dont Use Soft Clipped Bases" help="Do not analyze soft clipped bases in the reads"/>
+                <param name="emit_ref_confidence" argument="--emit-ref-confidence" type="select" label="Mode for emitting reference confidence scores" help="NOTE: This is a beta feature in Mutect2">
+                    <option value="NONE">None</option>
+                    <option value="BP_RESOLUTION">Basepair resolution</option>
+                    <option value="GVCF">Genomic VCF</option>
+                </param>
                 <param name="enable_all_annotations" argument="--enable-all-annotations" type="boolean" truevalue="--enable-all-annotations" falsevalue="" optional="true" checked="false" label="Enable All Annotations" help="Use all possible annotations (not for the faint of heart)"/>
-                <param name="genotype_filtered_alleles" argument="--genotype-filtered-alleles" type="boolean" truevalue="--genotype-filtered-alleles" falsevalue="" optional="true" checked="false" label="Genotype Filtered Alleles" help="Whether to genotype all given alleles, even filtered ones, --genotyping_mode is GENOTYPE_GIVEN_ALLELES"/>
-                <param name="input_prior" argument="--input-prior" type="float" optional="true" value="" label="Input Prior" help="By default, the prior specified with the heterozygosity argument is used for variant discovery at a particular locus, using an infinite sites model, see e.g. Waterson (1975) or Tajima (1996). This model asserts that the probability of having a population of k variant sites in N chromosomes is proportional to theta/k, for 1=1:N There are instances where using this prior might not be desireable, e.g. for population studies where prior might not be appropriate, as for example when the ancestral status of the reference allele is not known. By using this argument, user can manually specify priors to be used for calling as a vector for doubles, with the following restriciotns: a) User must specify 2N values, where N is the number of samples. b) Only diploid calls supported. c) Probability values are specified in double format, in linear space. d) No negative values allowed. e) Values will be added and Pr(AC=0) will be 1-sum, so that they sum up to one. f) If user-defined values add to more than one, an error will be produced. If user wants completely flat priors, then user should specify the same value (=1/(2*N+1)) 2*N times,e.g. -inputPrior 0.33 -inputPrior 0.33 for the single-sample diploid case."/>
+                <param name="force_active" argument="--force-active" type="boolean" truevalue="--force-active" falsevalue="" optional="true" checked="false" label="Mark all regions active" help="If selected, all regions will be marked as active"/>
+                <param name="force_call_filtered_alleles" argument="--force-call-filtered-alleles" type="boolean" truevalue="--force-call-filtered-alleles" falsevalue="" optional="true" checked="false" label="Force-call filtered alleles" help="Force-call filtered alleles included in the resource specified by --alleles"/>
+                <param name="gvcf_lod_band" argument="--gvcf-lod-band" type="float" optional="true" label="Upper bounds for reference confidence" help="Exclusive upper bounds for reference confidence LOD bands (must be specified in increasing order)" />
+                <param name="independent_mates" argument="--independent-mates" type="boolean" truevalue="--independent-mates" falsevalue="" label="Independent mates" help="Allow paired reads to independently support different haplotypes. Useful for validations with ill-designed synthetic data" />
                 <param name="kmer_size" argument="--kmer-size" type="integer" optional="true" value="" label="Kmer Size" help="Kmer size to use in the read threading assembler"/>
                 <param name="max_assembly_region_size" argument="--max-assembly-region-size" type="integer" optional="true" value="300" label="Max Assembly Region Size" help="Maximum size of an assembly region"/>
                 <param name="max_mnp_distance" argument="--max-mnp-distance" type="integer" optional="true" value="1" label="Max Mnp Distance" help="Two or more phased substitutions separated by this distance or less are merged into MNPs."/>
                 <param name="max_num_haplotypes_in_population" argument="--max-num-haplotypes-in-population" type="integer" optional="true" value="128" label="Max Num Haplotypes In Population" help="Maximum number of haplotypes to consider for your population"/>
                 <param name="max_prob_propagation_distance" argument="--max-prob-propagation-distance" type="integer" optional="true" value="50" label="Max Prob Propagation Distance" help="Upper limit on how many bases away probability mass can be moved around when calculating the boundaries between active and inactive assembly regions"/>
                 <param name="max_suspicious_reads_per_alignment_start" argument="--max-suspicious-reads-per-alignment-start" type="integer" optional="true" value="0" label="Max Suspicious Reads Per Alignment Start" help="Maximum number of suspicious reads (mediocre mapping quality or too many substitutions) allowed in a downsampling stride.  Set to 0 to disable."/>
+                <param name="max_unpruned_variants" argument="--max-unpruned-variants" type="integer" optional="true" value="100" label="Maximum number of variants" help="Maximum number of variants in graph the adaptive pruner will allow"/>
                 <param name="min_assembly_region_size" argument="--min-assembly-region-size" type="integer" optional="true" value="50" label="Min Assembly Region Size" help="Minimum size of an assembly region"/>
                 <param name="min_dangling_branch_length" argument="--min-dangling-branch-length" type="integer" optional="true" value="4" label="Min Dangling Branch Length" help="Minimum length of a dangling branch to attempt recovery"/>
                 <param name="min_pruning" argument="--min-pruning" type="integer" optional="true" value="2" label="Min Pruning" help="Minimum support to not prune paths in the graph"/>
+                <param name="minimum_allele_fraction" argument="--minimum-allele-fraction" type="float" optional="true" value="0.0" label="Fractions to consider" help="Lower bound of variant allele fractions to consider when calculating variant LOD"/>
                 <param name="num_pruning_samples" argument="--num-pruning-samples" type="integer" optional="true" value="1" label="Num Pruning Samples" help="Number of samples that must pass the minPruning threshold"/>
                 <param name="pair_hmm_gap_continuation_penalty" argument="--pair-hmm-gap-continuation-penalty" type="integer" optional="true" value="10" label="Pair Hmm Gap Continuation Penalty" help="Flat gap continuation penalty for use in the Pair HMM"/>
                 <param name="pair_hmm_implementation" argument="--pair-hmm-implementation" type="select" optional="true" label="Pair Hmm Implementation" help="The PairHMM implementation to use for genotype likelihood calculations">
@@ -531,6 +549,8 @@
                     <option value="AGGRESSIVE">Aggressive</option>
                 </param>
                 <param name="phred_scaled_global_read_mismapping_rate" argument="--phred-scaled-global-read-mismapping-rate" type="integer" optional="true" value="45" label="Phred Scaled Global Read Mismapping Rate" help="The global assumed mismapping rate for reads"/>
+                <param name="pruning_lod_threshold" argument="--pruning-lod-threshold" type="float" optional="true" value="2.302585092994046" label="Pruning LOD threshold" help="Likelihood ratio threshold for adaptive pruning algorithm" />
+                <param name="recover_all_dangling_branches" argument="--recover-all-dangling-branches" type="boolean" truevalue="--recover-all-dangling-branches" falsevalue="" label="Recover all dangling branches" />
                 <param name="smith_waterman" argument="--smith-waterman" type="select" optional="true" label="Smith Waterman" help="Which Smith-Waterman implementation to use, generally 'Fastest available' is the right choice">
                     <option selected="true" value="FASTEST_AVAILABLE">Fastest available</option>
                     <option value="AVX_ENABLED">AVX-Enabled</option>
@@ -571,7 +591,6 @@
             <param name="reference_sequence" ftype="fasta" value="reference.fa" />
             <param name="gzipped_output" value="false" />
             <param name="reference_source_selector" value="history" />
-            <param name="common_parameters" value="no" />
             <param name="optional_parameters" value="no" />
             <param name="advanced_parameters" value="no" />
             <param name="output_parameters" value="no" />
@@ -582,7 +601,6 @@
             <param name="reference_sequence" ftype="fasta" value="reference.fa" />
             <param name="gzipped_output" value="false" />
             <param name="reference_source_selector" value="history" />
-            <param name="common_parameters" value="yes" />
             <param name="read_filter" value="AmbiguousBaseReadFilter,FirstOfPairReadFilter,GoodCigarReadFilter" />
             <param name="seqdict_source" value="history" />
             <param name="seqdict_sequence" value="Mutect2-in2.dict" />
@@ -596,7 +614,6 @@
             <param name="reference_sequence" ftype="fasta" value="reference.fa" />
             <param name="gzipped_output" value="false" />
             <param name="reference_source_selector" value="history" />
-            <param name="common_parameters" value="no" />
             <param name="optional_parameters" value="yes" />
             <param name="annotation" value="StrandBiasBySample,BaseQualityHistogram,OrientationBiasReadCounts" />
             <param name="annotation_group" value="StandardMutectAnnotation" />
@@ -609,7 +626,6 @@
             <param name="reference_sequence" ftype="fasta" value="reference.fa" />
             <param name="gzipped_output" value="false" />
             <param name="reference_source_selector" value="history" />
-            <param name="common_parameters" value="no" />
             <param name="optional_parameters" value="yes" />
             <param name="advanced_parameters" value="yes" />
             <param name="dont_trim_active_regions" value="true" />
@@ -621,7 +637,6 @@
             <param name="reference_sequence" ftype="fasta" value="reference.fa" />
             <param name="gzipped_output" value="false" />
             <param name="reference_source_selector" value="history" />
-            <param name="common_parameters" value="no" />
             <param name="optional_parameters" value="no" />
             <param name="advanced_parameters" value="no" />
             <param name="output_parameters" value="yes" />