Skip to content
Snippets Groups Projects
Unverified Commit fb655dc5 authored by Laurent Modolo's avatar Laurent Modolo
Browse files

training_dataset.nf: rename output

parent 666d47e1
No related branches found
No related tags found
No related merge requests found
...@@ -63,14 +63,15 @@ process fasta_from_bed { ...@@ -63,14 +63,15 @@ process fasta_from_bed {
input: input:
file fasta from fasta_file file fasta from fasta_file
file bed from bed_files file bed from bed_files
val chromosome from params.chromosome
output: output:
file "*.fasta" into fasta_files_extracted file "*.fasta" into fasta_files_extracted
script: script:
""" """
bedtools getfasta -name \ bedtools getfasta \
-fi ${fasta} -bed ${bed} -fo ${fasta.baseName}_S.fasta -fi ${fasta} -bed ${bed} -fo s${fasta.baseName}.fasta
""" """
} }
...@@ -146,13 +147,12 @@ if ( params.fastq_paired != "" ) { ...@@ -146,13 +147,12 @@ if ( params.fastq_paired != "" ) {
set file_id, "*.fastq" into fastq_files_extracted set file_id, "*.fastq" into fastq_files_extracted
script: script:
""" """
samtools fastq -1 ${file_id}_SR1.fastq -2 ${file_id}_SR2.fastq -f 0x2 ${bam} samtools fastq -1 s${file_id}_R1.fastq -2 s${file_id}_R2.fastq -f 0x2 ${bam}
""" """
} }
process filter_bam_paired { process filter_bam_paired {
tag "$file_id" tag "$file_id"
publishDir "results/training/bams/", mode: 'copy'
cpus 4 cpus 4
input: input:
...@@ -163,7 +163,7 @@ if ( params.fastq_paired != "" ) { ...@@ -163,7 +163,7 @@ if ( params.fastq_paired != "" ) {
set file_id, "*.bam" into filtered_bam_files_paired set file_id, "*.bam" into filtered_bam_files_paired
script: script:
""" """
samtools view -@ ${task.cpus} -hb ${bam} -f 0x2 > ${file_id}_S.bam samtools view -@ ${task.cpus} -hb ${bam} -f 0x2 > f${file_id}.bam
""" """
} }
...@@ -176,11 +176,11 @@ if ( params.fastq_paired != "" ) { ...@@ -176,11 +176,11 @@ if ( params.fastq_paired != "" ) {
set file_id, file(bam) from filtered_bam_files_paired set file_id, file(bam) from filtered_bam_files_paired
output: output:
set file_id, "*_sorted.bam" into sorted_bam_files_paired set file_id, "*.bam" into sorted_bam_files_paired
script: script:
""" """
samtools sort -@ ${task.cpus} -O BAM -o ${file_id}_sorted.bam ${bam} samtools sort -@ ${task.cpus} -O BAM -o s${file_id}.bam ${bam}
""" """
} }
...@@ -244,7 +244,6 @@ if ( params.fastq_single != "" ) { ...@@ -244,7 +244,6 @@ if ( params.fastq_single != "" ) {
process bam_2_fastq_single { process bam_2_fastq_single {
tag "$file_id" tag "$file_id"
publishDir "results/training/fastq/", mode: 'copy'
input: input:
set file_id, file(bam) from bam_files_single_fa set file_id, file(bam) from bam_files_single_fa
...@@ -253,7 +252,7 @@ if ( params.fastq_single != "" ) { ...@@ -253,7 +252,7 @@ if ( params.fastq_single != "" ) {
set file_id, "*.fastq" into fastq_files_extracted set file_id, "*.fastq" into fastq_files_extracted
script: script:
""" """
samtools fastq -0 ${file_id}_S.fastq -F 0x4 ${bam} samtools fastq -0 s${file_id}.fastq -F 0x4 ${bam}
""" """
} }
...@@ -266,10 +265,10 @@ if ( params.fastq_single != "" ) { ...@@ -266,10 +265,10 @@ if ( params.fastq_single != "" ) {
file bed from bed_files file bed from bed_files
output: output:
set file_id, "*_S.bam" into filtered_bam_files_single set file_id, "*.bam" into filtered_bam_files_single
script: script:
""" """
samtools view -@ ${task.cpus} -hb ${bam} -F 0x4 > ${file_id}_S.bam samtools view -@ ${task.cpus} -hb ${bam} -F 0x4 > f${file_id}.bam
""" """
} }
...@@ -282,11 +281,11 @@ if ( params.fastq_single != "" ) { ...@@ -282,11 +281,11 @@ if ( params.fastq_single != "" ) {
set file_id, file(bam) from filtered_bam_files_single set file_id, file(bam) from filtered_bam_files_single
output: output:
set file_id, "*_sorted.bam" into sorted_bam_files_single set file_id, "*.bam" into sorted_bam_files_single
script: script:
""" """
samtools sort -@ ${task.cpus} -O BAM -o ${file_id}_sorted.bam ${bam} samtools sort -@ ${task.cpus} -O BAM -o s${file_id}.bam ${bam}
""" """
} }
......
0% Loading or .
You are about to add 0 people to the discussion. Proceed with caution.
Finish editing this message first!
Please register or to comment