RNA-seq snakemake 自动化流程

教程很多,随便列两个,强烈推荐学起来,没有python基础也可以搞定
参考1
参考2
Snakemake搭建生信分析流程-简介
snakemake使用笔记
[转]snakemake--我最喜欢的流程管理工具
主要需要一个snakefile和包含参数信息的config.yaml文件,所以需要编辑这两个文件,运行的时候只要把它们丢到数据所在的目录,使用以下代码运行就行了。

#!/bin/bash
#SBATCH --job-name=sbatch_rna_flow
#SBATCH --time=40:00:00
#SBATCH --cpus-per-task=20
#SBATCH --mem=60g
module load snakemake singularity
ml python/3.6
snakemake  -j 3 --use-singularity 

运行前建议使用

snakemake -np

去伪运行一下看看有没有错误在正式运行,这个习惯要保持。
如果因为运行出错导致lock可以用snakemake --unlock 解决

我使用的是SLURM递交系统,其他的可以用conda进行管理,老习惯,直接上代码,希望能够有所启发

PE (paired end) RNA-seq

snakefile

shell.executable("/bin/bash")
configfile: "./config.yaml"

(SAMPLES,READS,) = glob_wildcards("fastq/{sample}_{read}.fastq.gz")
READS=["1","2"]

rule all:
    input:
        "4_final_counts/final_counts.txt"

rule fastqc:
    input:
        "fastq/{sample}_1.fastq.gz",
        "fastq/{sample}_2.fastq.gz"
    output:
        "1_initial_qc/{sample}/{sample}_1_fastqc.zip",
        "1_initial_qc/{sample}/{sample}_2_fastqc.zip",
        "1_initial_qc/{sample}/{sample}_1_fastqc.html",
        "1_initial_qc/{sample}/{sample}_2_fastqc.html"
    log:
        "log/{sample}_fastqc"
    shell:
        """
        ml fastqc
        fastqc -o 1_initial_qc/{wildcards.sample} --noextract {input[0]} {input[1]} 2> {log}
        """

rule fastp:
    input:
        fwd="fastq/{sample}_1.fastq.gz",
        rev="fastq/{sample}_2.fastq.gz"
    output:
        fwd="2_fastp_output/{sample}_1_good.fq.gz",
        rev="2_fastp_output/{sample}_2_good.fq.gz",
        html="2_fastp_output/{sample}.html",
        json="2_fastp_output/{sample}.json"
    log:
        "log/{sample}_fastp"
    shell:
        """
        ml fastp
        fastp -w 10 -h {output[html]} -j  {output[json]} -i {input[fwd]} -I {input[rev]} -o {output[fwd]} -O {output[rev]} 2> {log}
        """

rule HISAT2:
    input:
        "2_fastp_output/{sample}_1_good.fq.gz",
        "2_fastp_output/{sample}_2_good.fq.gz"
    output:
        "3_HISAT2_aligned/{sample}.bam",
        "3_HISAT2_aligned/{sample}.bam.bai"
    params: "3_HISAT2_aligned/{sample}.bam"
    log:
        "log/{sample}_HISAT2"
    shell:
        """
        ml hisat
        ml samtools
        ml sambamba
        hisat2 -p {config[threads]} -x {config[index]} \
        -1 {input[0]} -2 {input[1]} \
        --no-mixed --no-discordant | sambamba view -t {config[threads]} --sam-input --format=bam /dev/stdin | \
        samtools sort -@ {config[threads]} > {params}
        samtools index -@ {config[threads]} {params}
        """

rule featureCounts:
    input:
        expand("3_HISAT2_aligned/{sample}.bam", sample=SAMPLES)
    output:
        "4_final_counts/final_counts.txt",
        "4_final_counts/final_counts.txt.summary"
    log:
        "log/featurecounts.log"
    shell:
        """ 
        ml subread
        ls 3_HISAT2_aligned/*bam | xargs featureCounts -a {config[gtf]} -o {output[0]} \
        -s {config[strand]} -T {config[threads]} -t exon -g gene_id 2> {log}
        """

config.yaml

gtf: "/gtf/gencode.v33.annotation.gtf"
index: "/hg38/grch38_p13/genome"
threads: 5
###featurecounts strand information 1 notrand 2 trand 0 unknown,depend on the library kit
strand: 2

SE RNAseq

snakefile

shell.executable("/bin/bash")
configfile: "./config.yaml"

(SAMPLES,) = glob_wildcards("fastq/{sample}.fastq.gz")


rule all:
    input:
        "4_final_counts/final_counts.txt"

rule fastqc:
    input:
        "fastq/{sample}.fastq.gz",
    output:
        "1_initial_qc/{sample}/{sample}.fastqc.zip",
        "1_initial_qc/{sample}/{sample}.fastqc.html",
    log:
        "log/{sample}_fastqc"
    shell:
        """
        ml fastqc
        fastqc -o 1_initial_qc/{wildcards.sample} --noextract {input[0]} 2> {log}
        """

rule fastp:
    input:
        "fastq/{sample}.fastq.gz"
    output:
        fwd="2_fastp_output/{sample}.good.fq.gz",
        html="2_fastp_output/{sample}.html",
        json="2_fastp_output/{sample}.json"
    log:
        "log/{sample}_fastp"
    shell:
        """
        ml fastp
        fastp -w 10 -h {output[html]} -j  {output[json]} -i {input[0]} -o {output[fwd]}  2> {log}
        """

rule HISAT2:
    input:
        "2_fastp_output/{sample}.good.fq.gz",
    output:
        "3_HISAT2_aligned/{sample}.bam",
        "3_HISAT2_aligned/{sample}.bam.bai"
    params: "3_HISAT2_aligned/{sample}.bam"
    log:
        "log/{sample}_HISAT2"
    shell:
        """
        ml hisat
        ml samtools
        ml sambamba
        hisat2 -p {config[threads]} -x {config[index]} \
        -U {input[0]} \
        --no-mixed --no-discordant | sambamba view -t {config[threads]} --sam-input --format=bam /dev/stdin | \
        samtools sort -@ {config[threads]} > {params}
        samtools index -@ {config[threads]} {params}
        """

rule featureCounts:
    input:
        expand("3_HISAT2_aligned/{sample}.bam", sample=SAMPLES)
    output:
        "4_final_counts/final_counts.txt",
        "4_final_counts/final_counts.txt.summary"
    log:
        "log/featurecounts.log"
    shell:
        """ 
        ml subread
        ls 3_HISAT2_aligned/*bam | xargs featureCounts -a {config[gtf]} -o {output[0]} \
        -s {config[strand]} -T {config[threads]} -t exon -g gene_id 2> {log}
        """

config.yaml

gtf: "/gtf/gencode.vM23.annotation.gtf"
index: "/grcm38/genome"
threads: 3
###featurecounts strand information 1 notrand 2 trand 0 unknown,depend on the library kit
strand: 0

轻松加easy,看个电影来收数据,注意控制好线程数否则内存爆表。


image.png
最后编辑于
©著作权归作者所有,转载或内容合作请联系作者
  • 序言:七十年代末,一起剥皮案震惊了整个滨河市,随后出现的几起案子,更是在滨河造成了极大的恐慌,老刑警刘岩,带你破解...
    沈念sama阅读 199,830评论 5 468
  • 序言:滨河连续发生了三起死亡事件,死亡现场离奇诡异,居然都是意外死亡,警方通过查阅死者的电脑和手机,发现死者居然都...
    沈念sama阅读 83,992评论 2 376
  • 文/潘晓璐 我一进店门,熙熙楼的掌柜王于贵愁眉苦脸地迎上来,“玉大人,你说我怎么就摊上这事。” “怎么了?”我有些...
    开封第一讲书人阅读 146,875评论 0 331
  • 文/不坏的土叔 我叫张陵,是天一观的道长。 经常有香客问我,道长,这世上最难降的妖魔是什么? 我笑而不...
    开封第一讲书人阅读 53,837评论 1 271
  • 正文 为了忘掉前任,我火速办了婚礼,结果婚礼上,老公的妹妹穿的比我还像新娘。我一直安慰自己,他们只是感情好,可当我...
    茶点故事阅读 62,734评论 5 360
  • 文/花漫 我一把揭开白布。 她就那样静静地躺着,像睡着了一般。 火红的嫁衣衬着肌肤如雪。 梳的纹丝不乱的头发上,一...
    开封第一讲书人阅读 48,091评论 1 277
  • 那天,我揣着相机与录音,去河边找鬼。 笑死,一个胖子当着我的面吹牛,可吹牛的内容都是我干的。 我是一名探鬼主播,决...
    沈念sama阅读 37,550评论 3 390
  • 文/苍兰香墨 我猛地睁开眼,长吁一口气:“原来是场噩梦啊……” “哼!你这毒妇竟也来了?” 一声冷哼从身侧响起,我...
    开封第一讲书人阅读 36,217评论 0 254
  • 序言:老挝万荣一对情侣失踪,失踪者是张志新(化名)和其女友刘颖,没想到半个月后,有当地人在树林里发现了一具尸体,经...
    沈念sama阅读 40,368评论 1 294
  • 正文 独居荒郊野岭守林人离奇死亡,尸身上长有42处带血的脓包…… 初始之章·张勋 以下内容为张勋视角 年9月15日...
    茶点故事阅读 35,298评论 2 317
  • 正文 我和宋清朗相恋三年,在试婚纱的时候发现自己被绿了。 大学时的朋友给我发了我未婚夫和他白月光在一起吃饭的照片。...
    茶点故事阅读 37,350评论 1 329
  • 序言:一个原本活蹦乱跳的男人离奇死亡,死状恐怖,灵堂内的尸体忽然破棺而出,到底是诈尸还是另有隐情,我是刑警宁泽,带...
    沈念sama阅读 33,027评论 3 315
  • 正文 年R本政府宣布,位于F岛的核电站,受9级特大地震影响,放射性物质发生泄漏。R本人自食恶果不足惜,却给世界环境...
    茶点故事阅读 38,623评论 3 303
  • 文/蒙蒙 一、第九天 我趴在偏房一处隐蔽的房顶上张望。 院中可真热闹,春花似锦、人声如沸。这庄子的主人今日做“春日...
    开封第一讲书人阅读 29,706评论 0 19
  • 文/苍兰香墨 我抬头看了看天上的太阳。三九已至,却和暖如春,着一层夹袄步出监牢的瞬间,已是汗流浃背。 一阵脚步声响...
    开封第一讲书人阅读 30,940评论 1 255
  • 我被黑心中介骗来泰国打工, 没想到刚下飞机就差点儿被人妖公主榨干…… 1. 我叫王不留,地道东北人。 一个月前我还...
    沈念sama阅读 42,349评论 2 346
  • 正文 我出身青楼,却偏偏与公主长得像,于是被迫代替她去往敌国和亲。 传闻我的和亲对象是个残疾皇子,可洞房花烛夜当晚...
    茶点故事阅读 41,936评论 2 341