我是第一次使用snakemake来使用cutadapt,bwa和GATK构建基本管道(修剪;映射;调用)。我想在目录中包含的每个fastq文件上运行此管道,而不必在snakefile或配置文件中指定它们的名称或其他内容。我想成功地做到这一点。
前两个步骤(cutadapt和bwa /修剪和映射)运行正常,但我遇到了GATK的一些问题。
首先,我必须从bam文件生成g.vcf文件。我使用这些规则来做这件事:
configfile: "config.yaml"
import os
import glob
rule all:
input:
"merge_calling.g.vcf"
rule cutadapt:
input:
read="data/Raw_reads/{sample}_R1_{run}.fastq.gz",
read2="data/Raw_reads/{sample}_R2_{run}.fastq.gz"
output:
R1=temp("trimmed_reads/{sample}_R1_{run}.fastq.gz"),
R2=temp("trimmed_reads/{sample}_R2_{run}.fastq.gz")
threads:
10
shell:
"cutadapt -q {config[Cutadapt][Quality_value]} -m {config[Cutadapt][min_length]} -a {config[Cutadapt][forward_adapter]} -A {config[Cutadapt][reverse_adapter]} -o {output.R1} -p '{output.R2}' {input.read} {input.read2}"
rule bwa_map:
input:
genome="data/genome.fasta",
read=expand("trimmed_reads/{{sample}}_{pair}_{{run}}.fastq.gz", pair=["R1", "R2"])
output:
temp("mapped_bam/{sample}_{run}.bam")
threads:
10
params:
rg="@RG\\tID:{sample}\\tPL:ILLUMINA\\tSM:{sample}"
shell:
"bwa mem -t 2 -R '{params.rg}' {input.genome} {input.read} | samtools view -Sb - > {output}"
rule picard_sort:
input:
"mapped_bam/{sample}.bam"
output:
"sorted_reads/{sample}.bam"
shell:
"java -Xmx4g -jar /home/alexandre/picard-tools/picard.jar SortSam I={input} O={output} SO=coordinate VALIDATION_STRINGENCY=SILENT"
rule picard_rmdup:
input:
bam="sorted_reads/{sample}.bam"
output:
"rmduped_reads/{sample}.bam",
"picard_stats/{sample}.bam"
params:
reads="rmduped_reads/{sample}.bam",
stats="picard_stats/{sample}.bam",
shell:
"java -jar -Xmx2g /home/alexandre/picard-tools/picard.jar MarkDuplicates "
"I={input.bam} "
"O='{params.reads}' "
"VALIDATION_STRINGENCY=SILENT "
"MAX_FILE_HANDLES_FOR_READ_ENDS_MAP=1000 "
"REMOVE_DUPLICATES=TRUE "
"M='{params.stats}'"
rule samtools_index:
input:
"rmduped_reads/{sample}.bam"
output:
"rmduped_reads/{sample}.bam.bai"
shell:
"samtools index {input}"
rule GATK_raw_calling:
input:
bam="rmduped_reads/{sample}.bam",
bai="rmduped_reads/{sample}.bam.bai",
genome="data/genome.fasta"
output:
"Raw_calling/{sample}.g.vcf",
shell:
"java -Xmx4g -jar /home/alexandre/GenomeAnalysisTK-3.7/GenomeAnalysisTK.jar -ploidy 2 --emitRefConfidence GVCF -T HaplotypeCaller -R {input.genome} -I {input.bam} --genotyping_mode DISCOVERY -o {output}"
这些规则运作正常。例如,如果我有文件: Cla001d_S281_L001_R1_001.fastq.gz Cla001d_S281_L001_R2_001.fastq.gz
我可以创建一个bam文件(Cla001d_S281_L001_001.bam
),然后从该bam文件中创建一个GVCF文件(Cla001d_S281_L001_001.g.vcf
)。我有很多像这样的示例,我需要为每个创建一个GVCF文件,然后将这些GVCF文件合并到一个文件中。问题是我无法将要合并的文件列表合并到以下规则:
rule GATK_merge:
input:
???
output:
"merge_calling.g.vcf"
shell:
"java -Xmx4g -jar /home/alexandre/GenomeAnalysisTK-3.7/GenomeAnalysisTK.jar "
"-T CombineGVCFs "
"-R data/genome.fasta "
"--variant {input} "
"-o {output}"
为了做到这一点,我尝试了几件事,但不能成功。问题是两个规则(GATK_raw_calling
和GATK_merge
之间的链接,它应该合并GATK_raw_calling
的输出。如果我指定GATK_raw_calling
的输出作为以下规则的输入(输入文件中的通配符无法从输出文件中确定),我就无法输出单个文件,并且我'如果我没有将这些文件指定为输入,则无法在这两个规则之间建立链接...
有没有办法成功呢?我认为困难在于我没有定义名单或其他名单。
提前感谢您的帮助。
答案 0 :(得分:4)
您可以尝试使用初始fastq.gz文件中的glob_wildcards生成样本ID列表:
sample_ids, run_ids = glob_wildcards("data/Raw_reads/{sample}_R1_{run}.fastq.gz")
然后,您可以使用此expand
输入GATK_merge
:
rule GATK_merge:
input:
expand("Raw_calling/{sample}_{run}.g.vcf",
sample=sample_ids, run=run_ids)
如果相同的运行ID始终带有相同的样品ID,则需要压缩而不是扩展,以避免不存在的组合:
rule GATK_merge:
input:
["Raw_calling/{sample}_{run}.g.vcf".format(
sample=sample_id,
run=run_id) for sample_id, run_id in zip(sample_ids, run_ids)]
答案 1 :(得分:1)
您可以使用python函数作为规则的输入来实现此目的,如snakemake文档here中所述。
可能看起来像这样:
# Define input files
def gatk_inputs(wildcards):
files = expand("Raw_calling/{sample}.g.vcf", sample=<samples list>)
return files
# Rule
rule gatk:
input: gatk_inputs
output: <output file name>
run: ...
希望这会有所帮助。