Seqanswers Leaderboard Ad

Collapse

Announcement

Collapse
No announcement yet.
X
 
  • Filter
  • Time
  • Show
Clear All
new posts

  • Trouble with EdgeR DE (in Trinity)

    Hello everyone, I am very new to RNA-seq and trinity and command line, please bear with me!

    I have successfully assembled my runs and am now trying to perform a differential expression between two samples using the edgeR method (described in the trinity manual). However, I keep erroring, and could use some insight on how to fix it.

    Code:
    [sjeschon@login001 ~]$ /gpfs/runtime/opt/trinity/2013-08-14/Analysis/DifferentialExpression/run_DE_analysis.pl --matrix /gpfs/data/kmowry/sjescho                n/RNASeqResults/2transcripts.counts.matrix --method edgeR --output /gpfs/data/kmowry/sjeschon/RNASeqResults/edger0
    Got 2 samples, and got: 3 data fields.
    Header: assembly_trinity_15443687.isoforms.results      assembly_trinity_17707296.isoforms.results
    Next: agalma/gene:21261.0/isoform:4     489.05  NA
    
    $VAR1 = {
              'assembly_trinity_17707296' => 2,
              'assembly_trinity_15443687' => 1
            };
    $VAR1 = {
              'assembly_trinity_17707296' => [
                                               'assembly_trinity_17707296'
                                             ],
              'assembly_trinity_15443687' => [
                                               'assembly_trinity_15443687'
                                             ]
            };
    Samples to compare: $VAR1 = [
              'assembly_trinity_17707296',
              'assembly_trinity_15443687'
            ];
    
    CMD: R --vanilla -q < 2transcripts.counts.matrix.assembly_trinity_15443687_vs_assembly_trinity_17707296.assembly_trinity_15443687.vs.assembly_tri                nity_17707296.EdgeR.Rscript
    > library(edgeR)
    Loading required package: limma
    >
    > data = read.table("/gpfs/data/kmowry/sjeschon/RNASeqResults/2transcripts.counts.matrix", header=T, row.names=1, com='')
    > col_ordering = c(1,2)
    > rnaseqMatrix = data[,col_ordering]
    > rnaseqMatrix = round(rnaseqMatrix)
    > rnaseqMatrix = rnaseqMatrix[rowSums(rnaseqMatrix)>=10,]
    > conditions = factor(c(rep("assembly_trinity_15443687", 1), rep("assembly_trinity_17707296", 1)))
    >
    > exp_study = DGEList(counts=rnaseqMatrix, group=conditions)
    > exp_study = calcNormFactors(exp_study)
    Error in if (any(allzero)) x <- x[!allzero, , drop = FALSE] :
      missing value where TRUE/FALSE needed
    Calls: calcNormFactors
    Execution halted
    Error, cmd: R --vanilla -q < 2transcripts.counts.matrix.assembly_trinity_15443687_vs_assembly_trinity_17707296.assembly_trinity_15443687.vs.assem                bly_trinity_17707296.EdgeR.Rscript died with ret (256)  at /gpfs/runtime/opt/trinity/2013-08-14/Analysis/DifferentialExpression/run_DE_analysis.p                l line 439.
    
    
    
    
    WARNING: This EdgeR comparison failed...
    Any help would be greatly appreciated!

  • #2
    Not sure if the error is due to the NA in the table?

    Error in if (any(allzero)) x <- x[!allzero, , drop = FALSE] :
    missing value where TRUE/FALSE needed

    Comment

    Latest Articles

    Collapse

    • seqadmin
      Advancing Precision Medicine for Rare Diseases in Children
      by seqadmin




      Many organizations study rare diseases, but few have a mission as impactful as Rady Children’s Institute for Genomic Medicine (RCIGM). “We are all about changing outcomes for children,” explained Dr. Stephen Kingsmore, President and CEO of the group. The institute’s initial goal was to provide rapid diagnoses for critically ill children and shorten their diagnostic odyssey, a term used to describe the long and arduous process it takes patients to obtain an accurate...
      12-16-2024, 07:57 AM
    • seqadmin
      Recent Advances in Sequencing Technologies
      by seqadmin



      Innovations in next-generation sequencing technologies and techniques are driving more precise and comprehensive exploration of complex biological systems. Current advancements include improved accessibility for long-read sequencing and significant progress in single-cell and 3D genomics. This article explores some of the most impactful developments in the field over the past year.

      Long-Read Sequencing
      Long-read sequencing has seen remarkable advancements,...
      12-02-2024, 01:49 PM

    ad_right_rmr

    Collapse

    News

    Collapse

    Topics Statistics Last Post
    Started by seqadmin, 12-17-2024, 10:28 AM
    0 responses
    22 views
    0 likes
    Last Post seqadmin  
    Started by seqadmin, 12-13-2024, 08:24 AM
    0 responses
    42 views
    0 likes
    Last Post seqadmin  
    Started by seqadmin, 12-12-2024, 07:41 AM
    0 responses
    28 views
    0 likes
    Last Post seqadmin  
    Started by seqadmin, 12-11-2024, 07:45 AM
    0 responses
    42 views
    0 likes
    Last Post seqadmin  
    Working...
    X