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

How To Rearrange Paired End Bam File?

Hello all,I have a paired end bam file and I want to use bedtools for them. After merging, the paired end read alignments are not lying next to each other. It is making problems in the bedtools...

View Article


How Can I Compare And Merge Bed Files

I have three bed files with chrNo, start, end position and type. I need to compare each chrNo, start and end position of one file with 2 other files and write the common one in a new file. Can any one...

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

Fastafrombed Problem

hi, I try this tools from BedTools but it doesnt work!$ cat testgenome404.fa>chr1 AAAAAAAACCCCCCCCCCCCCGCTACTGGGGGGGGGGGGGGGGGG $ cat test.bed chr1 5 10 $ ./fastaFromBed -fi testgenome404.fa -bed...

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


Annotating Genomic Intervals

How can I annotate human genomic intervals (BED file) from a ChIP-seq experiment with information such as whether the interval overlaps with a gene(s)? Upstream of a gene? Overlaps with an exon?...

View Article

Per Base Coverage

Is there a way to obtain per-base coverage for a define chromosome interval using a bam file generated from Illumina single-end reads? genomeCoverageBed in Bedtools does not seem to have an option for it.

View Article

how to get -nms for bedtools

I'd like to merge bed files and preserve the names of the merged features using bedtools -nms option.However, this option (-nms) is deprecated in the newer bedtools.The documentation says I can use -o...

View Article


GTF2/GFF3 "feature" types and expression analysis

Hi, I aligned a few samples using STAR to the genome provided in the Illumina iGenomes UCSC hg19 bundle (here) -- I used the provided gene feature (gtf2) file as is.  Now, my motive is to calculate the...

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

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

Picking Random Genomic Positions

I do have a set of TF binding coordinates and want to see if there is any significant overlap with an open chromatin annotation.Example of TF coord: chr1 19280 19298 chr1 245920 245938 chr2 97290 97308...

View Article

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


Comparative Snp Analysis

Hello, I am trying to compare the degree of A-to-G editing in a near-to-isogenic pair of cell lines. I have two biological replicates and have mapped with Bowtie and BWA, followed by a samtools mpileup...

View Article

Error In Bedtools Getfasta: Chromosome Not Found

Hi, I am triing to use BEDtools to get some sequences from genomic coordinates. But I am having an errors saying " WARNING. chromosome (chr12) was not found in the FASTA file. Skipping." for each read...

View Article


Bed File Of Mapq Sliding Window On A Bam File?

There may already be a recipe for this, so asking first before reinventing the wheel: I would like to create a bed file where the score is the average mapQ from the reads of the input.bam file. I think...

View Article

Bedtools Intersectbed

Apologies if this is blatantly obvious!I would like to compare coordinates in setA with those of setB. The output should have the same number of coordinates as setA and tell me how many nucleotides of...

View Article


Is It Possible To Filter Only Bookend Reads From A Bed File?

I have a bed file with many fragments, some overlapping, some on their own and some adjacent to each other (book-ended) features.I know can group overlapping and book-ended features using bedtools...

View Article

How To Check Whole Genome With Bigwigsummary ?

Hi,I have question about bigwigsummary tools ,I have my start and end positions and my bigwig file but I want to check whole genome instead of chromosome by chromosome Is there any option to use this...

View Article

Bedtools Genomecoveragebed Usage : How To Create A Genome File?

I am using BEDTOOLS and the following command to get the coverage file:$ ./genomeCoverageBed -ibam ~/GG_project/trim/ecoli.bam -g > ~/GG_project/trim/coveragewhere ecoli.bam is my sorted bam file,...

View Article
Browsing all 3764 articles
Browse latest View live