Mercurial > repos > crs4 > kggseq_variant_selection
view kggseq_variant_selection.xml @ 10:124e64eea35b draft default tip
Fix shell command
author | crs4 |
---|---|
date | Mon, 11 Jun 2018 13:19:34 -0400 |
parents | dc45e612bc47 |
children |
line wrap: on
line source
<tool id="kggseq_variant_selection" name="Variant selection with KGGSeq" version="1.5"> <description></description> <requirements> <requirement type="package" version="1.0_20180410">kggseq</requirement> </requirements> <command> java -jar \$KGGSEQ_JAR_PATH/kggseq.jar ## Environmental settings --buildver hg19 --resource \$KGGSEQ_JAR_PATH/resources --no-lib-check --no-resource-check --no-progress-check --out results --o-vcf --no-gz --vcf-file $inputFile --ped-file $pedFile --db-gene $db_gene $composite_subject_id ## Variant and genotype filters #if str($variant_genotype_filters.variant_genotype_filters_select) == "yes" $variant_genotype_filters.pass_variant_only --seq-qual $variant_genotype_filters.seq_qual --seq-mq $variant_genotype_filters.seq_mq --seq-sb $variant_genotype_filters.seq_sb --seq-fs $variant_genotype_filters.seq_fs --min-heta $variant_genotype_filters.min_heta --min-homa $variant_genotype_filters.min_homa --min-hetu $variant_genotype_filters.min_hetu --min-homu $variant_genotype_filters.min_homu --min-obsa $variant_genotype_filters.min_obsa --min-obsu $variant_genotype_filters.min_obsu --min-obs $variant_genotype_filters.min_obs #if str($variant_genotype_filters.hwe_control) --hwe-control $variant_genotype_filters.hwe_control #end if #if str($variant_genotype_filters.hwe_case) --hwe-case $variant_genotype_filters.hwe_case #end if #if str($variant_genotype_filters.hwe_all) --hwe-all $variant_genotype_filters.hwe_all #end if --gty-qual $variant_genotype_filters.gty_qual --gty-dp $variant_genotype_filters.gty_dp --gty-sec-pl $variant_genotype_filters.gty_sec_pl --gty-af-ref $variant_genotype_filters.gty_af_ref --gty-af-het $variant_genotype_filters.gty_af_het --gty-af-alt $variant_genotype_filters.gty_af_alt #else --no-qc #end if ## Genetic inheritance #if str($genetic_filters.genetic_filters_select) == "yes" #if str($genetic_filters.genetic_model.genetic_model_select) == "yes" #if $genetic_filters.genetic_model.custom_genetic_params --genotype-filter $genetic_filters.genetic_model.custom_genetic_params #end if #else $genetic_filters.genetic_model.suggested_genetic_params #end if #end if ## Homozygosity - IBS - IBD filters #if str($hom_ibs_ibd_filters.hom_ibs_ibd_filters_select) == "yes" #if str($hom_ibs_ibd_filters.homozygosity_case_filter) --homozygosity-case-filter $hom_ibs_ibd_filters.homozygosity_case_filter #end if #if str($hom_ibs_ibd_filters.ibs_case_filter) --ibs-case-filter $hom_ibs_ibd_filters.ibs_case_filter #end if #if str($hom_ibs_ibd_filters.ibd_annot) != 'None' --ibd-annot $hom_ibs_ibd_filters.ibd_annot #end if #end if ## Gene feature filters #if str($gene_feature_filters.gene_feature_filters_select) == "yes" and $gene_feature_filters.gene_features --gene-feature-in $gene_feature_filters.gene_features --splicing $gene_feature_filters.splicing --neargene $gene_feature_filters.neargene #end if ## Common variants filters #if str($allele_freq_filters.allele_freq_filters_select) == "yes" #if $allele_freq_filters.allele_freq_db --db-filter $allele_freq_filters.allele_freq_db #end if --rare-allele-freq $allele_freq_filters.rare_allele_freq #end if ## Genomic regions filters #if str($genomic_region_filters.genomic_region_filters_select) == "yes" $genomic_region_filters.ignore_indel_or_snv #if $genomic_region_filters.regions_in --regions-in "$genomic_region_filters.regions_in" #end if #if $genomic_region_filters.regions_out --regions-out "$genomic_region_filters.regions_out" #end if #if $genomic_region_filters.genes_in --genes-in "$genomic_region_filters.genes_in" #end if #if $genomic_region_filters.genes_out --genes-out "$genomic_region_filters.genes_out" #end if $genomic_region_filters.superdup #if str($genomic_region_filters.gene_var_filter) --gene-var-filter $genomic_region_filters.gene_var_filter #end if #end if ## Predicted impact filters #if str($impact_filters.impact_filters_select) == "yes" --db-score dbnsfp $impact_filters.filter_nondisease_variant $impact_filters.mendel_causing #end if ## Add annotations #if str($add_annotations.add_annotations_select) == "yes" #if str($add_annotations.o_flanking_seq) --o-flanking-seq $add_annotations.o_flanking_seq #end if $add_annotations.genome_annotation $add_annotations.omim_annotation $add_annotations.cosmic_annotation $add_annotations.scsnv_annotation $add_annotations.dgv_cnv_annotation $add_annotations.superdup_annotation $add_annotations.mouse_pheno_annotation $add_annotations.zebrafish_pheno_annotation $add_annotations.ddd_annotation $add_annotations.patho_gene_predict_annotation #if $add_annotations.pubmed_mining_gene --phenotype-term "$add_annotations.pubmed_mining_gene" --pubmed-mining #end if #if str($add_annotations.shared_genes.shared_genes_select) == "yes" --ppi-annot string --candi-file $add_annotations.shared_genes.candi_file --ppi-depth $add_annotations.shared_genes.ppi_depth --pathway-annot $add_annotations.shared_genes.pathway_annot #end if #end if > $logFile </command> <inputs> <param name="inputFile" type="data" format="vcf" label="VCF Variant file (--vcf-file)" help="Coordinates must refer to hg19" /> <param name="pedFile" type="data" format="tabular" label="Pedigree (--ped-file)" /> <param name="composite_subject_id" type="boolean" truevalue="--composite-subject-id" falsevalue="" checked="false" label="Composite subject ID (--composite-subject-id)" /> <param name="db_gene" type="select" display="checkboxes" multiple="true" label="Database(s) to annotate and filter variants (--db-gene)"> <option value="refgene" selected="true">refgene: The RefGene database compiled by UCSC from hg19 refGene. Note: RefSeq has NO mitochondria gene definition</option> <option value="gencode">gencode: The GENCODE gene sets. Note: GENCODE contains similar number of coding genes but more transcripts than RefGene. It HAS the mitochondria gene definition</option> <option value="knowngene">knowngene: The UCSC knonwGene datasase compiled by UCSC from hg19 knownGene</option> <option value="ensembl">ensembl: The Ensembl gene datasase compiled by UCSC from hg19 ensGene</option> <validator type="no_options" message="Select at least one database" /> </param> <!-- Variant and genotype quality control --> <conditional name="variant_genotype_filters"> <param name="variant_genotype_filters_select" type="select" label="Specify variant and genotype quality filters?"> <option value="yes">Yes</option> <option value="no" selected="true">No</option> </param> <when value="yes"> <param name="pass_variant_only" type="boolean" truevalue="--vcf-filter-in PASS" falsevalue="" checked="true" label="Don't include filtered loci (--vcf-filter-in PASS)" help="Keep only variants with FILTER equal to PASS" /> <param name="seq_qual" type="integer" value="50" label="Minimum overall Phred-scaled sequencing quality score for the variant (--seq-qual)" /> <param name="seq_mq" type="integer" value="20" label="Minimum overall Phred-scaled mapping quality score for the variant (--seq-mq)" /> <param name="seq_sb" type="float" value="-10" label="Maximal overall strand bias score for the variant (--seq-sb)" /> <param name="seq_fs" type="integer" value="60" label="Maximal overall strand bias Phred-scaled p-value (using Fisher's exact test) for the variant (--seq-fs)" /> <param name="min_heta" type="integer" value="0" label="Minimal observed number of heterozygote genotypes in cases (the affected) (--min-heta)" /> <param name="min_homa" type="integer" value="0" label="Minimal observed number of alternate homozygote genotypes in cases (the affected) (--min-homa)" /> <param name="min_hetu" type="integer" value="0" label="Minimal observed number of heterozygote genotypes in controls (the unaffected) (--min-hetu)" /> <param name="min_homu" type="integer" value="0" label="Minimal observed number of alternate homozygote genotypes in controls (the unaffected) (--min-homu)" /> <param name="min_obsa" type="integer" value="0" label="Minimal observed number of non-missing genotypes in cases (the affected) (--min-obsa)" /> <param name="min_obsu" type="integer" value="0" label="Minimal observed number of non-missing genotypes in controls (the unaffected) (--min-obsu)" /> <param name="min_obs" type="integer" value="1" label="Minimal observed number of non-missing genotypes in all samples (--min-obs)" /> <param name="hwe_control" type="float" value="" optional="true" label="Exclude variants in controls with the Hardy-Weinberg test p-value <= this value (--hwe-control)" /> <param name="hwe_case" type="float" value="" optional="true" label="Exclude variants in cases with the Hardy-Weinberg test p-value <= this value (--hwe-case)" /> <param name="hwe_all" type="float" value="" optional="true" label="Exclude variants in all subjects with the Hardy-Weinberg test p-value <= this value (--hwe-all)" /> <param name="gty_qual" type="integer" value="10" label="Minimum Phred-scaled genotyping quality (--gty-qual)" /> <param name="gty_dp" type="integer" value="4" label="Minimal read depth per genotype (--gty-dp)" /> <param name="gty_sec_pl" type="integer" value="20" label="Minimal value for second smallest normalized Phred-scaled genotype quality (--gty-sec-pl)" /> <param name="gty_af_ref" type="float" value="0.05" label="Maximal fraction of reads carrying alternative allele at a reference allele homozygous genotype (--gty-af-ref)" /> <param name="gty_af_het" type="float" value="0.25" label="Minimal fraction of reads carrying alternative allele at a heterozygous genotype (--gty-af-het)" /> <param name="gty_af_alt" type="float" value="0.5" label="Minimal fraction of reads carrying alternative allele at a alternative allele homozygous genotype (--gty-af-alt)" /> </when> <when value="no" /> </conditional> <!-- Genetic inheritance --> <conditional name="genetic_filters"> <param name="genetic_filters_select" type="select" label="Specify genetic inheritance?"> <option value="yes">Yes</option> <option value="no" selected="true">No</option> </param> <when value="yes"> <conditional name="genetic_model"> <param name="genetic_model_select" type="select" label="Specify advanced settings for genetic inheritance?"> <option value="yes">Yes</option> <option value="no" selected="true">No</option> </param> <!-- Custom genetic filters --> <when value="yes"> <param name="custom_genetic_params" type="select" display="checkboxes" multiple="true" label="Select genetic inheritance (advanced) (--genotype-filter)" help="Multiple filtration codes have logical OR relationship"> <option value="1">Exclude variants at which affected subjects have heterozygous genotypes (1)</option> <option value="2">Exclude variants at which both affected and unaffected subjects have the same homozygous genotypes (2)</option> <option value="3">Exclude variants at which affected subjects have reference homozygous genotypes (3)</option> <option value="4">Exclude variants at which both affected and unaffected subjects have the same heterozygous genotypes (4)</option> <option value="5">Exclude variants at which affected subjects have alternative homozygous genotypes (5)</option> <option value="6">Exclude variants at which affected family members have NO shared alleles (6)</option> <option value="7">ONLY include variants at which an offspring has one or two non-inherited alleles (7)</option> </param> </when> <!-- Suggested genetic filters --> <when value="no"> <param name="suggested_genetic_params" type="select" display="radio" label="Select genetic inheritance"> <option value="--genotype-filter 1,2,3">Recessive (--genotype-filter 1,2,3)</option> <option value="--double-hit-gene-trio-filter" selected="true">Recessive and compound-heterozygous (--double-hit-gene-trio-filter)</option> <option value="--double-hit-gene-phased-filter">Recessive and compound-heterozygous with phased samples (--double-hit-gene-phased-filter)</option> <option value="--genotype-filter 2,3,4,5">Dominant (--genotype-filter 2,3,4,5)</option> <option value="--genotype-filter 7">De novo mutation (--genotype-filter 7)</option> <option value="--unique-gene-filter">Only genes on which EVERY affected subject has at least one case-unique alternative allele, but these alleles may be from different variants (--unique-gene-filter)</option> </param> </when> </conditional> </when> <when value="no" /> </conditional> <!-- Homozygosity filtering --> <conditional name="hom_ibs_ibd_filters"> <param name="hom_ibs_ibd_filters_select" type="select" label="Specify homozygosity filters?"> <option value="yes">Yes</option> <option value="no" selected="true">No</option> </param> <when value="yes"> <param name="homozygosity_case_filter" type="integer" value="" optional="true" label="Filter by Runs of Homozygosity (ROH) (--homozygosity-case-filter)" help="Minimal length (in kb) of consecutive homozygous genotype for each interesting variant" /> <param name="ibs_case_filter" type="integer" value="" optional="true" label="Filter by Identical by State (IBS) (--ibs-case-filter)" help="Minimal length (in kb) of the region in which there is at least one allele identical among all cases" /> <param name="ibd_annot" type="data" format="txt,tabular,bed" optional="true" label="Add Identical by Descent (IBD) annotation (--ibd-annot)" help="File with IBD or significant linkage regions. Variants within these regions will be highlighted. Note: title line CHR START END is needed" /> </when> <when value="no" /> </conditional> <!-- Gene feature filtering --> <conditional name="gene_feature_filters"> <param name="gene_feature_filters_select" type="select" label="Specify gene feature filters?"> <option value="yes">Yes</option> <option value="no" selected="true">No</option> </param> <when value="yes"> <param name="gene_features" type="select" display="checkboxes" multiple="true" label="Select gene features (--gene-feature-in)" help="Variants falling outside the selected regions will be excluded"> <option value="0" selected="true">Frame-shift</option> <option value="1" selected="true">Loss of amino acids</option> <option value="2" selected="true">Loss of start codon</option> <option value="3" selected="true">Loss of stop codon (TAG, TAA, TGA)</option> <option value="4" selected="true">Gain of stop codon (TAG, TAA, TGA)</option> <option value="5" selected="true">Splicing</option> <option value="6" selected="true">Missense</option> <option value="7">Synonymous</option> <option value="8">Exonic</option> <option value="9">5-UTR</option> <option value="10">3-UTR</option> <option value="11">Intronic</option> <option value="12">Upstream of transcription start site</option> <option value="13">Downstream of transcription end site</option> <option value="14">ncRNA</option> <option value="15">Intergenic</option> <option value="16">Monomorphic</option> <option value="17">Unknown</option> </param> <param name="splicing" type="integer" value="2" label="Window size in base-pair around the splicing junction to flag the variant as splicing (--splicing)" /> <param name="neargene" type="integer" value="1000" label="Size in base-pair of region upstream and downstream (--neargene)" /> </when> <when value="no" /> </conditional> <!-- Allele frequency filtering --> <conditional name="allele_freq_filters"> <param name="allele_freq_filters_select" type="select" label="Specify filters by allele frequency?"> <option value="yes">Yes</option> <option value="no" selected="true">No</option> </param> <when value="yes"> <param name="allele_freq_db" type="select" display="checkboxes" multiple="true" label="Select databases for allelic frequency filtering (--db-filter)"> <option value="1kgeur201305">1KG EUR 201305: 495 subjects in the EUR panel of 1000 Genomes Project release in 2013 May (around 24.0 million sequence variants)</option> <option value="1kgeas201305">1KG EAS 201305: 496 subjects in the EAS panel of 1000 Genomes Project release in 2013 May (around 23.5 million sequence variants)</option> <option value="1kgafr201305">1KG AFR 201305: 645 subjects in the AFR panel of 1000 Genomes Project release in 2013 May (around 41.7 million sequence variants)</option> <option value="1kgsas201305">1KG SAS 201305: 485 subjects in the SAS panel of 1000 Genomes Project release in 2013 May (around 26.7 million sequence variants)</option> <option value="1kgamr201305">1KG AMR 201305: 346 subjects in the AMR panel of 1000 Genomes Project release in 2013 May (around 28.2 million sequence variants)</option> <option value="1kg201305" selected="true">1KG 201305: 1000 Genomes Project 2013 May release</option> <option value="1kg201204">1KG 201204: 1000 Genomes Project 2012 April release</option> <option value="1kgafr201204">1KG 201204 AFR: 1000 Genomes Project 2012 April release - African</option> <option value="1kgeur201204">1KG 201204 EUR: 1000 Genomes Project 2012 April release - European</option> <option value="1kgamr201204">1KG 201204 AMR: 1000 Genomes Project 2012 April release - Mixed American</option> <option value="1kgasn201204">1KG 201204 ASN: 1000 Genomes Project 2012 April release - Asian</option> <option value="ESP6500AA" selected="true">ESP6500AA: African American dataset from NHLBI GO Exome Sequencing Project (ESP6500)</option> <option value="ESP6500EA" selected="true">ESP6500EA: European American dataset from NHLBI GO Exome Sequencing Project (ESP6500)</option> <option value="dbsnp141" selected="true">dnSNP 141</option> <option value="dbsnp138">dbSNP 138</option> <option value="dbsnp138nf">dbSNP 138nf: dbSNP version 138 without the flagged SNPs by UCSC. Flagged SNPs include SNPs clinically associated by dbSNP, mapped to a single location in the reference genome assembly, and not known to have a minor allele frequency of at least 1%</option> <option value="dbsnp137">dbSNP 137</option> <option value="dbsnp135">dbSNP 135</option> <option value="exac">Exome Aggregation Consortium (ExAC): Variants from 61,486 unrelated individuals sequenced as part of various disease-specific and population genetic studies</option> <option value="gadexome">Genome Aggregation Database - Exome (gnomAD): Variants from 123,136 exomes sequenced as part of various disease-specific and population genetic studies</option> <option value="gadgenome">Genome Aggregation Database - Genome (gnomAD): Variants from 15,496 whole-genomes sequenced as part of various disease-specific and population genetic studies</option> </param> <param name="rare_allele_freq" type="float" value="0.01" label="Minor allele frequency (MAF) for selecting rare variants (--rare-allele-freq)" help="Set to >1 to only annotate MAF, without filtering" /> </when> <when value="no" /> </conditional> <!-- Variant type, region and gene filtering --> <conditional name="genomic_region_filters"> <param name="genomic_region_filters_select" type="select" label="Specify variant type, region and gene filtering?"> <option value="yes">Yes</option> <option value="no" selected="true">No</option> </param> <when value="yes"> <param name="ignore_indel_or_snv" type="select" label="Ignore indels or SNVs?"> <option value="" selected="true">No</option> <option value="--ignore-indel">Ignore insertion and deletion sequence variants (indels) (--ignore-indel)</option> <option value="--ignore-snv">Ignore single nucleotide variants (SNVs) (--ignore-snv)</option> </param> <param name="regions_in" type="text" label="Keep only variants within some genomic regions (--regions-in)" help="A comma-separated list of genomic regions, e.g. chrX,chrY:1-1000" /> <param name="regions_out" type="text" label="Ignore variants within some genomic regions (--regions-out)" help="A comma-separated list of genomic regions, e.g. chrX,chrY:1-1000" /> <param name="genes_in" type="text" label="Keep only variants within some genes (--genes-in)" help="A comma-separated list of gene symbols, e.g. TCF4,CNNM2,ANK3" /> <param name="genes_out" type="text" label="Ignore variants within some genes (--genes-out)" help="A comma-separated list of gene symbols, e.g. TCF4,CNNM2,ANK3" /> <param name="superdup" type="select" label="Annotate or filter out variants in super duplicate regions?" help="As defined in genomicSuperDups dataset from UCSC"> <option value="" selected="true">No</option> <option value="--superdup-annot">Annotate variants in super duplicate regions (--superdup-annot)</option> <option value="--superdup-filter">Filter out variants in super duplicate regions (--superdup-filter)</option> </param> <param name="gene_var_filter" type="integer" value="" optional="true" label="Filter out genes with at least this number of putative pathogenic variants (--gene-var-filter)" help="As a rule of thumb, it is safe to set a cutoff of 4 or more. " /> </when> <when value="no" /> </conditional> <!-- Predicted impact filtering --> <conditional name="impact_filters"> <param name="impact_filters_select" type="select" label="Specify functional impact filters?"> <option value="yes">Yes</option> <option value="no" selected="true">No</option> </param> <when value="yes"> <param name="filter_nondisease_variant" type="boolean" truevalue="--filter-nondisease-variant" falsevalue="" checked="false" label="Filter out variants predicted to be non-disease causal (--filter-nondisease-variant)" /> <param name="mendel_causing" type="boolean" truevalue="--mendel-causing-predict best" falsevalue="" checked="true" label="Predict Mendelian disease-causing variants by logistic regression model (--mendel-causing-predict)" /> </when> <when value="no" /> </conditional> <!-- Annotations --> <conditional name="add_annotations"> <param name="add_annotations_select" type="select" label="Add annotations?"> <option value="yes">Yes</option> <option value="no" selected="true">No</option> </param> <when value="yes"> <param name="o_flanking_seq" type="integer" value="" optional="true" label="Size in bp of flanking sequence to extract (--o-flanking-seq)" /> <param name="genome_annotation" type="boolean" truevalue="--genome-annot" falsevalue="" checked="true" label="Add genomic functional annotations (presudogenes, TFBS, enhancer, UniProt) (--genome-annot)" /> <param name="omim_annotation" type="boolean" truevalue="--omim-annot" falsevalue="" checked="true" label="Add OMIM annotation (--omim-annot)" /> <param name="cosmic_annotation" type="boolean" truevalue="--cosmic-annot" falsevalue="" checked="true" label="Add COSMIC annotation (--cosmic-annot)" /> <param name="scsnv_annotation" type="boolean" truevalue="--scsnv-annot" falsevalue="" checked="true" label="Potential of altering splicing (--scsnv-annot)" /> <param name="dgv_cnv_annotation" type="boolean" truevalue="--dgv-cnv-annot" falsevalue="" checked="true" label="Map a variant against known structure variation (--dgv-cnv-annot)" /> <param name="superdup_annotation" type="boolean" truevalue="--superdup-annot" falsevalue="" checked="true" label="Mark the variants in the super duplicate regions (--superdup-annot)" /> <param name="mouse_pheno_annotation" type="boolean" truevalue="--mouse-pheno" falsevalue="" checked="true" label="Annotate the genes with known mouse phenotypes as reference (--mouse-pheno)" /> <param name="zebrafish_pheno_annotation" type="boolean" truevalue="--zebrafish-pheno" falsevalue="" checked="true" label="Annotate the genes with known zebrafish phenotypes as reference (--zebrafish-pheno)" /> <param name="ddd_annotation" type="boolean" truevalue="--ddd-annot" falsevalue="" checked="true" label="Annotate by disease names in Deciphering Developmental Disorders (DDD) study (--ddd-annot)" /> <param name="patho_gene_predict_annotation" type="boolean" truevalue="--patho-gene-predict" falsevalue="" checked="true" label="Predict genes’ pathogenicity (--patho-gene-predict)" /> <param name="pubmed_mining_gene" type="text" label="Text mining in PubMed: search term(s) of interest (e.g. disease name)" help="A comma-separated list of search terms, each composed by plus-separated words, e.g. spinocerebellar+ataxia,other+search+term. If empty, no search will be performed" /> <!-- Shared protein-protein interactions and pathways --> <conditional name="shared_genes"> <param name="shared_genes_select" type="select" label="Add annotations for shared interactions/pathways?"> <option value="yes">Yes</option> <option value="no" selected="true">No</option> </param> <when value="yes"> <param name="candi_file" type="data" format="txt,tabular" label="List of candidate genes of interest (--candi-file)" /> <param name="ppi_depth" type="integer" value="1" label="Maximum distance of a protein-protein interaction (PPI) between candidate genes and genes containing the variants (--ppi-depth)" /> <param name="pathway_annot" type="select" label="Select databases for the identification of shared pathways between candidate genes and genes containing the variants (--pathway-annot)" help="Gene sets are extracted from MSigDB"> <option value="cura" selected="true">Curated gene sets (4850)</option> <option value="cano">Canonical pathways (1452)</option> <option value="onco">Oncogenic signatures (189)</option> <option value="cmop">Computational gene sets (858)</option> <option value="onto">Gene Ontology gene sets (1454)</option> </param> </when> <when value="no" /> </conditional> </when> <when value="no" /> </conditional> </inputs> <outputs> <data name="outVcf" format="vcf" label="${tool.name} on ${on_string}: VCF" from_work_dir="results.flt.vcf" /> <data name="outTabular" format="tabular" label="${tool.name} on ${on_string}: tabular" from_work_dir="results.flt.txt" /> <data name="outDoubleHitTriosGty" format="tabular" label="${tool.name} on ${on_string}: double-hit genotypes" from_work_dir="results.doublehit.gene.trios.flt.gty.txt"> <filter>genetic_filters['genetic_filters_select'] == "yes" and genetic_filters['genetic_model']['genetic_model_select'] == "no" and genetic_filters['genetic_model']['suggested_genetic_params'] == "--double-hit-gene-trio-filter"</filter> </data> <data name="outDoubleHitTriosCount" format="tabular" label="${tool.name} on ${on_string}: double-hit counts" from_work_dir="results.doublehit.gene.trios.flt.count.txt"> <filter>genetic_filters['genetic_filters_select'] == "yes" and genetic_filters['genetic_model']['genetic_model_select'] == "no" and genetic_filters['genetic_model']['suggested_genetic_params'] == "--double-hit-gene-trio-filter"</filter> </data> <data name="outDoubleHitPhasedGty" format="tabular" label="${tool.name} on ${on_string}: double-hit phased genotypes" from_work_dir="results.doublehit.gene.phased.flt.gty.txt"> <filter>genetic_filters['genetic_filters_select'] == "yes" and genetic_filters['genetic_model']['genetic_model_select'] == "no" and genetic_filters['genetic_model']['suggested_genetic_params'] == "--double-hit-gene-phased-filter"</filter> </data> <data name="outDoubleHitPhasedCount" format="tabular" label="${tool.name} on ${on_string}: double-hit phased counts" from_work_dir="results.doublehit.gene.phased.flt.count.txt"> <filter>genetic_filters['genetic_filters_select'] == "yes" and genetic_filters['genetic_model']['genetic_model_select'] == "no" and genetic_filters['genetic_model']['suggested_genetic_params'] == "--double-hit-gene-phased-filter"</filter> </data> <data name="logFile" format="txt" label="${tool.name} on ${on_string}: log" /> </outputs> <help> **What it does** This tool uses `KGGSeq`_ to filter and prioritize genetic variants from sequencing data. **License and citation** This Galaxy tool is Copyright © 2013-2014 `CRS4 Srl.`_ and is released under the `MIT license`_. .. _CRS4 Srl.: http://www.crs4.it/ .. _MIT license: http://opensource.org/licenses/MIT You can use this tool only if you agree to the license terms of: `KGGSeq`_. .. _KGGSeq: http://statgenpro.psychiatry.hku.hk/limx/kggseq/ If you use this tool, please cite: - |Cuccuru2014|_ - |Li2012|_ - |Li2013|_. .. |Cuccuru2014| replace:: Cuccuru, G., Orsini, M., Pinna, A., Sbardellati, A., Soranzo, N., Travaglione, A., Uva, P., Zanetti, G., Fotia, G. (2014) Orione, a web-based framework for NGS analysis in microbiology. *Bioinformatics* 30(13), 1928-1929 .. _Cuccuru2014: http://bioinformatics.oxfordjournals.org/content/30/13/1928 .. |Li2012| replace:: Li, M.-X., *et al.* (2012) A comprehensive framework for prioritizing variants in exome sequencing studies of Mendelian diseases. *Nucleic Acids Res.* 40(7), e53 .. _Li2012: http://nar.oxfordjournals.org/content/40/7/e53 .. |Li2013| replace:: Li, M.-X., *et al.* (2013) Predicting Mendelian Disease-Causing Non-Synonymous Single Nucleotide Variants in Exome Sequencing Studies. *PLoS Genet.* 9(1), e1003143 .. _Li2013: http://www.plosgenetics.org/article/info:doi/10.1371/journal.pgen.1003143 </help> </tool>