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

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


Convert Bamtobed Score

Hey,just a short question....is there a possibility to set the score in the bed file to "1" an not to the the alignment score?? arguments -tag and -ed only use BAM alignment tags... ?!? :/Cheers!

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

Tool For Binning Windowbed Output For K-Means Clustering

I have mapped high resolution ChIP-seq data to transcription start sites using windowBed. I now want to bin the data, in bin sizes of my choosing, relative to TSSs so that I can generate heat maps and...

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


Problems Extracting Non-Snps From A Vcf File

Hello,In an SNP analysis, I am trying to extract those editing sites no found in the dbSNPs vcf file I have downloaded a couple of files (All SNPs and Common/Medical SNPs) from...

View Article

Given gene ID and genomic coordinates, how can I create a GFF formatted file?

  I have downloaded a list of coordinates of yeast genes from Xu et al., 2009 (see table S3). Unfortunately its current format is not a standard format so it does not appear to be compatible with the...

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


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


Splice Junction file intersection with genome annotation

Hello,   I have a tab delimited format Splice Junction file and the file looks something like this: chr1    11212    12009    1    1    0    0    2    48 chr1    11672    12009    1    1    0    0    1...

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

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

Bedtools "Segmentation Fault" While Working With Genome.Fa

I wanted to use BEDTools to extract genomic sequences (fastaFromBed). My BED file has all 24 chromosomes, hence I want to use whole genome (merged from chromosome.fa). Tried to: fastaFromBed -fi...

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

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


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

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


Reporting The Bam Reads Overlapping A Set Of Intervals With Bedtools

I am trying to use bedtools to pull out the reads falling directly within a set of BED coordinates. While this command does it successfully:intersectBed -abam mybam.bam -b intervals.gff -wa -wb -f 1 |...

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

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
Browsing all 3764 articles
Browse latest View live