From 5299ef6a2d78348863206717eeb8c9c9b7630171 Mon Sep 17 00:00:00 2001 From: Erin Young Date: Fri, 17 May 2024 14:59:27 -0600 Subject: [PATCH 01/16] adjusted channels for failed spades --- main.nf | 21 ++++++++++++--------- 1 file changed, 12 insertions(+), 9 deletions(-) diff --git a/main.nf b/main.nf index 5b306f4..b4ec524 100644 --- a/main.nf +++ b/main.nf @@ -336,16 +336,18 @@ workflow { if ( params.sample_sheet || params.reads || params.sra_accessions ) { de_novo_alignment(ch_raw_reads) - ch_assembled = de_novo_alignment.out.contigs - ch_contigs = ch_fastas.mix(de_novo_alignment.out.contigs) - ch_clean_reads = de_novo_alignment.out.clean_reads - ch_for_multiqc = ch_for_multiqc.mix(de_novo_alignment.out.for_multiqc) - ch_versions = ch_versions.mix(de_novo_alignment.out.versions) + ch_assembled = de_novo_alignment.out.contigs + ch_contigs = ch_fastas.mix(de_novo_alignment.out.contigs) + ch_reads_contigs = ch_fastas.map{it -> tuple{it[0], it[1], null}}.mix(de_novo_alignment.out.reads_contigs) + ch_clean_reads = de_novo_alignment.out.clean_reads + ch_for_multiqc = ch_for_multiqc.mix(de_novo_alignment.out.for_multiqc) + ch_versions = ch_versions.mix(de_novo_alignment.out.versions) } else { - ch_contigs = ch_fastas - ch_clean_reads = Channel.empty() - ch_assembled = Channel.empty() + ch_contigs = ch_fastas + ch_reads_contigs = Channel.empty() + ch_clean_reads = Channel.empty() + ch_assembled = Channel.empty() } // getting a summary of everything @@ -353,6 +355,7 @@ workflow { quality_assessment( ch_raw_reads, ch_contigs, + ch_reads_contigs, summfle_script) ch_for_multiqc = ch_for_multiqc.mix(quality_assessment.out.for_multiqc) @@ -362,7 +365,7 @@ workflow { // optional subworkflow blobtools (useful for interspecies contamination) if ( params.blast_db && ( params.sample_sheet || params.reads || params.sra_accessions )) { - blobtools(ch_clean_reads, ch_assembled, quality_assessment.out.bams, ch_blast_db ) + blobtools(quality_assessment.out.bams, ch_blast_db ) ch_for_summary = ch_for_summary.mix(blobtools.out.for_summary) ch_for_flag = ch_for_flag.mix(blobtools.out.for_flag) From 583bf579bd7ccff216f3f56db6b685c9d178bc5b Mon Sep 17 00:00:00 2001 From: Erin Young Date: Fri, 17 May 2024 14:59:38 -0600 Subject: [PATCH 02/16] adjusted channels for failed spades --- subworkflows/blobtools.nf | 10 +++--- subworkflows/de_novo_alignment.nf | 10 +++--- subworkflows/information.nf | 52 +++++++++++++++++++----------- subworkflows/quality_assessment.nf | 14 +++----- 4 files changed, 48 insertions(+), 38 deletions(-) diff --git a/subworkflows/blobtools.nf b/subworkflows/blobtools.nf index 42a9b04..4b5ea05 100644 --- a/subworkflows/blobtools.nf +++ b/subworkflows/blobtools.nf @@ -5,14 +5,14 @@ include { blobtools_view } from '../modules/local/blobtools' addParams(param workflow blobtools { take: - ch_clean_reads - ch_contigs - ch_bams + ch_contig_bams ch_blast_db main: - blastn(ch_clean_reads.join(ch_contigs, by: 0).map{it -> tuple(it[0],it[2])}.combine(ch_blast_db)) - blobtools_create(ch_contigs.join(blastn.out.blastn, by: 0).join(ch_bams, by: 0)) + ch_contigs = ch_contig_bams.filter{it[1]}.map{it -> tuple(it[0], it[1])} + + blastn(ch_contigs.combine(ch_blast_db)) + blobtools_create(ch_contig_bams.join(blastn.out.blastn, by: 0, failOnMismatch: false, remainder: false)) blobtools_view(blobtools_create.out.json) blobtools_plot(blobtools_create.out.json) diff --git a/subworkflows/de_novo_alignment.nf b/subworkflows/de_novo_alignment.nf index 0a6b19c..5b0f4e0 100644 --- a/subworkflows/de_novo_alignment.nf +++ b/subworkflows/de_novo_alignment.nf @@ -10,8 +10,7 @@ workflow de_novo_alignment { bbduk(reads) fastp(bbduk.out.fastq) - fastp.out.fastq - .join(fastp.out.fastp_results) + fastp.out.fastp_results .filter ({ it[2] as int >= params.minimum_reads }) .map ( it -> tuple (it[0], it[1])) .set{ read_check } @@ -20,10 +19,11 @@ workflow de_novo_alignment { emit: // for downstream analyses - clean_reads = fastp.out.fastq - contigs = spades.out.contigs + reads_contigs = spades.out.reads_contigs + clean_reads = fastp.out.fastq + contigs = spades.out.contigs.filter{it[1] != null} // for multiqc for_multiqc = fastp.out.fastp_files.mix(bbduk.out.stats) - versions = bbduk.out.versions.mix(fastp.out.versions).mix(spades.out.versions) + versions = bbduk.out.versions.first().mix(fastp.out.versions.first()).mix(spades.out.versions.first()) } diff --git a/subworkflows/information.nf b/subworkflows/information.nf index ab8ffa6..b39ceee 100644 --- a/subworkflows/information.nf +++ b/subworkflows/information.nf @@ -20,25 +20,41 @@ workflow information { jsoncon_script main: + // species specific - // TODO : add blobtools - int grouptuplesize = 2 - if ( params.kraken2_db && ( params.sample_sheet || params.reads )) { grouptuplesize = grouptuplesize +1 } - - //flag(ch_flag.groupTuple(size : grouptuplesize, remainder: true )) - flag(ch_flag.groupTuple()) - - amrfinderplus(ch_contigs.join(flag.out.organism, by:0)) - drprg(ch_contigs.join(flag.out.myco_flag, by:0)) - emmtyper(ch_contigs.join(flag.out.strepa_flag, by:0).combine(summfle_script)) - kaptive(ch_contigs.join(flag.out.vibrio_flag, by:0)) - kleborate(ch_contigs.join(flag.out.klebsiella_flag, by:0).combine(summfle_script)) - elgato(ch_contigs.join(flag.out.legionella_flag, by:0)) - mykrobe(ch_contigs.join(flag.out.myco_flag, by:0)) - pbptyper(ch_contigs.join(flag.out.streppneu_flag, by:0)) - seqsero2(ch_contigs.join(flag.out.salmonella_flag, by:0)) - serotypefinder(ch_contigs.join(flag.out.ecoli_flag, by:0).combine(summfle_script)) - shigatyper(ch_contigs.join(flag.out.ecoli_flag, by:0).combine(summfle_script)) + // branch + join = faster than groupTuple + ch_flag + .branch { + blobtools: it[1] =~ /blobtools.txt/ + kraken2: it[1] =~ /kraken2.csv/ + mash: it[1] =~ /mash.csv/ + fastani: it[1] =~ /fastani.csv/ + } + .set { ch_flag_branch } + + ch_contigs + .filter{it[1] != null} + .join(ch_flag_branch.blobtools, by:0, failOnMismatch: false, remainder: true) + .join(ch_flag_branch.kraken2, by:0, failOnMismatch: false, remainder: true) + .join(ch_flag_branch.mash, by:0, failOnMismatch: false, remainder: true) + .join(ch_flag_branch.fastani, by:0, failOnMismatch: false, remainder: true) + .filter{it[1] != null} + .map{ it -> tuple(it[0],[it[1], it[2], it[3], it[4], it[5]])} + .set {ch_for_flag} + + flag(ch_for_flag) + + amrfinderplus(flag.out.organism) + drprg(flag.out.myco_flag) + emmtyper(flag.out.strepa_flag.combine(summfle_script)) + kaptive(flag.out.vibrio_flag) + kleborate(flag.out.klebsiella_flag.combine(summfle_script)) + elgato(flag.out.legionella_flag) + mykrobe(flag.out.myco_flag) + pbptyper(flag.out.streppneu_flag) + seqsero2(flag.out.salmonella_flag) + serotypefinder(flag.out.ecoli_flag.combine(summfle_script)) + shigatyper(flag.out.ecoli_flag.combine(summfle_script)) json_convert(drprg.out.json.combine(jsoncon_script)) diff --git a/subworkflows/quality_assessment.nf b/subworkflows/quality_assessment.nf index 34bd3a0..daa65df 100755 --- a/subworkflows/quality_assessment.nf +++ b/subworkflows/quality_assessment.nf @@ -8,6 +8,7 @@ workflow quality_assessment { take: ch_reads ch_contigs + ch_reads_contigs summfle_script main: @@ -20,13 +21,7 @@ workflow quality_assessment { if ( params.sample_sheet || params.reads || params.sra_accessions ) { fastqc(ch_reads) - ch_reads - .join(ch_contigs, by: 0, remainder: true) - .filter {it[1]} - .filter {it[2]} - .set { for_circulocov } - - circulocov(for_circulocov) + circulocov(ch_reads_contigs.filter{it[1]}.filter{it[2]}) for_multiqc = for_multiqc.mix(fastqc.out.for_multiqc) @@ -46,12 +41,11 @@ workflow quality_assessment { ch_summary = ch_summary.mix(circulocov_summary).mix(fastqc_summary) ch_versions = ch_versions.mix(fastqc.out.versions.first()).mix(circulocov.out.versions.first()) - ch_bams = ch_bams.mix(circulocov.out.bam) - + ch_bams = ch_bams.mix(circulocov.out.contig_bam) } // contigs - quast(ch_contigs.join(ch_reads, by: 0, remainder: true )) + quast(ch_reads_contigs.filter{it[2]}) mlst(ch_contigs.combine(summfle_script)) plasmidfinder(ch_contigs.combine(summfle_script)) From edb61089764065786216674256dec68dfbb5b69b Mon Sep 17 00:00:00 2001 From: Erin Young Date: Fri, 17 May 2024 14:59:51 -0600 Subject: [PATCH 03/16] updated version --- nextflow.config | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/nextflow.config b/nextflow.config index 3c7b256..3fba07a 100644 --- a/nextflow.config +++ b/nextflow.config @@ -3,7 +3,7 @@ manifest { author = 'Erin Young' homePage = 'https://github.com/UPHL-BioNGS/Grandeur' mainScript = 'main.nf' - version = '4.2.20240425' + version = '4.3.20240521' defaultBranch = 'main' description = 'Grandeur is short-read de novo assembly pipeline with serotyping.' nextflowVersion = '!>=22.10.1' From da95927af060fd7941997ca3d3967f8c223600ae Mon Sep 17 00:00:00 2001 From: Erin Young Date: Fri, 17 May 2024 15:00:20 -0600 Subject: [PATCH 04/16] added reads to emit --- modules/local/spades.nf | 11 +++++++---- 1 file changed, 7 insertions(+), 4 deletions(-) diff --git a/modules/local/spades.nf b/modules/local/spades.nf index 74e58ef..e42a40d 100644 --- a/modules/local/spades.nf +++ b/modules/local/spades.nf @@ -1,7 +1,9 @@ process spades { tag "${meta.id}" label "process_high" - publishDir params.outdir, mode: 'copy', saveAs: { filename -> filename.equals('versions.yml') ? null : filename } + publishDir path: params.outdir, mode: 'copy', pattern: 'logs/*/*log' + publishDir path: params.outdir, mode: 'copy', pattern: 'spades/*' + publishDir path: params.outdir, mode: 'copy', pattern: 'spades/*/*' container 'staphb/spades:3.15.5' errorStrategy { task.attempt < 2 ? 'retry' : 'ignore'} time '5h' @@ -10,10 +12,11 @@ process spades { tuple val(meta), file(reads) output: - path "spades/*/*", emit: files + path "spades/*/*", emit: files tuple val(meta), file("contigs/*_contigs.fa"), optional: true, emit: contigs - path "logs/${task.process}/*.log", emit: log - path "versions.yml", emit: versions + tuple val(meta), file("contigs/*_contigs.fa"), file(reads), optional: true, emit: reads_contigs + path "logs/${task.process}/*.log", emit: log + path "versions.yml", emit: versions when: task.ext.when == null || task.ext.when From 277aba7861769570255d7aaede25808e9dc70ed1 Mon Sep 17 00:00:00 2001 From: Erin Young Date: Fri, 17 May 2024 15:00:49 -0600 Subject: [PATCH 05/16] changed order of input --- modules/local/blobtools.nf | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/modules/local/blobtools.nf b/modules/local/blobtools.nf index 82e0fd0..0150bcd 100644 --- a/modules/local/blobtools.nf +++ b/modules/local/blobtools.nf @@ -7,7 +7,7 @@ process blobtools_create { errorStrategy { task.attempt < 2 ? 'retry' : 'ignore'} input: - tuple val(meta), file(contig), file(blastn), file(bam) + tuple val(meta), file(contig), file(bam), file(blastn) output: tuple val(meta), file("blobtools/*.blobDB.json"), emit: json From 7c8b28dfb252b10b63b0067fc6d3a57b710ece4f Mon Sep 17 00:00:00 2001 From: Erin Young Date: Fri, 17 May 2024 15:01:15 -0600 Subject: [PATCH 06/16] adjusted publishDir and input --- modules/local/circulocov.nf | 7 +++++-- 1 file changed, 5 insertions(+), 2 deletions(-) diff --git a/modules/local/circulocov.nf b/modules/local/circulocov.nf index 7ecc51d..7c7835b 100755 --- a/modules/local/circulocov.nf +++ b/modules/local/circulocov.nf @@ -2,16 +2,19 @@ process circulocov { tag "${meta.id}" label "process_medium" stageInMode "copy" - publishDir path: params.outdir, mode: 'copy', saveAs: { filename -> filename.equals('versions.yml') ? null : filename } + publishDir path: params.outdir, mode: 'copy', pattern: 'logs/*/*log' + publishDir path: params.outdir, mode: 'copy', pattern: 'circulocov/*' + publishDir path: params.outdir, mode: 'copy', pattern: 'circulocov/*/*' container 'staphb/circulocov:0.1.20240104' time '30m' errorStrategy { task.attempt < 2 ? 'retry' : 'ignore'} input: - tuple val(meta), file(fastqs), file(contigs) + tuple val(meta), file(contigs), file(fastqs) output: tuple val(meta), file("circulocov/*/*sr.bam*"), emit: bam + tuple val(meta), file(contigs), file("circulocov/*/*sr.bam*"), emit: contig_bam path "circulocov/*/overall_summary.txt", emit: collect path "circulocov/*", emit: everything path "circulocov/fastq/*", emit: fastq, optional: true From 699271fd136768fb9e84ea149adc12eb7153aff2 Mon Sep 17 00:00:00 2001 From: Erin Young Date: Fri, 17 May 2024 15:01:59 -0600 Subject: [PATCH 07/16] adjusted emit channel to include reads --- modules/local/fastp.nf | 10 +++++----- 1 file changed, 5 insertions(+), 5 deletions(-) diff --git a/modules/local/fastp.nf b/modules/local/fastp.nf index e9107e3..61fc087 100644 --- a/modules/local/fastp.nf +++ b/modules/local/fastp.nf @@ -11,11 +11,11 @@ process fastp { output: tuple val(meta), file("fastp/*_fastp_R{1,2}.fastq.gz"), emit: fastq, optional: true - path "fastp/*_fastp.html", emit: html, optional: true - path "fastp/*_fastp.json", emit: fastp_files, optional: true - path "logs/${task.process}/*.{log,err}", emit: log - tuple val(meta), env(passed_reads), emit: fastp_results - path "versions.yml", emit: versions + path "fastp/*_fastp.html", emit: html, optional: true + path "fastp/*_fastp.json", emit: fastp_files, optional: true + path "logs/${task.process}/*.{log,err}", emit: log + tuple val(meta), file("fastp/*_fastp_R{1,2}.fastq.gz"), env(passed_reads), emit: fastp_results + path "versions.yml", emit: versions when: task.ext.when == null || task.ext.when From c6ca1962545dff3c3fc69dff27e5cb5c940c9b00 Mon Sep 17 00:00:00 2001 From: Erin Young Date: Fri, 17 May 2024 15:02:27 -0600 Subject: [PATCH 08/16] added fasta to emit channel --- modules/local/local.nf | 24 ++++++++++++------------ 1 file changed, 12 insertions(+), 12 deletions(-) diff --git a/modules/local/local.nf b/modules/local/local.nf index 98acc0c..d2bd91f 100644 --- a/modules/local/local.nf +++ b/modules/local/local.nf @@ -77,18 +77,18 @@ process flag { tuple val(meta), file(files) output: - tuple val(meta), env(salmonella_flag) , emit: salmonella_flag - tuple val(meta), env(klebsiella_flag) , emit: klebsiella_flag - tuple val(meta), env(ecoli_flag) , emit: ecoli_flag - tuple val(meta), env(streppneu_flag) , emit: streppneu_flag - tuple val(meta), env(legionella_flag) , emit: legionella_flag - tuple val(meta), env(klebacin_flag) , emit: klebacin_flag - tuple val(meta), env(strepa_flag) , emit: strepa_flag - tuple val(meta), env(vibrio_flag) , emit: vibrio_flag - tuple val(meta), env(myco_flag) , emit: myco_flag - tuple val(meta), env(genus), env(species), emit: organism - path "flag/*_flag.csv" , emit: collect - path "logs/${task.process}/*.log" , emit: log_files + tuple val(meta), file("${files[0]}"), env(salmonella_flag) , emit: salmonella_flag + tuple val(meta), file("${files[0]}"), env(klebsiella_flag) , emit: klebsiella_flag + tuple val(meta), file("${files[0]}"), env(ecoli_flag) , emit: ecoli_flag + tuple val(meta), file("${files[0]}"), env(streppneu_flag) , emit: streppneu_flag + tuple val(meta), file("${files[0]}"), env(legionella_flag) , emit: legionella_flag + tuple val(meta), file("${files[0]}"), env(klebacin_flag) , emit: klebacin_flag + tuple val(meta), file("${files[0]}"), env(strepa_flag) , emit: strepa_flag + tuple val(meta), file("${files[0]}"), env(vibrio_flag) , emit: vibrio_flag + tuple val(meta), file("${files[0]}"), env(myco_flag) , emit: myco_flag + tuple val(meta), file("${files[0]}"), env(genus), env(species), emit: organism + path "flag/*_flag.csv", emit: collect + path "logs/${task.process}/*.log", emit: log_files shell: def prefix = task.ext.prefix ?: "${meta.id}" From d27f0f746bef0a6d22d9b06aac4be9cc8856580a Mon Sep 17 00:00:00 2001 From: Erin Young Date: Tue, 21 May 2024 14:43:18 -0600 Subject: [PATCH 09/16] updated to 3.12.8-2024-05-02.2 --- modules/local/amrfinderplus.nf | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/modules/local/amrfinderplus.nf b/modules/local/amrfinderplus.nf index 320dc2a..2d21f9a 100644 --- a/modules/local/amrfinderplus.nf +++ b/modules/local/amrfinderplus.nf @@ -2,7 +2,7 @@ process amrfinderplus { tag "${meta.id}" label "process_high" publishDir params.outdir, mode: 'copy', saveAs: { filename -> filename.equals('versions.yml') ? null : filename } - container 'staphb/ncbi-amrfinderplus:3.12.8-2024-01-31.1_2' + container 'staphb/ncbi-amrfinderplus:3.12.8-2024-05-02.2' errorStrategy { task.attempt < 2 ? 'retry' : 'ignore'} time '30m' From 738cb1d4b545373fadefef648693d68251161a9e Mon Sep 17 00:00:00 2001 From: Erin Young Date: Tue, 21 May 2024 14:43:35 -0600 Subject: [PATCH 10/16] updated to 16.15.0 --- modules/local/datasets.nf | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/modules/local/datasets.nf b/modules/local/datasets.nf index 83c7754..f38f447 100644 --- a/modules/local/datasets.nf +++ b/modules/local/datasets.nf @@ -2,7 +2,7 @@ process datasets_summary { tag "${taxon}" label "process_single" publishDir params.outdir, mode: 'copy', saveAs: { filename -> filename.equals('versions.yml') ? null : filename } - container 'staphb/ncbi-datasets:16.10.3' + container 'staphb/ncbi-datasets:16.15.0' time '1h' errorStrategy { task.attempt < 2 ? 'retry' : 'ignore' } From c2a7217228a17c9fe4afd0161819b0a3629643c6 Mon Sep 17 00:00:00 2001 From: Erin Young Date: Tue, 21 May 2024 14:43:55 -0600 Subject: [PATCH 11/16] reduced size of command --- modules/local/fastani.nf | 5 ++--- 1 file changed, 2 insertions(+), 3 deletions(-) diff --git a/modules/local/fastani.nf b/modules/local/fastani.nf index d2588a3..301b42e 100644 --- a/modules/local/fastani.nf +++ b/modules/local/fastani.nf @@ -25,12 +25,11 @@ process fastani { shell: def args = task.ext.args ?: '' def prefix = task.ext.prefix ?: "${meta.id}" - def ref = genomes.join(",") + def ends = genomes.collect { it.Name[-6..-1] }.flatten().unique().join(' *') """ mkdir -p fastani logs/${task.process} log_file=logs/${task.process}/${prefix}.${workflow.sessionId}.log - - echo ${ref} | tr "," "\\n" | sort > reference_list.txt + ls *${ends} | grep -v ${contigs} | sort > reference_list.txt fastANI ${args} \ --threads ${task.cpus} \ From d2d560f274d46d85074cf823a9fa8fb2c5d71fcd Mon Sep 17 00:00:00 2001 From: Erin Young Date: Tue, 21 May 2024 14:44:11 -0600 Subject: [PATCH 12/16] updated to 2.3.1 --- modules/local/iqtree2.nf | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/modules/local/iqtree2.nf b/modules/local/iqtree2.nf index d1ad8f3..8ae7366 100644 --- a/modules/local/iqtree2.nf +++ b/modules/local/iqtree2.nf @@ -2,7 +2,7 @@ process iqtree2 { tag "Phylogenetic analysis" label "process_high" publishDir params.outdir, mode: 'copy', saveAs: { filename -> filename.equals('versions.yml') ? null : filename } - container 'staphb/iqtree2:2.2.2.7' + container 'staphb/iqtree2:2.3.1' time '24h' errorStrategy { task.attempt < 2 ? 'retry' : 'ignore'} From ac914167b93a731e4e9e39948388f4921148e707 Mon Sep 17 00:00:00 2001 From: Erin Young Date: Tue, 21 May 2024 14:44:36 -0600 Subject: [PATCH 13/16] updated to 2.23.0-2024-05-01 --- modules/local/mlst.nf | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/modules/local/mlst.nf b/modules/local/mlst.nf index 416ea86..6710565 100644 --- a/modules/local/mlst.nf +++ b/modules/local/mlst.nf @@ -2,7 +2,7 @@ process mlst { tag "${meta.id}" label "process_medium" publishDir params.outdir, mode: 'copy', saveAs: { filename -> filename.equals('versions.yml') ? null : filename } - container 'staphb/mlst:2.23.0-2024-04-01' + container 'staphb/mlst:2.23.0-2024-05-01' maxForks 10 errorStrategy { task.attempt < 2 ? 'retry' : 'ignore'} time '10m' From ee1151e7340eb59050ac2f5ccc61463e26885dcb Mon Sep 17 00:00:00 2001 From: Erin Young Date: Tue, 21 May 2024 14:44:51 -0600 Subject: [PATCH 14/16] updated to 1.5.0 --- modules/local/panaroo.nf | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/modules/local/panaroo.nf b/modules/local/panaroo.nf index 04ca5a8..3c17fb0 100755 --- a/modules/local/panaroo.nf +++ b/modules/local/panaroo.nf @@ -2,7 +2,7 @@ process panaroo { tag "Core Genome Alignment" label "process_high" publishDir params.outdir, mode: 'copy', saveAs: { filename -> filename.equals('versions.yml') ? null : filename } - container 'staphb/panaroo:1.3.4' + container 'staphb/panaroo:1.5.0' errorStrategy { task.attempt < 2 ? 'retry' : 'ignore'} time '10h' From 3f9d6fd2ed9758a818a45eaf77d9a1dd4cb535d1 Mon Sep 17 00:00:00 2001 From: Erin Young Date: Tue, 21 May 2024 14:45:52 -0600 Subject: [PATCH 15/16] updated version to 4.4.240521 --- nextflow.config | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/nextflow.config b/nextflow.config index 3fba07a..2fe1277 100644 --- a/nextflow.config +++ b/nextflow.config @@ -3,7 +3,7 @@ manifest { author = 'Erin Young' homePage = 'https://github.com/UPHL-BioNGS/Grandeur' mainScript = 'main.nf' - version = '4.3.20240521' + version = '4.4.240521' defaultBranch = 'main' description = 'Grandeur is short-read de novo assembly pipeline with serotyping.' nextflowVersion = '!>=22.10.1' From cc0a6da338ac7e51507e3d5a0a224b9b7031c4ec Mon Sep 17 00:00:00 2001 From: Erin Young Date: Tue, 21 May 2024 15:08:25 -0600 Subject: [PATCH 16/16] added contigs to publishdir --- modules/local/spades.nf | 1 + 1 file changed, 1 insertion(+) diff --git a/modules/local/spades.nf b/modules/local/spades.nf index e42a40d..be42087 100644 --- a/modules/local/spades.nf +++ b/modules/local/spades.nf @@ -4,6 +4,7 @@ process spades { publishDir path: params.outdir, mode: 'copy', pattern: 'logs/*/*log' publishDir path: params.outdir, mode: 'copy', pattern: 'spades/*' publishDir path: params.outdir, mode: 'copy', pattern: 'spades/*/*' + publishDir path: params.outdir, mode: 'copy', pattern: 'contigs/*' container 'staphb/spades:3.15.5' errorStrategy { task.attempt < 2 ? 'retry' : 'ignore'} time '5h'