# HG changeset patch # User iuc # Date 1453925759 18000 # Node ID 607c0576c6ab19ddee9753ba97e86a8725f89741 # Parent 2cd7e321d259e430118a4a40b81b78a983a2ac71 planemo upload for repository https://github.com/galaxyproject/tools-iuc/tree/master/tools/bedtools commit 6692e3a4fa1bf6e9a407735afdbb2454ed32b316 diff -r 2cd7e321d259 -r 607c0576c6ab annotateBed.xml --- a/annotateBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/annotateBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - - + + annotate coverage of features from multiple files macros.xml @@ -7,6 +7,7 @@ - + + converter macros.xml - + + samtools + "${output}" ]]> - - - + + + + label="Use alignment's edit-distance for BED score" help="(-ed)" /> @@ -56,16 +65,16 @@ .. class:: infomark -The "Report spliced BAM alignment..." option breaks BAM alignments with the "N" (splice) operator into distinct BED entries. For example, using this option on a CIGAR such as 50M1000N50M would, by default, produce a single BED record that spans 1100bp. However, using this option, it would create two separate BED records that are each 50bp in size and are separated by 1000bp (the size of the N operation). This is important for RNA-seq and structural variation experiments. +The "Report spliced BAM alignment..." option breaks BAM alignments with the "N" (splice) operator into distinct BED entries. +For example, using this option on a CIGAR such as 50M1000N50M would, by default, produce a single BED record that spans 1100bp. +However, using this option, it would create two separate BED records that are each 50bp in size and are separated by 1000bp (the size of the N operation). +This is important for RNA-seq and structural variation experiments. .. class:: warningmark -If using a custom BAM alignment TAG as the BED score, note that this must be a numeric tag (e.g., type "i" as in NM:i:0). +If using a custom BAM alignment TAG as the BED score, note that this must be a numeric tag (e.g., type "i" as in NM:i:0). -.. class:: warningmark - -If creating a BEDPE output (see output formatting options), the BAM file should be sorted by query name. @REFERENCES@ ]]> diff -r 2cd7e321d259 -r 607c0576c6ab bamToFastq.xml --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/bamToFastq.xml Wed Jan 27 15:15:59 2016 -0500 @@ -0,0 +1,39 @@ + + + + macros.xml + + + + + bedtools bamtofastq + $tags + -i '$input' + -fq '$output' + #if $fq2: + -fq2 '$output2' + #end if + + + + + + + + + + fq2 is True + + + + +**What it does** + +bedtools bamtofastq is a conversion utility for extracting FASTQ records from sequence alignments in BAM format. + +@REFERENCES@ + + + + diff -r 2cd7e321d259 -r 607c0576c6ab bedToBam.xml --- a/bedToBam.xml Wed May 27 12:54:35 2015 -0400 +++ b/bedToBam.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - - + + converter macros.xml @@ -31,7 +31,7 @@ - + diff -r 2cd7e321d259 -r 607c0576c6ab bedpeToBam.xml --- a/bedpeToBam.xml Wed May 27 12:54:35 2015 -0400 +++ b/bedpeToBam.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - - + + converter macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab closestBed.xml --- a/closestBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/closestBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + find the closest, potentially non-overlapping interval macros.xml @@ -20,6 +20,9 @@ $io -mdb $mdb -t $ties + #if $k: + -k $k + #end if -a $inputA -b $inputBs > $output @@ -52,35 +55,21 @@ + - - - + - - - + - - - + + + @@ -126,6 +115,12 @@ + + + + + + - + cluster overlapping/nearby intervals macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab complementBed.xml --- a/complementBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/complementBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + Extract intervals not represented by an interval file macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab expandBed.xml --- a/expandBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/expandBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + replicate lines based on lists of values in columns macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab fisherBed.xml --- a/fisherBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/fisherBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + calculate Fisher statistic between two feature files macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab flankBed.xml --- a/flankBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/flankBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + create new intervals from the flanks of existing intervals macros.xml @@ -27,10 +27,10 @@ + help="E.g. if used on a 1000bp feature, -l 0.50, will add 500 bp “upstream”. (-pct)" /> + help="For example. if used, -l 500 for a negative-stranded feature, it will add 500 bp to the end coordinate. (-s)" /> diff -r 2cd7e321d259 -r 607c0576c6ab genomeCoverageBed.xml --- a/genomeCoverageBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/genomeCoverageBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - in bedGraph or histogram format + compute the coverage over an entire genome macros.xml @@ -74,7 +74,7 @@ label="Report the depth at each genome position with 1-based coordinates" help="(-d)" /> - diff -r 2cd7e321d259 -r 607c0576c6ab getfastaBed.xml --- a/getfastaBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/getfastaBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + use intervals to extract sequences from a FASTA file macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab groupbyBed.xml --- a/groupbyBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/groupbyBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + group by common cols and summarize other cols macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab intersectBed.xml --- a/intersectBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/intersectBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - - + + find overlapping intervals in various ways macros.xml @@ -28,6 +28,7 @@ $once $header $modes + $count > "${output}" ]]> diff -r 2cd7e321d259 -r 607c0576c6ab jaccardBed.xml --- a/jaccardBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/jaccardBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + calculate the distribution of relative distances between two files macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab linksBed.xml --- a/linksBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/linksBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + create a HTML page of links to UCSC locations macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab macros.xml --- a/macros.xml Wed May 27 12:54:35 2015 -0400 +++ b/macros.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,11 +1,11 @@ - bedtools + bedtools - 2.22 + 2.24 @@ -53,6 +53,23 @@ + + + + + + + + + diff -r 2cd7e321d259 -r 607c0576c6ab makeWindowsBed.xml --- a/makeWindowsBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/makeWindowsBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + make interval windows across a genome macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab mapBed.xml --- a/mapBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/mapBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + apply a function to a column for each overlapping interval macros.xml @@ -41,6 +41,7 @@ + diff -r 2cd7e321d259 -r 607c0576c6ab maskFastaBed.xml --- a/maskFastaBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/maskFastaBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + use intervals to mask sequences from a FASTA file macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab mergeBed.xml --- a/mergeBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/mergeBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - - (mergeBed) + + combine overlapping/nearby intervals into a single interval macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab multiCov.xml --- a/multiCov.xml Wed May 27 12:54:35 2015 -0400 +++ b/multiCov.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + counts coverage from multiple BAMs at specific intervals macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab multiIntersectBed.xml --- a/multiIntersectBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/multiIntersectBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - - + + identifies common intervals among multiple interval files macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab nucBed.xml --- a/nucBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/nucBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + profile the nucleotide content of intervals in a FASTA file macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab overlapBed.xml --- a/overlapBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/overlapBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + computes the amount of overlap from two intervals macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab randomBed.xml --- a/randomBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/randomBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + generate random intervals in a genome macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab reldist.xml --- a/reldist.xml Wed May 27 12:54:35 2015 -0400 +++ b/reldist.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + calculate the distribution of relative distances macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab shuffleBed.xml --- a/shuffleBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/shuffleBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + randomly redistrubute intervals in a genome macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab slopBed.xml --- a/slopBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/slopBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + adjust the size of intervals macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab sortBed.xml --- a/sortBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/sortBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - - + + order the intervals macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab spacingBed.xml --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/spacingBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -0,0 +1,38 @@ + + reports the distances between features + + macros.xml + + + + + $output +]]> + + + + + + + + + + + + + + + + + + diff -r 2cd7e321d259 -r 607c0576c6ab subtractBed.xml --- a/subtractBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/subtractBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + remove intervals based on overlaps macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab tagBed.xml --- a/tagBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/tagBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + tag BAM alignments based on overlaps with interval files macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab test-data/annotateBed_result.bed --- a/test-data/annotateBed_result.bed Wed May 27 12:54:35 2015 -0400 +++ b/test-data/annotateBed_result.bed Wed Jan 27 15:15:59 2016 -0500 @@ -1,3 +1,4 @@ +# annotateBed2.bed annotateBed3.bed annotateBed4.bed chr1 100 200 nasty 1 - 0.500000 1.000000 0.300000 chr2 500 1000 ugly 2 + 0.000000 0.600000 1.000000 chr3 1000 5000 big 3 - 1.000000 0.250000 0.000000 diff -r 2cd7e321d259 -r 607c0576c6ab test-data/bedToBam_result.bam Binary file test-data/bedToBam_result.bam has changed diff -r 2cd7e321d259 -r 607c0576c6ab test-data/closestBed_result6.bed --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/closestBed_result6.bed Wed Jan 27 15:15:59 2016 -0500 @@ -0,0 +1,3 @@ +chr1 100 200 chr1 100 200 +chr1 100 200 chr1 180 250 +chr1 100 200 chr1 250 500 diff -r 2cd7e321d259 -r 607c0576c6ab test-data/spacingBed_result1.bed --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/spacingBed_result1.bed Wed Jan 27 15:15:59 2016 -0500 @@ -0,0 +1,4 @@ +chr1 100 200 . +chr1 180 250 0 +chr1 250 500 0 +chr1 501 1000 1 diff -r 2cd7e321d259 -r 607c0576c6ab tool_dependencies.xml --- a/tool_dependencies.xml Wed May 27 12:54:35 2015 -0400 +++ b/tool_dependencies.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,6 +1,9 @@ - - + + + + + diff -r 2cd7e321d259 -r 607c0576c6ab unionBedGraphs.xml --- a/unionBedGraphs.xml Wed May 27 12:54:35 2015 -0400 +++ b/unionBedGraphs.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + combines coverage intervals from multiple BEDGRAPH files macros.xml diff -r 2cd7e321d259 -r 607c0576c6ab windowBed.xml --- a/windowBed.xml Wed May 27 12:54:35 2015 -0400 +++ b/windowBed.xml Wed Jan 27 15:15:59 2016 -0500 @@ -1,5 +1,5 @@ - + find overlapping intervals within a window around an interval macros.xml