Quantcast
Channel: Post Feed
Browsing all 3764 articles
Browse latest View live
↧

Getting All Reads That Align To A Region In Compact Bed Format Using Bedtools?

I'm trying to find all the reads (by name) from a BAM file that align to various regions in a bed file. Right now I can do this with bedtools using intersectBed:intersectBed -abam reads.bam -wo -f 1 -b...

View Article


Tutorial: Introduction to bedtools.

We have created a basic tutorial introducing bedtools. It is intended for folks that are new to the tools, but in addition, there are some puzzles at the end that may be useful for people that use...

View Article


compute normal-tumor coverage ratio from exome BAMs

Could someone please suggest a quick way to compute the data ratio of uniquely mapped reads in the normal to uniquely mapped reads in the tumor, as required by Varscan in the command below? I have over...

View Article

Genomic Regions To Exclude Before Shuffling Intervals

I want to do permutation test: randomly reposit (shuffle) given genomic intervals and measure intersection between new coordinates and specific genomic element.Example: Different sets of genes: protein...

View Article

Convert .Txt Into Bed Files

I used paired-end sequence data for copy number variation study; and eventually get .txt files as output. I'm hoping to use Bedtools to compare my results with others. Can I convert .txt files into...

View Article


Split A Bam File Into Several Files Containing All The Alignments For X...

Hi everyone! I am struggling with annotating a very big .bam file that was mapped using TopHat. The run was a large number of reads : ~200M. The problem is that when I now try to Annotate each read...

View Article

Coveragebed, Depth/Breadth Of Coverage

I'm using coverageBed to calculate the depth and breadth of coverage, but I'm not sure I'm doing this right. I want to calculate the two values for each human chromosome. For example, I've created a...

View Article

bedtools 2.0 merge - "unable to open file or unable to determine types"

I have a sorted bedfile comprised of three columns: seqid, start, and end. sort -k1,1 -k2,2n tmp2.bed > tmp3.bed 1    6589256    6589207 1    11627195    12127194 1    12616616    12116617 1...

View Article


How To Find The Closest Distance From Bed Files Between Genes And Repeats...

How can I use the closestBed from bedtools to find the closest locations between two bed files. The important bit here is that i want them to be upstream and in correct oriantation.When I use the -s...

View Article


Reproduce Encode/Cshl Long Rna-Seq Data Visualization Viewed In Ucsc, But...

Motivation The ENCODE data comes out, and luckily they provide both .bam file and .bigwig file. Thus, it occurs to me that I want to give a try to reproduce the data visualization with tool: BEDtools...

View Article

Correlation Of Fpkm And Length Normalized Transcript Mapped Read Count

Hello, in the process of estimating expression for a 16 human tissue dataset ("Human Body Map 2.0 GSE30611") I used different methods to estimate the expression of the genes. After mapping against hg19...

View Article

Genomecoveragebed - Bedtool For Reporting Per Base Genome Coverage

Hi Everyone I would nedd some help on genomeCoverageBed tool. This tools when used for finding per base genome coverage uses an option -d. I am actually interested in finding read counts for each base...

View Article

Get The Idea Of Splicing From Reads Mapped In Rna-Seq

I've got a set of 100 bam files from a public experiment, I want to have an idea of splicing in each of them regarding three exons,without entering in some kind of depth-level procedure like Cufflinks...

View Article


Using Gnu Parallel For Bedtools

I am trying to run gnu:parallel on bedtools multicov function where the original command is bedtools multicov -bams bam1 bam2 bam3.. -bed anon.bed > Q1_Counst.bedI would like to implement the above...

View Article

Getting Rna Sequences From Gff And Fa Files

Hi. I have a folder full of .fa files, and a .gff. The gff file contains information about which loci look like they code for RNA sequences. The .fa contain the DNA sequences for a set of human...

View Article


How To Get Fasta Format Using Fastafrombed Or How To Turn Linearized Fasta To...

I extracted sequences with fastaFromBed and have no complains about the BEDTools which is really awesome thing.Otherwise extracted sequences look like this:>chr19:13985513-13985622...

View Article

Bed File Bedpe Format

Hi,I'm having trouble with converting the bam file into bed -bedpe using the bedtools.workflow: samtools sort -n mut.bam mut.Namesorted bamTobed -i mut.Namesorted.bam -bedpe >...

View Article


Finding Overlapping Variants (I.E. Indels, Snps) Using Annovar Format.

Hello,I know that using bedtools functions (specifically intersect and windows), it is possible to find overlapping features in the two sets of data. The catch here is that bedtools only accept the...

View Article

N Closest Genes To A Given Location

Hi,This is basically an extension of the following question already asked in biostar (http://biostars.org/post/show/53561/python-finding-gene-closest-to-a-given-location/).Let us say I have a list of...

View Article

How Do You Get The Quality Score And Coverage For Every Single Position Of A...

Hi,I am trying to extract the coverage and the average quality score for each position of a reference assembly in bam/sam format. I have managed to get the coverage using BEDtools genomeCoverageBed...

View Article
Browsing all 3764 articles
Browse latest View live