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

Merging/Intersecting Different Gene Annotations - Should I Extend Coordinates?

I want to create gene data-set (as big as possible), hence I am using several gene annotations. However, genes in different annotations overlap (it's the same gene). For reducing biases I overlap...

View Article


Bedtools Compare Multiple Bed Files?

I've been dealing with comparison between two bed files using intersectBed -a -b command. I'm just wondering, is there any commands in Bedtools which can help us compare multiple bed files? Say, I have...

View Article


Tutorial: Piping With Samtools, Bwa And Bedtools

In this tutorial I will introduce some concepts related to unix piping. Piping is a very useful feature to avoid creation of intermediate use once files. It is assumed that bedtools, samtools, and bwa...

View Article

Intersect Gene Annotation With Specific Position Or Genomic Interval

Hi,I've several genomic interval and I want to check if they are overlapping with known gene. I've a gtf file with the coordinates of gene exons. My idea was to use intersectBed from bedtools but I've...

View Article

Filtering Bed Files By Using Bedops

hello every one,I have paired end illumina reads, R1.fastq and R2.fastq and I have mapped them as single-end reads by using bowtie2 default parameters, I performed further downstream analysis by using...

View Article


Does Bedtools Intersect -V Consider Unmapped Reads "As Not In B"

bedtools intersect -v -abam my.bam -b myregions.gff > notinmyregions.bamwould we see reads with 4 in the FLAG field - i.e. unmapped reads in notinmyregions.bam

View Article

Does Windowbed Extend Reads?

I am using WindowBed, part of the BedTools suite, to align reads to a reference file and I obtained a very interesting result. I am trying to rule out an analysis artifact that could be caused by...

View Article

Does Bedops Have A Command Similar To The Bedtools Makewindows?

With bedtools you can make genomic windows from a genome file or a bed fileinput.bedchr1 1000000 1500000 chr3 500000 900000[prompt]$ bedtools makewindows -b input.bed -w 250000chr1 1000000 1250000 chr1...

View Article


Help With Exception When Using Bedtools Coveragebed With Paired Alignment....

I use bwa mem to align paired reads to few hundreds of microbial contigs; then I sort the alignment, and trying to get a coverage using bedtools genomecov -ibam alignments.paired.sorted.bam -bg...

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

Snps Comparison

Hello,I would like to compare SNPs from different methods:number of SNPsSNPs postion (position where method A has SNPs but not B and vice versa. Where both have SNPs)I would be interested to get a...

View Article

How To Get Annotation For Bed File From Another Bed File

Hello All,I have a bed file (with Chr, Start, End, Name, Score and Strand) Chr1 5678 5680 NA 7 + Chr1 700 800 NA 8 - Chr1 900 1200 NA 10 -and would like to know, how can I get the annotation for the...

View Article

Raw Counts From Cufflinks Output

Hi, I want to ask how to get the raw counts from the output of cufflinks. One way to do this is to use the fpkm.raw counts = FPKM * (length of that transcript/1000) * (# of mapped reads / 1e6)The FPKM...

View Article


Intersectbed Provides An Empty Output

Hi,I've downloaded the recent Cygwin version 1.7.24 and an trying to run bedTools but I get an empty file as my output. When I run the same commandline and files on a colleagues computer also through...

View Article

How To Use Bedtools To Extract Promoters From A Mouse Bed File

Hello, I would like to know how to use Bedtools to extract promoter sequences (as FASTAs) from the mouse genome (mm9) starting from a BED file.

View Article


Simple Redirection, I/O Problem With Bedtools

Hi Guys, Just a quick question. Its more of a Bash question rather than Bioinformatics, with Bedtools in question.I mostly pipe the bedtools I/O. Here's a general scenario :sed 1d fileA.bed |...

View Article

How Can I Merge Intervals ?

Hello everybody, I should be grateful if you would kindly help me de fix my problem. I have a table like that :Chromosome start end info1 info2 chr01 1 100 15 35 chr01 150 300 15 39 chr01 299 750 16...

View Article


Bedtools Multicov Need A Bam Index File Specification Option

bedtools version 2.16.2 multicov used to compute the multiple sample coverage given a feature file(gtf bed).format: bedtools multicov -bams alin1.bam aln2.bam .. -bed capturRegion.bed...

View Article

How To Extract Scores From Bedgraph File Using Bed Tools

file1chr1 10 20 name 0 +file2chr1 12 14 2.5 chr1 14 15 0.5How could i extract average scores of file1 using file2, like below? I am trying to extract phastcons (file2) average scores of file1.chr1 10...

View Article

General Considerations For Genomic Overlaps?

Hello I was wondering about general considerations for performing overlap of genomic regions and doing Monte Carlo-type statistics. Below I have made a description of how I do it, unfortunately Im not...

View Article
Browsing all 3764 articles
Browse latest View live