348 results • Page 2 of 6
HI, I'm using featureCounts (a sw provided by the Subread package) to count reads taken from a BAM file without the SEQ - QVAL fields. The read...summation routine gives the expected results with the following parameters: featureCounts -M -a data/basicAnnotation.gtf -o result/basic_M.FC data/basic.bam. I’m wondering if the absence of the SEQ/QVAL...be an issue when using any of the other …
updated 5.2 years ago • martinag.work
Hi,   I am trying to count the number of genes with featureCounts (subread1.5.1-source). I use -a my annotation.gff but it gives me error    WARNING no features were loaded
updated 9.0 years ago • esu2001
Hi, I used STAR, featureCounts, and edgeR for RNA-Seq alignment, quantification, and differentially expressed analysis. Could you teach...Hi, I used STAR, featureCounts, and edgeR for RNA-Seq alignment, quantification, and differentially expressed analysis. Could you teach me
updated 7.5 years ago • Gary
I am using featureCounts to try and create a count table for some RNA-Seq data I collected using an Oxford Nanopore platform. I have .sam...files aligned with minimap2, and am running the following command to try to get a count table: ``` featureCounts -a knownGene_v36.gtf -o countFile *.sam -L ``` Both the GTF file I am using, and the reference genome that the alignments...problem with t…
updated 4.3 years ago • nklier38
with more than 95 percent of reads successfully aligned. I then quantified gene expression using featureCounts with the corresponding Ensembl GTF (release 115). When running featureCounts with `-t exon -g gene_id`, approximately
updated 8 days ago • Luca
Ensembl/Gencode GRCh38 for mapping total RNA-Seq projects with STAR, and then counted reads with the featureCounts command from Subread or Rsubread. We are attempting to set up new pipelines with the latest release 43 (GRCh38.p13...differ (NC_060930.1). What (if any) modifications can be made to run Subread or RSubread featureCounts on the new NCBI release and obtain counts data for all ~57 th…
updated 2.8 years ago • Hilary
div class="preformatted">Hello, I would like to request a simple feature for Rsubread's featureCounts function that would make it more useful for ChIP-Seq applications. I want to use featureCounts to count the...sequenced is not representative of the fragment length. Would it be possible to add a parameter to featureCounts to allow this adjustment? Also, an additional feature that would be ni…
updated 10.1 years ago • Ryan C. Thompson
Hello all, From my understanding of the featureCounts manual it should, by default, count reads that align to the features (exons) of a meta-feature (gene). However my...Hello all, From my understanding of the featureCounts manual it should, by default, count reads that align to the features (exons) of a meta-feature (gene). However my output...file is at the exon level (sorry for the…
updated 2.7 years ago • CDSPARKS
requested in a [previous post](https://support.bioconductor.org/p/83968/)). From reading the featureCounts documentation, I suspected that this would be accomplished by setting the `nonOverlap` parameter, described...to 0. For the rest of the post, I will be discussing the results when using the following call to featureCounts (where the goal was to assign reads to a gene with which it completely…
updated 21 months ago • isaac.vock
<div class="preformatted">Hi Sheng, Please keep your post on the list. This is a rather arbitrary choice. You may play with different cutoffs to see what the difference it makes for your data, but a cutoff of 5 or less seems to be quite low to me. I dont really think genes with only 5 reads or less are of interest. Best wishes, Wei On Jul 6, 2013, at 7:38 AM, Sheng Zhao wrote: &gt;…
featureCounts: 0% successfully assigned fragments on PE .BAM files I am facing same problem, performed every suggestion but
updated 3.6 years ago • KMS
file which i converted to BAM file format. Now i want to count the reads by using Rsubread function featurecounts, This requires gtf annotation file. how can i generate the gtf file for this. Thank you
Hi, I'm using featureCounts (subread v2.0.2) to generate a count matrix for an RNAseq experiment. I have aligned paired-end .sam files sorted...Hi, I'm using featureCounts (subread v2.0.2) to generate a count matrix for an RNAseq experiment. I have aligned paired-end .sam files sorted by read name and have specified the -p flag and the −−countReadPairs parameter (please see code below). Whe…
updated 4.5 years ago • s.muroy
div class="preformatted">Hi Ryan, Sorry for my late reply. We have added the following options to featureCounts to let users be able to extend reads and also control the overlap length between reads and featureCounts: readExtension5...readExtension3 minReadOverlap The featureCounts help page describes the meaning of these parameters and how to use them. Changes have been committed to bioc.…
updated 11.7 years ago • Wei Shi
sam2bed | cut -f 6 | sort | uniq -c 11 - 1272 + ``` So far so good. Now lets try with featureCount from the R package Rsubread **Rsubread::featureCount approach**: ``` library(Rsubread) ### Create regions to quantify...sense x &lt;- capture.output( # prevent the subread printout senseQuantPaired &lt;- featureCounts( files = bamFiles, annot.e…
updated 6.7 years ago • k.vitting.seerup
I'm using the featureCounts function of Rsubread to assign aligned reads to features. Something like ~20% of my reads are unassigned (in...I'm using the featureCounts function of Rsubread to assign aligned reads to features. Something like ~20% of my reads are unassigned (in the
updated 5.7 years ago • am39
3 of the SAM files were created from PE data, and 1 SAM file was created from SE data. I want to use featurecounts to create a count matrix, however, should I be using paired end mode or single end mode?&nbsp; Thanks for the help
updated 8.4 years ago • nikelle.petrillo
Hello, I'm looking at the featureCount flag -t and the gtf file for my organism of study, and the gtf file has the following feature options: gene, exon...Hello, I'm looking at the featureCount flag -t and the gtf file for my organism of study, and the gtf file has the following feature options: gene, exon, transcript
updated 2.2 years ago • HS
I extracted exon information from mm9 and then used it for featureCount. Next I used an in-built mm9 annotation of featureCount and I got less exons annotated somehow. __Extraction...uc007aeu.1 &nbsp; Xkr4</pre> &nbsp; __FeatureCount with the manual exon annotation:__ ​manual=featureCounts(c(bam.CTCF,bam.H3K27ac),annot.ext=exon\_info\_red,isGTFAnnotationFile=FALSE, <p…
updated 10.3 years ago • tonja.r
Right now, the result objects from `Rsubread::featureCounts` can easily read into most DE Analysis packages (at least for `DESeq2` and `edgeR`, which should cover most use cases...Right now, the result objects from `Rsubread::featureCounts` can easily read into most DE Analysis packages (at least for `DESeq2` and `edgeR`, which should cover most use cases). However, at this time, it appears to me…
updated 3.6 years ago • johnmcma
because my bam is quite big, and already sorted by coordinates, and I takes much more time to ask featureCounts to re-order the reads to use paire end mode (and I have a lot of bam to count, onto various features, so it is taking
updated 10.6 years ago • samuel collombet
Hi, &nbsp; I want to obtain read counts at the exon level using featureCounts. I run Rsubread and use these options: annot.ext="/home/inah/RefGTF/GRCh38/annotation/Homo\_sapiens.GRCh38.85.gtf
updated 8.6 years ago • inah
RNASeq analysis so I'm having a lot of difficulties analyzing the data. First of all, I got some raw FeatureCount data, and there are multiple entries of the same meta-feature (gene) all with the same or very similar counts. What
updated 11.0 years ago • ccheung
I am testing the various featurecounts options from the very useful Rsubread package. I have noticed that in all tested libraries (&gt;100) using exon
updated 8.8 years ago • IV
Hi, I have a couple of questions regarding parameter choices for featureCounts. I have stranded 150 bp paired-end reads. I have currently chosen the following settings. As far as I understand...have set my STAR mapping to output all alignments with the best score as primary alignments). ```r featureCounts -p -B −−countReadPairs -C -F GTF --verbose -M --fraction --primary -A chromosome_name_ali…
Dear, Currently, I would like to calculate exon counts using package Rsubread 1.32.0, function featurecounts. Inputs: 1. Bam file based on paired end RNA sequencing. 2. Annotation file in GTF format, downloaded from GenCode...Gatk.ApplyBQSR From my point of view, I should be able to run following command: featureCounts( files=inputfile, annot.ext=annotation…
Hi all I first use the featureCounts in-build annotation ([another post](https://support.bioconductor.org/p/102280/)) and get the result. There are...Hi all I first use the featureCounts in-build annotation ([another post](https://support.bioconductor.org/p/102280/)) and get the result. There are 20454...img alt="" src="https://i.imgur.com/4wcOQT8.png" style="height:147px; width:730px"/> …
in a feature even if they have soft-clipped and inserted bases. Is there a simple solution to make featureCounts include these reads? I'm thinking to hack the bam file to replace cigar strings containing S or I (but not containing...amp; $1 !~ "^@" &amp;&amp; ($6 ~ "I" || $6 ~ "S")) {$6 = length($10)"M"} print $0}' &gt; out.sam featureCounts --fracOverlap 1 -O -f -a genes.gtf -o co…
updated 4.4 years ago • dario.beraldi
Hello- I'm trying to use `Rsubread`'s `featureCounts` function in a single-cell ATAC-seq data set, to count the number of reads in each cell that map to each peak. My...a BAM file that initially contained cell barcodes in the `CB` tag of each read -- then I found that `featureCounts` has no mechanism to use anything but the read group to separate reads, so I copied the barcodes to each read...…
updated 4.2 years ago • mruffalo
I have a featureCounts results file that looks like the snippet at bottom. I have another file for the parent that looks similar. How...link looks like: ``` &gt; library(DESeq2) &gt; setwd("~/example_data/practice_rnaseq_data/featurecounts/") &gt; counts=read.csv("counts2.txt", sep="", head=T, skip=1, row.names = "Geneid") &gt; colnames(counts)[6:11] &gt; colnames(co…
updated 5.8 years ago • chunter
Hello, I would like to confirm if the low assignment ratio (54%) is normal, and please check the possible reason I found. I used Hisat2 to assign paired-end strand-specific transcriptomic sequences (rRNA removed) to a reference genome. Because I filtered out the unmapped sequences in advance, the overall assignment ratio displayed by Hisat2 was 100%, and the multi-mapping ratio was only 0.3%. T…
updated 3.7 years ago • Sarah_piggy
I run follow Command-line code: #### Linux (Ununtu 22.04.5 LTS in Whidows WSL) ```bash hisat2 -p 6 --dta -x /mnt/d/hiv_omics/scripts/Hisat2_index/genome_tran -U /mnt/d/hiv_omics/GSE180044/SRR15127754/trimmed_output/SRR15127754_trimmed.fq.gz -S /mnt/d/hiv_omics/GSE180044/SRR15127754/alignment/SRR15127754_align.sam samtools view -@ 8 -bS /mnt/d/hiv_omics/GSE180044/SRR15127754/alignment/SRR15127…
updated 11 weeks ago • Rui
1 utf8_1.2.1 stringi_1.6.2 munsell_0.5.0 broom_0.7.6 crayon_1.4.1 ``` # run featureCounts ```r library(tidyverse) library(Rsubread) list.BAM &lt;- list.files(path = file.path("BAM"), pattern = ".bam$", recursive...GRCh38/sncRNA_piRNBnk_RNACent_GRCh38_v34.gtf") todate &lt;- format(Sys.time(), "%d_%b_%Y") fc &lt;- fea…
updated 4.6 years ago • Konstantinos Yeles
Hi- I've noticed what i think is a bug in featureCounts with paired-end reads and `--countReadPairs`. When a bam is used that has been filtered post alignment so that...Hi- I've noticed what i think is a bug in featureCounts with paired-end reads and `--countReadPairs`. When a bam is used that has been filtered post alignment so that some...reads that were originally paired are no longe…
updated 2.4 years ago • StevenE.Strong
Hi, running Rsubread 2.8.2/2.12.0 or featureCounts 2.0.3/2.0.1, I stumbled over two issues when allowing ambiguous read assignment (-O/allowMultiOverlap) 1) regarding...assignment via minimum fractional overlap (--fracOverlap) using featureCounts stand-alone binary. 2) when combined with --/largestOverlap and --/fraction using Rsubread featureCounts function...is enabled (--/fraction), both re…
updated 3.1 years ago • Konstantin
div class="preformatted">Hi, I am trying to use featureCounts to perform strand-specifc RNA-Seq read counting with an Ensembl GTF file. However, it seems to count reads from...the problem. First, if I specify strandSpefic = 0 I get 97.7% of the reads aligned to two genes: a = featureCounts("merged.bam", annot.ext = "Homo_sapiens.GRCh38.76.gtf", strandSpecific = 0, isGTFAnnotationFile = TRUE,…
updated 11.3 years ago • Guest User
p/249955/#250010)[,](https://www.biostars.org/p/249955/#250010) but according to the featureCounts website, I should post on this forum for help ::__ I am using featureCounts (version 1.5.2) to count the number of...reads within bins along the genome: <pre> featureCounts -R -F SAF --fracOverlap 1 -Q 1 --primary -T 20 -a Bins.saf -o readCounts.txt Input.bam</pre> A small percen…
updated 8.7 years ago • jma1991
Dear All, I am interested in counting the number of mapped reads in equal size intervals on genome (say 200 bp), my question is whether featurecounts any option for doing this. According to what I have found so far it sounds like it is more appropriate for counting reads mapping to exons, genes, and promoters. In order to use it for this purpose I define a set of features like following: --- l…
updated 9.5 years ago • Hadi Gharibi
i just created 16 BAM file by using Rsubread packege. When i run the featurecounts then I only get the total counts for each of the BAM file but not getting the count matrix.&nbsp; when i use fc$counts
updated 7.8 years ago • mmurshed
Hey, nice package. I have an error using featureCounts with paired end reads: I mapped paired end reads with STAR (trimmed reads with fastp), and wanted to try out Rsubread...counting in R. library(Rsubread) # Define paths to RNA-seq bam file and gtf a &lt;- featureCounts(files = df$RNA[1], annot.ext = gtfAnno, isGTFAnnotationFile = T, isPairedEnd = T, requireBothEndsMap…
updated 6.5 years ago • hauken_heyken
I am new to R and RStudio but have been trying to work through different examples using Rsubread for my data. I have tried reading vignettes and manuals prior to posting here but I am stuck and could really use some advice. I have 7 paired-end, fastq files from Illumina sequencing of human samples. I have downloaded RStudio version 2022.12.0+353. I have installed the packages BiocManager and R…
updated 2.8 years ago • rmoorehe
F 0x8 -F 0x100 -F 0x200 -F 0x400 -F 0x800 WT_1.bam &gt; WT_1.f.bam`) 2. Assign reads to genes with featureCounts (call below). Since only the primary alignment of multi-mapping reads are retained, there should be no instances...this and several other bam file were flagged as "Unassigned_MultiMapping" in the resulting CORE file. featureCounts call: ``` featureCounts -T 8 -s 2 -a genome.gtf…
updated 15 months ago • isaac.vock
with changes in exon usage that I should be able to recapitulate. My strategy was to use featureCounts (Rsubread) in order to get count data for each exon. I generated the flattened gtf using the python script provided...transcripts "ENST00000456328"; exonic_part_number "009" The issue arises when I try to use the featureCount function with these gtfs on their respective datasets. Both data…
updated 6.1 years ago • seung.ho.steven.choi
I am processing paired-end RNA-Seq data. I map them using Hisat2.0.3.Next I convert SAM files to BAM, sort and index the BAM file using samtools 1.3. I subsequently use the sorted BAM files to aggregate mapped reads based on annotation using featureCounts (Rsubread package v1.20.6). After mapping the reads using Hisat2, we get some summary statistics like this: 20358841...1.3. I subsequently us…
updated 9.6 years ago • Koen Van den Berge
Hi, I have RNAseq data with strand information and I'm using `` Rsubread ``'s `` featureCounts function to sum reads onto the GTF annotation. `` &nbsp; `` This is the command I'm using: `` `` featureCounts(files=my.bam
updated 9.0 years ago • rubi
Setup --- files: /path/to/file/here/file1.bam; /path/to/file/here/file2.bam countData=featureCounts(.....) ------- 1.28.1 --- colnames(countData$counts) [1] file1.bam [2] file2.bam ---- 1.34.0 ---- colnames(countData$counts) [1] X.path.to.file.here.file1.bam
updated 6.6 years ago • wunderl
Hi all I am trying to learn how to use Rsubread. I have a bam file from a bacterial sequencing project, and a related gtf file.&nbsp; I want to count hits to each gene and have been using the following command: _fc\_External&lt;-featureCounts("bamFIle.bam", annot.ext= "gtfFile.gtf", isGTFAnnotationFile=TRUE, GTF.featureType="CDS",useMetaFeatures=TRUE...nbsp; I want to count hits to eac…
updated 10.4 years ago • ross.chapman
you that the two genes are on different strands. &gt;&gt; &gt;&gt; When strandSpecific is set to 1, featureCounts requires the strand of a read is the same as that of a gene before assigning the read to the gene. When strandSpecific...is set to 2, featureCounts will flip the strand of each read and then try to match it to the strands of genes. Since your two genes are on...or smal…
updated 11.3 years ago • Wei Shi
is related to the introduction of coldata information in the matrix before running DESeq2 when using featureCounts data. 1) using Galaxy with 2 factors (2 batches/ 2 discinct studies from the litterature), 3 levels in each factor...error lie? Or at least what this row.names length error refers to? 2) I then tried to retrieve my featureCounts datasets from galaxy so that I can do deseq2 myse…
updated 5.1 years ago • NGS_enthusiast
I increased&nbsp; nthethreads value in featureCounts but the running time didnt decrease. <pre> I used the following command: subread_res &lt;- featureCounts(files...I increased&nbsp; nthethreads value in featureCounts but the running time didnt decrease. <pre> I used the following command: subread_res &lt;- featureCounts(files, annot.ext = GTF_file, …
updated 8.3 years ago • shao
Hi all,&nbsp; I am having a weird issue (weird to me being a new R user) using featurecounts to generate counts for genes but also for individual exons. I have successfully mapped gene counts to their...with total read mapped to genes. The code I am using is as follows: For annotating genes: fc &lt;- featureCounts(bamDir, isGTFAnnotationFile = TRUE, annot.ext = "Mus\_musculus.GRCm38.94…
updated 7.1 years ago • A
detailing the assignment of each individual sequencing read), I found a weird bug. Occasionally, featureCounts would assign reads to the identical set of isoforms, but would output different comma-separated target list...file with one of these two target lists and 100 with the other target list. Notably, when running featureCounts as detailed below on this downsampled bam file, the reads get assi…
updated 23 months ago • isaac.vock
Hi, I think I might have found a bug in featureCounts from Rsubread (v2.12.3). I am trying to find reads overlapping exon junctions from a personalised reference...Hi, I think I might have found a bug in featureCounts from Rsubread (v2.12.3). I am trying to find reads overlapping exon junctions from a personalised reference, using Nanopore long read BAMs. I am afraid I cannot share fully …
updated 2.7 years ago • Carlos
I'm having a very strange error when running featureCounts on a tiny test file: it says it's generating counts in the summary.txt file, but the 7th column of the counttable...0</pre> &nbsp; Where did the 18 reads go? &nbsp; <pre> head testYA.multicounts.txt # Program:featureCounts v1.5.0; Command:"/home/me/bin/subread-1.5.0-Linux-x86_64/bin/featureCounts" "-p" "-M" "--fr…
updated 9.9 years ago • Darya Vanichkina
____ \| |__| | ========== |_____/ \____/|____/|_| \_\______/_/ \_\_____/ v2.0.1 //========================== featureCounts setting ===========================\\ || || || Input files : 18 BAM files || || o bulk_trimmedAligned.…
Hello, I am using Rsubread's featureCounts() to quantify the genes in my RNA-Seq data. There are two options to count "genes" or "exons" that are then aggregated
Hello, I did a bulkRNA-seq and now have an output gene count file from: `featureCounts -s 0 -p -P -d 0 -D 1000 -B --primary -t exon -g gene_name -a gtf -T 6 -o output bam1 bam2 bam3` (I did it via hisat2 then samtools sort...then featurecounts using linux command line) The three bam files belong to 3 cell lines and I want to do a differential analysis
updated 3.3 years ago • Jiayi
Hi, I am using featureCounts to count reads for every gene from refSeq annotation file. But it went to error: featureCounts -a ../refGeneReviewed.gtf...Hi, I am using featureCounts to count reads for every gene from refSeq annotation file. But it went to error: featureCounts -a ../refGeneReviewed.gtf -t exon -g gene\_id -p -Q 10 -o ../../result/fc\_accepted\_hits.txt accepted\_hits.bam &…
updated 10.9 years ago • syrttgump
Hi, I am currently running featureCounts to count the number of reads that have been mapped to each gene. However, it is taking forever to run in R studio...Hi, I am currently running featureCounts to count the number of reads that have been mapped to each gene. However, it is taking forever to run in R studio and I am wondering if it is an issue with my code.&nbsp; Here is the code I used…
updated 7.7 years ago • octopuslegs11
I can't figure out how to get featureCounts to generate a count matrix. I have a gff3 file that I've converted to a SAF. Regardless of whether I use the gff3...have a gtf file available for the version of the genome that I'm working with. ```r counts &lt;- featureCounts( annot.ext = "~/Desktop/Spurp_reference_files/Spurp_genome/Sp5_genome_new_download/sp5_0_GCF.saf", isPairedEnd...…
updated 19 months ago • atan
348 results • Page 2 of 6
Traffic: 1980 users visited in the last hour
Help About
FAQ
Access RSS
API
Stats

Use of this site constitutes acceptance of our User Agreement and Privacy Policy.

Powered by the version 2.3.6