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

Image may be NSFW.
Clik here to view.

How To Explain Uneven Coverage Of A Dna Seqment Obtained Via Pcr Amplification.

Experiment: deep sequencing for mutants in 700nt fragment.the fragment of dna was preamplified by primers flanking the fragment followed by hiseq.per base coverage was calculated by coverageBed -d...

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


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

Random shuffling of features leaving gene models intact

I am looking for a tool that can randomly shuffle gff features into intergenic regions, but leaving the gene-models 'intact', so that at least all features of a gene are placed on the same contig and...

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


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

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

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


Intersectbed/Coveragebed -Split Purify Exon?

all.reads.bam file records mapped RNA-seq reads data, including:exon:exon junctionexon bodyintron bodyexon:intron junctionQ1: When calculating RPKM for given RefSeq gene including all the position...

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

How To Use Bedtools Windows To Overlap Upstream For Positive Strand Strand

Hi,I am trying to use bedtools windows. It has been explained in the manual of the bedtools but I am still bit confused and thought a confirmation would be good. And I have no biological background.I...

View Article

How To Find The Nearest Gene To A Retrotransposon Insert?

Hi,I have a BED file with the position of retrotransposons in the mouse genome and I would like to find the nearest gene, the distance to that gene and whether it is on the + or - strand. There are so...

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


"mask" values in a bedgraph

I am trying to plot average conservation in a list of genomic features, and so far managed to do it successfully using a combination of the phastCons bigwig files (hg19.100way.phastCons.bw) and...

View Article

Bedgraph Not Displayed In Igv

Hi, I am new and so facing problem. I was trying to make a bed graph file using bed tools genomecov command. The command was: bedtools genomecov -ibam filename.sorted.bam -g chromosome sizes.txt >...

View Article


Multi Thread Bedtools

Hi,Is there a multi thread version of bedtools ? or is this feature in development ? Thanks,N.

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


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

Bedtools subtract not dealing well with large datasets

I am using bedtools subtract with large datasets and it keeps crashing, giving the following error    terminate called after throwing an instance of 'std::bad_alloc'Is there a way to get over this...

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