diff --git a/.github/workflows/pytest-workflow.yml b/.github/workflows/pytest-workflow.yml index 87f02f55..6428c50d 100644 --- a/.github/workflows/pytest-workflow.yml +++ b/.github/workflows/pytest-workflow.yml @@ -25,7 +25,7 @@ jobs: matrix: nxf_version: ['20.11.0-edge'] tags: ['${{ fromJson(needs.changes.outputs.modules) }}'] - profile: ['docker', 'singularity', 'conda'] + profile: ['docker'] ## 'conda', 'singularity' env: NXF_ANSI_LOG: false steps: @@ -72,8 +72,11 @@ jobs: uses: conda-incubator/setup-miniconda@v2 with: auto-update-conda: true - channels: defaults, bioconda, conda-forge + channels: conda-forge,bioconda,defaults python-version: ${{ matrix.python-version }} + - name: Conda clean + if: matrix.profile == 'conda' + run: conda clean -a # Test the module - name: Run pytest-workflow diff --git a/deprecated/bedtools/complement/Dockerfile b/deprecated/bedtools/complement/Dockerfile deleted file mode 100644 index 1d9dbb95..00000000 --- a/deprecated/bedtools/complement/Dockerfile +++ /dev/null @@ -1,7 +0,0 @@ -FROM nfcore/base -LABEL authors="Jose Espinosa-Carrasco" \ - description="Docker image containing all requirements for nf-core/modules/bedtools/complement" - -COPY environment.yml / -RUN conda env create -f /environment.yml && conda clean -a -ENV PATH /opt/conda/envs/nf-core-bedtools-complement/bin:$PATH diff --git a/deprecated/bedtools/complement/environment.yml b/deprecated/bedtools/complement/environment.yml deleted file mode 100644 index 544f0e6e..00000000 --- a/deprecated/bedtools/complement/environment.yml +++ /dev/null @@ -1,9 +0,0 @@ -# You can use this file to create a conda environment for this pipeline: -# conda env create -f environment.yml -name: nf-core-bedtools-complement -channels: - - conda-forge - - bioconda - - defaults -dependencies: - - bioconda::bedtools=2.29.2 diff --git a/deprecated/bedtools/complement/main.nf b/deprecated/bedtools/complement/main.nf deleted file mode 100644 index d9291d3b..00000000 --- a/deprecated/bedtools/complement/main.nf +++ /dev/null @@ -1,32 +0,0 @@ -def MODULE = "bedtools_complement" -params.publish_dir = MODULE -params.publish_results = "default" - -process BEDTOOLS_COMPLEMENT { - tag {input_file} - - publishDir "${params.out_dir}/${params.publish_dir}", - mode: params.publish_dir_mode, - saveAs: { filename -> - if (params.publish_results == "none") null - else filename } - - container "docker.pkg.github.com/nf-core/$MODULE" - - conda "${moduleDir}/environment.yml" - - input: - path (input_file) - path (fasta_sizes) - val (bedtools_complement_args) - - output: - path "${input_file}.bed", emit: complement - path "*.version.txt", emit: version - - script: - """ - bedtools complement -i ${input_file} -g ${fasta_sizes} ${bedtools_complement_args} > ${input_file}.bed - bedtools --version | sed -n "s/.*\\(v.*\$\\)/\\1/p" > bedtools.version.txt - """ -} diff --git a/deprecated/bedtools/complement/meta.yml b/deprecated/bedtools/complement/meta.yml deleted file mode 100644 index bb1baa0f..00000000 --- a/deprecated/bedtools/complement/meta.yml +++ /dev/null @@ -1,30 +0,0 @@ -name: bedtools complement -description: Returns all intervals in a genome that are not covered by at least one interval in the input BED/GFF/VCF file -keywords: - - complement -tools: - - bedtools: - description: | - Bedtools is a software package that provides with a toolset to perform genome arithmetic operations. - homepage: https://bedtools.readthedocs.io/en/latest/index.html - documentation: https://bedtools.readthedocs.io/en/latest/index.html - doi: 10.093/bioinformatics/btq033 -input: - - - - input_file: - type: file - description: Input genomic coordinates file - pattern: "*.{bed,gff,vcf}" - - fasta_sizes: - type: file - description: Genome chromosome sizes - pattern: "*.{txt,sizes}" - -output: - - - - index: - type: stdout,file - description: - pattern: "stdout,*.{bed,gff,vcf}" -authors: - - "@JoseEspinosa" diff --git a/deprecated/bedtools/complement/test/input_data/A.bed b/deprecated/bedtools/complement/test/input_data/A.bed deleted file mode 120000 index 4698611f..00000000 --- a/deprecated/bedtools/complement/test/input_data/A.bed +++ /dev/null @@ -1 +0,0 @@ -../../../../../tests/data/bed/A.bed \ No newline at end of file diff --git a/deprecated/bedtools/complement/test/input_data/genome.sizes b/deprecated/bedtools/complement/test/input_data/genome.sizes deleted file mode 120000 index 3457e6c9..00000000 --- a/deprecated/bedtools/complement/test/input_data/genome.sizes +++ /dev/null @@ -1 +0,0 @@ -../../../../../tests/data/bed/genome.sizes \ No newline at end of file diff --git a/deprecated/bedtools/complement/test/main.nf b/deprecated/bedtools/complement/test/main.nf deleted file mode 100644 index dfa024cc..00000000 --- a/deprecated/bedtools/complement/test/main.nf +++ /dev/null @@ -1,19 +0,0 @@ -#!/usr/bin/env nextflow - -nextflow.preview.dsl = 2 - -params.out_dir = "test_output" -params.fastqc_args = '' -params.publish_dir_mode = "copy" -params.bedtools_complement_args = '' - -include BEDTOOLS_COMPLEMENT from '../main.nf' params(params) - -// Define input channels -ch_input = Channel.fromPath('./input_data/A.bed') -chrom_sizes = Channel.fromPath('./input_data/genome.sizes') - -// Run the workflow -workflow { - BEDTOOLS_COMPLEMENT(ch_input, chrom_sizes, params.bedtools_complement_args) -} diff --git a/deprecated/bedtools/genomecov/Dockerfile b/deprecated/bedtools/genomecov/Dockerfile deleted file mode 100644 index c3211e5d..00000000 --- a/deprecated/bedtools/genomecov/Dockerfile +++ /dev/null @@ -1,7 +0,0 @@ -FROM nfcore/base -LABEL authors="Jose Espinosa-Carrasco" \ - description="Docker image containing all requirements for nf-core/modules/bedtools/genomecov" - -COPY environment.yml / -RUN conda env create -f /environment.yml && conda clean -a -ENV PATH /opt/conda/envs/nf-core-bedtools-genomecov/bin:$PATH diff --git a/deprecated/bedtools/genomecov/environment.yml b/deprecated/bedtools/genomecov/environment.yml deleted file mode 100644 index 7b962671..00000000 --- a/deprecated/bedtools/genomecov/environment.yml +++ /dev/null @@ -1,9 +0,0 @@ -# You can use this file to create a conda environment for this pipeline: -# conda env create -f environment.yml -name: nf-core-bedtools-genomecov -channels: - - conda-forge - - bioconda - - defaults -dependencies: - - bioconda::bedtools=2.29.2 diff --git a/deprecated/bedtools/genomecov/main.nf b/deprecated/bedtools/genomecov/main.nf deleted file mode 100644 index 9b7277ef..00000000 --- a/deprecated/bedtools/genomecov/main.nf +++ /dev/null @@ -1,32 +0,0 @@ -def MODULE = "bedtools_genomecov" -params.publish_dir = MODULE -params.publish_results = "default" - -process BEDTOOLS_GENOMECOV { - tag {bam} - - publishDir "${params.out_dir}/${params.publish_dir}", - mode: params.publish_dir_mode, - saveAs: { filename -> - if (params.publish_results == "none") null - else filename } - - container "docker.pkg.github.com/nf-core/$MODULE" - - conda "${moduleDir}/environment.yml" - - input: - path (bam) - path (chrom_sizes) - val (bedtools_genomecov_args) - - output: - path "${bam}.bed", emit: coverage - path "*.version.txt", emit: version - - script: - """ - bedtools genomecov -ibam ${bam} -g ${chrom_sizes} ${bedtools_genomecov_args} > ${bam}.bed - bedtools --version | sed -n "s/.*\\(v.*\$\\)/\\1/p" > bedtools.version.txt - """ -} diff --git a/deprecated/bedtools/genomecov/meta.yml b/deprecated/bedtools/genomecov/meta.yml deleted file mode 100644 index 83283f38..00000000 --- a/deprecated/bedtools/genomecov/meta.yml +++ /dev/null @@ -1,30 +0,0 @@ -name: bedtools genomecov -description: Returns feature coverage for a given genome in different formats -keywords: - - genomecov -tools: - - bedtools: - description: | - Bedtools is a software package that provides with a toolset to perform genome arithmetic operations. - homepage: https://bedtools.readthedocs.io/en/latest/index.html - documentation: https://bedtools.readthedocs.io/en/latest/index.html - doi: 10.093/bioinformatics/btq033 -input: - - - - input_file: - type: file - description: Input genomic coordinates file - pattern: "*.{bam}" - - chrom_sizes: - type: file - description: Genome chromosome sizes - pattern: "*.{txt,sizes}" - -output: - - - - index: - type: stdout,file - description: - pattern: "stdout,*.{bed,bedGraph}" -authors: - - "@JoseEspinosa" diff --git a/deprecated/bedtools/genomecov/test/input_data/JK2067_downsampled_s0.1.bam b/deprecated/bedtools/genomecov/test/input_data/JK2067_downsampled_s0.1.bam deleted file mode 120000 index 50ca10b6..00000000 --- a/deprecated/bedtools/genomecov/test/input_data/JK2067_downsampled_s0.1.bam +++ /dev/null @@ -1 +0,0 @@ -../../../../../tests/data/bam/JK2067_downsampled_s0.1.bam \ No newline at end of file diff --git a/deprecated/bedtools/genomecov/test/input_data/genome.sizes b/deprecated/bedtools/genomecov/test/input_data/genome.sizes deleted file mode 120000 index 3457e6c9..00000000 --- a/deprecated/bedtools/genomecov/test/input_data/genome.sizes +++ /dev/null @@ -1 +0,0 @@ -../../../../../tests/data/bed/genome.sizes \ No newline at end of file diff --git a/deprecated/bedtools/genomecov/test/main.nf b/deprecated/bedtools/genomecov/test/main.nf deleted file mode 100644 index 50d6bd6e..00000000 --- a/deprecated/bedtools/genomecov/test/main.nf +++ /dev/null @@ -1,19 +0,0 @@ -#!/usr/bin/env nextflow - -nextflow.preview.dsl = 2 - -params.out_dir = "test_output" -params.fastqc_args = '' -params.publish_dir_mode = "copy" -params.bedtools_genomecov_args = '' //'-bg' - -include BEDTOOLS_GENOMECOV from '../main.nf' params(params) - -// Define input channels -ch_input = Channel.fromPath('./input_data/JK2067_downsampled_s0.1.bam') -chrom_sizes = Channel.fromPath('./input_data/genome.sizes') - -// Run the workflow -workflow { - BEDTOOLS_GENOMECOV(ch_input, chrom_sizes, params.bedtools_genomecov_args) -} diff --git a/deprecated/bedtools/intersect/Dockerfile b/deprecated/bedtools/intersect/Dockerfile deleted file mode 100644 index 94ce0c08..00000000 --- a/deprecated/bedtools/intersect/Dockerfile +++ /dev/null @@ -1,7 +0,0 @@ -FROM nfcore/base -LABEL authors="Jose Espinosa-Carrasco" \ - description="Docker image containing all requirements for nf-core/modules/bedtools/intersect" - -COPY environment.yml / -RUN conda env create -f /environment.yml && conda clean -a -ENV PATH /opt/conda/envs/nf-core-bedtools-intersectbed/bin:$PATH diff --git a/deprecated/bedtools/intersect/environment.yml b/deprecated/bedtools/intersect/environment.yml deleted file mode 100644 index e82358e5..00000000 --- a/deprecated/bedtools/intersect/environment.yml +++ /dev/null @@ -1,9 +0,0 @@ -# You can use this file to create a conda environment for this pipeline: -# conda env create -f environment.yml -name: nf-core-bedtools-intersect -channels: - - conda-forge - - bioconda - - defaults -dependencies: - - bioconda::bedtools=2.29.2 diff --git a/deprecated/bedtools/intersect/main.nf b/deprecated/bedtools/intersect/main.nf deleted file mode 100644 index fd2d8af1..00000000 --- a/deprecated/bedtools/intersect/main.nf +++ /dev/null @@ -1,36 +0,0 @@ -def MODULE = "bedtools_intersect" -params.publish_dir = MODULE -params.publish_results = "default" - -process INTERSECT_BED { - tag "$input_file_1-$input_file_2" - - publishDir "${params.out_dir}/${params.publish_dir}", - mode: params.publish_dir_mode, - saveAs: { filename -> - if (params.publish_results == "none") null - else filename } - - container "docker.pkg.github.com/nf-core/$MODULE" - - conda "${moduleDir}/environment.yml" - - input: - path (input_file_1) - path (input_file_2) - val (intersectbed_args) - - output: - path "${input_file_1.baseName}_i_${input_file_2.baseName}.bed", emit: intersect - path "*.version.txt", emit: version - - script: - def params_string = intersectbed_args.collect { - /-$it.key $it.value/ - } join " " - - """ - bedtools intersect -a ${input_file_1} -b ${input_file_2} ${params_string} > ${input_file_1.baseName}_i_${input_file_2.baseName}.bed - bedtools --version | sed -n "s/.*\\(v.*\$\\)/\\1/p" > bedtools.version.txt - """ -} diff --git a/deprecated/bedtools/intersect/meta.yml b/deprecated/bedtools/intersect/meta.yml deleted file mode 100644 index d2df3589..00000000 --- a/deprecated/bedtools/intersect/meta.yml +++ /dev/null @@ -1,30 +0,0 @@ -name: bedtools intersect -description: Returns the overlapping features between two sets of genomics features -keywords: - - bedtools intersect -tools: - - bedtools: - description: | - Bedtools is a software package that provides with a toolset to perform genome arithmetic operations. - homepage: https://bedtools.readthedocs.io/en/latest/index.html - documentation: https://bedtools.readthedocs.io/en/latest/index.html - doi: 10.093/bioinformatics/btq033 -input: - - - - input_file_1: - type: file - description: Input genomic coordinates file - pattern: "*.{bam,bed,BED,gff,vcf}" - - input_file_2: - type: file - description: Input genomic coordinates file - pattern: "*.{bam,bed,BED,gff,vcf}" - -output: - - - - index: - type: stdout,file - description: - pattern: "stdout,*.{bed,BED}" -authors: - - "@JoseEspinosa" diff --git a/deprecated/bedtools/intersect/test/input_data/A.bed b/deprecated/bedtools/intersect/test/input_data/A.bed deleted file mode 120000 index 4698611f..00000000 --- a/deprecated/bedtools/intersect/test/input_data/A.bed +++ /dev/null @@ -1 +0,0 @@ -../../../../../tests/data/bed/A.bed \ No newline at end of file diff --git a/deprecated/bedtools/intersect/test/input_data/B.bed b/deprecated/bedtools/intersect/test/input_data/B.bed deleted file mode 120000 index d0ad47f4..00000000 --- a/deprecated/bedtools/intersect/test/input_data/B.bed +++ /dev/null @@ -1 +0,0 @@ -../../../../../tests/data/bed/B.bed \ No newline at end of file diff --git a/deprecated/bedtools/intersect/test/main.nf b/deprecated/bedtools/intersect/test/main.nf deleted file mode 100644 index b38f4c68..00000000 --- a/deprecated/bedtools/intersect/test/main.nf +++ /dev/null @@ -1,24 +0,0 @@ -#!/usr/bin/env nextflow - -nextflow.preview.dsl = 2 -params.out_dir = "test_output" -params.fastqc_args = '' -params.publish_dir_mode = "copy" -params.intersect_args = '' //'-bed -c -f 0.20' - -include check_output from '../../../../tests/functions/check_process_outputs.nf' // params(params) -include INTERSECT_BED from '../main.nf' params(params) - -// Define input channels -ch_input_1 = Channel.fromPath('./input_data/A.bed') -ch_input_2 = Channel.fromPath('./input_data/B.bed') - -def additional_params_map = [:] - -additional_params_map = [ s: "", - f: 0.9 ] - -// Run the workflow -workflow { - INTERSECT_BED(ch_input_1, ch_input_2, additional_params_map) -} diff --git a/deprecated/bedtools/merge/Dockerfile b/deprecated/bedtools/merge/Dockerfile deleted file mode 100644 index 4424203e..00000000 --- a/deprecated/bedtools/merge/Dockerfile +++ /dev/null @@ -1,7 +0,0 @@ -FROM nfcore/base -LABEL authors="Jose Espinosa-Carrasco" \ - description="Docker image containing all requirements for nf-core/modules/bedtools/complementbed" - -COPY environment.yml / -RUN conda env create -f /environment.yml && conda clean -a -ENV PATH /opt/conda/envs/nf-core-bedtools-merge/bin:$PATH diff --git a/deprecated/bedtools/merge/environment.yml b/deprecated/bedtools/merge/environment.yml deleted file mode 100644 index dad8488a..00000000 --- a/deprecated/bedtools/merge/environment.yml +++ /dev/null @@ -1,9 +0,0 @@ -# You can use this file to create a conda environment for this pipeline: -# conda env create -f environment.yml -name: nf-core-bedtools-merge -channels: - - conda-forge - - bioconda - - defaults -dependencies: - - bioconda::bedtools=2.29.2 diff --git a/deprecated/bedtools/merge/main.nf b/deprecated/bedtools/merge/main.nf deleted file mode 100644 index ff4e0aa1..00000000 --- a/deprecated/bedtools/merge/main.nf +++ /dev/null @@ -1,31 +0,0 @@ -def MODULE = "bedtools_merge" -params.publish_dir = MODULE -params.publish_results = "default" - -process BEDTOOLS_MERGE { - tag { input_file } - - publishDir "${params.out_dir}/${params.publish_dir}", - mode: params.publish_dir_mode, - saveAs: { filename -> - if (params.publish_results == "none") null - else filename } - - container "docker.pkg.github.com/nf-core/$MODULE" - - conda "${moduleDir}/environment.yml" - - input: - path (input_file) - val (bedtools_merge_args) - - output: - path "${input_file}.bed", emit: merge - path "*.version.txt", emit: version - - script: - """ - bedtools merge -i ${input_file} ${bedtools_merge_args} > ${input_file}.bed - bedtools --version | sed -n "s/.*\\(v.*\$\\)/\\1/p" > bedtools.version.txt - """ -} diff --git a/deprecated/bedtools/merge/meta.yml b/deprecated/bedtools/merge/meta.yml deleted file mode 100644 index ea0950d8..00000000 --- a/deprecated/bedtools/merge/meta.yml +++ /dev/null @@ -1,26 +0,0 @@ -name: bedtools merge -description: Combines overlapping genome features of a single file -keywords: - - merge -tools: - - bedtools: - description: | - Bedtools is a software package that provides with a toolset to perform genome arithmetic operations. - homepage: https://bedtools.readthedocs.io/en/latest/index.html - documentation: https://bedtools.readthedocs.io/en/latest/index.html - doi: 10.093/bioinformatics/btq033 -input: - - - - input_file: - type: file - description: Input genomic coordinates file - pattern: "*.{bed,gff,vcf,bam}" - -output: - - - - index: - type: stdout,file - description: - pattern: "stdout,*.{bed}" -authors: - - "@JoseEspinosa" diff --git a/deprecated/bedtools/merge/test/input_data/A.bed b/deprecated/bedtools/merge/test/input_data/A.bed deleted file mode 120000 index 4698611f..00000000 --- a/deprecated/bedtools/merge/test/input_data/A.bed +++ /dev/null @@ -1 +0,0 @@ -../../../../../tests/data/bed/A.bed \ No newline at end of file diff --git a/deprecated/bedtools/merge/test/input_data/JK2067_downsampled_s0.1.bam b/deprecated/bedtools/merge/test/input_data/JK2067_downsampled_s0.1.bam deleted file mode 120000 index 50ca10b6..00000000 --- a/deprecated/bedtools/merge/test/input_data/JK2067_downsampled_s0.1.bam +++ /dev/null @@ -1 +0,0 @@ -../../../../../tests/data/bam/JK2067_downsampled_s0.1.bam \ No newline at end of file diff --git a/deprecated/bedtools/merge/test/main.nf b/deprecated/bedtools/merge/test/main.nf deleted file mode 100644 index a4ef92a5..00000000 --- a/deprecated/bedtools/merge/test/main.nf +++ /dev/null @@ -1,19 +0,0 @@ -#!/usr/bin/env nextflow - -nextflow.preview.dsl = 2 - -params.out_dir = "test_output" -params.fastqc_args = '' -params.publish_dir_mode = "copy" -params.bedtools_merge_args = '' //''-s -c 6 -o distinct' - -include BEDTOOLS_MERGE from '../main.nf' params(params) - -// Define input channels -ch_input = Channel.fromPath('./input_data/A.bed') -//ch_input = Channel.fromPath('./input_data/JK2067_downsampled_s0.1.bam') - -// Run the workflow -workflow { - BEDTOOLS_MERGE(ch_input, params.bedtools_merge_args) -} diff --git a/deprecated/bedtools/merge/test/nextflow.config b/deprecated/bedtools/merge/test/nextflow.config deleted file mode 100644 index c137a138..00000000 --- a/deprecated/bedtools/merge/test/nextflow.config +++ /dev/null @@ -1,2 +0,0 @@ -docker.enabled = true -params.outdir = './results' diff --git a/deprecated/bedtools/sort/environment.yml b/deprecated/bedtools/sort/environment.yml deleted file mode 100644 index 305a5b8f..00000000 --- a/deprecated/bedtools/sort/environment.yml +++ /dev/null @@ -1,9 +0,0 @@ -# You can use this file to create a conda environment for this pipeline: -# conda env create -f environment.yml -name: nf-core-bedtools-sort -channels: - - conda-forge - - bioconda - - defaults -dependencies: - - bioconda::bedtools=2.29.2 diff --git a/deprecated/bedtools/sort/main.nf b/deprecated/bedtools/sort/main.nf deleted file mode 100644 index 77b9300f..00000000 --- a/deprecated/bedtools/sort/main.nf +++ /dev/null @@ -1,31 +0,0 @@ -def MODULE = "bedtools_sort" -params.publish_dir = MODULE -params.publish_results = "default" - -process BEDTOOLS_SORT { - tag { input_file } - - publishDir "${params.out_dir}/${params.publish_dir}", - mode: params.publish_dir_mode, - saveAs: { filename -> - if (params.publish_results == "none") null - else filename } - - container "docker.pkg.github.com/nf-core/$MODULE" - - conda "${moduleDir}/environment.yml" - - input: - path (input_file) - val (bedtools_sort_args) - - output: - path "${input_file}.bed", emit: sort - path "*.version.txt", emit: version - - script: - """ - bedtools sort -i ${input_file} ${bedtools_sort_args} > ${input_file}.bed - bedtools --version | sed -n "s/.*\\(v.*\$\\)/\\1/p" > bedtools.version.txt - """ -} diff --git a/deprecated/bedtools/sort/meta.yml b/deprecated/bedtools/sort/meta.yml deleted file mode 100644 index 30751216..00000000 --- a/deprecated/bedtools/sort/meta.yml +++ /dev/null @@ -1,26 +0,0 @@ -name: bedtools sort -description: Returns a sorted feature file by chromosome and other criteria -keywords: - - sort -tools: - - bedtools: - description: | - Bedtools is a software package that provides with a toolset to perform genome arithmetic operations. - homepage: https://bedtools.readthedocs.io/en/latest/index.html - documentation: https://bedtools.readthedocs.io/en/latest/index.html - doi: 10.093/bioinformatics/btq033 -input: - - - - input_file: - type: file - description: Input genomic coordinates file - pattern: "*.{bed,gff,vcf}" - -output: - - - - index: - type: stdout,file - description: - pattern: "stdout,*.{bed,gff,vcf}" -authors: - - "@JoseEspinosa" diff --git a/deprecated/bedtools/sort/test/input_data/A.bed b/deprecated/bedtools/sort/test/input_data/A.bed deleted file mode 120000 index 4698611f..00000000 --- a/deprecated/bedtools/sort/test/input_data/A.bed +++ /dev/null @@ -1 +0,0 @@ -../../../../../tests/data/bed/A.bed \ No newline at end of file diff --git a/deprecated/bedtools/sort/test/main.nf b/deprecated/bedtools/sort/test/main.nf deleted file mode 100644 index be464741..00000000 --- a/deprecated/bedtools/sort/test/main.nf +++ /dev/null @@ -1,18 +0,0 @@ -#!/usr/bin/env nextflow - -nextflow.preview.dsl = 2 - -params.out_dir = "test_output" -params.fastqc_args = '' -params.publish_dir_mode = "copy" -params.bedtools_sort_args = '' //'-sizeD' - -include BEDTOOLS_SORT from '../main.nf' params(params) - -// Define input channels -ch_input = Channel.fromPath('./input_data/A.bed') - -// Run the workflow -workflow { - BEDTOOLS_SORT(ch_input, params.bedtools_sort_args) -} diff --git a/deprecated/bowtie2/main.nf b/deprecated/bowtie2/main.nf deleted file mode 100644 index 31c3e149..00000000 --- a/deprecated/bowtie2/main.nf +++ /dev/null @@ -1,52 +0,0 @@ -nextflow.preview.dsl=2 -params.genome = '' - -process BOWTIE2 { - // depending on the genome used one might want/need to adjust the memory settings. - // For the E. coli test data this is probably not required - - // label 'bigMem' - // label 'multiCore' - - publishDir "$outdir/bowtie2", - mode: "copy", overwrite: true - - input: - tuple val(name), path(reads) - val (outdir) - val (bowtie2_args) - val (verbose) - - output: - path "*bam", emit: bam - path "*stats.txt", emit: stats - - script: - if (verbose){ - println ("[MODULE] BOWTIE2 ARGS: " + bowtie2_args) - } - - cores = 4 - - readString = "" - - // Options we add are - bowtie2_options = bowtie2_args - bowtie2_options += " --no-unal " // We don't need unaligned reads in the BAM file - - // single-end / paired-end distinction. Might also be handled via params.single_end - if (reads instanceof List) { - readString = "-1 " + reads[0] + " -2 " + reads[1] - } - else { - readString = "-U " + reads - } - - index = params.genome["bowtie2"] - bowtie2_name = name + "_" + params.genome["name"] - - """ - bowtie2 -x ${index} -p ${cores} ${bowtie2_options} ${readString} 2>${bowtie2_name}_bowtie2_stats.txt | samtools view -bS -F 4 -F 8 -F 256 -> ${bowtie2_name}_bowtie2.bam - """ - -} diff --git a/deprecated/bowtie2/meta.yml b/deprecated/bowtie2/meta.yml deleted file mode 100644 index e742b1d0..00000000 --- a/deprecated/bowtie2/meta.yml +++ /dev/null @@ -1,37 +0,0 @@ -name: Bowtie 2 -description: Ultrafast alignment to reference genome -keywords: - - Alignment - - Short reads - - FM Index -tools: - - fastqc: - description: | - Bowtie 2 is an ultrafast and memory-efficient tool for aligning sequencing reads - to long reference sequences. It is particularly good at aligning reads of about - 50 up to 100s or 1,000s of characters, and particularly good at aligning to relatively - long (e.g. mammalian) genomes. Bowtie 2 indexes the genome with an FM Index to keep - its memory footprint small: for the human genome, its memory footprint is typically - around 3.2 GB. Bowtie 2 supports gapped, local, and paired-end alignment modes. - homepage: http://bowtie-bio.sourceforge.net/bowtie2/index.shtml - documentation: http://bowtie-bio.sourceforge.net/bowtie2/manual.shtml -input: - - - - sample_id: - type: string - description: Sample identifier - - reads: - type: file - description: Input FastQ file, or pair of files -output: - - - - report: - type: file - description: mapping statistics report - pattern: "*bowtie2_stats.txt" - - alignment: - type: file - description: alignment file in BAM format - pattern: "*bowtie2.bam" -authors: - - "@FelixKrueger" diff --git a/deprecated/bowtie2/test/indices/E_coli/E_coli.1.bt2 b/deprecated/bowtie2/test/indices/E_coli/E_coli.1.bt2 deleted file mode 100644 index 03defbe6..00000000 Binary files a/deprecated/bowtie2/test/indices/E_coli/E_coli.1.bt2 and /dev/null differ diff --git a/deprecated/bowtie2/test/indices/E_coli/E_coli.2.bt2 b/deprecated/bowtie2/test/indices/E_coli/E_coli.2.bt2 deleted file mode 100644 index 90cdc20f..00000000 Binary files a/deprecated/bowtie2/test/indices/E_coli/E_coli.2.bt2 and /dev/null differ diff --git a/deprecated/bowtie2/test/indices/E_coli/E_coli.3.bt2 b/deprecated/bowtie2/test/indices/E_coli/E_coli.3.bt2 deleted file mode 100644 index 171a3625..00000000 Binary files a/deprecated/bowtie2/test/indices/E_coli/E_coli.3.bt2 and /dev/null differ diff --git a/deprecated/bowtie2/test/indices/E_coli/E_coli.4.bt2 b/deprecated/bowtie2/test/indices/E_coli/E_coli.4.bt2 deleted file mode 100644 index b2dc290b..00000000 Binary files a/deprecated/bowtie2/test/indices/E_coli/E_coli.4.bt2 and /dev/null differ diff --git a/deprecated/bowtie2/test/indices/E_coli/E_coli.rev.1.bt2 b/deprecated/bowtie2/test/indices/E_coli/E_coli.rev.1.bt2 deleted file mode 100644 index 9fa63794..00000000 Binary files a/deprecated/bowtie2/test/indices/E_coli/E_coli.rev.1.bt2 and /dev/null differ diff --git a/deprecated/bowtie2/test/indices/E_coli/E_coli.rev.2.bt2 b/deprecated/bowtie2/test/indices/E_coli/E_coli.rev.2.bt2 deleted file mode 100644 index a78402f5..00000000 Binary files a/deprecated/bowtie2/test/indices/E_coli/E_coli.rev.2.bt2 and /dev/null differ diff --git a/deprecated/bowtie2/test/indices/E_coli/NC_010473.fa b/deprecated/bowtie2/test/indices/E_coli/NC_010473.fa deleted file mode 120000 index d2298ff8..00000000 --- a/deprecated/bowtie2/test/indices/E_coli/NC_010473.fa +++ /dev/null @@ -1 +0,0 @@ -../../../../../tests/data/fasta/E_coli/NC_010473.fa \ No newline at end of file diff --git a/deprecated/bowtie2/test/input/Ecoli_DNA_R1.fastq.gz b/deprecated/bowtie2/test/input/Ecoli_DNA_R1.fastq.gz deleted file mode 120000 index c325c16c..00000000 --- a/deprecated/bowtie2/test/input/Ecoli_DNA_R1.fastq.gz +++ /dev/null @@ -1 +0,0 @@ -../../../../tests/data/fastq/dna/Ecoli_DNA_R1.fastq.gz \ No newline at end of file diff --git a/deprecated/bowtie2/test/input/Ecoli_DNA_R2.fastq.gz b/deprecated/bowtie2/test/input/Ecoli_DNA_R2.fastq.gz deleted file mode 120000 index 2d974f67..00000000 --- a/deprecated/bowtie2/test/input/Ecoli_DNA_R2.fastq.gz +++ /dev/null @@ -1 +0,0 @@ -../../../../tests/data/fastq/dna/Ecoli_DNA_R2.fastq.gz \ No newline at end of file diff --git a/deprecated/bowtie2/test/input/test_R1_val_1.fq.gz b/deprecated/bowtie2/test/input/test_R1_val_1.fq.gz deleted file mode 120000 index 88ccdc87..00000000 --- a/deprecated/bowtie2/test/input/test_R1_val_1.fq.gz +++ /dev/null @@ -1 +0,0 @@ -../../../../tests/data/fastq/rna/test_R1_val_1.fq.gz \ No newline at end of file diff --git a/deprecated/bowtie2/test/input/test_R2_val_2.fq.gz b/deprecated/bowtie2/test/input/test_R2_val_2.fq.gz deleted file mode 120000 index 440be644..00000000 --- a/deprecated/bowtie2/test/input/test_R2_val_2.fq.gz +++ /dev/null @@ -1 +0,0 @@ -../../../../tests/data/fastq/rna/test_R2_val_2.fq.gz \ No newline at end of file diff --git a/deprecated/bowtie2/test/main.nf b/deprecated/bowtie2/test/main.nf deleted file mode 100755 index 5c02914b..00000000 --- a/deprecated/bowtie2/test/main.nf +++ /dev/null @@ -1,31 +0,0 @@ -#!/usr/bin/env nextflow -nextflow.preview.dsl=2 - -params.outdir = "." -params.genome = "" -params.bowtie2_args = '' -// Bowtie2 arguments should be supplied in the following format to work: -// --bowtie2_args="--score-min L,0,-0.8" - -params.verbose = false - -if (params.verbose){ - println ("[WORKFLOW] BOWTIE2 ARGS: " + params.bowtie2_args) -} - -// for other genomes this needs to be handled somehow to return all possible genomes -genomeValues = ["name" : params.genome] -genomeValues["bowtie2"] = "/bi/home/fkrueger/VersionControl/nf-core-modules/test-datasets/indices/bowtie2/E_coli/${params.genome}"; - -include '../main.nf' params(genome: genomeValues) - -ch_read_files = Channel - .fromFilePairs('../../../test-datasets/Ecoli*{1,2}.fastq.gz',size:-1) - // .view() // to check whether the input channel works - -workflow { - - main: - BOWTIE2(ch_read_files, params.outdir, params.bowtie2_args, params.verbose) - -} \ No newline at end of file diff --git a/deprecated/bowtie2/test/nextflow.config b/deprecated/bowtie2/test/nextflow.config deleted file mode 100644 index c137a138..00000000 --- a/deprecated/bowtie2/test/nextflow.config +++ /dev/null @@ -1,2 +0,0 @@ -docker.enabled = true -params.outdir = './results' diff --git a/deprecated/bowtie2/test/output/Ecoli_DNA_R_E_coli_bowtie2.bam b/deprecated/bowtie2/test/output/Ecoli_DNA_R_E_coli_bowtie2.bam deleted file mode 100644 index dfaa3e54..00000000 Binary files a/deprecated/bowtie2/test/output/Ecoli_DNA_R_E_coli_bowtie2.bam and /dev/null differ diff --git a/deprecated/bowtie2/test/output/Ecoli_DNA_R_E_coli_bowtie2_stats.txt b/deprecated/bowtie2/test/output/Ecoli_DNA_R_E_coli_bowtie2_stats.txt deleted file mode 100644 index bc6ab152..00000000 --- a/deprecated/bowtie2/test/output/Ecoli_DNA_R_E_coli_bowtie2_stats.txt +++ /dev/null @@ -1,15 +0,0 @@ -10000 reads; of these: - 10000 (100.00%) were paired; of these: - 893 (8.93%) aligned concordantly 0 times - 8474 (84.74%) aligned concordantly exactly 1 time - 633 (6.33%) aligned concordantly >1 times - ---- - 893 pairs aligned concordantly 0 times; of these: - 815 (91.27%) aligned discordantly 1 time - ---- - 78 pairs aligned 0 times concordantly or discordantly; of these: - 156 mates make up the pairs; of these: - 0 (0.00%) aligned 0 times - 1 (0.64%) aligned exactly 1 time - 155 (99.36%) aligned >1 times -100.00% overall alignment rate diff --git a/deprecated/bowtie2/test/output/test_GRCm38_bowtie2.bam b/deprecated/bowtie2/test/output/test_GRCm38_bowtie2.bam deleted file mode 100644 index 2177aef9..00000000 Binary files a/deprecated/bowtie2/test/output/test_GRCm38_bowtie2.bam and /dev/null differ diff --git a/deprecated/bowtie2/test/output/test_GRCm38_bowtie2_stats.txt b/deprecated/bowtie2/test/output/test_GRCm38_bowtie2_stats.txt deleted file mode 100644 index 38a6ca98..00000000 --- a/deprecated/bowtie2/test/output/test_GRCm38_bowtie2_stats.txt +++ /dev/null @@ -1,15 +0,0 @@ -9979 reads; of these: - 9979 (100.00%) were paired; of these: - 3584 (35.92%) aligned concordantly 0 times - 3705 (37.13%) aligned concordantly exactly 1 time - 2690 (26.96%) aligned concordantly >1 times - ---- - 3584 pairs aligned concordantly 0 times; of these: - 886 (24.72%) aligned discordantly 1 time - ---- - 2698 pairs aligned 0 times concordantly or discordantly; of these: - 5396 mates make up the pairs; of these: - 2282 (42.29%) aligned 0 times - 1467 (27.19%) aligned exactly 1 time - 1647 (30.52%) aligned >1 times -88.57% overall alignment rate diff --git a/deprecated/cutadapt/main.nf b/deprecated/cutadapt/main.nf deleted file mode 100644 index d0a1141a..00000000 --- a/deprecated/cutadapt/main.nf +++ /dev/null @@ -1,41 +0,0 @@ -process cutadapt { - tag "${sample_id}" - - container 'quay.io/biocontainers/cutadapt:1.16--py27_1' - - input: - tuple val(sample_id), path(reads) - - output: - tuple sample_id, path("trimmed_*.fastq") - - script: - forward_fq = "trimmed_1.fastq" - reverse_fq = "trimmed_2.fastq" - - - if (params.single_end) { - processing = """ - cutadapt \ - -j ${task.cpus} \ - -q $params.cutadapt_min_quality \ - --minimum-length $params.cutadapt_min_length \ - --output ${forward_fq} \ - ${reads} - """ - } else { - processing = """ - cutadapt \ - -j ${task.cpus} \ - -q $params.cutadapt_min_quality \ - --minimum-length $params.cutadapt_min_length \ - --pair-filter=any \ - --output ${forward_fq} \ - --paired-output ${reverse_fq} ${reads} - """ - } - - version = "cutadapt --version &> v_cutadapt.txt" - - return processing + version -} diff --git a/deprecated/cutadapt/meta.yml b/deprecated/cutadapt/meta.yml deleted file mode 100644 index eee43a07..00000000 --- a/deprecated/cutadapt/meta.yml +++ /dev/null @@ -1,36 +0,0 @@ -name: Cutadapt -description: cutadapt removes adapter sequences from high-throughput sequencing reads -keywords: - - Quality Control - - QC - - Adapters -tools: - - fastqc: - description: | - Cutadapt finds and removes adapter sequences, primers, poly-A tails and other types of unwanted sequence - from your high-throughput sequencing reads. - - Cleaning your data in this way is often required: Reads from small-RNA sequencing contain the 3’ - sequencing adapter because the read is longer than the molecule that is sequenced. Amplicon reads - start with a primer sequence. Poly-A tails are useful for pulling out RNA from your sample, but - often you don’t want them to be in your reads. - homepage: https://cutadapt.readthedocs.io/en/stable/ - documentation: https://cutadapt.readthedocs.io/en/stable/ -input: - - - - sample_id: - type: string - description: Sample identifier - - reads: - type: file - description: Input FastQ file, or pair of files -output: - - - - sample_id: - type: string - description: Sample identifier - - reads: - type: file - description: trimmed FastQ file, or pair of files -authors: - - "@piotr-faba-ardigen" diff --git a/deprecated/cutadapt/test/main.nf b/deprecated/cutadapt/test/main.nf deleted file mode 100644 index 186af146..00000000 --- a/deprecated/cutadapt/test/main.nf +++ /dev/null @@ -1,20 +0,0 @@ -#!/usr/bin/env nextflow -nextflow.preview.dsl = 2 -include '../main.nf' params(params) - -// Define input channels -input_fastqs = Channel.fromFilePairs('../../../test-datasets/tools/cutadapt/input/*_{1,2}.fastq' ) - -if(params.single_end){ - input_fastqs = Channel.from([ - ['SRR4238351', '../../../test-datasets/tools/cutadapt/input/SRR4238351_subsamp.fastq.gz'], - ['SRR4238355', '../../../test-datasets/tools/cutadapt/input/SRR4238355_subsamp.fastq.gz'], - ['SRR4238359', '../../../test-datasets/tools/cutadapt/input/SRR4238359_subsamp.fastq.gz'], - ['SRR4238379', '../../../test-datasets/tools/cutadapt/input/SRR4238379_subsamp.fastq.gz'] - ]).map { row -> [ row[0], [ file(row[1]) ] ] } -} - -// Run the workflow -workflow { - cutadapt(input_fastqs) -} diff --git a/deprecated/cutadapt/test/nextflow.config b/deprecated/cutadapt/test/nextflow.config deleted file mode 100644 index 888e1ec8..00000000 --- a/deprecated/cutadapt/test/nextflow.config +++ /dev/null @@ -1,9 +0,0 @@ -docker.enabled = true -params.outdir = './results' - -params{ - // Preprocessing options - cutadapt_min_length = 40 - cutadapt_min_quality = 25 - single_end = false -} diff --git a/deprecated/hisat2/main.nf b/deprecated/hisat2/main.nf deleted file mode 100644 index fa83e108..00000000 --- a/deprecated/hisat2/main.nf +++ /dev/null @@ -1,58 +0,0 @@ -nextflow.preview.dsl=2 -params.genome = '' - -process HISAT2 { - // depending on the genome used one might want/need to adjust the memory settings. - // For the E. coli test data this is probably not required - // label 'bigMem' - // label 'multiCore' - - publishDir "$outdir/hisat2", - mode: "copy", overwrite: true - - input: - tuple val(name), path(reads) - val outdir - val hisat2_args - val verbose - - output: - path "*bam", emit: bam - path "*stats.txt", emit: stats - - script: - - if (verbose){ - println ("[MODULE] HISAT2 ARGS: " + hisat2_args) - } - - cores = 4 - readString = "" - hisat_options = hisat2_args - - // Options we add are - hisat_options = hisat_options + " --no-unal --no-softclip " - - if (reads instanceof List) { - readString = "-1 "+reads[0]+" -2 "+reads[1] - hisat_options = hisat_options + " --no-mixed --no-discordant" - } - else { - readString = "-U "+reads - } - index = params.genome["hisat2"] - - splices = '' - if (params.genome.containsKey("hisat2_splices")){ - splices = " --known-splicesite-infile " + params.genome["hisat2_splices"] - } - else{ - println ("No key 'hisat2_splices' was supplied. Skipping...") - } - hisat_name = name + "_" + params.genome["name"] - - """ - hisat2 -p ${cores} ${hisat_options} -x ${index} ${splices} ${readString} 2>${hisat_name}_hisat2_stats.txt | samtools view -bS -F 4 -F 8 -F 256 -> ${hisat_name}_hisat2.bam - """ - -} diff --git a/deprecated/hisat2/meta.yml b/deprecated/hisat2/meta.yml deleted file mode 100644 index 811727a7..00000000 --- a/deprecated/hisat2/meta.yml +++ /dev/null @@ -1,37 +0,0 @@ -name: HISAT2 -description: Graph-based alignment of next generation sequencing reads to a population of genomes -keywords: - - Alignment - - Short reads - - graph FM Index (GFM) - - RNA-seq -tools: - - fastqc: - description: | - HISAT2 is a fast and sensitive alignment program for mapping next-generation - sequencing reads (whole-genome, transcriptome, and exome sequencing data) - against the general human population (as well as against a single reference genome). - Based on GCSA (an extension of BWT for a graph) it is designed and implemented as a - graph FM index (GFM). - homepage: http://daehwankimlab.github.io/hisat2/ - documentation: https://ccb.jhu.edu/software/hisat2/manual.shtml -input: - - - - sample_id: - type: string - description: Sample identifier - - reads: - type: file - description: Input FastQ file, or pair of files -output: - - - - report: - type: file - description: mapping statistics report - pattern: "*hisat2_stats.txt" - - alignment: - type: file - description: alignment file in BAM format - pattern: "*hisat2.bam" -authors: - - "@FelixKrueger" diff --git a/deprecated/hisat2/test/indices/E_coli/E_coli.1.ht2 b/deprecated/hisat2/test/indices/E_coli/E_coli.1.ht2 deleted file mode 100644 index 21db313f..00000000 Binary files a/deprecated/hisat2/test/indices/E_coli/E_coli.1.ht2 and /dev/null differ diff --git a/deprecated/hisat2/test/indices/E_coli/E_coli.2.ht2 b/deprecated/hisat2/test/indices/E_coli/E_coli.2.ht2 deleted file mode 100644 index 90cdc20f..00000000 Binary files a/deprecated/hisat2/test/indices/E_coli/E_coli.2.ht2 and /dev/null differ diff --git a/deprecated/hisat2/test/indices/E_coli/E_coli.3.ht2 b/deprecated/hisat2/test/indices/E_coli/E_coli.3.ht2 deleted file mode 100644 index 171a3625..00000000 Binary files a/deprecated/hisat2/test/indices/E_coli/E_coli.3.ht2 and /dev/null differ diff --git a/deprecated/hisat2/test/indices/E_coli/E_coli.4.ht2 b/deprecated/hisat2/test/indices/E_coli/E_coli.4.ht2 deleted file mode 100644 index b2dc290b..00000000 Binary files a/deprecated/hisat2/test/indices/E_coli/E_coli.4.ht2 and /dev/null differ diff --git a/deprecated/hisat2/test/indices/E_coli/E_coli.5.ht2 b/deprecated/hisat2/test/indices/E_coli/E_coli.5.ht2 deleted file mode 100644 index e49b8cc0..00000000 Binary files a/deprecated/hisat2/test/indices/E_coli/E_coli.5.ht2 and /dev/null differ diff --git a/deprecated/hisat2/test/indices/E_coli/E_coli.6.ht2 b/deprecated/hisat2/test/indices/E_coli/E_coli.6.ht2 deleted file mode 100644 index 8ed6edd4..00000000 Binary files a/deprecated/hisat2/test/indices/E_coli/E_coli.6.ht2 and /dev/null differ diff --git a/deprecated/hisat2/test/indices/E_coli/E_coli.7.ht2 b/deprecated/hisat2/test/indices/E_coli/E_coli.7.ht2 deleted file mode 100644 index 32354e90..00000000 Binary files a/deprecated/hisat2/test/indices/E_coli/E_coli.7.ht2 and /dev/null differ diff --git a/deprecated/hisat2/test/indices/E_coli/E_coli.8.ht2 b/deprecated/hisat2/test/indices/E_coli/E_coli.8.ht2 deleted file mode 100644 index 20d5cb86..00000000 Binary files a/deprecated/hisat2/test/indices/E_coli/E_coli.8.ht2 and /dev/null differ diff --git a/deprecated/hisat2/test/indices/E_coli/NC_010473.fa b/deprecated/hisat2/test/indices/E_coli/NC_010473.fa deleted file mode 120000 index d2298ff8..00000000 --- a/deprecated/hisat2/test/indices/E_coli/NC_010473.fa +++ /dev/null @@ -1 +0,0 @@ -../../../../../tests/data/fasta/E_coli/NC_010473.fa \ No newline at end of file diff --git a/deprecated/hisat2/test/input/Ecoli_DNA_R1.fastq.gz b/deprecated/hisat2/test/input/Ecoli_DNA_R1.fastq.gz deleted file mode 120000 index c325c16c..00000000 --- a/deprecated/hisat2/test/input/Ecoli_DNA_R1.fastq.gz +++ /dev/null @@ -1 +0,0 @@ -../../../../tests/data/fastq/dna/Ecoli_DNA_R1.fastq.gz \ No newline at end of file diff --git a/deprecated/hisat2/test/input/Ecoli_DNA_R2.fastq.gz b/deprecated/hisat2/test/input/Ecoli_DNA_R2.fastq.gz deleted file mode 120000 index 2d974f67..00000000 --- a/deprecated/hisat2/test/input/Ecoli_DNA_R2.fastq.gz +++ /dev/null @@ -1 +0,0 @@ -../../../../tests/data/fastq/dna/Ecoli_DNA_R2.fastq.gz \ No newline at end of file diff --git a/deprecated/hisat2/test/main.nf b/deprecated/hisat2/test/main.nf deleted file mode 100755 index f846c94c..00000000 --- a/deprecated/hisat2/test/main.nf +++ /dev/null @@ -1,34 +0,0 @@ -#!/usr/bin/env nextflow -nextflow.preview.dsl=2 - -params.outdir = "." -params.genome = "" -params.hisat2_args = '' -// HISAT2 arguments should be supplied in the following format to work: -// --hisat2_args="--score-min L,0,-0.8" - -params.verbose = false - -if (params.verbose){ - println ("[WORKFLOW] HISAT2 ARGS ARE: " + params.hisat2_args) -} -// for other genomes this needs to be handled somehow to return all possible genomes -genomeValues = ["name" : params.genome] -genomeValues["hisat2"] = "/bi/home/fkrueger/VersionControl/nf-core-modules/test-datasets/indices/hisat2/E_coli/${params.genome}"; - -include '../main.nf' params(genome: genomeValues) - -ch_read_files = Channel - .fromFilePairs('../../../test-datasets/Ecoli*{1,2}.fastq.gz',size:-1) - // .view() // to check whether the input channel works - -workflow { - - main: - HISAT2(ch_read_files, params.outdir, params.hisat2_args, params.verbose) -} - - - - - diff --git a/deprecated/hisat2/test/nextflow.config b/deprecated/hisat2/test/nextflow.config deleted file mode 100644 index 63c458ca..00000000 --- a/deprecated/hisat2/test/nextflow.config +++ /dev/null @@ -1,2 +0,0 @@ -// docker.enabled = true -params.outdir = './results' diff --git a/deprecated/hisat2/test/output/Ecoli_DNA_R_E_coli_hisat2.bam b/deprecated/hisat2/test/output/Ecoli_DNA_R_E_coli_hisat2.bam deleted file mode 100644 index a7a891a8..00000000 Binary files a/deprecated/hisat2/test/output/Ecoli_DNA_R_E_coli_hisat2.bam and /dev/null differ diff --git a/deprecated/hisat2/test/output/Ecoli_DNA_R_E_coli_hisat2_stats.txt b/deprecated/hisat2/test/output/Ecoli_DNA_R_E_coli_hisat2_stats.txt deleted file mode 100644 index 2752674a..00000000 --- a/deprecated/hisat2/test/output/Ecoli_DNA_R_E_coli_hisat2_stats.txt +++ /dev/null @@ -1,6 +0,0 @@ -10000 reads; of these: - 10000 (100.00%) were paired; of these: - 823 (8.23%) aligned concordantly 0 times - 8583 (85.83%) aligned concordantly exactly 1 time - 594 (5.94%) aligned concordantly >1 times -91.77% overall alignment rate diff --git a/deprecated/multiqc/main.nf b/deprecated/multiqc/main.nf deleted file mode 100644 index 2de75010..00000000 --- a/deprecated/multiqc/main.nf +++ /dev/null @@ -1,31 +0,0 @@ -nextflow.preview.dsl=2 - -process MULTIQC { - - // tag "FastQC - $sample_id" - - publishDir "${outdir}/multiqc", - mode: "copy", overwrite: true - - input: - path file - val outdir - val multiqc_args - // multiqc_args are best passed into the workflow in the following manner: - // --multiqc_args="--exlude STAR --title custom_report_title" - val verbose - - output: - path "*html", emit: html - - script: - - if (verbose){ - println ("[MODULE] MULTIQC ARGS: " + multiqc_args) - } - - """ - multiqc $multiqc_args -x work . - """ - -} diff --git a/deprecated/multiqc/meta.yml b/deprecated/multiqc/meta.yml deleted file mode 100644 index 86a9799b..00000000 --- a/deprecated/multiqc/meta.yml +++ /dev/null @@ -1,26 +0,0 @@ -name: MultiQC -description: Aggregate results from bioinformatics analyses across many samples into a single report -keywords: - - QC - - bioinformatics tools - - Beautiful stand-alone HTML report -tools: - - fastqc: - description: | - MultiQC searches a given directory for analysis logs and compiles a HTML report. - It's a general use tool, perfect for summarising the output from numerous bioinformatics tools. - homepage: https://multiqc.info/ - documentation: https://multiqc.info/docs/ -input: - - - - reads: - type: file - description: List of report file(s) -output: - - - - multiqc_report: - type: file - description: MultiQC report - pattern: "*multiqc*.html" -authors: - - "@FelixKrueger" diff --git a/deprecated/multiqc/test/input/bowtie2/test_GRCm38_bowtie2_stats.txt b/deprecated/multiqc/test/input/bowtie2/test_GRCm38_bowtie2_stats.txt deleted file mode 120000 index b8967087..00000000 --- a/deprecated/multiqc/test/input/bowtie2/test_GRCm38_bowtie2_stats.txt +++ /dev/null @@ -1 +0,0 @@ -../../../../bowtie2/test/output/test_GRCm38_bowtie2_stats.txt \ No newline at end of file diff --git a/deprecated/multiqc/test/input/fastq_screen/test_R1_screen.txt b/deprecated/multiqc/test/input/fastq_screen/test_R1_screen.txt deleted file mode 120000 index 6ca7bf7e..00000000 --- a/deprecated/multiqc/test/input/fastq_screen/test_R1_screen.txt +++ /dev/null @@ -1 +0,0 @@ -../../../../fastq_screen/test/output/test_R1_screen.txt \ No newline at end of file diff --git a/deprecated/multiqc/test/input/fastqc/test_R1_fastqc.zip b/deprecated/multiqc/test/input/fastqc/test_R1_fastqc.zip deleted file mode 120000 index 0d58f91a..00000000 --- a/deprecated/multiqc/test/input/fastqc/test_R1_fastqc.zip +++ /dev/null @@ -1 +0,0 @@ -../../../../fastqc/test/output/test_R1_fastqc.zip \ No newline at end of file diff --git a/deprecated/multiqc/test/input/fastqc/test_R1_val_1_fastqc.zip b/deprecated/multiqc/test/input/fastqc/test_R1_val_1_fastqc.zip deleted file mode 120000 index cd7c4d8b..00000000 --- a/deprecated/multiqc/test/input/fastqc/test_R1_val_1_fastqc.zip +++ /dev/null @@ -1 +0,0 @@ -../../../../fastqc/test/output/test_R1_val_1_fastqc.zip \ No newline at end of file diff --git a/deprecated/multiqc/test/input/fastqc/test_R2_fastqc.zip b/deprecated/multiqc/test/input/fastqc/test_R2_fastqc.zip deleted file mode 120000 index abae135e..00000000 --- a/deprecated/multiqc/test/input/fastqc/test_R2_fastqc.zip +++ /dev/null @@ -1 +0,0 @@ -../../../../fastqc/test/output/test_R2_fastqc.zip \ No newline at end of file diff --git a/deprecated/multiqc/test/input/fastqc/test_R2_val_2_fastqc.zip b/deprecated/multiqc/test/input/fastqc/test_R2_val_2_fastqc.zip deleted file mode 120000 index ce42f0d9..00000000 --- a/deprecated/multiqc/test/input/fastqc/test_R2_val_2_fastqc.zip +++ /dev/null @@ -1 +0,0 @@ -../../../../fastqc/test/output/test_R2_val_2_fastqc.zip \ No newline at end of file diff --git a/deprecated/multiqc/test/input/hisat2/Ecoli_DNA_R_E_coli_hisat2_stats.txt b/deprecated/multiqc/test/input/hisat2/Ecoli_DNA_R_E_coli_hisat2_stats.txt deleted file mode 120000 index a1c92656..00000000 --- a/deprecated/multiqc/test/input/hisat2/Ecoli_DNA_R_E_coli_hisat2_stats.txt +++ /dev/null @@ -1 +0,0 @@ -../../../../hisat2/test/output/Ecoli_DNA_R_E_coli_hisat2_stats.txt \ No newline at end of file diff --git a/deprecated/multiqc/test/input/trim_galore/test_R1.fastq.gz_trimming_report.txt b/deprecated/multiqc/test/input/trim_galore/test_R1.fastq.gz_trimming_report.txt deleted file mode 120000 index 69891ace..00000000 --- a/deprecated/multiqc/test/input/trim_galore/test_R1.fastq.gz_trimming_report.txt +++ /dev/null @@ -1 +0,0 @@ -../../../../trim_galore/test/output/test_R1.fastq.gz_trimming_report.txt \ No newline at end of file diff --git a/deprecated/multiqc/test/input/trim_galore/test_R2.fastq.gz_trimming_report.txt b/deprecated/multiqc/test/input/trim_galore/test_R2.fastq.gz_trimming_report.txt deleted file mode 120000 index 3f6cee73..00000000 --- a/deprecated/multiqc/test/input/trim_galore/test_R2.fastq.gz_trimming_report.txt +++ /dev/null @@ -1 +0,0 @@ -../../../../trim_galore/test/output/test_R2.fastq.gz_trimming_report.txt \ No newline at end of file diff --git a/deprecated/multiqc/test/main.nf b/deprecated/multiqc/test/main.nf deleted file mode 100755 index dbfc3c98..00000000 --- a/deprecated/multiqc/test/main.nf +++ /dev/null @@ -1,44 +0,0 @@ -#!/usr/bin/env nextflow -nextflow.preview.dsl=2 - -params.outdir = "." -params.verbose = false -params.multiqc_args = '' - -// include '../../../tests/functions/check_process_outputs.nf' -include '../main.nf' - -if (params.verbose){ - println ("[WORKFLOW] MULTIQC ARGS: " + params.multiqc_args) -} - -multiqc_ch = Channel - .fromPath( ['../../../test-datasets/*trimming_report.txt','../../../test-datasets/*fastqc.zip','../../../test-datasets/*screen.txt','../../../test-datasets/*bowtie2_stats.txt'] ) - .collect() // collect() flattens all channels to single list - // .view() // view the files in the channel - - -// Run the workflow -workflow { - - main: - // This is an example workflow for real reads aligned with Bowtie2. Just for illustration purposes - - // FASTQC (file_ch, params.outdir, params.fastqc_args, params.verbose) - // FASTQ_SCREEN (file_ch, params.outdir, params.fastq_screen_args, params.verbose) - // TRIM_GALORE (file_ch, params.outdir, params.trim_galore_args, params.verbose) - // FASTQC2 (TRIM_GALORE.out.reads, params.outdir, params.fastqc_args, params.verbose) - // BOWTIE2 (TRIM_GALORE.out.reads, params.outdir, params.bowtie2_args, params.verbose) - - // merging channels for MultiQC - // multiqc_ch = FASTQC.out.report.mix( - // TRIM_GALORE.out.report, - // FASTQ_SCREEN.out.report, - // FASTQC2.out.report, - // BOWTIE2.out.stats, - // ).collect() - - MULTIQC (multiqc_ch, params.outdir, params.multiqc_args, params.verbose) - - // .check_output() TODO -} \ No newline at end of file diff --git a/deprecated/multiqc/test/nextflow.config b/deprecated/multiqc/test/nextflow.config deleted file mode 100644 index 63c458ca..00000000 --- a/deprecated/multiqc/test/nextflow.config +++ /dev/null @@ -1,2 +0,0 @@ -// docker.enabled = true -params.outdir = './results' diff --git a/deprecated/multiqc/test/output/multiqc_report.html b/deprecated/multiqc/test/output/multiqc_report.html deleted file mode 100644 index 3db17237..00000000 --- a/deprecated/multiqc/test/output/multiqc_report.html +++ /dev/null @@ -1,6244 +0,0 @@ - - - - - - - - - - - - - -MultiQC Report - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - -
-
-

- - - - - - -

- -

Loading report..

- -
- -
-
- - - -
- - - - -
- - - - -
-

- - Highlight Samples -

- -
- - - -
-

- Regex mode off - - -

-
    -
    - - -
    -

    - - Rename Samples -

    - -
    - - - -
    -

    Click here for bulk input.

    -
    -

    Paste two columns of a tab-delimited table here (eg. from Excel).

    -

    First column should be the old name, second column the new name.

    -
    - - -
    -
    -

    - Regex mode off - - -

    -
      -
      - - -
      -

      - - Show / Hide Samples -

      - -
      -
      - -
      -
      - -
      -
      - - -
      -
      - -

      - Regex mode off - - -

      -
        -
        - - -
        -

        Export Plots

        -
        - -
        -
        -
        -
        -
        - - px -
        -
        -
        -
        - - px -
        -
        -
        -
        -
        - -
        -
        - -
        -
        -
        -
        - -
        -
        -
        - - X -
        -
        -
        -
        - -
        -

        Download the raw data used to create the plots in this report below:

        -
        -
        - -
        -
        - -
        -
        - -

        Note that additional data was saved in multiqc_data when this report was generated.

        - -
        -
        -
        - -
        -
        Choose Plots
        - - -
        - -
        - -

        If you use plots from MultiQC in a publication or presentation, please cite:

        -
        - MultiQC: Summarize analysis results for multiple tools and samples in a single report
        - Philip Ewels, Måns Magnusson, Sverker Lundin and Max Käller
        - Bioinformatics (2016)
        - doi: 10.1093/bioinformatics/btw354
        - PMID: 27312411 -
        -
        -
        - - -
        -

        Save Settings

        -

        You can save the toolbox settings for this report to the browser.

        -
        - - -
        -
        - -

        Load Settings

        -

        Choose a saved report profile from the dropdown box below:

        -
        -
        - -
        -
        - - - - -
        -
        -
        - - -
        -

        About MultiQC

        -

        This report was generated using MultiQC, version 1.7

        -

        You can see a YouTube video describing how to use MultiQC reports here: - https://youtu.be/qPbIlO_KWN0

        -

        For more information about MultiQC, including other videos and - extensive documentation, please visit http://multiqc.info

        -

        You can report bugs, suggest improvements and find the source code for MultiQC on GitHub: - https://github.com/ewels/MultiQC

        -

        MultiQC is published in Bioinformatics:

        -
        - MultiQC: Summarize analysis results for multiple tools and samples in a single report
        - Philip Ewels, Måns Magnusson, Sverker Lundin and Max Käller
        - Bioinformatics (2016)
        - doi: 10.1093/bioinformatics/btw354
        - PMID: 27312411 -
        -
        - -
        - -
        - - -
        - - - -

        - - - - -

        - - - -

        - A modular tool to aggregate results from bioinformatics analyses across many samples into a single report. -

        - - - - - - - - - - -
        -

        Report generated on 2020-03-18, 10:46 based on data in: - /bi/home/fkrueger/VersionControl/nf-core-modules/tools/multiqc/test/work/52/07836c4fe43e822e375798bf42c0e4 - -

        - - - -
        - - - - - - - - -
        -

        General Statistics

        - - - - - - - - - - Showing 5/5 rows and 5/7 columns. - -
        -
        - -
        Sample Name% Aligned% Trimmed% Dups% GCM Seqs
        test_GRCm38_bowtie2_stats
        88.6%
        test_R1
        1.5%
        8.3%
        44%
        0.0
        test_R1_val_1
        7.0%
        44%
        0.0
        test_R2
        1.9%
        8.4%
        44%
        0.0
        test_R2_val_2
        7.2%
        44%
        0.0
        - - -
        - - - - - - -
        -

        Bowtie 2

        -

        Bowtie 2 is an ultrafast and memory-efficient tool for aligning sequencing reads to long reference sequences.

        - - - - - - -
        - -

        This plot shows the number of reads aligning to the reference in different ways.
        Please note that single mate alignment counts are halved to tally with pair counts properly.

        - - -
        -

        There are 6 possible types of alignment: -* PE mapped uniquely: Pair has only one occurence in the reference genome. -* PE mapped discordantly uniquely: Pair has only one occurence but not in proper pair. -* PE one mate mapped uniquely: One read of a pair has one occurence. -* PE multimapped: Pair has multiple occurence. -* PE one mate multimapped: One read of a pair has multiple occurence. -* PE neither mate aligned: Pair has no occurence.

        -
        - -
        - - -
        -
        loading..
        -
        - - -
        - - -
        -
        - - - -
        -

        Cutadapt

        -

        Cutadapt is a tool to find and remove adapter sequences, primers, poly-Atails and other types of unwanted sequence from your high-throughput sequencing reads.

        - - - - -
        - -

        This plot shows the number of reads with certain lengths of adapter trimmed. - Obs/Exp shows the raw counts divided by the number expected due to sequencing errors. A defined peak - may be related to adapter length. See the - cutadapt documentation - for more information on how these numbers are generated.

        - - -
        - - -
        - -
        loading..
        -
        - - -
        - - -
        -
        - - - -
        -

        FastQ Screen

        -

        FastQ Screen allows you to screen a library of sequences in FastQ format against a set of sequence databases so you can see if the composition of the library matches with what you expect.

        - - - - -
        - - - - -
        -
        - - -
        - - -
        -
        - - - -
        -

        FastQC

        -

        FastQC is a quality control tool for high throughput sequence data, written by Simon Andrews at the Babraham Institute in Cambridge.

        - - - - -
        - -

        - Sequence Counts - - - -

        - -

        Sequence counts for each sample. Duplicate read counts are an estimate only.

        - - -
        -

        This plot show the total number of reads, broken down into unique and duplicate -if possible (only more recent versions of FastQC give duplicate info).

        -

        You can read more about duplicate calculation in the -FastQC documentation. -A small part has been copied here for convenience:

        -

        Only sequences which first appear in the first 100,000 sequences -in each file are analysed. This should be enough to get a good impression -for the duplication levels in the whole file. Each sequence is tracked to -the end of the file to give a representative count of the overall duplication level.

        -

        The duplication detection requires an exact sequence match over the whole length of -the sequence. Any reads over 75bp in length are truncated to 50bp for this analysis.

        -
        - -
        - - -
        -
        loading..
        -
        - -
        -
        - - - - -
        - -

        - Sequence Quality Histograms - - - -

        - -

        The mean quality value across each base position in the read.

        - - -
        -

        To enable multiple samples to be plotted on the same graph, only the mean quality -scores are plotted (unlike the box plots seen in FastQC reports).

        -

        Taken from the FastQC help:

        -

        The y-axis on the graph shows the quality scores. The higher the score, the better -the base call. The background of the graph divides the y axis into very good quality -calls (green), calls of reasonable quality (orange), and calls of poor quality (red). -The quality of calls on most platforms will degrade as the run progresses, so it is -common to see base calls falling into the orange area towards the end of a read.

        -
        - -
        loading..
        -
        - -
        -
        - - - - -
        - -

        - Per Sequence Quality Scores - - - -

        - -

        The number of reads with average quality scores. Shows if a subset of reads has poor quality.

        - - -
        -

        From the FastQC help:

        -

        The per sequence quality score report allows you to see if a subset of your -sequences have universally low quality values. It is often the case that a -subset of sequences will have universally poor quality, however these should -represent only a small percentage of the total sequences.

        -
        - -
        loading..
        -
        - -
        -
        - - - - -
        - -

        - Per Base Sequence Content - - - -

        - -

        The proportion of each base position for which each of the four normal DNA bases has been called.

        - - -
        -

        To enable multiple samples to be shown in a single plot, the base composition data -is shown as a heatmap. The colours represent the balance between the four bases: -an even distribution should give an even muddy brown colour. Hover over the plot -to see the percentage of the four bases under the cursor.

        -

        To see the data as a line plot, as in the original FastQC graph, click on a sample track.

        -

        From the FastQC help:

        -

        Per Base Sequence Content plots out the proportion of each base position in a -file for which each of the four normal DNA bases has been called.

        -

        In a random library you would expect that there would be little to no difference -between the different bases of a sequence run, so the lines in this plot should -run parallel with each other. The relative amount of each base should reflect -the overall amount of these bases in your genome, but in any case they should -not be hugely imbalanced from each other.

        -

        It's worth noting that some types of library will always produce biased sequence -composition, normally at the start of the read. Libraries produced by priming -using random hexamers (including nearly all RNA-Seq libraries) and those which -were fragmented using transposases inherit an intrinsic bias in the positions -at which reads start. This bias does not concern an absolute sequence, but instead -provides enrichement of a number of different K-mers at the 5' end of the reads. -Whilst this is a true technical bias, it isn't something which can be corrected -by trimming and in most cases doesn't seem to adversely affect the downstream -analysis.

        -
        - -
        -
        -
        - - Click a sample row to see a line plot for that dataset. -
        -
        Rollover for sample name
        - -
        - Position: - -
        %T: -
        -
        %C: -
        -
        %A: -
        -
        %G: -
        -
        -
        -
        - -
        -
        -
        -
        - -
        -
        - - - - -
        - -

        - Per Sequence GC Content - - - -

        - -

        The average GC content of reads. Normal random library typically have a - roughly normal distribution of GC content.

        - - -
        -

        From the FastQC help:

        -

        This module measures the GC content across the whole length of each sequence -in a file and compares it to a modelled normal distribution of GC content.

        -

        In a normal random library you would expect to see a roughly normal distribution -of GC content where the central peak corresponds to the overall GC content of -the underlying genome. Since we don't know the the GC content of the genome the -modal GC content is calculated from the observed data and used to build a -reference distribution.

        -

        An unusually shaped distribution could indicate a contaminated library or -some other kinds of biased subset. A normal distribution which is shifted -indicates some systematic bias which is independent of base position. If there -is a systematic bias which creates a shifted normal distribution then this won't -be flagged as an error by the module since it doesn't know what your genome's -GC content should be.

        -
        - -
        - - -
        - -
        loading..
        -
        - -
        -
        - - - - -
        - -

        - Per Base N Content - - - -

        - -

        The percentage of base calls at each position for which an N was called.

        - - -
        -

        From the FastQC help:

        -

        If a sequencer is unable to make a base call with sufficient confidence then it will -normally substitute an N rather than a conventional base call. This graph shows the -percentage of base calls at each position for which an N was called.

        -

        It's not unusual to see a very low proportion of Ns appearing in a sequence, especially -nearer the end of a sequence. However, if this proportion rises above a few percent -it suggests that the analysis pipeline was unable to interpret the data well enough to -make valid base calls.

        -
        - -
        loading..
        -
        - -
        -
        - - - - -
        - -

        - Sequence Length Distribution - -

        - -

        The distribution of fragment sizes (read lengths) found. - See the FastQC help

        - - -
        loading..
        -
        - -
        -
        - - - - -
        - -

        - Sequence Duplication Levels - - - -

        - -

        The relative level of duplication found for every sequence.

        - - -
        -

        From the FastQC Help:

        -

        In a diverse library most sequences will occur only once in the final set. -A low level of duplication may indicate a very high level of coverage of the -target sequence, but a high level of duplication is more likely to indicate -some kind of enrichment bias (eg PCR over amplification). This graph shows -the degree of duplication for every sequence in a library: the relative -number of sequences with different degrees of duplication.

        -

        Only sequences which first appear in the first 100,000 sequences -in each file are analysed. This should be enough to get a good impression -for the duplication levels in the whole file. Each sequence is tracked to -the end of the file to give a representative count of the overall duplication level.

        -

        The duplication detection requires an exact sequence match over the whole length of -the sequence. Any reads over 75bp in length are truncated to 50bp for this analysis.

        -

        In a properly diverse library most sequences should fall into the far left of the -plot in both the red and blue lines. A general level of enrichment, indicating broad -oversequencing in the library will tend to flatten the lines, lowering the low end -and generally raising other categories. More specific enrichments of subsets, or -the presence of low complexity contaminants will tend to produce spikes towards the -right of the plot.

        -
        - -
        loading..
        -
        - -
        -
        - - - - -
        - -

        - Overrepresented sequences - - - -

        - -

        The total amount of overrepresented sequences found in each library.

        - - -
        -

        FastQC calculates and lists overrepresented sequences in FastQ files. It would not be -possible to show this for all samples in a MultiQC report, so instead this plot shows -the number of sequences categorized as over represented.

        -

        Sometimes, a single sequence may account for a large number of reads in a dataset. -To show this, the bars are split into two: the first shows the overrepresented reads -that come from the single most common sequence. The second shows the total count -from all remaining overrepresented sequences.

        -

        From the FastQC Help:

        -

        A normal high-throughput library will contain a diverse set of sequences, with no -individual sequence making up a tiny fraction of the whole. Finding that a single -sequence is very overrepresented in the set either means that it is highly biologically -significant, or indicates that the library is contaminated, or not as diverse as you expected.

        -

        FastQC lists all of the sequences which make up more than 0.1% of the total. -To conserve memory only sequences which appear in the first 100,000 sequences are tracked -to the end of the file. It is therefore possible that a sequence which is overrepresented -but doesn't appear at the start of the file for some reason could be missed by this module.

        -
        - -
        4 samples had less than 1% of reads made up of overrepresented sequences
        - -
        -
        - - - - -
        - -

        - Adapter Content - - - -

        - -

        The cumulative percentage count of the proportion of your - library which has seen each of the adapter sequences at each position.

        - - -
        -

        Note that only samples with ≥ 0.1% adapter contamination are shown.

        -

        There may be several lines per sample, as one is shown for each adapter -detected in the file.

        -

        From the FastQC Help:

        -

        The plot shows a cumulative percentage count of the proportion -of your library which has seen each of the adapter sequences at each position. -Once a sequence has been seen in a read it is counted as being present -right through to the end of the read so the percentages you see will only -increase as the read length goes on.

        -
        - -
        loading..
        -
        - - -
        - - -
        - - - - -
        - - - - - - - - - - - - - - - - diff --git a/deprecated/samtools/faidx/main.nf b/deprecated/samtools/faidx/main.nf deleted file mode 100644 index 1e0458b8..00000000 --- a/deprecated/samtools/faidx/main.nf +++ /dev/null @@ -1,16 +0,0 @@ -process samtools_faidx { - tag "$fasta" - - container 'quay.io/biocontainers/samtools:1.9--h10a08f8_12' - - input: - path fasta - - output: - path "${fasta}.fai" - - script: - """ - samtools faidx ${fasta} - """ -} diff --git a/deprecated/samtools/faidx/meta.yml b/deprecated/samtools/faidx/meta.yml deleted file mode 100644 index 95c2bf4b..00000000 --- a/deprecated/samtools/faidx/meta.yml +++ /dev/null @@ -1,27 +0,0 @@ -name: samtools faidx -description: index a fasta file -keywords: - - faidx -tools: - - samtools: - description: | - SAMtools is a set of utilities for interacting with and post-processing - short DNA sequence read alignments in the SAM, BAM and CRAM formats, written by Heng Li. - These files are generated as output by short read aligners like BWA. - homepage: http://www.htslib.org/ - documentation: hhttp://www.htslib.org/doc/samtools.html - doi: 10.1093/bioinformatics/btp352 -input: - - - - input: - type: file - description: Input fasta file - pattern: "*.{fasta,fa}" -output: - - - - faidx: - type: file - description: samtools index fasta file - pattern: "*.fasta.fai" -authors: - - "@maxulysse" diff --git a/deprecated/samtools/faidx/test/main.nf b/deprecated/samtools/faidx/test/main.nf deleted file mode 100644 index 39ad118c..00000000 --- a/deprecated/samtools/faidx/test/main.nf +++ /dev/null @@ -1,13 +0,0 @@ -#!/usr/bin/env nextflow -nextflow.preview.dsl = 2 -include '../../../tests/functions/check_process_outputs.nf' params(params) -include '../main.nf' params(params) - -// Define input channels -input = '../../../test-datasets/tools/bwa/index/input/reference.fasta' - -// Run the workflow -workflow { - samtools_faidx(input) - // .check_output() -} diff --git a/deprecated/samtools/faidx/test/nextflow.config b/deprecated/samtools/faidx/test/nextflow.config deleted file mode 100644 index c137a138..00000000 --- a/deprecated/samtools/faidx/test/nextflow.config +++ /dev/null @@ -1,2 +0,0 @@ -docker.enabled = true -params.outdir = './results' diff --git a/deprecated/umi_tools/Dockerfile b/deprecated/umi_tools/Dockerfile deleted file mode 100644 index 19a390f3..00000000 --- a/deprecated/umi_tools/Dockerfile +++ /dev/null @@ -1,8 +0,0 @@ -FROM nfcore/base:1.7 -LABEL authors="chris.cheshire@crick.ac.uk" \ - description="Docker image containing all requirements for the nf-core umi_tools module" - -# Install conda packages -COPY environment.yml / -RUN conda env create -f /environment.yml && conda clean -a -ENV PATH /opt/conda/envs/nfcore-module-umitools/bin:$PATH diff --git a/deprecated/umi_tools/environment.yml b/deprecated/umi_tools/environment.yml deleted file mode 100644 index da7adab9..00000000 --- a/deprecated/umi_tools/environment.yml +++ /dev/null @@ -1,10 +0,0 @@ -# This file creates a conda environment for the umi_tools module -# conda env create -f environment.yml -name: nfcore-module-umitools -channels: - - conda-forge - - bioconda - - defaults -dependencies: - - umi_tools=1.0.1 - - samtools=1.1.0 diff --git a/deprecated/umi_tools/main.nf b/deprecated/umi_tools/main.nf deleted file mode 100644 index b3c89a97..00000000 --- a/deprecated/umi_tools/main.nf +++ /dev/null @@ -1,45 +0,0 @@ -#!/usr/bin/env nextflow - -// Specify DSL2 -nextflow.preview.dsl = 2 - -// Process definition -process umitools_dedup { - publishDir "${params.outdir}/umitools/dedup", - mode: "copy", overwrite: true - - container 'luslab/nf-modules-umitools:latest' - - input: - tuple val(sample_id), path(bam) - - output: - tuple val(sample_id), path("${sample_id}.dedup.bam"), emit: dedupBam - tuple val(sample_id), path("${sample_id}.dedup.bam.bai"), emit: dedupBai - path "*.dedup.log", emit: report - - script: - - // Init - args = "--log=${sample_id}.dedup.log" - - // Check main args string exists and strip whitespace - if(params.umitools_dedup_args) { - ext_args = params.umitools_dedup_args - args += " " + ext_args.trim() - } - - // Contruct CL line - dedup_command = "umi_tools dedup ${args} -I ${bam[0]} -S ${sample_id}.dedup.bam --output-stats=${sample_id}" - - // Log - if (params.verbose){ - println ("[MODULE] umi_tools/dedup command: " + dedup_command) - } - - //SHELL - """ - ${dedup_command} - samtools index ${sample_id}.dedup.bam - """ -} diff --git a/deprecated/umi_tools/test/input/sample1.bai b/deprecated/umi_tools/test/input/sample1.bai deleted file mode 100755 index 37ab26af..00000000 Binary files a/deprecated/umi_tools/test/input/sample1.bai and /dev/null differ diff --git a/deprecated/umi_tools/test/input/sample1.bam b/deprecated/umi_tools/test/input/sample1.bam deleted file mode 100755 index 2d2b2271..00000000 Binary files a/deprecated/umi_tools/test/input/sample1.bam and /dev/null differ diff --git a/deprecated/umi_tools/test/input/sample2.bai b/deprecated/umi_tools/test/input/sample2.bai deleted file mode 100755 index e1cec326..00000000 Binary files a/deprecated/umi_tools/test/input/sample2.bai and /dev/null differ diff --git a/deprecated/umi_tools/test/input/sample2.bam b/deprecated/umi_tools/test/input/sample2.bam deleted file mode 100755 index f215656c..00000000 Binary files a/deprecated/umi_tools/test/input/sample2.bam and /dev/null differ diff --git a/deprecated/umi_tools/test/input/sample3.bai b/deprecated/umi_tools/test/input/sample3.bai deleted file mode 100755 index 78585088..00000000 Binary files a/deprecated/umi_tools/test/input/sample3.bai and /dev/null differ diff --git a/deprecated/umi_tools/test/input/sample3.bam b/deprecated/umi_tools/test/input/sample3.bam deleted file mode 100755 index 377ed560..00000000 Binary files a/deprecated/umi_tools/test/input/sample3.bam and /dev/null differ diff --git a/deprecated/umi_tools/test/input/sample4.bai b/deprecated/umi_tools/test/input/sample4.bai deleted file mode 100755 index 8235bdd7..00000000 Binary files a/deprecated/umi_tools/test/input/sample4.bai and /dev/null differ diff --git a/deprecated/umi_tools/test/input/sample4.bam b/deprecated/umi_tools/test/input/sample4.bam deleted file mode 100755 index bcb6ac80..00000000 Binary files a/deprecated/umi_tools/test/input/sample4.bam and /dev/null differ diff --git a/deprecated/umi_tools/test/input/sample5.bai b/deprecated/umi_tools/test/input/sample5.bai deleted file mode 100755 index eb2d8be7..00000000 Binary files a/deprecated/umi_tools/test/input/sample5.bai and /dev/null differ diff --git a/deprecated/umi_tools/test/input/sample5.bam b/deprecated/umi_tools/test/input/sample5.bam deleted file mode 100755 index f132d1e6..00000000 Binary files a/deprecated/umi_tools/test/input/sample5.bam and /dev/null differ diff --git a/deprecated/umi_tools/test/input/sample6.bai b/deprecated/umi_tools/test/input/sample6.bai deleted file mode 100755 index a534ded3..00000000 Binary files a/deprecated/umi_tools/test/input/sample6.bai and /dev/null differ diff --git a/deprecated/umi_tools/test/input/sample6.bam b/deprecated/umi_tools/test/input/sample6.bam deleted file mode 100755 index 99bdc4dc..00000000 Binary files a/deprecated/umi_tools/test/input/sample6.bam and /dev/null differ diff --git a/deprecated/umi_tools/test/main.nf b/deprecated/umi_tools/test/main.nf deleted file mode 100644 index 6e40d5e1..00000000 --- a/deprecated/umi_tools/test/main.nf +++ /dev/null @@ -1,62 +0,0 @@ -#!/usr/bin/env nextflow - -// Define DSL2 -nextflow.preview.dsl=2 - -// Log -log.info ("Starting tests for umi_tools dedup...") - -/*------------------------------------------------------------------------------------*/ -/* Define params ---------------------------------------------------------------------------------------*/ - -params.umitools_dedup_args = '--umi-separator=":"' -params.verbose = false - -/*------------------------------------------------------------------------------------*/ -/* Module inclusions ---------------------------------------------------------------------------------------*/ - -include umitools_dedup from '../main.nf' - -/*------------------------------------------------------------------------------------*/ -/* Define input channels ---------------------------------------------------------------------------------------*/ - -// Define test data -testData = [ - ['sample1', "$baseDir/input/sample1.bam", "$baseDir/input/sample1.bai"], - ['sample2', "$baseDir/input/sample2.bam", "$baseDir/input/sample2.bai"], - ['sample3', "$baseDir/input/sample3.bam", "$baseDir/input/sample3.bai"], - ['sample4', "$baseDir/input/sample4.bam", "$baseDir/input/sample4.bai"], - ['sample5', "$baseDir/input/sample5.bam", "$baseDir/input/sample5.bai"], - ['sample6', "$baseDir/input/sample6.bam", "$baseDir/input/sample6.bai"] -] - -//Define test data input channel -Channel - .from(testData) - .map { row -> [ row[0], [file(row[1], checkIfExists: true), file(row[2], checkIfExists: true)]]} - .set {ch_bam} - -/*------------------------------------------------------------------------------------*/ -/* Run tests ---------------------------------------------------------------------------------------*/ - -workflow { - // Run dedup - umitools_dedup ( ch_bam ) -} - -workflow.onComplete { - def proc = "$baseDir/verify-checksum.sh $baseDir/../../../results/umitools/dedup/*.bam $baseDir/output/*.bam".execute() - def b = new StringBuffer() - proc.consumeProcessErrorStream(b) - - log.info proc.text - - errorString = b.toString() - if(errorString != '') - log.error errorString - exit 1 -} \ No newline at end of file diff --git a/deprecated/umi_tools/test/nextflow.config b/deprecated/umi_tools/test/nextflow.config deleted file mode 100644 index 22f424b4..00000000 --- a/deprecated/umi_tools/test/nextflow.config +++ /dev/null @@ -1,2 +0,0 @@ -params.outdir = './results' -docker.enabled = true \ No newline at end of file diff --git a/deprecated/umi_tools/test/verify-checksum.sh b/deprecated/umi_tools/test/verify-checksum.sh deleted file mode 100755 index 76aa7a5f..00000000 --- a/deprecated/umi_tools/test/verify-checksum.sh +++ /dev/null @@ -1,40 +0,0 @@ -#!/bin/sh - -if [ -z "$1" ] - then - echo "No check pattern argument supplied" >&2 - exit 1 -fi - -if [ -z "$2" ] - then - echo "No verify pattern argument supplied" >&2 - exit 1 -fi - -checkfiles=$1 -infiles=$2 -#echo $checkfiles -#echo $infiles - -echo '\nCalculating check file hashes...' -md5sum $checkfiles - -echo '\nCalculating input file hashes...' -md5sum $infiles - -echo '\nComparing hash of file of hashes...' -checkver=$(md5sum $checkfiles | awk '{print $1}' | md5sum | awk '{print $1}') -echo $checkver - -inver=$(md5sum $infiles | awk '{print $1}' | md5sum | awk '{print $1}') -echo $inver - -if [ "$checkver" == "$inver" ] -then - echo "Hashes match" - exit 0 -else - echo "Hashes do not match" >&2 - exit 1 -fi \ No newline at end of file diff --git a/deprecated/umi_tools/umi_tools.yml b/deprecated/umi_tools/umi_tools.yml deleted file mode 100644 index fcc53b46..00000000 --- a/deprecated/umi_tools/umi_tools.yml +++ /dev/null @@ -1,45 +0,0 @@ -name: umi_tools -version: 1.0 -description: Tools for dealing with Unique Molecular Identifiers (UMIs)/Random Molecular Tags (RMTs) and single cell RNA-Seq cell barcodes. -keywords: - - UMI - - RMT - - Barcode -tools: - - umi_tools: - description: | - Tools for dealing with Unique Molecular Identifiers (UMIs)/Random Molecular Tags (RMTs) and single cell RNA-Seq cell barcodes. - homepage: https://github.com/CGATOxford/UMI-tools - documentation: https://umi-tools.readthedocs.io/en/latest/ -processes: - - dedup: - operation: | - Set command args to params.umitools_dedup_args - The program will execute with the following pattern: - umi_tools dedup --log={SAMPLE_ID}.dedup.log {params.umitools_dedup_args} -I {SAMPLE_ID}.bam -S {SAMPLE_ID}.dedup.bam --output-stats={SAMPLE_ID} - description: | - Groups PCR duplicates and de-duplicates reads to yield one read per group. - Use this when you want to remove the PCR duplicates prior to any downstream analysis. - input: - - sample_id: - type: string - description: Sample identifier - - bam: - type: file array - description: BAM sequence file and associated BAI index file - output: - - dedupBam: - type: tuple - description: A tuple of samples id and output bam file - pattern: [sample_id, "*SAMPLE_ID.dedup.bam"] - - dedupBam: - type: tuple - description: A tuple of samples id and output bai file - pattern: [sample_id, "*SAMPLE_ID.dedup.bam.bai"] - - report: - type: file - description: Log file for the umi_tools operation - pattern: "*SAMPLE_ID.dedup.log" -authors: - - "@candiceh08" - - "@chris-cheshire" diff --git a/software/SOFTWARE/TOOL/main.nf b/software/SOFTWARE/TOOL/main.nf index 455b4e9e..b8371e69 100644 --- a/software/SOFTWARE/TOOL/main.nf +++ b/software/SOFTWARE/TOOL/main.nf @@ -37,9 +37,8 @@ process SOFTWARE_TOOL { saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } // TODO nf-core: List required Conda packages. - // Software MUST be pinned to channel (i.e. "bioconda") and version (i.e. "1.10") as in the example below. - // Pinning the build too e.g. "bioconda::samtools=1.10=h9402c20_2" is not currently a requirement. - conda (params.enable_conda ? "bioconda::samtools=1.10" : null) + // Software MUST be pinned to channel (i.e. "bioconda"), version (i.e. "1.10") and build (i.e. "h9402c20_2") as in the example below. + conda (params.enable_conda ? "bioconda::samtools=1.10=h9402c20_2" : null) // TODO nf-core: Fetch "docker pull" address for latest BioContainer image of software: e.g. https://biocontainers.pro/#/tools/samtools // Click on the Pacakages and Containers tab, sort by Version and get the portion of the link after the docker pull command where Type is Docker. diff --git a/software/bowtie/align/main.nf b/software/bowtie/align/main.nf index de9e8b3d..e181e54e 100644 --- a/software/bowtie/align/main.nf +++ b/software/bowtie/align/main.nf @@ -11,7 +11,7 @@ process BOWTIE_ALIGN { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? 'bioconda::bowtie=1.3.0 bioconda::samtools=1.10' : null) + conda (params.enable_conda ? 'bioconda::bowtie=1.3.0=py38hed8969a_1 bioconda::samtools=1.11=h6270b1f_0' : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container 'https://depot.galaxyproject.org/singularity/mulled-v2-ffbf83a6b0ab6ec567a336cf349b80637135bca3:9e14e16c284d6860574cf5b624bbc44c793cb024-0' } else { diff --git a/software/bowtie/build/main.nf b/software/bowtie/build/main.nf index 4dd20b85..a40cc0f9 100644 --- a/software/bowtie/build/main.nf +++ b/software/bowtie/build/main.nf @@ -11,7 +11,7 @@ process BOWTIE_BUILD { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:'') } - conda (params.enable_conda ? 'bioconda::bowtie=1.3.0' : null) + conda (params.enable_conda ? 'bioconda::bowtie=1.3.0=py38hed8969a_1' : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container 'https://depot.galaxyproject.org/singularity/bowtie:1.3.0--py38hed8969a_1' } else { diff --git a/software/bowtie2/align/main.nf b/software/bowtie2/align/main.nf index 4c018aa9..00d4dd39 100644 --- a/software/bowtie2/align/main.nf +++ b/software/bowtie2/align/main.nf @@ -11,7 +11,7 @@ process BOWTIE2_ALIGN { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? 'bioconda::bowtie2=2.4.2 bioconda::samtools=1.11 conda-forge::pigz=2.3.4' : null) + conda (params.enable_conda ? 'bioconda::bowtie2=2.4.2=py38h1c8e9b9_1 bioconda::samtools=1.11=h6270b1f_0 conda-forge::pigz=2.3.4=hed695b0_1' : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/mulled-v2-ac74a7f02cebcfcc07d8e8d1d750af9c83b4d45a:577a697be67b5ae9b16f637fd723b8263a3898b3-0" } else { diff --git a/software/bowtie2/build/main.nf b/software/bowtie2/build/main.nf index b2ff6fb8..89e0a8fd 100644 --- a/software/bowtie2/build/main.nf +++ b/software/bowtie2/build/main.nf @@ -11,7 +11,7 @@ process BOWTIE2_BUILD { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:'') } - conda (params.enable_conda ? 'bioconda::bowtie2=2.4.2' : null) + conda (params.enable_conda ? 'bioconda::bowtie2=2.4.2=py38h1c8e9b9_1' : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container 'https://depot.galaxyproject.org/singularity/bowtie2:2.4.2--py38h1c8e9b9_1' } else { diff --git a/software/bwa/index/main.nf b/software/bwa/index/main.nf index 47d2ec54..ec525e2c 100644 --- a/software/bwa/index/main.nf +++ b/software/bwa/index/main.nf @@ -11,7 +11,7 @@ process BWA_INDEX { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:'') } - conda (params.enable_conda ? "bioconda::bwa=0.7.17" : null) + conda (params.enable_conda ? "bioconda::bwa=0.7.17=hed695b0_7" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/bwa:0.7.17--hed695b0_7" } else { diff --git a/software/bwa/mem/main.nf b/software/bwa/mem/main.nf index 4ce1c578..2f2d42c1 100644 --- a/software/bwa/mem/main.nf +++ b/software/bwa/mem/main.nf @@ -11,7 +11,7 @@ process BWA_MEM { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::bwa=0.7.17 bioconda::samtools=1.10" : null) + conda (params.enable_conda ? "bioconda::bwa=0.7.17=hed695b0_7 bioconda::samtools=1.10=h9402c20_2" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/mulled-v2-fe8faa35dbf6dc65a0f7f5d4ea12e31a79f73e40:eabfac3657eda5818bae4090db989e3d41b01542-0" } else { diff --git a/software/cutadapt/main.nf b/software/cutadapt/main.nf index b883b079..1339d0eb 100644 --- a/software/cutadapt/main.nf +++ b/software/cutadapt/main.nf @@ -11,7 +11,7 @@ process CUTADAPT { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? 'bioconda::cutadapt:3.2' : null) + conda (params.enable_conda ? 'bioconda::cutadapt:3.2=py38h0213d0e_0' : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container 'https://depot.galaxyproject.org/singularity/cutadapt:3.2--py38h0213d0e_0' } else { diff --git a/software/deeptools/computematrix/main.nf b/software/deeptools/computematrix/main.nf index 18f9c248..ba72d2b3 100644 --- a/software/deeptools/computematrix/main.nf +++ b/software/deeptools/computematrix/main.nf @@ -11,7 +11,7 @@ process DEEPTOOLS_COMPUTEMATRIX { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::deeptools=3.5.0" : null) + conda (params.enable_conda ? "bioconda::deeptools=3.5.0=py_0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/deeptools:3.5.0--py_0" } else { diff --git a/software/deeptools/plotfingerprint/main.nf b/software/deeptools/plotfingerprint/main.nf index c3d4c33b..809fe7ff 100644 --- a/software/deeptools/plotfingerprint/main.nf +++ b/software/deeptools/plotfingerprint/main.nf @@ -11,7 +11,7 @@ process DEEPTOOLS_PLOTFINGERPRINT { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::deeptools=3.5.0" : null) + conda (params.enable_conda ? "bioconda::deeptools=3.5.0=py_0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/deeptools:3.5.0--py_0" } else { diff --git a/software/deeptools/plotheatmap/main.nf b/software/deeptools/plotheatmap/main.nf index 624b4b9e..d43b8a4b 100644 --- a/software/deeptools/plotheatmap/main.nf +++ b/software/deeptools/plotheatmap/main.nf @@ -11,7 +11,7 @@ process DEEPTOOLS_PLOTHEATMAP { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::deeptools=3.5.0" : null) + conda (params.enable_conda ? "bioconda::deeptools=3.5.0=py_0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/deeptools:3.5.0--py_0" } else { diff --git a/software/deeptools/plotprofile/main.nf b/software/deeptools/plotprofile/main.nf index d4326434..f0fc73c3 100644 --- a/software/deeptools/plotprofile/main.nf +++ b/software/deeptools/plotprofile/main.nf @@ -11,7 +11,7 @@ process DEEPTOOLS_PLOTPROFILE { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::deeptools=3.5.0" : null) + conda (params.enable_conda ? "bioconda::deeptools=3.5.0=py_0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/deeptools:3.5.0--py_0" } else { diff --git a/software/dsh/filterbed/main.nf b/software/dsh/filterbed/main.nf index 7de7a8e3..e9f27eca 100644 --- a/software/dsh/filterbed/main.nf +++ b/software/dsh/filterbed/main.nf @@ -11,7 +11,7 @@ process DSH_FILTERBED { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::dsh-bio=2.0" : null) + conda (params.enable_conda ? "bioconda::dsh-bio=2.0=0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/dsh-bio:2.0--0" } else { diff --git a/software/dsh/splitbed/main.nf b/software/dsh/splitbed/main.nf index 9925b252..09abe307 100644 --- a/software/dsh/splitbed/main.nf +++ b/software/dsh/splitbed/main.nf @@ -11,7 +11,7 @@ process DSH_SPLITBED { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::dsh-bio=2.0" : null) + conda (params.enable_conda ? "bioconda::dsh-bio=2.0=0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/dsh-bio:2.0--0" } else { diff --git a/software/fastp/main.nf b/software/fastp/main.nf index a9d048cf..00c2dce2 100644 --- a/software/fastp/main.nf +++ b/software/fastp/main.nf @@ -11,7 +11,7 @@ process FASTP { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? 'bioconda::fastp=0.20.1' : null) + conda (params.enable_conda ? 'bioconda::fastp=0.20.1=h8b12597_0' : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container 'https://depot.galaxyproject.org/singularity/fastp:0.20.1--h8b12597_0' } else { diff --git a/software/fastqc/main.nf b/software/fastqc/main.nf index cce410a0..589c0a3e 100644 --- a/software/fastqc/main.nf +++ b/software/fastqc/main.nf @@ -11,7 +11,7 @@ process FASTQC { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::fastqc=0.11.9" : null) + conda (params.enable_conda ? "bioconda::fastqc=0.11.9=0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/fastqc:0.11.9--0" } else { diff --git a/software/gffread/main.nf b/software/gffread/main.nf index 3d81a125..01677672 100644 --- a/software/gffread/main.nf +++ b/software/gffread/main.nf @@ -10,7 +10,7 @@ process GFFREAD { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:'') } - conda (params.enable_conda ? "bioconda::gffread=0.12.1" : null) + conda (params.enable_conda ? "bioconda::gffread=0.12.1=h8b12597_0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/gffread:0.12.1--h8b12597_0" } else { diff --git a/software/hisat2/align/main.nf b/software/hisat2/align/main.nf index 4af22d6d..d470f593 100644 --- a/software/hisat2/align/main.nf +++ b/software/hisat2/align/main.nf @@ -13,7 +13,7 @@ process HISAT2_ALIGN { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::hisat2=2.2.0 bioconda::samtools=1.10" : null) + conda (params.enable_conda ? "bioconda::hisat2=2.2.0=py37h3340039_3 bioconda::samtools=1.10=h9402c20_2" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/mulled-v2-a97e90b3b802d1da3d6958e0867610c718cb5eb1:2880dd9d8ad0a7b221d4eacda9a818e92983128d-0" } else { diff --git a/software/hisat2/build/main.nf b/software/hisat2/build/main.nf index c703fd48..395dfeaf 100644 --- a/software/hisat2/build/main.nf +++ b/software/hisat2/build/main.nf @@ -12,7 +12,7 @@ process HISAT2_BUILD { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:'') } - conda (params.enable_conda ? "bioconda::hisat2=2.2.0" : null) + conda (params.enable_conda ? "bioconda::hisat2=2.2.0=py37hfa133b6_4" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/hisat2:2.2.0--py37hfa133b6_4" } else { diff --git a/software/hisat2/extractsplicesites/main.nf b/software/hisat2/extractsplicesites/main.nf index 2ff846a3..3178c23c 100644 --- a/software/hisat2/extractsplicesites/main.nf +++ b/software/hisat2/extractsplicesites/main.nf @@ -11,7 +11,7 @@ process HISAT2_EXTRACTSPLICESITES { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:'') } - conda (params.enable_conda ? "bioconda::hisat2=2.2.0" : null) + conda (params.enable_conda ? "bioconda::hisat2=2.2.0=py37hfa133b6_4" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/hisat2:2.2.0--py37hfa133b6_4" } else { diff --git a/software/homer/annotatepeaks/main.nf b/software/homer/annotatepeaks/main.nf index 1e03eb64..0330380b 100644 --- a/software/homer/annotatepeaks/main.nf +++ b/software/homer/annotatepeaks/main.nf @@ -13,7 +13,7 @@ process HOMER_ANNOTATEPEAKS { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::homer=4.11" : null) + conda (params.enable_conda ? "bioconda::homer=4.11=pl526hc9558a2_3" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/homer:4.11--pl526hc9558a2_3" } else { diff --git a/software/macs2/callpeak/main.nf b/software/macs2/callpeak/main.nf index de518669..99ec4054 100644 --- a/software/macs2/callpeak/main.nf +++ b/software/macs2/callpeak/main.nf @@ -11,7 +11,7 @@ process MACS2_CALLPEAK { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::macs2=2.2.7.1" : null) + conda (params.enable_conda ? "bioconda::macs2=2.2.7.1=py38h0213d0e_1" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/macs2:2.2.7.1--py38h0213d0e_1" } else { diff --git a/software/multiqc/main.nf b/software/multiqc/main.nf index ff1175fc..3aa7a9af 100644 --- a/software/multiqc/main.nf +++ b/software/multiqc/main.nf @@ -10,7 +10,7 @@ process MULTIQC { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename: filename, options: params.options, publish_dir: getSoftwareName(task.process), publish_id: '') } - conda (params.enable_conda ? "bioconda::multiqc=1.9" : null) + conda (params.enable_conda ? "bioconda::multiqc=1.9=pyh9f0ad1d_0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/multiqc:1.9--pyh9f0ad1d_0" } else { diff --git a/software/pangolin/main.nf b/software/pangolin/main.nf index 8abea296..ad1decb2 100644 --- a/software/pangolin/main.nf +++ b/software/pangolin/main.nf @@ -11,7 +11,7 @@ process PANGOLIN { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? 'bioconda::pangolin=2.1.7' : null) + conda (params.enable_conda ? 'bioconda::pangolin=2.1.7=py_0' : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container 'https://depot.galaxyproject.org/singularity/pangolin:2.1.7--py_0' } else { diff --git a/software/phantompeakqualtools/main.nf b/software/phantompeakqualtools/main.nf index 19a7c388..f7222ddb 100644 --- a/software/phantompeakqualtools/main.nf +++ b/software/phantompeakqualtools/main.nf @@ -13,7 +13,7 @@ process PHANTOMPEAKQUALTOOLS { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::phantompeakqualtools=1.2.2" : null) + conda (params.enable_conda ? "bioconda::phantompeakqualtools=1.2.2=0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/phantompeakqualtools:1.2.2--0" } else { diff --git a/software/picard/collectmultiplemetrics/main.nf b/software/picard/collectmultiplemetrics/main.nf index a4eb4e5f..2b8e339b 100644 --- a/software/picard/collectmultiplemetrics/main.nf +++ b/software/picard/collectmultiplemetrics/main.nf @@ -11,7 +11,7 @@ process PICARD_COLLECTMULTIPLEMETRICS { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::picard=2.23.9" : null) + conda (params.enable_conda ? "bioconda::picard=2.23.9=0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/picard:2.23.9--0" } else { diff --git a/software/picard/markduplicates/main.nf b/software/picard/markduplicates/main.nf index 958f4502..87508887 100644 --- a/software/picard/markduplicates/main.nf +++ b/software/picard/markduplicates/main.nf @@ -11,7 +11,7 @@ process PICARD_MARKDUPLICATES { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::picard=2.23.9" : null) + conda (params.enable_conda ? "bioconda::picard=2.23.9=0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/picard:2.23.9--0" } else { diff --git a/software/picard/mergesamfiles/main.nf b/software/picard/mergesamfiles/main.nf index 400fecde..455d9f34 100644 --- a/software/picard/mergesamfiles/main.nf +++ b/software/picard/mergesamfiles/main.nf @@ -11,7 +11,7 @@ process PICARD_MERGESAMFILES { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::picard=2.23.9" : null) + conda (params.enable_conda ? "bioconda::picard=2.23.9=0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/picard:2.23.9--0" } else { diff --git a/software/preseq/lcextrap/main.nf b/software/preseq/lcextrap/main.nf index 7be82eb8..a6e78f95 100644 --- a/software/preseq/lcextrap/main.nf +++ b/software/preseq/lcextrap/main.nf @@ -12,7 +12,7 @@ process PRESEQ_LCEXTRAP { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::preseq=2.0.3" : null) + conda (params.enable_conda ? "bioconda::preseq=2.0.3=hf53bd2b_3" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/preseq:2.0.3--hf53bd2b_3" } else { diff --git a/software/qualimap/rnaseq/main.nf b/software/qualimap/rnaseq/main.nf index c649bb50..99b1a9b6 100644 --- a/software/qualimap/rnaseq/main.nf +++ b/software/qualimap/rnaseq/main.nf @@ -11,7 +11,7 @@ process QUALIMAP_RNASEQ { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::qualimap=2.2.2d" : null) + conda (params.enable_conda ? "bioconda::qualimap=2.2.2d=1" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/qualimap:2.2.2d--1" } else { diff --git a/software/quast/main.nf b/software/quast/main.nf index 4d5ed531..b93689f6 100644 --- a/software/quast/main.nf +++ b/software/quast/main.nf @@ -10,7 +10,7 @@ process QUAST { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:'') } - conda (params.enable_conda ? 'bioconda::quast=5.0.2' : null) + conda (params.enable_conda ? 'bioconda::quast=5.0.2=py37pl526hb5aa323_2' : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container 'https://depot.galaxyproject.org/singularity/quast:5.0.2--py37pl526hb5aa323_2' } else { diff --git a/software/rsem/calculateexpression/main.nf b/software/rsem/calculateexpression/main.nf index 6f8c54a0..2678f010 100644 --- a/software/rsem/calculateexpression/main.nf +++ b/software/rsem/calculateexpression/main.nf @@ -11,7 +11,7 @@ process RSEM_CALCULATEEXPRESSION { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::rsem=1.3.3 bioconda::star=2.7.6a" : null) + conda (params.enable_conda ? "bioconda::rsem=1.3.3=pl526hfbaaabd_1 bioconda::star=2.7.6a=0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/mulled-v2-cf0123ef83b3c38c13e3b0696a3f285d3f20f15b:606b713ec440e799d53a2b51a6e79dbfd28ecf3e-0" } else { diff --git a/software/rsem/preparereference/main.nf b/software/rsem/preparereference/main.nf index d82e4270..8b53c095 100644 --- a/software/rsem/preparereference/main.nf +++ b/software/rsem/preparereference/main.nf @@ -11,7 +11,7 @@ process RSEM_PREPAREREFERENCE { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:'') } - conda (params.enable_conda ? "bioconda::rsem=1.3.3 bioconda::star=2.7.6a" : null) + conda (params.enable_conda ? "bioconda::rsem=1.3.3=pl526hfbaaabd_1 bioconda::star=2.7.6a=0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/mulled-v2-cf0123ef83b3c38c13e3b0696a3f285d3f20f15b:606b713ec440e799d53a2b51a6e79dbfd28ecf3e-0" } else { diff --git a/software/rseqc/bamstat/main.nf b/software/rseqc/bamstat/main.nf index 1ee570e7..a07d2603 100644 --- a/software/rseqc/bamstat/main.nf +++ b/software/rseqc/bamstat/main.nf @@ -11,7 +11,7 @@ process RSEQC_BAMSTAT { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::rseqc=3.0.1" : null) + conda (params.enable_conda ? "bioconda::rseqc=3.0.1=py37h516909a_1" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/rseqc:3.0.1--py37h516909a_1" } else { diff --git a/software/rseqc/inferexperiment/main.nf b/software/rseqc/inferexperiment/main.nf index 834a01a5..c462aec3 100644 --- a/software/rseqc/inferexperiment/main.nf +++ b/software/rseqc/inferexperiment/main.nf @@ -11,7 +11,7 @@ process RSEQC_INFEREXPERIMENT { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::rseqc=3.0.1" : null) + conda (params.enable_conda ? "bioconda::rseqc=3.0.1=py37h516909a_1" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/rseqc:3.0.1--py37h516909a_1" } else { diff --git a/software/rseqc/innerdistance/main.nf b/software/rseqc/innerdistance/main.nf index df6d1fd1..f3807cfa 100644 --- a/software/rseqc/innerdistance/main.nf +++ b/software/rseqc/innerdistance/main.nf @@ -11,7 +11,7 @@ process RSEQC_INNERDISTANCE { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::rseqc=3.0.1" : null) + conda (params.enable_conda ? "bioconda::rseqc=3.0.1=py37h516909a_1" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/rseqc:3.0.1--py37h516909a_1" } else { diff --git a/software/rseqc/junctionannotation/main.nf b/software/rseqc/junctionannotation/main.nf index 9d39ccc8..15c2c09b 100644 --- a/software/rseqc/junctionannotation/main.nf +++ b/software/rseqc/junctionannotation/main.nf @@ -11,7 +11,7 @@ process RSEQC_JUNCTIONANNOTATION { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::rseqc=3.0.1" : null) + conda (params.enable_conda ? "bioconda::rseqc=3.0.1=py37h516909a_1" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/rseqc:3.0.1--py37h516909a_1" } else { diff --git a/software/rseqc/junctionsaturation/main.nf b/software/rseqc/junctionsaturation/main.nf index b11cdad8..1cd81f7d 100644 --- a/software/rseqc/junctionsaturation/main.nf +++ b/software/rseqc/junctionsaturation/main.nf @@ -11,7 +11,7 @@ process RSEQC_JUNCTIONSATURATION { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::rseqc=3.0.1" : null) + conda (params.enable_conda ? "bioconda::rseqc=3.0.1=py37h516909a_1" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/rseqc:3.0.1--py37h516909a_1" } else { diff --git a/software/rseqc/readdistribution/main.nf b/software/rseqc/readdistribution/main.nf index 6782c40b..60c6e863 100644 --- a/software/rseqc/readdistribution/main.nf +++ b/software/rseqc/readdistribution/main.nf @@ -11,7 +11,7 @@ process RSEQC_READDISTRIBUTION { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::rseqc=3.0.1" : null) + conda (params.enable_conda ? "bioconda::rseqc=3.0.1=py37h516909a_1" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/rseqc:3.0.1--py37h516909a_1" } else { diff --git a/software/rseqc/readduplication/main.nf b/software/rseqc/readduplication/main.nf index 1d0d99fd..4336e490 100644 --- a/software/rseqc/readduplication/main.nf +++ b/software/rseqc/readduplication/main.nf @@ -11,7 +11,7 @@ process RSEQC_READDUPLICATION { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::rseqc=3.0.1" : null) + conda (params.enable_conda ? "bioconda::rseqc=3.0.1=py37h516909a_1" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/rseqc:3.0.1--py37h516909a_1" } else { diff --git a/software/salmon/index/main.nf b/software/salmon/index/main.nf index 0b335aa9..648fb644 100644 --- a/software/salmon/index/main.nf +++ b/software/salmon/index/main.nf @@ -11,7 +11,7 @@ process SALMON_INDEX { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:'') } - conda (params.enable_conda ? "bioconda::salmon=1.4.0" : null) + conda (params.enable_conda ? "bioconda::salmon=1.4.0=hf69c8f4_0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/salmon:1.4.0--hf69c8f4_0" } else { diff --git a/software/salmon/quant/main.nf b/software/salmon/quant/main.nf index 716f13da..342ee90c 100644 --- a/software/salmon/quant/main.nf +++ b/software/salmon/quant/main.nf @@ -11,7 +11,7 @@ process SALMON_QUANT { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::salmon=1.4.0" : null) + conda (params.enable_conda ? "bioconda::salmon=1.4.0=hf69c8f4_0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/salmon:1.4.0--hf69c8f4_0" } else { diff --git a/software/samtools/flagstat/main.nf b/software/samtools/flagstat/main.nf index 9b663ee7..e6c7a7d2 100644 --- a/software/samtools/flagstat/main.nf +++ b/software/samtools/flagstat/main.nf @@ -9,7 +9,7 @@ process SAMTOOLS_FLAGSTAT { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::samtools=1.10" : null) + conda (params.enable_conda ? "bioconda::samtools=1.10=h9402c20_2" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/samtools:1.10--h9402c20_2" } else { diff --git a/software/samtools/idxstats/main.nf b/software/samtools/idxstats/main.nf index 26ff4075..13eaad91 100644 --- a/software/samtools/idxstats/main.nf +++ b/software/samtools/idxstats/main.nf @@ -9,7 +9,7 @@ process SAMTOOLS_IDXSTATS { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::samtools=1.10" : null) + conda (params.enable_conda ? "bioconda::samtools=1.10=h9402c20_2" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/samtools:1.10--h9402c20_2" } else { diff --git a/software/samtools/index/main.nf b/software/samtools/index/main.nf index 5dd631da..f23ddf55 100644 --- a/software/samtools/index/main.nf +++ b/software/samtools/index/main.nf @@ -9,7 +9,7 @@ process SAMTOOLS_INDEX { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::samtools=1.10" : null) + conda (params.enable_conda ? "bioconda::samtools=1.10=h9402c20_2" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/samtools:1.10--h9402c20_2" } else { diff --git a/software/samtools/mpileup/main.nf b/software/samtools/mpileup/main.nf index 662588fd..1779c4be 100644 --- a/software/samtools/mpileup/main.nf +++ b/software/samtools/mpileup/main.nf @@ -11,7 +11,7 @@ process SAMTOOLS_MPILEUP { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::samtools=1.10" : null) + conda (params.enable_conda ? "bioconda::samtools=1.10=h9402c20_2" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/samtools:1.10--h9402c20_2" } else { diff --git a/software/samtools/sort/main.nf b/software/samtools/sort/main.nf index 2b95b1d5..3bcbc9cb 100644 --- a/software/samtools/sort/main.nf +++ b/software/samtools/sort/main.nf @@ -11,7 +11,7 @@ process SAMTOOLS_SORT { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::samtools=1.10" : null) + conda (params.enable_conda ? "bioconda::samtools=1.10=h9402c20_2" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/samtools:1.10--h9402c20_2" } else { diff --git a/software/samtools/stats/main.nf b/software/samtools/stats/main.nf index d8d1d020..2253a5c7 100644 --- a/software/samtools/stats/main.nf +++ b/software/samtools/stats/main.nf @@ -9,7 +9,7 @@ process SAMTOOLS_STATS { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::samtools=1.10" : null) + conda (params.enable_conda ? "bioconda::samtools=1.10=h9402c20_2" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/samtools:1.10--h9402c20_2" } else { diff --git a/software/samtools/view/main.nf b/software/samtools/view/main.nf index 968fcc4c..7cf9390d 100644 --- a/software/samtools/view/main.nf +++ b/software/samtools/view/main.nf @@ -10,7 +10,7 @@ process SAMTOOLS_VIEW { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::samtools=1.10" : null) + conda (params.enable_conda ? "bioconda::samtools=1.10=h9402c20_2" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/samtools:1.10--h9402c20_2" } else { diff --git a/software/seacr/callpeak/main.nf b/software/seacr/callpeak/main.nf index 3d67a058..9f3746b9 100644 --- a/software/seacr/callpeak/main.nf +++ b/software/seacr/callpeak/main.nf @@ -13,7 +13,7 @@ process SEACR_CALLPEAK { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::seacr=1.3 conda-forge::r-base=4.0.2 bioconda::bedtools=2.29.2" : null) + conda (params.enable_conda ? "bioconda::seacr=1.3=1 conda-forge::r-base=4.0.2=he766273_1 bioconda::bedtools=2.29.2=hc088bd4_0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/mulled-v2-03bfeb32fe80910c231f630d4262b83677c8c0f4:5bb5ed4307a8187a7f34730b00431de93688fa59-0" } else { diff --git a/software/sortmerna/main.nf b/software/sortmerna/main.nf index ac1ce074..52b82ce5 100644 --- a/software/sortmerna/main.nf +++ b/software/sortmerna/main.nf @@ -11,7 +11,7 @@ process SORTMERNA { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::sortmerna=4.2.0" : null) + conda (params.enable_conda ? "bioconda::sortmerna=4.2.0=0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/sortmerna:4.2.0--0" } else { diff --git a/software/star/align/main.nf b/software/star/align/main.nf index 3c317ad1..697c1230 100644 --- a/software/star/align/main.nf +++ b/software/star/align/main.nf @@ -12,7 +12,7 @@ process STAR_ALIGN { saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } // Note: 2.7X indices incompatible with AWS iGenomes. - conda (params.enable_conda ? 'bioconda::star=2.6.1d' : null) + conda (params.enable_conda ? 'bioconda::star=2.6.1d=0' : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container 'https://depot.galaxyproject.org/singularity/star:2.6.1d--0' } else { diff --git a/software/star/genomegenerate/main.nf b/software/star/genomegenerate/main.nf index e9aa1234..5bc65457 100644 --- a/software/star/genomegenerate/main.nf +++ b/software/star/genomegenerate/main.nf @@ -12,7 +12,7 @@ process STAR_GENOMEGENERATE { saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:'') } // Note: 2.7X indices incompatible with AWS iGenomes. - conda (params.enable_conda ? "bioconda::star=2.6.1d" : null) + conda (params.enable_conda ? "bioconda::star=2.6.1d=0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/star:2.6.1d--0" } else { diff --git a/software/stringtie/main.nf b/software/stringtie/main.nf index 321fa4c5..e624354b 100644 --- a/software/stringtie/main.nf +++ b/software/stringtie/main.nf @@ -11,7 +11,7 @@ process STRINGTIE { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::stringtie=2.1.4" : null) + conda (params.enable_conda ? "bioconda::stringtie=2.1.4=h7e0af3c_0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/stringtie:2.1.4--h7e0af3c_0" } else { diff --git a/software/subread/featurecounts/main.nf b/software/subread/featurecounts/main.nf index d9780ea5..533adb49 100644 --- a/software/subread/featurecounts/main.nf +++ b/software/subread/featurecounts/main.nf @@ -11,7 +11,7 @@ process SUBREAD_FEATURECOUNTS { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::subread=2.0.1" : null) + conda (params.enable_conda ? "bioconda::subread=2.0.1=hed695b0_0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/subread:2.0.1--hed695b0_0" } else { diff --git a/software/trimgalore/main.nf b/software/trimgalore/main.nf index 79cc7456..09706ee4 100644 --- a/software/trimgalore/main.nf +++ b/software/trimgalore/main.nf @@ -11,7 +11,7 @@ process TRIMGALORE { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::trim-galore=0.6.6" : null) + conda (params.enable_conda ? "bioconda::trim-galore=0.6.6=0" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/trim-galore:0.6.6--0" } else { diff --git a/software/ucsc/bedgraphtobigwig/main.nf b/software/ucsc/bedgraphtobigwig/main.nf index 10300280..cbb875bf 100644 --- a/software/ucsc/bedgraphtobigwig/main.nf +++ b/software/ucsc/bedgraphtobigwig/main.nf @@ -13,7 +13,7 @@ process UCSC_BEDGRAPHTOBIGWIG { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::ucsc-bedgraphtobigwig=377" : null) + conda (params.enable_conda ? "bioconda::ucsc-bedgraphtobigwig=377=h446ed27_1" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/ucsc-bedgraphtobigwig:377--h446ed27_1" } else { diff --git a/software/umitools/dedup/main.nf b/software/umitools/dedup/main.nf index 9df37494..dbdf41f4 100644 --- a/software/umitools/dedup/main.nf +++ b/software/umitools/dedup/main.nf @@ -11,7 +11,7 @@ process UMITOOLS_DEDUP { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::umi_tools=1.1.1" : null) + conda (params.enable_conda ? "bioconda::umi_tools=1.1.1=py38h0213d0e_1" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/umi_tools:1.1.1--py38h0213d0e_1" } else { diff --git a/software/umitools/extract/main.nf b/software/umitools/extract/main.nf index 89f78b9b..b12c75bc 100644 --- a/software/umitools/extract/main.nf +++ b/software/umitools/extract/main.nf @@ -11,7 +11,7 @@ process UMITOOLS_EXTRACT { mode: params.publish_dir_mode, saveAs: { filename -> saveFiles(filename:filename, options:params.options, publish_dir:getSoftwareName(task.process), publish_id:meta.id) } - conda (params.enable_conda ? "bioconda::umi_tools=1.1.1" : null) + conda (params.enable_conda ? "bioconda::umi_tools=1.1.1=py38h0213d0e_1" : null) if (workflow.containerEngine == 'singularity' && !params.singularity_pull_docker_container) { container "https://depot.galaxyproject.org/singularity/umi_tools:1.1.1--py38h0213d0e_1" } else { diff --git a/test_import.nf b/test_import.nf deleted file mode 100644 index 3d7ebd23..00000000 --- a/test_import.nf +++ /dev/null @@ -1,2 +0,0 @@ -// This file doesn't do anything, -// but pipelines can attempt to import it to check connection status diff --git a/tests/software/bowtie/test.yml b/tests/software/bowtie/test.yml index 61ed5f1d..5d1e28e3 100644 --- a/tests/software/bowtie/test.yml +++ b/tests/software/bowtie/test.yml @@ -37,8 +37,6 @@ md5sum: f3c398bba5158f4039334a932d79c051 - path: output/bowtie/test.out md5sum: a81cb18024616415a6cec3108a36fccd - - path: output/bowtie/test.bam - md5sum: 9feed8a55d4b5e600dcc577768ef07fc - name: Run bowtie index and align paired-end command: nextflow run ./tests/software/bowtie -entry test_bowtie_alignment_paired_end -c tests/config/nextflow.config @@ -59,6 +57,4 @@ - path: output/bowtie/bowtie/NC_010473.rev.2.ebwt md5sum: f3c398bba5158f4039334a932d79c051 - path: output/bowtie/test.out - md5sum: a23e9a2a76e949aeb3693bcfae41a615 - - path: output/bowtie/test.bam - md5sum: cf6a6381aa504e8342638ff3b509721e + md5sum: a23e9a2a76e949aeb3693bcfae41a615 \ No newline at end of file diff --git a/tests/software/bowtie2/test.yml b/tests/software/bowtie2/test.yml index f5ecbf12..7263aa0c 100644 --- a/tests/software/bowtie2/test.yml +++ b/tests/software/bowtie2/test.yml @@ -37,8 +37,6 @@ md5sum: 5e8fb4af677eb3a57a40e76dc3f6db72 - path: output/bowtie2/test.bowtie2.log md5sum: 90041c264231be535042adb93a279356 - - path: output/bowtie2/test.bam - md5sum: 906102f401d8234b6473790988fb09cf - name: Run bowtie2 index and align paired-end command: nextflow run ./tests/software/bowtie2 -entry test_bowtie2_alignment_paired_end -c tests/config/nextflow.config @@ -60,5 +58,3 @@ md5sum: 5e8fb4af677eb3a57a40e76dc3f6db72 - path: output/bowtie2/test.bowtie2.log md5sum: 9f9eb40b5f57e0f2d5c874f2c1b5cfd5 - - path: output/bowtie2/test.bam - md5sum: 732a33cd9816b38ea9b919c25eeb78f8