Skip to content

Commit 081bdb8

Browse files
committed
Workflow params (first preview)
Signed-off-by: Ben Sherman <[email protected]>
1 parent 711e58a commit 081bdb8

File tree

2 files changed

+24
-12
lines changed

2 files changed

+24
-12
lines changed

main.nf

Lines changed: 23 additions & 11 deletions
Original file line numberDiff line numberDiff line change
@@ -5,23 +5,35 @@
55
*/
66

77
nextflow.preview.output = true
8-
9-
/*
10-
* Default pipeline parameters. They can be overriden on the command line eg.
11-
* given `params.reads` specify on the run command line `--reads some_value`.
12-
*/
13-
14-
params.reads = null
15-
params.transcriptome = null
16-
params.outdir = "results"
17-
params.multiqc = "$projectDir/multiqc"
8+
nextflow.preview.params = true
189

1910
/*
2011
* import modules
2112
*/
2213
include { RNASEQ } from './modules/rnaseq'
2314
include { MULTIQC } from './modules/multiqc'
2415

16+
/*
17+
* Pipeline parameters can be overridden on the command line,
18+
* e.g. `--reads myreads.csv --transcriptome myref.fa`.
19+
*/
20+
params {
21+
/**
22+
* CSV file of FASTQ pairs to analyze.
23+
*/
24+
reads
25+
26+
/**
27+
* FASTA file for the reference transcriptome.
28+
*/
29+
transcriptome
30+
31+
/**
32+
* Directory containing the configuration for MultiQC.
33+
*/
34+
multiqc = "$projectDir/multiqc"
35+
}
36+
2537
/*
2638
* main script flow
2739
*/
@@ -32,7 +44,7 @@ workflow {
3244
===================================
3345
transcriptome: ${params.transcriptome}
3446
reads : ${params.reads}
35-
outdir : ${params.outdir}
47+
outdir : ${workflow.outputDir}
3648
""".stripIndent()
3749

3850
inputs_ch = channel.fromPath(params.reads)

nextflow.config

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -13,7 +13,7 @@
1313
manifest {
1414
description = 'Proof of concept of a RNA-seq pipeline implemented with Nextflow'
1515
author = 'Paolo Di Tommaso'
16-
nextflowVersion = '>=23.10.0'
16+
nextflowVersion = '>=25.04.0'
1717
}
1818

1919
/*

0 commit comments

Comments
 (0)