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

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


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 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

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

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


N Closest Genes To A Given Location

Hi,This is basically an extension of the following question already asked in biostar (http://biostars.org/post/show/53561/python-finding-gene-closest-to-a-given-location/).Let us say I have a list of...

View Article

Filtering Bed Files By Using Bedops

hello every one,I have paired end illumina reads, R1.fastq and R2.fastq and I have mapped them as single-end reads by using bowtie2 default parameters, I performed further downstream analysis by using...

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


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


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

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

Merging/Intersecting Different Gene Annotations - Should I Extend Coordinates?

I want to create gene data-set (as big as possible), hence I am using several gene annotations. However, genes in different annotations overlap (it's the same gene). For reducing biases I overlap...

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


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

bedtools: extracting no coverage regions

Hello,I am not sure if this has been answered before as I looked and couldn't find a simple answer.I have a bam file, and all I want is to annotated all regions with 0 coverage in bed format. Is that...

View Article


How To Get Annotation For Bed File From Another Bed File

Hello All,I have a bed file (with Chr, Start, End, Name, Score and Strand) Chr1 5678 5680 NA 7 + Chr1 700 800 NA 8 - Chr1 900 1200 NA 10 -and would like to know, how can I get the annotation for the...

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


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

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

Intersectbed: Return Reads In Fraction In Input Files

I have a question with respect to intersectBED and multiple input files:Is it possible to return reads which are present in, say 8/10 input files, without fractioning the reads in smaller...

View Article
Browsing all 3764 articles
Browse latest View live