Skip to content
Snippets Groups Projects
Commit cfc1506f authored by vvanoost's avatar vvanoost
Browse files

Merge branch 'master' of gitlab_lbmc:pipelines/nextflow

parents b39575a3 af1d5130
No related branches found
No related tags found
No related merge requests found
...@@ -4,8 +4,8 @@ MAINTAINER Laurent Modolo ...@@ -4,8 +4,8 @@ MAINTAINER Laurent Modolo
ENV BOWTIE2_VERSION=2.3.4.1 ENV BOWTIE2_VERSION=2.3.4.1
ENV SAMTOOLS_VERSION=1.7 ENV SAMTOOLS_VERSION=1.7
ENV PACKAGES bowtie2=${BOWTIE2_VERSION}* \ ENV PACKAGES bowtie2=${BOWTIE2_VERSION}* \
samtools=${SAMTOOLS_VERSION}* samtools=${SAMTOOLS_VERSION}* \
perl=5.26.1*
RUN apt-get update && \ RUN apt-get update && \
apt-get install -y --no-install-recommends ${PACKAGES} && \ apt-get install -y --no-install-recommends ${PACKAGES} && \
......
...@@ -127,7 +127,7 @@ process mapping_fastq { ...@@ -127,7 +127,7 @@ process mapping_fastq {
} }
} }
""" """
bowtie2 --very_sensitive -p ${task.cpus} -x ${index_id} \ bowtie2 --very-sensitive -p ${task.cpus} -x ${index_id} \
-U ${reads} 2> \ -U ${reads} 2> \
${reads.baseName}_bowtie2_report.txt | \ ${reads.baseName}_bowtie2_report.txt | \
samtools view -Sb - > ${reads.baseName}.bam samtools view -Sb - > ${reads.baseName}.bam
......
...@@ -33,7 +33,7 @@ process mapping_fastq { ...@@ -33,7 +33,7 @@ process mapping_fastq {
} }
} }
""" """
bowtie2 --very_sensitive -p ${task.cpus} -x ${index_id} \ bowtie2 --very-sensitive -p ${task.cpus} -x ${index_id} \
-U ${reads} 2> \ -U ${reads} 2> \
${reads.baseName}_bowtie2_report.txt | \ ${reads.baseName}_bowtie2_report.txt | \
samtools view -Sb - > ${reads.baseName}.bam samtools view -Sb - > ${reads.baseName}.bam
......
...@@ -29,7 +29,7 @@ process fastqc_fastq { ...@@ -29,7 +29,7 @@ process fastqc_fastq {
file reads from fastq_files file reads from fastq_files
output: output:
file "*.{zip,html}" into fastqc_repport file "*.{zip,html}" into fastqc_report
script: script:
""" """
...@@ -59,7 +59,7 @@ process fastqc_fastq { ...@@ -59,7 +59,7 @@ process fastqc_fastq {
set pair_id, file(reads) from fastq_files set pair_id, file(reads) from fastq_files
output: output:
file "*.{zip,html}" into fastqc_repport file "*.{zip,html}" into fastqc_report
script: script:
""" """
......
...@@ -15,7 +15,7 @@ process fastqc_fastq { ...@@ -15,7 +15,7 @@ process fastqc_fastq {
set pair_id, file(reads) from fastq_files set pair_id, file(reads) from fastq_files
output: output:
file "*.{zip,html}" into fastqc_repport file "*.{zip,html}" into fastqc_report
script: script:
""" """
......
...@@ -16,7 +16,7 @@ process fastqc_fastq { ...@@ -16,7 +16,7 @@ process fastqc_fastq {
file reads from fastq_files file reads from fastq_files
output: output:
file "*.{zip,html}" into fastqc_repport file "*.{zip,html}" into fastqc_report
script: script:
""" """
......
...@@ -7,12 +7,12 @@ ...@@ -7,12 +7,12 @@
/* MultiQC */ /* MultiQC */
process multiqc { process multiqc {
tag "$repport.baseName" tag "$report.baseName"
publishDir "results/fastq/multiqc/", mode: 'copy' publishDir "results/fastq/multiqc/", mode: 'copy'
cpus = 1 cpus = 1
input: input:
file repport from fastqc_repport.collect() file report from fastqc_report.collect()
output: output:
file "*multiqc_*" into multiqc_report file "*multiqc_*" into multiqc_report
......
...@@ -15,7 +15,7 @@ process fastqc_fastq { ...@@ -15,7 +15,7 @@ process fastqc_fastq {
set pair_id, file(reads) from fastq_files set pair_id, file(reads) from fastq_files
output: output:
file "*.{zip,html}" into fastqc_repport file "*.{zip,html}" into fastqc_report
script: script:
""" """
...@@ -25,12 +25,12 @@ ${reads[0]} ${reads[1]} ...@@ -25,12 +25,12 @@ ${reads[0]} ${reads[1]}
} }
process multiqc { process multiqc {
tag "$repport[0].baseName" tag "$report[0].baseName"
publishDir "results/fastq/multiqc/", mode: 'copy' publishDir "results/fastq/multiqc/", mode: 'copy'
cpus = 1 cpus = 1
input: input:
file repport from fastqc_repport.collect() file report from fastqc_report.collect()
output: output:
file "*multiqc_*" into multiqc_report file "*multiqc_*" into multiqc_report
......
...@@ -16,7 +16,7 @@ process fastqc_fastq { ...@@ -16,7 +16,7 @@ process fastqc_fastq {
file reads from fastq_files file reads from fastq_files
output: output:
file "*.{zip,html}" into fastqc_repport file "*.{zip,html}" into fastqc_report
script: script:
""" """
...@@ -25,12 +25,12 @@ fastqc --quiet --threads ${task.cpus} --format fastq --outdir ./ ${reads} ...@@ -25,12 +25,12 @@ fastqc --quiet --threads ${task.cpus} --format fastq --outdir ./ ${reads}
} }
process multiqc { process multiqc {
tag "$repport[0].baseName" tag "$report[0].baseName"
publishDir "results/fastq/multiqc/", mode: 'copy' publishDir "results/fastq/multiqc/", mode: 'copy'
cpus = 1 cpus = 1
input: input:
file repport from fastqc_repport.collect() file report from fastqc_report.collect()
output: output:
file "*multiqc_*" into multiqc_report file "*multiqc_*" into multiqc_report
......
0% Loading or .
You are about to add 0 people to the discussion. Proceed with caution.
Please register or to comment