Skip to content

Commit

Permalink
snakefmt
Browse files Browse the repository at this point in the history
  • Loading branch information
dlaehnemann committed Oct 20, 2023
1 parent 83241b9 commit c576b56
Show file tree
Hide file tree
Showing 4 changed files with 9 additions and 4 deletions.
2 changes: 1 addition & 1 deletion workflow/rules/common.smk
Original file line number Diff line number Diff line change
Expand Up @@ -169,7 +169,7 @@ enrichment_env = render_enrichment_env()

def kallisto_quant_input(wildcards):
if is_3prime_experiment:
return "results/mane_3prime_reads/{sample}-{unit}.fastq",
return "results/mane_3prime_reads/{sample}-{unit}.fastq"
elif not is_single_end(wildcards.sample, wildcards.unit):
return expand(
"results/trimmed/{{sample}}-{{unit}}.{group}.fastq.gz", group=[1, 2]
Expand Down
4 changes: 2 additions & 2 deletions workflow/rules/quant_3prime.smk
Original file line number Diff line number Diff line change
Expand Up @@ -47,7 +47,7 @@ rule get_only_mane_select_reads_closest_to_3_prime:

rule get_mane_fastq:
input:
bam="results/mapped_3prime_mane/{sample}-{unit}.mane_select_closest_to_3_prime.bam"
bam="results/mapped_3prime_mane/{sample}-{unit}.mane_select_closest_to_3_prime.bam",
output:
fastq="results/mane_3prime_reads/{sample}-{unit}.fastq",
log:
Expand Down Expand Up @@ -111,4 +111,4 @@ rule kallisto_samtools_index:
extra="", # optional params string
threads: 4 # This value - 1 will be sent to -@
wrapper:
"v1.18.3/bio/samtools/index"
"v1.18.3/bio/samtools/index"
6 changes: 5 additions & 1 deletion workflow/rules/ref.smk
Original file line number Diff line number Diff line change
Expand Up @@ -32,7 +32,11 @@ rule get_annotation:

rule get_transcript_info:
output:
multiext("resources/transcripts_annotation", ".results.rds", ".mane_strand_length.tsv"),
multiext(
"resources/transcripts_annotation",
".results.rds",
".mane_strand_length.tsv",
),
params:
species=get_bioc_species_name(),
version=config["resources"]["ref"]["release"],
Expand Down
1 change: 1 addition & 0 deletions workflow/rules/ref_3prime.smk
Original file line number Diff line number Diff line change
Expand Up @@ -10,6 +10,7 @@ rule cds_polyA_T_removal:
script:
"../scripts/remove_poly_tails.py"


rule get_mane_transcripts_fasta:
input:
fasta="resources/transcriptome.cdna.without_poly_a.fasta",
Expand Down

0 comments on commit c576b56

Please sign in to comment.