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

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


Calculating Exome Coverage

*// Edit to make the post more clear (Mapping done via Bowtie2). My problem is that when counting Exome Coverage via coverageBed gives different results than via genomeCoverageBed. So I'm not sure if...

View Article


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

Extracting Genomic Coverage Information Across Different Samples

Hello, I have 3 bam files that i wanted to compare against each other. For example i have reference file with 10,000 sequences. I have paired end reads sequenced for 3 different samples. 1) Sample 1 is...

View Article

Bowtie2 Mapping Different Number Of Reads To Same Sequence When Ref-Seq Is...

I am using bowtie2 to map my PE reads. I have indexed multiple bacterial genomes by putting them together in a multi-fasta file fashion.bowtie2 -q -a -p 1 -x Multi -1 R100_1.fq -2 R100_2.fq -U...

View Article


Correlation Of Fpkm And Length Normalized Transcript Mapped Read Count

Hello, in the process of estimating expression for a 16 human tissue dataset ("Human Body Map 2.0 GSE30611") I used different methods to estimate the expression of the genes. After mapping against hg19...

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

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


Split A Bam File Into Several Files Containing All The Alignments For X...

Hi everyone! I am struggling with annotating a very big .bam file that was mapped using TopHat. The run was a large number of reads : ~200M. The problem is that when I now try to Annotate each read...

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

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

How To Create A Read Density Profile Within A Interval?

HI!I need some help: I have to create density profile with a window specific of 1kb (how many time a sequence is detected after NGS method). I have to use SAM and BEDtools, I think I can use genomeCov...

View Article


Intersectbed Overlap

Hi,I've a question about intersectBed. Is it possible to extract only alignment like this :chromosome =============================================================== BED/BAM A ==============...

View Article

Can Bedtools/Bedops Used To Extract Regions Where Scores Are Higher Than A...

I have a very basic question about bedtools and bedops. Can I use these tools to filter all the regions where the score is higher (or lower) than a given value? For example, let's say that I have a BED...

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

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


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

error with bedtools slop

Hi, I am trying to run a bedtools slop on my.bed file and hg19.genomebedtools slop -i H3K27me3.bed -g hg19.genome -b 30I get the following error:Less than the req'd two fields were encountered in the...

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