mirror of
https://github.com/MillironX/nf-core_modules.git
synced 2024-12-22 11:08:17 +00:00
Merge branch 'master' into bump/picard
This commit is contained in:
commit
45f3795670
26 changed files with 479 additions and 44 deletions
|
@ -42,7 +42,6 @@ output:
|
|||
type: file
|
||||
description: File containing software versions
|
||||
pattern: "versions.yml"
|
||||
## TODO nf-core: Delete / customise this example output
|
||||
- out:
|
||||
type: file
|
||||
description: The data in the asked format (bed, fasta, fastq, json, pileup, sam, yaml)
|
||||
|
|
|
@ -8,7 +8,7 @@ process BCFTOOLS_CONCAT {
|
|||
'quay.io/biocontainers/bcftools:1.14--h88f3f91_0' }"
|
||||
|
||||
input:
|
||||
tuple val(meta), path(vcfs)
|
||||
tuple val(meta), path(vcfs), path(tbi)
|
||||
|
||||
output:
|
||||
tuple val(meta), path("*.gz"), emit: vcf
|
||||
|
|
|
@ -25,6 +25,11 @@ input:
|
|||
description: |
|
||||
List containing 2 or more vcf files
|
||||
e.g. [ 'file1.vcf', 'file2.vcf' ]
|
||||
- tbi:
|
||||
type: files
|
||||
description: |
|
||||
List containing 2 or more index files (optional)
|
||||
e.g. [ 'file1.tbi', 'file2.tbi' ]
|
||||
output:
|
||||
- meta:
|
||||
type: map
|
||||
|
|
|
@ -2,13 +2,15 @@ process DEEPTOOLS_BAMCOVERAGE {
|
|||
tag "$meta.id"
|
||||
label 'process_low'
|
||||
|
||||
conda (params.enable_conda ? "bioconda::deeptools=3.5.1" : null)
|
||||
conda (params.enable_conda ? "bioconda::deeptools=3.5.1 bioconda::samtools=1.15.1" : null)
|
||||
container "${ workflow.containerEngine == 'singularity' && !task.ext.singularity_pull_docker_container ?
|
||||
'https://depot.galaxyproject.org/singularity/deeptools:3.5.1--py_0':
|
||||
'quay.io/biocontainers/deeptools:3.5.1--py_0' }"
|
||||
'https://depot.galaxyproject.org/singularity/mulled-v2-eb9e7907c7a753917c1e4d7a64384c047429618a:2c687053c0252667cca265c9f4118f2c205a604c-0':
|
||||
'quay.io/biocontainers/mulled-v2-eb9e7907c7a753917c1e4d7a64384c047429618a:2c687053c0252667cca265c9f4118f2c205a604c-0' }"
|
||||
|
||||
input:
|
||||
tuple val(meta), path(input), path(input_index)
|
||||
path(fasta)
|
||||
path(fasta_fai)
|
||||
|
||||
output:
|
||||
tuple val(meta), path("*.bigWig") , emit: bigwig, optional: true
|
||||
|
@ -22,16 +24,44 @@ process DEEPTOOLS_BAMCOVERAGE {
|
|||
def args = task.ext.args ?: ''
|
||||
def prefix = task.ext.prefix ?: "${meta.id}.bigWig"
|
||||
|
||||
"""
|
||||
bamCoverage \\
|
||||
--bam $input \\
|
||||
$args \\
|
||||
--numberOfProcessors ${task.cpus} \\
|
||||
--outFileName ${prefix}
|
||||
// cram_input is currently not working with deeptools
|
||||
// therefore it's required to convert cram to bam first
|
||||
def is_cram = input.Extension == "cram" ? true : false
|
||||
def input_out = is_cram ? input.BaseName + ".bam" : "${input}"
|
||||
def fai_reference = fasta_fai ? "--fai-reference ${fasta_fai}" : ""
|
||||
|
||||
if (is_cram){
|
||||
"""
|
||||
samtools view -T $fasta $input $fai_reference -@ $task.cpus -o $input_out
|
||||
samtools index -b $input_out -@ $task.cpus
|
||||
|
||||
bamCoverage \\
|
||||
--bam $input_out \\
|
||||
$args \\
|
||||
--numberOfProcessors ${task.cpus} \\
|
||||
--outFileName ${prefix}
|
||||
|
||||
cat <<-END_VERSIONS > versions.yml
|
||||
"${task.process}":
|
||||
samtools: \$(echo \$(samtools --version 2>&1) | sed 's/^.*samtools //; s/Using.*\$//')
|
||||
deeptools: \$(bamCoverage --version | sed -e "s/bamCoverage //g")
|
||||
END_VERSIONS
|
||||
"""
|
||||
|
||||
}
|
||||
else {
|
||||
"""
|
||||
bamCoverage \\
|
||||
--bam $input_out \\
|
||||
$args \\
|
||||
--numberOfProcessors ${task.cpus} \\
|
||||
--outFileName ${prefix}
|
||||
|
||||
cat <<-END_VERSIONS > versions.yml
|
||||
"${task.process}":
|
||||
deeptools: \$(bamCoverage --version | sed -e "s/bamCoverage //g")
|
||||
END_VERSIONS
|
||||
"""
|
||||
}
|
||||
|
||||
cat <<-END_VERSIONS > versions.yml
|
||||
"${task.process}":
|
||||
deeptools: \$(bamCoverage --version | sed -e "s/bamCoverage //g")
|
||||
END_VERSIONS
|
||||
"""
|
||||
}
|
||||
|
|
|
@ -25,6 +25,14 @@ input:
|
|||
type: file
|
||||
description: BAM/CRAM index file
|
||||
pattern: "*.{bai,crai}"
|
||||
- fasta:
|
||||
type: file
|
||||
description: Reference file the CRAM file was created with (required with CRAM input)
|
||||
pattern: "*.{fasta,fa}"
|
||||
- fasta_fai:
|
||||
type: file
|
||||
description: Index of the reference file (optional, but recommended)
|
||||
pattern: "*.{fai}"
|
||||
|
||||
output:
|
||||
- meta:
|
||||
|
@ -47,3 +55,4 @@ output:
|
|||
|
||||
authors:
|
||||
- "@FriederikeHanssen"
|
||||
- "@SusiJo"
|
||||
|
|
|
@ -11,7 +11,7 @@ process FILTLONG {
|
|||
tuple val(meta), path(shortreads), path(longreads)
|
||||
|
||||
output:
|
||||
tuple val(meta), path("${meta.id}_lr_filtlong.fastq.gz"), emit: reads
|
||||
tuple val(meta), path("*.fastq.gz"), emit: reads
|
||||
path "versions.yml" , emit: versions
|
||||
|
||||
when:
|
||||
|
@ -20,13 +20,14 @@ process FILTLONG {
|
|||
script:
|
||||
def args = task.ext.args ?: ''
|
||||
def prefix = task.ext.prefix ?: "${meta.id}"
|
||||
def short_reads = meta.single_end ? "-1 $shortreads" : "-1 ${shortreads[0]} -2 ${shortreads[1]}"
|
||||
def short_reads = !shortreads ? "" : meta.single_end ? "-1 $shortreads" : "-1 ${shortreads[0]} -2 ${shortreads[1]}"
|
||||
if ("$longreads" == "${prefix}.fastq.gz") error "Longread FASTQ input and output names are the same, set prefix in module configuration to disambiguate!"
|
||||
"""
|
||||
filtlong \\
|
||||
$short_reads \\
|
||||
$args \\
|
||||
$longreads \\
|
||||
| gzip -n > ${prefix}_lr_filtlong.fastq.gz
|
||||
| gzip -n > ${prefix}.fastq.gz
|
||||
|
||||
cat <<-END_VERSIONS > versions.yml
|
||||
"${task.process}":
|
||||
|
|
53
modules/gatk4/composestrtablefile/main.nf
Normal file
53
modules/gatk4/composestrtablefile/main.nf
Normal file
|
@ -0,0 +1,53 @@
|
|||
process GATK4_COMPOSESTRTABLEFILE {
|
||||
tag "$fasta"
|
||||
label 'process_low'
|
||||
|
||||
conda (params.enable_conda ? "bioconda::gatk4=4.2.6.1" : null)
|
||||
container "${ workflow.containerEngine == 'singularity' && !task.ext.singularity_pull_docker_container ?
|
||||
'https://depot.galaxyproject.org/singularity/gatk4:4.2.6.1--hdfd78af_0':
|
||||
'quay.io/biocontainers/gatk4:4.2.6.1--hdfd78af_0' }"
|
||||
|
||||
input:
|
||||
path(fasta)
|
||||
path(fasta_fai)
|
||||
path(dict)
|
||||
|
||||
output:
|
||||
path "*.zip" , emit: str_table
|
||||
path "versions.yml" , emit: versions
|
||||
|
||||
when:
|
||||
task.ext.when == null || task.ext.when
|
||||
|
||||
script:
|
||||
def args = task.ext.args ?: ''
|
||||
|
||||
def avail_mem = 6
|
||||
if (!task.memory) {
|
||||
log.info '[GATK ComposeSTRTableFile] Available memory not known - defaulting to 6GB. Specify process memory requirements to change this.'
|
||||
} else {
|
||||
avail_mem = task.memory.giga
|
||||
}
|
||||
"""
|
||||
gatk --java-options "-Xmx${avail_mem}g" ComposeSTRTableFile \\
|
||||
--reference $fasta \\
|
||||
--output ${fasta.baseName}.zip \\
|
||||
--tmp-dir . \\
|
||||
$args
|
||||
|
||||
cat <<-END_VERSIONS > versions.yml
|
||||
"${task.process}":
|
||||
gatk4: \$(echo \$(gatk --version 2>&1) | sed 's/^.*(GATK) v//; s/ .*\$//')
|
||||
END_VERSIONS
|
||||
"""
|
||||
|
||||
stub:
|
||||
"""
|
||||
touch test.zip
|
||||
|
||||
cat <<-END_VERSIONS > versions.yml
|
||||
"${task.process}":
|
||||
gatk4: \$(echo \$(gatk --version 2>&1) | sed 's/^.*(GATK) v//; s/ .*\$//')
|
||||
END_VERSIONS
|
||||
"""
|
||||
}
|
43
modules/gatk4/composestrtablefile/meta.yml
Normal file
43
modules/gatk4/composestrtablefile/meta.yml
Normal file
|
@ -0,0 +1,43 @@
|
|||
name: "gatk4_composestrtablefile"
|
||||
description: This tool looks for low-complexity STR sequences along the reference that are later used to estimate the Dragstr model during single sample auto calibration CalibrateDragstrModel.
|
||||
keywords:
|
||||
- gatk4
|
||||
- composestrtablefile
|
||||
tools:
|
||||
- gatk4:
|
||||
description:
|
||||
Genome Analysis Toolkit (GATK4). Developed in the Data Sciences Platform at the Broad Institute, the toolkit offers a wide variety of tools
|
||||
with a primary focus on variant discovery and genotyping. Its powerful processing engine
|
||||
and high-performance computing features make it capable of taking on projects of any size.
|
||||
homepage: https://gatk.broadinstitute.org/hc/en-us
|
||||
documentation: https://gatk.broadinstitute.org/hc/en-us/articles/4405451249819-ComposeSTRTableFile
|
||||
tool_dev_url: https://github.com/broadinstitute/gatk
|
||||
doi: 10.1158/1538-7445.AM2017-3590
|
||||
licence: ["Apache-2.0"]
|
||||
|
||||
input:
|
||||
- fasta:
|
||||
type: file
|
||||
description: FASTA reference file
|
||||
pattern: "*.{fasta,fa}"
|
||||
- fasta_fai:
|
||||
type: file
|
||||
description: index of the FASTA reference file
|
||||
pattern: "*.fai"
|
||||
- dict:
|
||||
type: file
|
||||
description: Sequence dictionary of the FASTA reference file
|
||||
pattern: "*.dict"
|
||||
|
||||
output:
|
||||
- versions:
|
||||
type: file
|
||||
description: File containing software versions
|
||||
pattern: "versions.yml"
|
||||
- str_table:
|
||||
type: file
|
||||
description: A zipped folder containing the STR table files
|
||||
pattern: "*.zip"
|
||||
|
||||
authors:
|
||||
- "@nvnieuwk"
|
|
@ -13,6 +13,7 @@ process GATK4_MERGEVCFS {
|
|||
|
||||
output:
|
||||
tuple val(meta), path('*.vcf.gz'), emit: vcf
|
||||
tuple val(meta), path("*.tbi") , emit: tbi
|
||||
path "versions.yml" , emit: versions
|
||||
|
||||
when:
|
||||
|
|
|
@ -35,6 +35,11 @@ output:
|
|||
type: file
|
||||
description: merged vcf file
|
||||
pattern: "*.vcf.gz"
|
||||
- tbi:
|
||||
type: file
|
||||
description: index files for the merged vcf files
|
||||
pattern: "*.tbi"
|
||||
|
||||
- versions:
|
||||
type: file
|
||||
description: File containing software versions
|
||||
|
|
67
modules/vsearch/usearchglobal/main.nf
Normal file
67
modules/vsearch/usearchglobal/main.nf
Normal file
|
@ -0,0 +1,67 @@
|
|||
process VSEARCH_USEARCHGLOBAL {
|
||||
tag "${meta.id}"
|
||||
label 'process_low'
|
||||
|
||||
conda (params.enable_conda ? "bioconda::vsearch=2.21.1" : null)
|
||||
container "${ workflow.containerEngine == 'singularity' && !task.ext.singularity_pull_docker_container ?
|
||||
'https://depot.galaxyproject.org/singularity/vsearch:2.21.1--h95f258a_0':
|
||||
'quay.io/biocontainers/vsearch:2.21.1--h95f258a_0' }"
|
||||
|
||||
input:
|
||||
tuple val(meta), path(queryfasta)
|
||||
path db
|
||||
val idcutoff
|
||||
val outoption
|
||||
val user_columns
|
||||
|
||||
output:
|
||||
tuple val(meta), path('*.aln') , optional: true, emit: aln
|
||||
tuple val(meta), path('*.biom') , optional: true, emit: biom
|
||||
tuple val(meta), path('*.lca') , optional: true, emit: lca
|
||||
tuple val(meta), path('*.mothur') , optional: true, emit: mothur
|
||||
tuple val(meta), path('*.otu') , optional: true, emit: otu
|
||||
tuple val(meta), path('*.sam') , optional: true, emit: sam
|
||||
tuple val(meta), path('*.tsv') , optional: true, emit: tsv
|
||||
tuple val(meta), path('*.txt') , optional: true, emit: txt
|
||||
tuple val(meta), path('*.uc') , optional: true, emit: uc
|
||||
path "versions.yml" , emit: versions
|
||||
|
||||
when:
|
||||
task.ext.when == null || task.ext.when
|
||||
|
||||
script:
|
||||
def args = task.ext.args ?: ''
|
||||
def prefix = task.ext.prefix ?: "${meta.id}"
|
||||
def columns = user_columns ? "--userfields ${user_columns}" : ''
|
||||
switch ( outoption ) {
|
||||
case "alnout": outfmt = "--alnout"; out_ext = 'aln'; break
|
||||
case "biomout": outfmt = "--biomout"; out_ext = 'biom'; break
|
||||
case "blast6out": outfmt = "--blast6out"; out_ext = 'txt'; break
|
||||
case "mothur_shared_out": outfmt = "--mothur_shared_out"; out_ext = 'mothur'; break
|
||||
case "otutabout": outfmt = "--otutabout"; out_ext = 'otu'; break
|
||||
case "samout": outfmt = "--samout"; out_ext = 'sam'; break
|
||||
case "uc": outfmt = "--uc"; out_ext = 'uc'; break
|
||||
case "userout": outfmt = "--userout"; out_ext = 'tsv'; break
|
||||
case "lcaout": outfmt = "--lcaout"; out_ext = 'lca'; break
|
||||
default:
|
||||
outfmt = "--alnout";
|
||||
out_ext = 'aln';
|
||||
log.warn("Unknown output file format provided (${outoption}): selecting pairwise alignments (alnout)");
|
||||
break
|
||||
}
|
||||
"""
|
||||
vsearch \\
|
||||
--usearch_global $queryfasta \\
|
||||
--db $db \\
|
||||
--id $idcutoff \\
|
||||
--threads $task.cpus \\
|
||||
$args \\
|
||||
${columns} \\
|
||||
${outfmt} ${prefix}.${out_ext}
|
||||
|
||||
cat <<-END_VERSIONS > versions.yml
|
||||
"${task.process}":
|
||||
vsearch: \$(vsearch --version 2>&1 | head -n 1 | sed 's/vsearch //g' | sed 's/,.*//g' | sed 's/^v//' | sed 's/_.*//')
|
||||
END_VERSIONS
|
||||
"""
|
||||
}
|
83
modules/vsearch/usearchglobal/meta.yml
Normal file
83
modules/vsearch/usearchglobal/meta.yml
Normal file
|
@ -0,0 +1,83 @@
|
|||
name: "vsearch_usearchglobal"
|
||||
description: Compare target sequences to fasta-formatted query sequences using global pairwise alignment.
|
||||
keywords:
|
||||
- vsearch
|
||||
- usearch
|
||||
- alignment
|
||||
- fasta
|
||||
tools:
|
||||
- "vsearch":
|
||||
description: "VSEARCH is a versatile open-source tool for microbiome analysis, including chimera detection, clustering, dereplication and rereplication, extraction, FASTA/FASTQ/SFF file processing, masking, orienting, pair-wise alignment, restriction site cutting, searching, shuffling, sorting, subsampling, and taxonomic classification of amplicon sequences for metagenomics, genomics, and population genetics. (USEARCH alternative)"
|
||||
homepage: "https://github.com/torognes/vsearch"
|
||||
documentation: "None"
|
||||
tool_dev_url: "https://github.com/torognes/vsearch"
|
||||
doi: "doi: 10.7717/peerj.2584"
|
||||
licence: "['GPL v3-or-later OR BSD-2-clause']"
|
||||
|
||||
input:
|
||||
- meta:
|
||||
type: map
|
||||
description: Groovy Map containing sample information e.g. [ id:'test' ]
|
||||
- queryfasta:
|
||||
type: file
|
||||
description: Query sequences in FASTA format
|
||||
pattern: "*.{fasta,fa,fna,faa}"
|
||||
- db:
|
||||
type: file
|
||||
description: Reference database file in FASTA or UDB format
|
||||
pattern: "*"
|
||||
- idcutoff:
|
||||
type: real
|
||||
description: Reject the sequence match if the pairwise identity is lower than the given id cutoff value (value ranging from 0.0 to 1.0 included)
|
||||
- outoption:
|
||||
type: string
|
||||
description: Specify the type of output file to be generated by selecting one of the vsearch output file options
|
||||
pattern: "alnout|biomout|blast6out|mothur_shared_out|otutabout|samout|uc|userout|lcaout"
|
||||
- user_columns:
|
||||
type: string
|
||||
description: If using the `userout` option, specify which columns to include in output, with fields separated with `+` (e.g. query+target+id). See USEARCH manual for valid options. For other output options, use an empty string.
|
||||
|
||||
output:
|
||||
- aln:
|
||||
type: file
|
||||
description: Results in pairwise alignment format
|
||||
pattern: "*.{aln}"
|
||||
- biom:
|
||||
type: file
|
||||
description: Results in an OTU table in the biom version 1.0 file format
|
||||
pattern: "*.{biom}"
|
||||
- lca:
|
||||
type: file
|
||||
description: Last common ancestor (LCA) information about the hits of each query in tab-separated format
|
||||
pattern: "*.{lca}"
|
||||
- mothur:
|
||||
type: file
|
||||
description: Results in an OTU table in the mothur ’shared’ tab-separated plain text file format
|
||||
pattern: "*.{mothur}"
|
||||
- otu:
|
||||
type: file
|
||||
description: Results in an OTU table in the classic tab-separated plain text format
|
||||
pattern: "*.{otu}"
|
||||
- sam:
|
||||
type: file
|
||||
description: Results written in sam format
|
||||
pattern: "*.{sam}"
|
||||
- tsv:
|
||||
type: file
|
||||
description: Results in tab-separated output, columns defined by user
|
||||
pattern: "*.{tsv}"
|
||||
- txt:
|
||||
type: file
|
||||
description: Tab delimited results in blast-like tabular format
|
||||
pattern: "*.{txt}"
|
||||
- uc:
|
||||
type: file
|
||||
description: Tab delimited results in a uclust-like format with 10 columns
|
||||
pattern: "*.{uc}"
|
||||
- versions:
|
||||
type: file
|
||||
description: File containing software versions
|
||||
pattern: "versions.yml"
|
||||
|
||||
authors:
|
||||
- "@jtangrot"
|
|
@ -751,6 +751,10 @@ gatk4/combinegvcfs:
|
|||
- modules/gatk4/combinegvcfs/**
|
||||
- tests/modules/gatk4/combinegvcfs/**
|
||||
|
||||
gatk4/composestrtablefile:
|
||||
- modules/gatk4/composestrtablefile/**
|
||||
- tests/modules/gatk4/composestrtablefile/**
|
||||
|
||||
gatk4/createsequencedictionary:
|
||||
- modules/gatk4/createsequencedictionary/**
|
||||
- tests/modules/gatk4/createsequencedictionary/**
|
||||
|
@ -2052,6 +2056,10 @@ vcftools:
|
|||
- modules/vcftools/**
|
||||
- tests/modules/vcftools/**
|
||||
|
||||
vsearch/usearchglobal:
|
||||
- modules/vsearch/usearchglobal/**
|
||||
- tests/modules/vsearch/usearchglobal/**
|
||||
|
||||
yara/index:
|
||||
- modules/yara/index/**
|
||||
- tests/modules/yara/index/**
|
||||
|
|
|
@ -4,13 +4,25 @@ nextflow.enable.dsl = 2
|
|||
|
||||
include { BCFTOOLS_CONCAT } from '../../../../modules/bcftools/concat/main.nf'
|
||||
|
||||
workflow test_bcftools_concat {
|
||||
workflow test_bcftools_concat_tbi {
|
||||
|
||||
input = [ [ id:'test3' ], // meta map
|
||||
[ file(params.test_data['sarscov2']['illumina']['test_vcf_gz'], checkIfExists: true),
|
||||
file(params.test_data['sarscov2']['illumina']['test2_vcf_gz'], checkIfExists: true) ]
|
||||
file(params.test_data['sarscov2']['illumina']['test2_vcf_gz'], checkIfExists: true) ],
|
||||
[ file(params.test_data['sarscov2']['illumina']['test_vcf_gz_tbi'], checkIfExists: true),
|
||||
file(params.test_data['sarscov2']['illumina']['test2_vcf_gz_tbi'], checkIfExists: true) ]
|
||||
]
|
||||
|
||||
BCFTOOLS_CONCAT ( input )
|
||||
}
|
||||
|
||||
workflow test_bcftools_concat_no_tbi {
|
||||
|
||||
input = [ [ id:'test3' ], // meta map
|
||||
[ file(params.test_data['sarscov2']['illumina']['test_vcf_gz'], checkIfExists: true),
|
||||
file(params.test_data['sarscov2']['illumina']['test2_vcf_gz'], checkIfExists: true) ],
|
||||
[]
|
||||
]
|
||||
|
||||
|
||||
BCFTOOLS_CONCAT ( input )
|
||||
}
|
||||
|
|
|
@ -1,8 +1,17 @@
|
|||
- name: bcftools concat test_bcftools_concat
|
||||
command: nextflow run ./tests/modules/bcftools/concat -entry test_bcftools_concat -c ./tests/config/nextflow.config -c ./tests/modules/bcftools/concat/nextflow.config
|
||||
- name: bcftools concat test_bcftools_concat_tbi
|
||||
command: nextflow run ./tests/modules/bcftools/concat -entry test_bcftools_concat_tbi -c ./tests/config/nextflow.config -c ./tests/modules/bcftools/concat/nextflow.config
|
||||
tags:
|
||||
- bcftools/concat
|
||||
- bcftools
|
||||
- bcftools/concat
|
||||
files:
|
||||
- path: output/bcftools/test3.vcf.gz
|
||||
md5sum: 35c88bfaad20101062e98beb217d7137
|
||||
|
||||
- name: bcftools concat test_bcftools_concat_no_tbi
|
||||
command: nextflow run ./tests/modules/bcftools/concat -entry test_bcftools_concat_no_tbi -c ./tests/config/nextflow.config -c ./tests/modules/bcftools/concat/nextflow.config
|
||||
tags:
|
||||
- bcftools
|
||||
- bcftools/concat
|
||||
files:
|
||||
- path: output/bcftools/test3.vcf.gz
|
||||
md5sum: 35c88bfaad20101062e98beb217d7137
|
||||
|
|
|
@ -12,7 +12,7 @@ workflow test_deeptools_bamcoverage_bam {
|
|||
file(params.test_data['homo_sapiens']['illumina']['test_paired_end_sorted_bam_bai'], checkIfExists: true)
|
||||
]
|
||||
|
||||
DEEPTOOLS_BAMCOVERAGE ( input )
|
||||
DEEPTOOLS_BAMCOVERAGE ( input, [], [] )
|
||||
}
|
||||
|
||||
workflow test_deeptools_bamcoverage_cram {
|
||||
|
@ -22,6 +22,20 @@ workflow test_deeptools_bamcoverage_cram {
|
|||
file(params.test_data['homo_sapiens']['illumina']['test_paired_end_sorted_cram'], checkIfExists: true),
|
||||
file(params.test_data['homo_sapiens']['illumina']['test_paired_end_sorted_cram_crai'], checkIfExists: true)
|
||||
]
|
||||
fasta = file(params.test_data['homo_sapiens']['genome']['genome_fasta'], checkIfExists: true)
|
||||
fasta_fai = file(params.test_data['homo_sapiens']['genome']['genome_fasta_fai'], checkIfExists: true)
|
||||
|
||||
DEEPTOOLS_BAMCOVERAGE ( input )
|
||||
DEEPTOOLS_BAMCOVERAGE ( input, fasta, fasta_fai)
|
||||
}
|
||||
|
||||
workflow test_deeptools_bamcoverage_cram_no_fasta_fai {
|
||||
|
||||
input = [
|
||||
[ id:'test', single_end:false ], // meta map
|
||||
file(params.test_data['homo_sapiens']['illumina']['test_paired_end_sorted_cram'], checkIfExists: true),
|
||||
file(params.test_data['homo_sapiens']['illumina']['test_paired_end_sorted_cram_crai'], checkIfExists: true)
|
||||
]
|
||||
fasta = file(params.test_data['homo_sapiens']['genome']['genome_fasta'], checkIfExists: true)
|
||||
|
||||
DEEPTOOLS_BAMCOVERAGE ( input, fasta, [])
|
||||
}
|
||||
|
|
|
@ -1,21 +1,26 @@
|
|||
- name: deeptools bamcoverage test_deeptools_bamcoverage_bam
|
||||
command: nextflow run tests/modules/deeptools/bamcoverage -entry test_deeptools_bamcoverage_bam -c tests/config/nextflow.config
|
||||
command: nextflow run ./tests/modules/deeptools/bamcoverage -entry test_deeptools_bamcoverage_bam -c ./tests/config/nextflow.config -c ./tests/modules/deeptools/bamcoverage/nextflow.config
|
||||
tags:
|
||||
- deeptools
|
||||
- deeptools/bamcoverage
|
||||
- deeptools
|
||||
files:
|
||||
- path: output/deeptools/test.bigWig
|
||||
md5sum: 95fe9383a9e6c02aea6b785cf074274f
|
||||
- path: output/deeptools/versions.yml
|
||||
md5sum: 68c94e73b7a8c0935578bad61fea54c1
|
||||
|
||||
- name: deeptools bamcoverage test_deeptools_bamcoverage_cram
|
||||
command: nextflow run tests/modules/deeptools/bamcoverage -entry test_deeptools_bamcoverage_cram -c tests/config/nextflow.config
|
||||
command: nextflow run ./tests/modules/deeptools/bamcoverage -entry test_deeptools_bamcoverage_cram -c ./tests/config/nextflow.config -c ./tests/modules/deeptools/bamcoverage/nextflow.config
|
||||
tags:
|
||||
- deeptools
|
||||
- deeptools/bamcoverage
|
||||
- deeptools
|
||||
files:
|
||||
- path: output/deeptools/test.bigWig
|
||||
md5sum: 95fe9383a9e6c02aea6b785cf074274f
|
||||
|
||||
- name: deeptools bamcoverage test_deeptools_bamcoverage_cram_no_fasta_fai
|
||||
command: nextflow run ./tests/modules/deeptools/bamcoverage -entry test_deeptools_bamcoverage_cram_no_fasta_fai -c ./tests/config/nextflow.config -c ./tests/modules/deeptools/bamcoverage/nextflow.config
|
||||
tags:
|
||||
- deeptools/bamcoverage
|
||||
- deeptools
|
||||
files:
|
||||
- path: output/deeptools/test.bigWig
|
||||
md5sum: 95fe9383a9e6c02aea6b785cf074274f
|
||||
- path: output/deeptools/versions.yml
|
||||
md5sum: 665bbd2979c49bf3974a24bd44a88e94
|
||||
|
|
|
@ -2,4 +2,7 @@ process {
|
|||
|
||||
publishDir = { "${params.outdir}/${task.process.tokenize(':')[-1].tokenize('_')[0].toLowerCase()}" }
|
||||
|
||||
ext.args = "--min_length 10"
|
||||
ext.prefix = "test_lr"
|
||||
|
||||
}
|
||||
|
|
|
@ -1,23 +1,26 @@
|
|||
- name: filtlong test_filtlong
|
||||
command: nextflow run ./tests/modules/filtlong -entry test_filtlong -c ./tests/config/nextflow.config -c ./tests/modules/filtlong/nextflow.config
|
||||
command: nextflow run ./tests/modules/filtlong -entry test_filtlong -c ./tests/config/nextflow.config -c ./tests/modules/filtlong/nextflow.config
|
||||
tags:
|
||||
- filtlong
|
||||
files:
|
||||
- path: output/filtlong/test_lr_filtlong.fastq.gz
|
||||
md5sum: 7029066c27ac6f5ef18d660d5741979a
|
||||
- path: output/filtlong/test_lr.fastq.gz
|
||||
contains:
|
||||
- "@00068f7a-51b3-4933-8fc6-7d6e29181ff9"
|
||||
|
||||
- name: filtlong test_filtlong_illumina_se
|
||||
command: nextflow run ./tests/modules/filtlong -entry test_filtlong_illumina_se -c ./tests/config/nextflow.config -c ./tests/modules/filtlong/nextflow.config
|
||||
command: nextflow run ./tests/modules/filtlong -entry test_filtlong_illumina_se -c ./tests/config/nextflow.config -c ./tests/modules/filtlong/nextflow.config
|
||||
tags:
|
||||
- filtlong
|
||||
files:
|
||||
- path: output/filtlong/test_lr_filtlong.fastq.gz
|
||||
md5sum: 7029066c27ac6f5ef18d660d5741979a
|
||||
- path: output/filtlong/test_lr.fastq.gz
|
||||
contains:
|
||||
- "@00068f7a-51b3-4933-8fc6-7d6e29181ff9"
|
||||
|
||||
- name: filtlong test_filtlong_illumina_pe
|
||||
command: nextflow run ./tests/modules/filtlong -entry test_filtlong_illumina_pe -c ./tests/config/nextflow.config -c ./tests/modules/filtlong/nextflow.config
|
||||
command: nextflow run ./tests/modules/filtlong -entry test_filtlong_illumina_pe -c ./tests/config/nextflow.config -c ./tests/modules/filtlong/nextflow.config
|
||||
tags:
|
||||
- filtlong
|
||||
files:
|
||||
- path: output/filtlong/test_lr_filtlong.fastq.gz
|
||||
md5sum: 7029066c27ac6f5ef18d660d5741979a
|
||||
- path: output/filtlong/test_lr.fastq.gz
|
||||
contains:
|
||||
- "@00068f7a-51b3-4933-8fc6-7d6e29181ff9"
|
||||
|
|
16
tests/modules/gatk4/composestrtablefile/main.nf
Normal file
16
tests/modules/gatk4/composestrtablefile/main.nf
Normal file
|
@ -0,0 +1,16 @@
|
|||
#!/usr/bin/env nextflow
|
||||
|
||||
nextflow.enable.dsl = 2
|
||||
|
||||
include { GATK4_COMPOSESTRTABLEFILE } from '../../../../modules/gatk4/composestrtablefile/main.nf'
|
||||
|
||||
workflow test_gatk4_composestrtablefile {
|
||||
|
||||
fasta = file(params.test_data['homo_sapiens']['genome']['genome_fasta'], checkIfExists: true)
|
||||
|
||||
fasta_fai = file(params.test_data['homo_sapiens']['genome']['genome_fasta_fai'], checkIfExists: true)
|
||||
|
||||
dict = file(params.test_data['homo_sapiens']['genome']['genome_dict'], checkIfExists: true)
|
||||
|
||||
GATK4_COMPOSESTRTABLEFILE ( fasta, fasta_fai, dict )
|
||||
}
|
5
tests/modules/gatk4/composestrtablefile/nextflow.config
Normal file
5
tests/modules/gatk4/composestrtablefile/nextflow.config
Normal file
|
@ -0,0 +1,5 @@
|
|||
process {
|
||||
|
||||
publishDir = { "${params.outdir}/${task.process.tokenize(':')[-1].tokenize('_')[0].toLowerCase()}" }
|
||||
|
||||
}
|
7
tests/modules/gatk4/composestrtablefile/test.yml
Normal file
7
tests/modules/gatk4/composestrtablefile/test.yml
Normal file
|
@ -0,0 +1,7 @@
|
|||
- name: gatk4 composestrtablefile test_gatk4_composestrtablefile
|
||||
command: nextflow run ./tests/modules/gatk4/composestrtablefile -entry test_gatk4_composestrtablefile -c ./tests/config/nextflow.config -c ./tests/modules/gatk4/composestrtablefile/nextflow.config
|
||||
tags:
|
||||
- gatk4/composestrtablefile
|
||||
- gatk4
|
||||
files:
|
||||
- path: output/gatk4/genome.zip
|
|
@ -6,6 +6,8 @@
|
|||
files:
|
||||
- path: output/gatk4/test.vcf.gz
|
||||
md5sum: 5b289bda88d3a3504f2e19ee8cff177c
|
||||
- path: output/gatk4/test.vcf.gz.tbi
|
||||
md5sum: a81673763b13086cfce9a23e72a35a16
|
||||
- path: output/gatk4/versions.yml
|
||||
|
||||
- name: gatk4 mergevcfs test_gatk4_mergevcfs_no_dict
|
||||
|
|
25
tests/modules/vsearch/usearchglobal/main.nf
Normal file
25
tests/modules/vsearch/usearchglobal/main.nf
Normal file
|
@ -0,0 +1,25 @@
|
|||
#!/usr/bin/env nextflow
|
||||
|
||||
nextflow.enable.dsl = 2
|
||||
|
||||
include { VSEARCH_USEARCHGLOBAL } from '../../../../modules/vsearch/usearchglobal/main.nf'
|
||||
|
||||
workflow test_vsearch_usearchglobal {
|
||||
|
||||
query = file(params.test_data['sarscov2']['genome']['transcriptome_fasta'], checkIfExists: true)
|
||||
db = file(params.test_data['sarscov2']['genome']['genome_fasta'], checkIfExists: true)
|
||||
idcutoff = 0.985
|
||||
outoption = "xcfert" // Nonsense text to check default case.
|
||||
columns = ""
|
||||
VSEARCH_USEARCHGLOBAL ( [[id:'test'], query], db, idcutoff, outoption, columns )
|
||||
}
|
||||
|
||||
workflow test_vsearch_usearchglobal_userout {
|
||||
|
||||
query = file(params.test_data['sarscov2']['genome']['transcriptome_fasta'], checkIfExists: true)
|
||||
db = file(params.test_data['sarscov2']['genome']['genome_fasta'], checkIfExists: true)
|
||||
idcutoff = 0.985
|
||||
outoption = "userout"
|
||||
columns = "query+target+id"
|
||||
VSEARCH_USEARCHGLOBAL ( [[id:'test'], query], db, idcutoff, outoption, columns )
|
||||
}
|
4
tests/modules/vsearch/usearchglobal/nextflow.config
Normal file
4
tests/modules/vsearch/usearchglobal/nextflow.config
Normal file
|
@ -0,0 +1,4 @@
|
|||
process {
|
||||
publishDir = { "${params.outdir}/${task.process.tokenize(':')[-1].tokenize('_')[0].toLowerCase()}" }
|
||||
}
|
||||
|
26
tests/modules/vsearch/usearchglobal/test.yml
Normal file
26
tests/modules/vsearch/usearchglobal/test.yml
Normal file
|
@ -0,0 +1,26 @@
|
|||
- name: vsearch usearchglobal test_vsearch_usearchglobal
|
||||
command: nextflow run ./tests/modules/vsearch/usearchglobal -entry test_vsearch_usearchglobal -c ./tests/config/nextflow.config -c ./tests/modules/vsearch/usearchglobal/nextflow.config
|
||||
tags:
|
||||
- vsearch/usearchglobal
|
||||
- vsearch
|
||||
files:
|
||||
- path: output/vsearch/test.aln
|
||||
contains:
|
||||
- "vsearch --usearch_global transcriptome.fasta --db genome.fasta --id 0.985 --threads 2 --alnout test.aln"
|
||||
- "Query >lcl|MT192765.1_cds_QIK50427.1_2"
|
||||
- "%Id TLen Target"
|
||||
- "100% 29829 MT192765.1"
|
||||
- "Query 3822nt >lcl|MT192765.1_cds_QIK50427.1_2"
|
||||
- "Target 29829nt >MT192765.1"
|
||||
- "Qry 21249 + CAACAGAGTTGTTATTTCTAGTGATGTTCTTGTTAACAACTAA 21291"
|
||||
- "Tgt 21506 + CAACAGAGTTGTTATTTCTAGTGATGTTCTTGTTAACAACTAA 21548"
|
||||
- "21291 cols, 21290 ids (100.0%), 1 gaps (0.0%)"
|
||||
|
||||
- name: vsearch usearchglobal test_vsearch_usearchglobal_userout
|
||||
command: nextflow run ./tests/modules/vsearch/usearchglobal -entry test_vsearch_usearchglobal_userout -c ./tests/config/nextflow.config -c ./tests/modules/vsearch/usearchglobal/nextflow.config
|
||||
tags:
|
||||
- vsearch/usearchglobal
|
||||
- vsearch
|
||||
files:
|
||||
- path: output/vsearch/test.tsv
|
||||
md5sum: b6cc50f7c8d18cb82e74dab70ed4baab
|
Loading…
Reference in a new issue