Skip to content

Commit

Permalink
feat: made output temporary for any files not needed for the report
Browse files Browse the repository at this point in the history
  • Loading branch information
yeising committed Sep 19, 2024
1 parent 822120c commit c96d155
Show file tree
Hide file tree
Showing 6 changed files with 13 additions and 13 deletions.
4 changes: 2 additions & 2 deletions workflow/rules/alignment.smk
Original file line number Diff line number Diff line change
Expand Up @@ -2,7 +2,7 @@ rule build_minimap_index: ## build minimap2 index
input:
target="transcriptome/transcriptome.fa",
output:
index="index/transcriptome_index.mmi",
index=temp("index/transcriptome_index.mmi"),
params:
extra=config["minimap_index_opts"],
log:
Expand All @@ -17,7 +17,7 @@ rule map_reads:
target="index/transcriptome_index.mmi",
query="filter/{sample}_filtered.fq",
output:
"alignments/{sample}.sam",
temp("alignments/{sample}.sam"),
log:
"logs/minimap2/mapping_{sample}.log",
params:
Expand Down
4 changes: 2 additions & 2 deletions workflow/rules/alignmod.smk
Original file line number Diff line number Diff line change
Expand Up @@ -2,7 +2,7 @@ rule sam_view:
input:
sam="alignments/{sample}.sam",
output:
"sorted_alignments/{sample}.bam",
temp("sorted_alignments/{sample}.bam"),
log:
"logs/samtools/samview_{sample}.log",
params:
Expand All @@ -15,7 +15,7 @@ rule sam_sort:
input:
sam="alignments/{sample}.sam",
output:
"sorted_alignments/{sample}_sorted.bam",
temp("sorted_alignments/{sample}_sorted.bam"),
log:
"logs/samtools/samsort_{sample}.log",
params:
Expand Down
4 changes: 2 additions & 2 deletions workflow/rules/datamod.smk
Original file line number Diff line number Diff line change
Expand Up @@ -7,7 +7,7 @@ rule genome_to_transcriptome:
genome="references/genomic.fa",
annotation="references/genomic.gff",
output:
transcriptome="transcriptome/transcriptome.fa",
transcriptome=temp("transcriptome/transcriptome.fa"),
log:
"logs/gffread.log",
conda:
Expand All @@ -24,7 +24,7 @@ rule filter_reads:
samples["sample"][wildcards.sample]
),
output:
"filter/{sample}_filtered.fq",
temp("filter/{sample}_filtered.fq"),
message:
f"Filtering with read length >= {config['min_length']}."
log:
Expand Down
6 changes: 3 additions & 3 deletions workflow/rules/qc.smk
Original file line number Diff line number Diff line change
Expand Up @@ -23,7 +23,7 @@ rule plot_samples:
caption="../report/nanoplot_sample_report.rst",
),
params:
outdir=lambda wildcards: f"NanoPlot/{wildcards.sample}",
outdir=temp(lambda wildcards: f"NanoPlot/{wildcards.sample}"),
log:
"logs/NanoPlot/{sample}.log",
resources:
Expand All @@ -46,7 +46,7 @@ rule plot_all_samples:
),
# This parameter is in line with the Snakemake docs 8.20.3 guideline on how to avoid having parameters as output prefixes
params:
outdir=lambda wildcards, output: output[0][:-21],
outdir=temp(lambda wildcards, output: output[0][:-21]),
log:
"logs/NanoPlot/all_samples.log",
conda:
Expand Down Expand Up @@ -86,7 +86,7 @@ rule map_qc:
input:
bam="sorted_alignments/{sample}_sorted.bam",
output:
directory("QC/qualimap/{sample}"),
temp(directory("QC/qualimap/{sample}")),
log:
"logs/qualimap/{sample}.log",
wrapper:
Expand Down
4 changes: 2 additions & 2 deletions workflow/rules/quantification.smk
Original file line number Diff line number Diff line change
Expand Up @@ -7,9 +7,9 @@ rule count_reads:
bam="sorted_alignments/{sample}.bam",
trs="transcriptome/transcriptome.fa",
output:
tsv="counts/{sample}_salmon/quant.sf",
tsv=temp("counts/{sample}_salmon/quant.sf"),
params:
outdir=lambda wildcards: f"counts/{wildcards.sample}_salmon",
outdir=temp(lambda wildcards: f"counts/{wildcards.sample}_salmon"),
libtype=config["salmon_libtype"],
log:
"logs/salmon/{sample}.log",
Expand Down
4 changes: 2 additions & 2 deletions workflow/rules/ref.smk
Original file line number Diff line number Diff line change
Expand Up @@ -24,7 +24,7 @@ rule extract_genome:
input:
rules.get_genome.output,
output:
"references/genomic.fa",
temp("references/genomic.fa"),
group:
"reference"
params:
Expand All @@ -43,7 +43,7 @@ rule extract_annotation:
input:
rules.get_genome.output,
output:
"references/genomic.gff",
temp("references/genomic.gff"),
group:
"reference"
params:
Expand Down

0 comments on commit c96d155

Please sign in to comment.