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

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


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 Can I Include One Bed File In Another Bed File ?

Hello, I have 2 bedfiles that share some common features let's call the first file A.bed (bigger file) and the second B.bed (smaller file). I would like to have a new bed file that includes everything...

View Article

Counting Features In A Bed File

I have a file in the following BED formatChr1 1022071 1022105 + Chr1 1022071 1022105 + Chr1 1022072 1022106 - Chr1 1022072 1022106 - Chr1 1022072 1022106 - Chr1 1022072 1022106 -I am trying get the...

View Article

How To Check Whole Genome With Bigwigsummary ?

Hi,I have question about bigwigsummary tools ,I have my start and end positions and my bigwig file but I want to check whole genome instead of chromosome by chromosome Is there any option to use this...

View Article


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

Running BedTools on Linux Cluster: Permission Denied

I been having some problems with running BedTools binaries in a linux cluster. I have the binaries in my own $HOME/bin file and when I try to run bedtools I get this error message  -bash: bedtools:...

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 the rRNA ratio from a RNAseq dataset

Hello, I want to know if there is any way using the bedtools and miRdeep2 output bed file to get the rRNA ratio in my miRNAseq fastq data. Thank you very much! I have a gtf file, a genome.fa, a bed...

View Article


compute normal-tumor coverage ratio from exome BAMs

Could someone please suggest a quick way to compute the data ratio of uniquely mapped reads in the normal to uniquely mapped reads in the tumor, as required by Varscan in the command below? I have over...

View Article

Given gene ID and genomic coordinates, how can I create a GFF formatted file?

  I have downloaded a list of coordinates of yeast genes from Xu et al., 2009 (see table S3). Unfortunately its current format is not a standard format so it does not appear to be compatible with the...

View Article

Intersectbed Tool Generating Empty File

I have used the Bedtools command intersectBed to check the overlap between two bed files. A is my INDEL file and B is my Reference file. But it is producing an empty output file. I thought the problem...

View Article

macs and bedtools

HelloI have MACS2 output and now looking for peaks which are situated in introns. I have bed file with introns from USCS for my species. What file with peaks should I use for bedtools intersection?...

View Article


Bedtools Genomecoveragebed Usage : How To Create A Genome File?

I am using BEDTOOLS and the following command to get the coverage file:$ ./genomeCoverageBed -ibam ~/GG_project/trim/ecoli.bam -g > ~/GG_project/trim/coveragewhere ecoli.bam is my sorted bam file,...

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


Counting Number Of Bam Reads Directly Within Set Of Intervals With Bedtools

how can I count the number of BAM reads falling directly within a set of intervals, given in a GFF format? Note that I do not want reads overlapping the intervals, but ones that fall directly within...

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


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

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

Image may be NSFW.
Clik here to view.

Extract Only Paired-End Reads That Map A Specific Interval

Hi,Is it possible to extract paired-end reads that map to a specific interval ( from a bam file ). I tried with intersectBed :intersectBed -abam align.bam -b interval.gff3 -wa > result.bamhere's the...

View Article
Browsing all 3764 articles
Browse latest View live