Tag: dgelist
Limma returned only positive logFC values
Limma returned only positive logFC values 0 I want to obtain the upregulated and downregulated genes using limma. However, all the DEGs returned by my code have positive LogFC and none are downregulated (negative LogFC). This observation is consistent across multiple distinct dataframes. Is there something wrong with my code?…
manually calculate log2 fold change and compare
Hi everybody, I am struggling trying to calculate log2FC manually with an RNA-seq experiment that has no replicates. I know this question has been posted but hadn’t been able to transfer the answers to my data. So I have 3 conditions, let’s say HpA, SpA and Empty. I would like…
Having problem on doing edgeR anlysis- cant create the DGE list through readbismark2DGE function.
I am facing a problem on getting the DGElist from the function of readbismark2dGE(). It didn’t show any error. output of bismark2DGE only shows Hashing, counting. I am using google colab to get more system RAM. I am using R version R4.2.3 and BiocManager 3.16. if (!requireNamespace(“BiocManager”, quietly = TRUE))…
coef /makeContrasts very different results
I have a situation where I have a factoral independant variable ‘suicide’ with three levels ‘non_suicide’, suicide, and ‘unkown’. I have been setting up my analysis thus: suicide.non.undet <- as.factor(df$suicide) CauseofDeath.recode <- as.factor(df$CauseofDeath) Sex <- as.factor(df$Sex) Smoking <- as.factor(df$Smoking) Ethanol <- as.factor(df$Ethanol) svseq1 <- as.numeric(df$svseq1) design1 <- model.matrix(~ suicide +…
non-numeric values found in counts
Error in DGEList(counts = cnt, group = group) : non-numeric values found in counts 2 @681bb58b Last seen 3 hours ago Costa Rica When I tried to create a list with EdgeR, I encountered a error:”Error in DGEList(counts = cnt, group = group) : non-numeric values found in counts” ….
Calculate RPKM
Calculate RPKM 0 Hi bioinformaticians, would anyone calculate RPKM from the count matrix with edgeR or DESeq2? I found some resources guide on this but there are one or two steps I don’t know such as this: y <- DGEList(counts=counts,genes=data.frame(Length=GeneLength)) y <- calcNormFactors(y) RPKM <- rpkm(y) How to get GeneLength?…
paired test for differential expression on RNAseq data
I need to make a paired wise differential expression test for a metadata like below: colData<- DataFrame(row.names = c( “1”, “2”, “3”, “4”, “5”, “6”), Patient=c(“b1″,”c1″,”d1″,”b1″,”c1″,”d1”), condition=c(“ctr”,”ctr”,”ctr”,”tre”,”tre”,”tre”)) DataFrame with 6 rows and 2 columns Patient condition <character> <character> 1 b1 ctr 2 c1 ctr 3 d1 ctr 4 b1 tre…
do I have to do this step in creating DGEList ?
do I have to do this step in creating DGEList ? 1 @441fab0f Last seen 2 hours ago United Kingdom Hi guys, at the moment I have a dataframe, which the Gene ID is in one column, the others are sample ID as column names and expression value as observations….
finding error to run edgeR , please check my code to be helpful for finding error and solving it. difficulty in finding the next steps of the code because of the occurring errors.
library(edgeR) counts <- read.delim(“GSE116959_series_matrix.txt”, row.names = 1) head(counts) data <- read.table(“annotation.txt”,header=TRUE , sep = “\t”) data head(data) d0<- DGEList(counts=counts , group = factor(counts)) d0 dim(d0) d0.full <- d0 #keep the old one in case we mess up countsPerMillion <- cpm(d0) summary(countsPerMillion) countCheck <- countsPerMillion > 1 head(countCheck) keep <- which(rowSums(countCheck)…
Which input file is used for DGEList in EgdeR?
Which input file is used for DGEList in EgdeR? 1 @mohammedtoufiq91-17679 Last seen 1 day ago Qatar Hi, I used an nf-core/rnaseq pipeline using star_salmon default aligner, on strand specific dataset. I have a question about gene counts data obtained as a result of salmon quantification. I am interested in…
finding error to run edgeR, error in ploting MDS and after that in model matrix also
finding error to run edgeR, error in ploting MDS and after that in model matrix also 0 library(edgeR) counts <- read.delim(“GSE116959_series_matrix.txt”, row.names = 1) head(counts) d0 <- DGEList(counts) d0 <- calcNormFactors(d0) d0 cutoff <- 1 drop <- which(apply(cpm(d0), 1, max) < cutoff) d <- d0[-drop,] dim(d) # number of genes…
Which RUVr batch corrected output is better to calculate TPM?
Which RUVr batch corrected output is better to calculate TPM? 0 I have downloaded several samples from 5 studies (5 batches). Example of my count table: S_rep1_batch1 S_rep2_batch1 S_rep1_batch2 S_rep2_batch2 S_rep3_batch2 . . . Gene1 34 54 65 76 67 Gene2 87 77 90 35 19 Gene3 47 67 70…
Hugely different results between edgeR and DESeq2
Hugely different results between edgeR and DESeq2 0 I am working on a 18-patients dataset. I am trying to calculate DE genes with both EdgeR and DESeq2 for further analyses. Its a 2-factor design (Status, Fraction). I want to calculate DE genes of different Fractions using the Status as covariate….
Subset count data in DGEList using edgeR/DESeq2
Subset count data in DGEList using edgeR/DESeq2 1 @0f752196 Last seen 1 day ago United Kingdom Hello, I have an enormous methylation dataset (12.6Gb) that is proving too much for my computer to handle. This data is loaded in to R as a DGEList (with counts, samples, genes and a…
Estimating Fold-Changes of Lowly Expressed Genes
Estimating Fold-Changes of Lowly Expressed Genes 1 @vm-21340 Last seen 6 hours ago Brazil I am doing a DGE analysis using RNAseq data to compare three conditions. I am using a standard pipeline (Create DGEList > Filter very lowly expressed genes > TMM normalize > DGE). Since there is a…
Differential gene expression analysis with no replicates using edgeR
Dear all, I have an experimental design where I have only one sample in each condition (2 conditions in total) and want to do differential gene expression analysis using edgeR. This is the script I want to use for the analysis and it runs without any errors – with this…
TPM normalization starting with read counts
Hello everyone I have multiple bulk RNA-seq datasets that I need to apply the same pipe line on. I want to normalize them from counts data to TPM. In all datasets, I have the genes as rows, and samples as columns. Unfortunately, I don’t have the fastq files, all I…
I have a query regarding differential gene expression using limma-voom.
I have a query regarding differential gene expression using limma-voom. 1 @28946033 Last seen 1 day ago India I used the following pipeline for RNA Seq Analysis Fastq-Trimmomatic- Hisat2(gtf file was annotated)-featurecounts After featurecounts I tried to do limmavoom, but I get error saying this An error occurred with this…
Gene Expression Analysis Steps ?
Hi everybody, I’m new in this field. I’m trying to replicate a paper to train my self . The results come out pretty the same but not exactly the same, so I wanted to know if all my steps are right or if I’m missing something ( or even completely…
rna seq – R – [DESeq2] – How use TMM normalized counts (from EdgeR) in inputs for DESeq2?
I have several RNAseq samples, from different experimental conditions. After sequencing, and alignment to reference genome, I merged the raw counts to get a dataframe that looks like this: > df_merge T0 DJ21 DJ24 DJ29 DJ32 Rec2 Rec6 Rec9 G10 421 200 350 288 284 198 314 165 G1000 17208…
Unsuccessful DE analysis using limma
This might be a bit long, please bare with me. I’m conducting a differential expression analysis using limma – voom. My comparison is regarding response vs non-response to a cancer drug. However, I’m not getting any DE genes, absolute zeros. Someone here once recommended not to use contrast matrix for…
Removing replicate not clustering and group with replicate Vs without -edgeR rnaseq analysis
Removing replicate not clustering and group with replicate Vs without -edgeR rnaseq analysis 0 I am working with bacteria samples – in 3 groups that include the control, Treatment A, and Treatment B. From the PCA I find that the replicates are far apart. So I have removed the treatment…
r – Contrast for Limma – Voom
I’m doing a differential expression analysis for RNA-seq data with limma – voom. My data is about a cancer drug, 49 samples in total, some of them are responders some of them are not. I need some help building the contrast. I’m dealing with only one factor here, so two…
Limma Differential Analysis on Proteomics data
Limma Differential Analysis on Proteomics data 1 @3c9b3fdc Last seen 7 hours ago United States Hi, I have a proteomics data set and I am doing the differential analysis on that. I used the Limma package to do that. I first removed the negative counts and did the analysis but…
DGE from tumor-adjacent normal pair RNA-seq data. For an individual, no replicate
Single sample analysis can be done in edgeR, while it is deprecated in DNASeq2 in 2018 probably (if you can use old DESeq version then it will work in single sample also). For egdeR you just do library(edgeR) setwd() rawdata <- read.delim(“filename”, check.names=FALSE, stringsAsFactors=FALSE) ngenes <- 10000 #no. of genes…
keep only genes expressed in sample at the same time as a particular gene of interest
Filter DGElist object: keep only genes expressed in sample at the same time as a particular gene of interest 0 Hello, need some help here as I’m kind of stuck with the edgeR DGElist format. I have a DGE list named x with the following dimensions: > dim(x ) [1]…
Calculate fold change in edgeR with one sample per condition
Hi, We have run a pilot RNA-Seq study with one sample per condition, this is just a test run. I understand there is no valid statistical test in this case, however just curious to obtain differential expression through edgeR package in R assuming dispersion = 0.4 for the human data….