美文网首页🍊码农my RNA-seq转录组
hisat2+stringtie+deseq2分析RNA-SEQ

hisat2+stringtie+deseq2分析RNA-SEQ

作者: 547可是贼帅的547 | 来源:发表于2018-05-16 13:26 被阅读287次

    hisat2+stringtie

    for ((i=2064449;i<2064457;i++)); 

    do 

    hisat2 -p 2 --dta -x ~/RNASEQ/index/grch38_tran/genome_tran -U ~/ribosome/GSE69923/SRR${i}.rmadapt.fq -S SRR${i}.sam;

     samtools sort -@ 2 -o SRR${i}.bam SRR${i}.sam;

     samtools index -@ 2 SRR${i}.bam

    stringtie -p 2 -G ~/RNASEQ/index/grch38_tran/Homo_sapiens.GRCh38.84.gtf -o SRR${i}.gtf -A SRR${i}.tab -B -e -l SRR${i} SRR${i}.bam

    done

    prepDE.py

    生成DEseq2能够读取的read count 矩阵

    python ~/Software/prepDE.py -i gtflist.txt -g countRes/gene_count.csv -t countRes/transcript.csv

    附:gtflist.txt格式:

    SRR3469478    ./SRR3469478.gtf

    SRR3469479      ./SRR3469479.gtf

    SRR4421540      ./SRR4421540.gtf

    SRR4421541      ./SRR4421541.gtf

    DEseq2差异分析的R代码

    args<-commandArgs(TRUE)

    library(DESeq2)

    library(BiocParallel)

    register(MulticoreParam(8))

    database=read.csv("transcript_count_matrix.csv",header = T,row.names = 1)

    condition <- factor(c(rep("control",args[1]),rep("treat",args[2])))

    coldata <- data.frame(row.names = colnames(database), condition)

    dds <- DESeqDataSetFromMatrix(countData=database, colData=coldata, design=~condition)

    dds <- dds[ rowSums(counts(dds)) > 1, ]

    nrow(dds)

    dds <- DESeq(dds,parallel = T)

    res <- results(dds)

    summary(res)

    count_r <- counts(dds, normalized=T)

    table(res$padj<0.01)

    res <- res[order(res$padj),]

    resdata <- merge(as.data.frame(res), as.data.frame(counts(dds, normalized=TRUE)),by="row.names",sort=FALSE)

    signresdata<-resdata[resdata$padj<0.01,]

    write.csv(signresdata,file = "DE_results.csv")

    write.csv(count_r,file = "read_counts.csv")

    相关文章

      网友评论

      • 33cd6c285c6c:你好,问一下,我用Stringtie的prepDE.py得到的gene_count.csv表格中有一多半是MSTRG的geneID怎么能直接生成出gene_name
        547可是贼帅的547:@passby_W 地址贴一下
        33cd6c285c6c:@aa啊啊机智占领前排阵地biu 都是在ensembl上下载的啊
        547可是贼帅的547:@passby_W 这个情况你可能是参考的GTF文件和基因组索引不匹配,你这两个都是在哪里下的?
      • 青鳉君:正好stringtie2deseq这步不太清楚,学习了😄
        青鳉君:@青鳉君 Python3运行prepDE.py脚本会出错,mark一下😄
        547可是贼帅的547:@青鳉君 共同进步吧!

      本文标题:hisat2+stringtie+deseq2分析RNA-SEQ

      本文链接:https://www.haomeiwen.com/subject/vsspdftx.html