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

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


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


Discrepancy In Samtools Mpileup/Depth And Bedtools Genomecoveragebed Counts

I am getting different counts for the number of bases on reference covered by aligned reads using samtools depth/mpileup and BEDTools genomeCoverageBed commands. I am using samtools-0.1.19 and...

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

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


How Do You Get The Quality Score And Coverage For Every Single Position Of A...

Hi,I am trying to extract the coverage and the average quality score for each position of a reference assembly in bam/sam format. I have managed to get the coverage using BEDtools genomeCoverageBed...

View Article

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


Bedtools "Segmentation Fault" While Working With Genome.Fa

I wanted to use BEDTools to extract genomic sequences (fastaFromBed). My BED file has all 24 chromosomes, hence I want to use whole genome (merged from chromosome.fa). Tried to: fastaFromBed -fi...

View Article


Multi Thread Bedtools

Hi,Is there a multi thread version of bedtools ? or is this feature in development ? Thanks,N.

View Article

Using Gnu Parallel For Bedtools

I am trying to run gnu:parallel on bedtools multicov function where the original command is bedtools multicov -bams bam1 bam2 bam3.. -bed anon.bed > Q1_Counst.bedI would like to implement the above...

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

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


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

How To Install Bedtools In A User Directory

I am trying to install Bedtools in a user directory, however I looked at the manual for its makefile, and there is no such argument like "--prefix" for me to change. Is there a way to install all...

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

Snps Comparison

Hello,I would like to compare SNPs from different methods:number of SNPsSNPs postion (position where method A has SNPs but not B and vice versa. Where both have SNPs)I would be interested to get a...

View Article


Counting The Whole Insert Size From Paired-End Reads As Coverage

We have updated our workflows for per base sequence coverage to use genomeCoverageBed from BAM files. However for pair-end data it seems as though the regions between pair-end reads are not counted. To...

View Article

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

Intersect Gene Annotation With Specific Position Or Genomic Interval

Hi,I've several genomic interval and I want to check if they are overlapping with known gene. I've a gtf file with the coordinates of gene exons. My idea was to use intersectBed from bedtools but I've...

View Article
Browsing all 3764 articles
Browse latest View live