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 ArticleHow 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 ArticleTool 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 ArticleHow 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 ArticleConverting Sam Files To Bam Files - Reproduce Results Nature Paper:...
I want to reproduce the results that people achieved in the following Nature paper: Transcriptome genetics using second generation sequencing in a Caucasian...
View ArticleHow 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 ArticleWhat Is The Fastest Method To Determine The Number Of Positions In A Bam File...
I have two very large BAM files (high depth, human, whole genome). I have a seemingly simple question. I want to know how many positions in each are covered by at least N reads (say 20). For now I am...
View ArticleCoveragebed, 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 ArticleIs 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 ArticleHow 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 ArticleIntersectbed - Overlap Analysis Usign Vcf And Bed Files
I am trying to do an overlap analysis between 200 danish exomes (VCF courtsey: Zev) and 10 different gene regions. I would like to know what percentage overlaps between my region of interest (in...
View ArticlePer Base Coverage
Is there a way to obtain per-base coverage for a define chromosome interval using a bam file generated from Illumina single-end reads? genomeCoverageBed in Bedtools does not seem to have an option for it.
View ArticleHow To Count Genes In Genomic Regions Using A Gtf/Gff3 And A Bed File Of Regions
I'd like to count the number of unique genes in a gff file falling within a list of genomic regions. With bedtools I can count the number of regions within the gff which is almost what I want, but not...
View ArticleBedtools 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 ArticleSamtools or Bedtools: How to filter a bam file with a bed file using strand...
HiI would like to filter a bam file, keeping only reads overlapping with genomic intervals from a bed file. I used samtools for this:samtools view -b -h -L bedfile.bed bamfile.bam However the -L option...
View ArticleSplice 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 ArticleSplit 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 ArticleBowtie2 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 ArticleDifferent coverage from bedtools and in vcf file - HELP PLEASE
Dear all, I have trouble to understand how bedtools computing coverage. I have vcf file (generated from Illumina somatic caller) - I was created bed file from my vcf. Then I try to compute coverag with...
View ArticleGet 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