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
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
- Toggle navigation
-
-
-
-
-
-
-
- v1.7
-
-
-
-
Loading report..
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
- A modular tool to aggregate results from bioinformatics analyses across many samples into a single report.
-
-
-
-
-
-
-
-
-
-
JavaScript Disabled
-
MultiQC reports use JavaScript for plots and toolbox functions. It looks like
- you have JavaScript disabled in your web browser. Please note that many of the report
- functions will not work as intended.
-
-
-
-
Loading 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
-
-
- Copy table
-
-
-
- Configure Columns
-
-
-
- Sort by highlight
-
-
-
- Plot
-
-
-
Showing 5 /5 rows and 5 /7 columns.
-
-
-
-
- 88.6%
1.5%
8.3%
44%
76 bp
9%
0.0
7.0%
44%
75 bp
9%
0.0
1.9%
8.4%
44%
76 bp
9%
0.0
7.2%
44%
74 bp
9%
0.0
-
-
-
-
-
-
-
Uncheck the tick box to hide columns. Click and drag the handle on the left to change order.
-
- Show All
- Show None
-
-
-
-
-
-
-
-
-
-
-
-
-
-
Bowtie 2
-
Bowtie 2 is an ultrafast and memory-efficient tool for aligning sequencing reads to long reference sequences.
-
-
-
-
-
-
- Help
-
-
-
-
-
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.
-
-
-
-Number of Reads
-Percentages
-
-
-
-
-
-
-
-
-
-
-
-
-
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.
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
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
-
-
-
- Help
-
-
-
-
-
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.
-
-
-
-Number of reads
-Percentages
-
-
-
-
-
-
-
-
-
-
-
- Sequence Quality Histograms
-
-
-
- Help
-
-
-
-
-
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.
-
-
-
-
-
-
-
-
-
-
-
-
-
- Per Sequence Quality Scores
-
-
-
- Help
-
-
-
-
-
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.
-
-
-
-
-
-
-
-
-
-
-
-
-
- Per Base Sequence Content
-
-
-
- Help
-
-
-
-
-
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
-
Export Plot
-
- Position:
-
-
%T: -
-
%C: -
-
%A: -
-
%G: -
-
-
-
-
-
-
-
-
-
-
-
-
-
-
- Per Sequence GC Content
-
-
-
- Help
-
-
-
-
-
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.
-
-
-
-Percentages
-Counts
-
-
-
-
-
-
-
-
-
-
-
-
-
-
- Per Base N Content
-
-
-
- Help
-
-
-
-
-
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.
-
-
-
-
-
-
-
-
-
-
-
-
-
- Sequence Length Distribution
-
-
-
-
The distribution of fragment sizes (read lengths) found.
- See the FastQC help
-
-
-
-
-
-
-
-
-
-
-
-
-
- Sequence Duplication Levels
-
-
-
- Help
-
-
-
-
-
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.
-
-
-
-
-
-
-
-
-
-
-
-
-
- Overrepresented sequences
-
-
-
- Help
-
-
-
-
-
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
-
-
-
- Help
-
-
-
-
-
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.
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
- Select Column
-
-
-
-
- Select Column
-
-
-
-
-
- Please select two table columns.
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
-
Toolbox search strings can behave as regular expressions (regexes). Click a button below to see an example of it in action. Try modifying them yourself in the text box.
-
-
- ^
(start of string)
- $
(end of string)
- []
(character choice)
- \d
(shorthand for [0-9]
)
- \w
(shorthand for [0-9a-zA-Z_]
)
- .
(any character)
- \.
(literal full stop)
- ()
|
(group / separator)
- *
(prev char 0 or more)
- +
(prev char 1 or more)
- ?
(prev char 0 or 1)
- {}
(char num times)
- {,}
(count range)
-
-
-
-
-samp_1
-samp_1_edited
-samp_2
-samp_2_edited
-samp_3
-samp_3_edited
-prepended_samp_1
-tmp_samp_1_edited
-tmpp_samp_1_edited
-tmppp_samp_1_edited
-#samp_1_edited.tmp
-samp_11
-samp_11111
-
-
See regex101.com for a more heavy duty testing suite.
-
-
-
-
-
-
-
-
-
-
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"