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

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


Tool: Bedtools: Analyzing Genomic Features

All practicing bioinformaticians will face problems that require them to compare, query and select genomic features across an entire genome. As it happens efficient interval representation and query is...

View Article


How To Combine Fpkm Values From Cufflinks With Contigs From De Novo Assembly...

Hi all,I am working on RNA-seq data analysis. I've finished running Tophat and Cufflinks to get FPKM values for each read from Illumina pair-end sequence. Also, parallely I've run Velvet to get contig...

View Article

Why does BedTools Map operation produce all dots as output?

I am using BedTools Map operation to map the DNAse I signal of a cell type into some chromosome regions, by computing the mean on the third column The command I use is the following: $ bedtools map -a...

View Article

Getting Number Of Reads In Intervals With Bedtools

What is the correct way to get the total number of reads strictly contained in each interval in a GFF from a BAM file while enforcing strandedness? What I am looking for is very close to this...

View Article


Creating Bed File For Lncrna Using Gencode Gtf File

Hi all,I want to get the bed file of lncRNA based on GENCODE GTF fileI download the file "gencode.v16.long_noncoding_RNAs.gtf.gz", and extract the chr, start, end info from the file, then I use...

View Article

What Is The Best Way To Run Bedtools In Parallel With Blocking

Say I am working on a server with a shared file system and 4 quad core nodes (I/O is not an issue, 16 cores total). I want to run coverageBed across 20 files. Currently I have a shell script that would...

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


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


Getting Unmapped Reads: Comparing Fastq To Bam

given a FASTQ file and a BAM file of aligned reads, is there an efficient way to get all FASTQ reads that are in the original FASTQ but not in the BAM? Perhaps using bedtools. i.e.:unmapped_script...

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

Image may be NSFW.
Clik here to view.

Profile Coverage Of Rnaseq Samples?

Hi all,I have a quick question:How can I visualize aligned paired-end reads from RNAseq datasets in UCSC browser?I already mapped the reads and assembled the transcripts with Tophat/Cufflinks but I'm...

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


How To Get All Entries Of B With Bedtools

Hi All, Is there any way to get all the original B entry(even the ones for which there is no overlap with A as well) in intersectBed utility? I am trying to overlap two bed files. I need all the entry...

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


Counting The Whole Insert Size From Paired-End Reads As Coverage

We have updated our workflows for per base sequence coverage to use genomeCoverageBed from BAM files. However for pair-end data it seems as though the regions between pair-end reads are not counted. To...

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


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

Bedtools: Top N Most Similar Regions When Comparing Two Bed/Wig/Bam Files?

Is there an easy way of finding, probably with bedtools, given a window size, the top N most correlated regions when comparing two bed/wig files? For example, in comparing two bed/wig/bam files that...

View Article

Problem With Counting Mapped Reads

Hi, This is my very first experience analysing RNAseq data. My goal is to do differential analysis between two strains of a bacteria. So far, i managed to align and produce SAM and BAM files. I'm...

View Article
Browsing all 3764 articles
Browse latest View live