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

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


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

How Can I Compare And Merge Bed Files

I have three bed files with chrNo, start, end position and type. I need to compare each chrNo, start and end position of one file with 2 other files and write the common one in a new file. Can any one...

View Article

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


Tutorial: Piping With Samtools, Bwa And Bedtools

In this tutorial I will introduce some concepts related to unix piping. Piping is a very useful feature to avoid creation of intermediate use once files. It is assumed that bedtools, samtools, and bwa...

View Article

GTF2/GFF3 "feature" types and expression analysis

Hi, I aligned a few samples using STAR to the genome provided in the Illumina iGenomes UCSC hg19 bundle (here) -- I used the provided gene feature (gtf2) file as is.  Now, my motive is to calculate the...

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


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


Bedtools on Cygwin problem.

Hi   I'm trying to install the latest release of Bedtools via Cygwin but there's a weird error during process. I know this isn't the best solution, but I do not have an other choice. Perhaps anyone...

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

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

Extract rows from BED file on the base of text content in one column

Hi,I am a newbie with scripting so I can't find an easy solution to this question by myself and I'd like to ask for some help.I have a long list of BED files, and for each file I want to scan them row...

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

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


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

Genomic Regions To Exclude Before Shuffling Intervals

I want to do permutation test: randomly reposit (shuffle) given genomic intervals and measure intersection between new coordinates and specific genomic element.Example: Different sets of genes: protein...

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

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

How To Rearrange Paired End Bam File?

Hello all,I have a paired end bam file and I want to use bedtools for them. After merging, the paired end read alignments are not lying next to each other. It is making problems in the bedtools...

View Article
Browsing all 3764 articles
Browse latest View live