# HG changeset patch # User iuc # Date 1550782299 18000 # Node ID 56e6dfc9f4bb007ad5b0c3233e601f7744c09c8e # Parent 6180665df8f7f7b58131efeb46a59df1a54e43d4 planemo upload for repository https://github.com/galaxyproject/tools-iuc/tree/master/tools/bcftools commit 2684e1443f03bfe2ae20c31d23817415ec8f7e69 diff -r 6180665df8f7 -r 56e6dfc9f4bb bcftools_call.xml --- a/bcftools_call.xml Tue Dec 12 13:53:35 2017 -0500 +++ b/bcftools_call.xml Thu Feb 21 15:51:39 2019 -0500 @@ -1,16 +1,16 @@ - + SNP/indel variant calling from VCF/BCF call macros.xml - - - + + + #set $novel_rate = [] @@ -36,10 +36,10 @@ #set $section = $sec_consensus_variant_calling.variant_calling #set $targets_path = None #if $section.method == 'multiallelic': - #if $section.genotypes.constrain == 'alleles': - #set $section = $sec_consensus_variant_calling.variant_calling.genotypes - @PREPARE_TARGETS_FILE@ - #end if + #if $section.genotypes.constrain == 'alleles': + #set $section = $sec_consensus_variant_calling.variant_calling.genotypes + @PREPARE_TARGETS_FILE@ + #end if #end if #set $section = $sec_restrict @PREPARE_REGIONS_FILE@ @@ -48,59 +48,57 @@ #set $section = $sec_consensus_variant_calling.variant_calling #if $section.method == 'multiallelic': - -m - #if str($section.gvcf) != '': - --gvcf $section.gvcf - #end if - #if str($section.prior_freqs) != '': - --prior-freqs $section.prior_freqs - #end if - #if $section.genotypes.constrain == 'alleles': - --constrain alleles $section.genotypes.insert_missed - #set $section = $sec_consensus_variant_calling.variant_calling.genotypes - @TARGETS_FILE@ - #else - #if $section.genotypes.constrain == 'trio': - --constrain trio - @NOVEL_RATE@ - #end if - #set $section = $sec_consensus_variant_calling.variant_calling.genotypes - @TARGETS@ - #end if -#else - -c + -m + #if str($section.gvcf): + --gvcf $section.gvcf + #end if + #if str($section.prior_freqs): + --prior-freqs '$section.prior_freqs' + #end if + #if str($section.prior): + --prior $section.prior + #end if + #if $section.genotypes.constrain == 'alleles': + --constrain alleles $section.genotypes.insert_missed + #set $section = $sec_consensus_variant_calling.variant_calling.genotypes + @TARGETS_FILE@ + #else + #if $section.genotypes.constrain == 'trio': + --constrain trio + @NOVEL_RATE@ + #end if + #set $section = $sec_consensus_variant_calling.variant_calling.genotypes + @TARGETS@ + #end if +#else + -c + #if str($section.pval_threshold): + --pval-threshold $section.pval_threshold + #end if #end if #set $section = $sec_restrict @REGIONS@ @SAMPLES@ -#set $section = $sec_consensus_variant_calling -#if $section.pval_threshold: - --pval-threshold "$section.pval_threshold" -#end if -#if $section.prior: - --prior "$section.prior" -#end if - ## File format section #set $section = $sec_file_format #if $section.ploidy: - --ploidy "${section.ploidy}" + --ploidy ${section.ploidy} #end if #if $section.ploidy_file: - --ploidy-file "${section.ploidy_file}" + --ploidy-file '${section.ploidy_file}' #end if ## Input/output section #set $section = $sec_input_output ${section.keep_alts} -## #if section.format_fields: -## --format-fields "${section.format_fields}" -## #end if +#if $section.format_fields: + --format-fields '${section.format_fields}' +#end if ${section.keep_masked_ref} #if $section.skip_variants: - --skip-variants "${section.skip_variants}" + --skip-variants ${section.skip_variants} #end if ${section.variants_only} @@ -110,8 +108,7 @@ ## Primary Input/Outputs @INPUT_FILE@ > '$output_file' -]]> - + ]]>
@@ -120,13 +117,13 @@
- - - + + + - + @@ -136,17 +133,17 @@ - + - + if the input VCF has the following INFO tags:
##INFO=<ID=REF_AN,Number=1,Type=Integer,Description="Total number of alleles in reference genotypes">
##INFO=<ID=REF_AC,Number=A,Type=Integer,Description="Allele count in reference genotypes for each ALT allele"> @@ -154,50 +151,49 @@
^(\w+,\w+)?$ - + + - + - - + + - -
- + - +
- - + + ^([A-Za-z]+(,[A-Za-z]+)*)?$ - - + + - +
@@ -258,13 +254,13 @@ bcftools @EXECUTABLE@ ================================== -SNP/indel variant calling from VCF/BCF. To be used in conjunction with samtools mpileup. +SNP/indel variant calling from VCF/BCF. To be used in conjunction with samtools mpileup. - - This command replaces the former "bcftools view" caller. - - Some of the original functionality has been temporarily lost in the process of transition to htslib, but will be added back on popular demand. + - This command replaces the former "bcftools view" caller. + - Some of the original functionality has been temporarily lost in the process of transition to htslib, but will be added back on popular demand. - The original calling model can be invoked with the -c option. -The novel-rate option can be set to modify the likelihood of novel mutation for constrained -C trio calling. The trio genotype calling maximizes likelihood of a particular combination of genotypes for father, mother and the child P(F=i,M=j,C=k) = P(unconstrained) * Pn + P(constrained) * (1-Pn). By providing three values, the mutation rate Pn is set explicitly for SNPs, deletions and insertions, respectively. If two values are given, the first is interpreted as the mutation rate of SNPs and the second is used to calculate the mutation rate of indels according to their length as Pn=float*exp(-a-b*len), where a=22.8689, b=0.2994 for insertions and a=21.9313, b=0.2856 for deletions [pubmed:23975140]. If only one value is given, the same mutation rate Pn is used for SNPs and indels. +The novel-rate option can be set to modify the likelihood of novel mutation for constrained -C trio calling. The trio genotype calling maximizes likelihood of a particular combination of genotypes for father, mother and the child P(F=i,M=j,C=k) = P(unconstrained) * Pn + P(constrained) * (1-Pn). By providing three values, the mutation rate Pn is set explicitly for SNPs, deletions and insertions, respectively. If two values are given, the first is interpreted as the mutation rate of SNPs and the second is used to calculate the mutation rate of indels according to their length as Pn=float*exp(-a-b*len), where a=22.8689, b=0.2994 for insertions and a=21.9313, b=0.2856 for deletions [pubmed:23975140]. If only one value is given, the same mutation rate Pn is used for SNPs and indels. @REGIONS_HELP@ diff -r 6180665df8f7 -r 56e6dfc9f4bb macros.xml --- a/macros.xml Tue Dec 12 13:53:35 2017 -0500 +++ b/macros.xml Thu Feb 21 15:51:39 2019 -0500 @@ -1,5 +1,5 @@ - 1.4.0 + 1.9 @@ -10,13 +10,13 @@ - bcftools - htslib + bcftools + htslib - samtools + samtools bcftools 2>&1 | grep 'Version:' @@ -39,7 +39,7 @@ ]]>
- + @@ -68,7 +71,7 @@ - + $input_vcf && bcftools index $input_vcf && - #elif $input_file.is_of_type('vcf_bgz') - ln -s '$input_file' $input_vcf + #elif $input_file.is_of_type('vcf_bgzip') + ln -s '$input_file' $input_vcf && + #if $input_file.metadata.tabix_index: + ln -s '${input_file.metadata.tabix_index}' ${input_vcf}.tbi && + #else + bcftools index $input_vcf && + #end if #elif $input_file.is_of_type('bcf') #set $input_vcf = 'input' + str($i) + '.bcf.gz' ln -s '$input_file' $input_vcf && @@ -90,8 +98,6 @@ #else bcftools index $input_vcf && #end if - #elif $input_file.is_of_type('bcfvcf_bgz') - ln -s '$input_file' $input_vcf && #end if echo '$input_vcf' >> $vcfs_list_file && $input_vcfs.append($input_vcf) @@ -106,7 +112,7 @@ - + - + @@ -165,7 +171,7 @@ - + #if 'estimate_AF' in $section and $section.estimate_AF: @@ -174,7 +180,7 @@ - + - + #if 'ploidy_file' in $section and $section.ploidy_file: @@ -208,7 +214,7 @@ - + @@ -224,8 +230,8 @@ - + ^([^ \t\n\r\f\v,]+(,[^ \t\n\r\f\v,]+)*)?$ @@ -271,13 +277,13 @@ - ^(\w+(:\d+(-\d+)?)?(,\w+(:\d+(-\d+)?)?)*)?$ - + @@ -346,7 +352,7 @@ - ^(\w+(:\d+(-\d+)?)?(,\w+(:\d+(-\d+)?)?)*)?$ @@ -373,16 +379,16 @@ - + ^(\w+(,\w+)*)?$ - - + help="Inverts the query/filtering applied by Samples (adds "^" prefix to exclude)" /> + + #set $samples_defined = False @@ -397,7 +403,7 @@ - + #if $section.sample: @@ -407,7 +413,7 @@ - + ^[^']*$ @@ -419,7 +425,7 @@ - + ^[^']*$ @@ -431,8 +437,8 @@ - + ^([^,]+(,[^,]+)*)?$ diff -r 6180665df8f7 -r 56e6dfc9f4bb test-data/summary.pdf Binary file test-data/summary.pdf has changed diff -r 6180665df8f7 -r 56e6dfc9f4bb test-data/view.bcf Binary file test-data/view.bcf has changed diff -r 6180665df8f7 -r 56e6dfc9f4bb test-data/view.bcf.csi Binary file test-data/view.bcf.csi has changed diff -r 6180665df8f7 -r 56e6dfc9f4bb test-data/view.vcf_bgzip Binary file test-data/view.vcf_bgzip has changed