Skip to content

Commit

Permalink
Update syntax to 2nd prefix
Browse files Browse the repository at this point in the history
Signed-off-by: Paolo Di Tommaso <[email protected]>
  • Loading branch information
pditommaso committed Oct 27, 2024
1 parent f11a178 commit 2690963
Show file tree
Hide file tree
Showing 5 changed files with 22 additions and 19 deletions.
25 changes: 15 additions & 10 deletions main.nf
Original file line number Diff line number Diff line change
Expand Up @@ -17,13 +17,6 @@ params.transcriptome = "$baseDir/data/ggal/ggal_1_48850000_49020000.Ggal71.500bp
params.outdir = "results"
params.multiqc = "$baseDir/multiqc"

log.info """\
R N A S E Q - N F P I P E L I N E
===================================
transcriptome: ${params.transcriptome}
reads : ${params.reads}
outdir : ${params.outdir}
"""

// import modules
include { RNASEQ } from './modules/rnaseq'
Expand All @@ -33,7 +26,19 @@ include { MULTIQC } from './modules/multiqc'
* main script flow
*/
workflow {
read_pairs_ch = channel.fromFilePairs( params.reads, checkIfExists: true )
RNASEQ( params.transcriptome, read_pairs_ch )
MULTIQC( RNASEQ.out, params.multiqc )
main:
log.info """\
R N A S E Q - N F P I P E L I N E
===================================
transcriptome: ${params.transcriptome}
reads : ${params.reads}
outdir : ${params.outdir}
"""

read_pairs_ch = channel.fromFilePairs( params.reads, checkIfExists: true )
RNASEQ( params.transcriptome, read_pairs_ch )
MULTIQC( RNASEQ.out, params.multiqc )

publish:
MULTIQC.out.report >> 'multiqc'
}
5 changes: 1 addition & 4 deletions modules/fastqc/main.nf
Original file line number Diff line number Diff line change
Expand Up @@ -8,10 +8,7 @@ process FASTQC {

output:
path "fastqc_${sample_id}_logs", emit: logs

publish:
logs >> 'fastqc'


script:
"""
fastqc.sh "$sample_id" "$reads"
Expand Down
5 changes: 1 addition & 4 deletions modules/multiqc/main.nf
Original file line number Diff line number Diff line change
Expand Up @@ -4,14 +4,11 @@ process MULTIQC {

input:
path '*'
path 'config'
path config

output:
path 'multiqc_report.html', emit: report

publish:
report >> 'multiqc'

script:
"""
cp $config/* .
Expand Down
4 changes: 4 additions & 0 deletions modules/rnaseq.nf
Original file line number Diff line number Diff line change
Expand Up @@ -16,4 +16,8 @@ workflow RNASEQ {

emit:
QUANT.out | concat(FASTQC.out) | collect

publish:
FASTQC.out.logs >> 'fastqc'

}
2 changes: 1 addition & 1 deletion nextflow.config
Original file line number Diff line number Diff line change
Expand Up @@ -13,7 +13,7 @@
manifest {
description = 'Proof of concept of a RNA-seq pipeline implemented with Nextflow'
author = 'Paolo Di Tommaso'
nextflowVersion = '24.04.4'
nextflowVersion = '24.10.0'
}

/*
Expand Down

0 comments on commit 2690963

Please sign in to comment.