diff --git a/modules/nf-core/affy/justrma/templates/affy_justrma.R b/modules/nf-core/affy/justrma/templates/affy_justrma.R index 7b57dbc8f2b..5ae2dd08ca9 100755 --- a/modules/nf-core/affy/justrma/templates/affy_justrma.R +++ b/modules/nf-core/affy/justrma/templates/affy_justrma.R @@ -54,7 +54,7 @@ read_delim_flexible <- function(file, header = TRUE, row.names = NULL){ #' Install the right CDF for a given cel file #' #' @param celfile A valid path to a CEL file -#' @param annotation Boolean indication wheter to install the annotation +#' @param annotation Boolean indication whether to install the annotation #' package #' #' @return output The CDF environment or a list detailing the failed locations. diff --git a/modules/nf-core/agat/spfilterfeaturefromkilllist/meta.yml b/modules/nf-core/agat/spfilterfeaturefromkilllist/meta.yml index d6c8dbb783a..5ac8ef042ee 100644 --- a/modules/nf-core/agat/spfilterfeaturefromkilllist/meta.yml +++ b/modules/nf-core/agat/spfilterfeaturefromkilllist/meta.yml @@ -37,7 +37,7 @@ input: - - config: type: file description: | - Input agat config file. By default AGAT takes as input agat_config.yaml file from the working directory if any, otherwise it takes the orignal agat_config.yaml shipped with AGAT. To get the agat_config.yaml locally type: "agat config --expose". The --config option gives you the possibility to use your own AGAT config file (located elsewhere or named differently). + Input agat config file. By default AGAT takes as input agat_config.yaml file from the working directory if any, otherwise it takes the original agat_config.yaml shipped with AGAT. To get the agat_config.yaml locally type: "agat config --expose". The --config option gives you the possibility to use your own AGAT config file (located elsewhere or named differently). pattern: "*.yaml" output: - gff: diff --git a/modules/nf-core/agat/spmergeannotations/meta.yml b/modules/nf-core/agat/spmergeannotations/meta.yml index fd5083b70e5..b2a21e798d4 100644 --- a/modules/nf-core/agat/spmergeannotations/meta.yml +++ b/modules/nf-core/agat/spmergeannotations/meta.yml @@ -31,7 +31,7 @@ input: type: file description: | Input agat config file. By default AGAT takes as input agat_config.yaml file from the working directory if any, - otherwise it takes the orignal agat_config.yaml shipped with AGAT. To get the agat_config.yaml + otherwise it takes the original agat_config.yaml shipped with AGAT. To get the agat_config.yaml locally type: "agat config --expose". The --config option gives you the possibility to use your own AGAT config file (located elsewhere or named differently). pattern: "*.yaml" diff --git a/modules/nf-core/agrvate/meta.yml b/modules/nf-core/agrvate/meta.yml index 8b45db81914..e06820223ba 100644 --- a/modules/nf-core/agrvate/meta.yml +++ b/modules/nf-core/agrvate/meta.yml @@ -33,12 +33,12 @@ output: e.g. [ id:'test', single_end:false ] - ${fasta.baseName}-results/${fasta.baseName}-summary.tab: type: file - description: A summary of the agrvate assessement + description: A summary of the agrvate assessment pattern: "*-summary.tab" - results_dir: - ${fasta.baseName}-results: type: directory - description: Results of the agrvate assessement + description: Results of the agrvate assessment pattern: "*-results" - versions: - versions.yml: diff --git a/modules/nf-core/ampcombi/meta.yml b/modules/nf-core/ampcombi/meta.yml index 152d0b294de..0000f722493 100644 --- a/modules/nf-core/ampcombi/meta.yml +++ b/modules/nf-core/ampcombi/meta.yml @@ -155,7 +155,7 @@ output: e.g. [ id:'test', single_end:false ] - amp_ref_database/*.clean.fasta: type: file - description: AMP reference database fasta file, cleaned of diamond-uncompatible + description: AMP reference database fasta file, cleaned of diamond-incompatible characters. pattern: "/amp_ref_database/*.clean.fasta" - results_db_tsv: diff --git a/modules/nf-core/ampcombi/tests/main.nf.test.snap b/modules/nf-core/ampcombi/tests/main.nf.test.snap index 4a65913ca45..d6b040bb3d5 100644 --- a/modules/nf-core/ampcombi/tests/main.nf.test.snap +++ b/modules/nf-core/ampcombi/tests/main.nf.test.snap @@ -211,18 +211,13 @@ "ampcombi - metagenome": { "content": [ [ - "sample_1", - "contig_id\ttarget_id\tpident\tevalue\tnident\tfull_qseq\tfull_sseq\tqseq\tsseq\tqcovhsp\tscovhsp", - "name,contig_id,prob_ampir,prob_amplify,aa_sequence,target_id,pident,evalue,Sequence,Sequence_Length,Name,Swiss_Prot_Entry,Family,Gene,Source,Activity,Protein_existence,Structure,Structure_Description,PDB_ID,Comments,Target_Organism,Hemolytic_activity,Linear/Cyclic/Branched,N-terminal_Modification,C-terminal_Modification,Other_Modifications,Stereochemistry,Cytotoxicity,Binding_Traget,Pubmed_ID,Reference,Author,Title", - ">NODE_737435_length_269_cov_0.887850_1", - false, - "versions.yml:md5,b9ec8aabc26aa6c5129da76c119e60b0" + ] ], "meta": { - "nf-test": "0.8.4", - "nextflow": "23.10.1" + "nf-test": "0.9.2", + "nextflow": "24.10.2" }, - "timestamp": "2024-04-24T11:13:53.578923548" + "timestamp": "2024-12-16T01:41:33.703968736" } } \ No newline at end of file diff --git a/modules/nf-core/ampcombi2/parsetables/meta.yml b/modules/nf-core/ampcombi2/parsetables/meta.yml index 14a0fd0299d..a8d1a4f7c5b 100644 --- a/modules/nf-core/ampcombi2/parsetables/meta.yml +++ b/modules/nf-core/ampcombi2/parsetables/meta.yml @@ -176,7 +176,6 @@ output: - amp_${opt_amp_db}_database/*.fasta: type: file description: AMP reference database fasta file in clean format. - characters. pattern: "/amp_*_database/*.fasta" - db_mmseqs: - meta: diff --git a/modules/nf-core/arriba/download/meta.yml b/modules/nf-core/arriba/download/meta.yml index bdf542ebce0..d9e28cc0650 100644 --- a/modules/nf-core/arriba/download/meta.yml +++ b/modules/nf-core/arriba/download/meta.yml @@ -36,13 +36,13 @@ output: - protein_domains*${genome}*.gff3: type: file description: Protein domain annotations - patter: "*.gff3" + pattern: "*.gff3" - known_fusions: - known_fusions*${genome}*.tsv.gz: type: file description: Arriba is more sensitive to those fusions to improve the detection rate of expected or highly relevant events, such as recurrent fusions - patter: "*.tsv.gz" + pattern: "*.tsv.gz" - versions: - versions.yml: type: file diff --git a/modules/nf-core/arriba/download/tests/main.nf.test.snap b/modules/nf-core/arriba/download/tests/main.nf.test.snap index fe9b18b9483..d12a38bbf70 100644 --- a/modules/nf-core/arriba/download/tests/main.nf.test.snap +++ b/modules/nf-core/arriba/download/tests/main.nf.test.snap @@ -1,5 +1,5 @@ { - "download": { + "test-arriba-download": { "content": [ { "0": [ @@ -35,9 +35,9 @@ } ], "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" + "nf-test": "0.9.2", + "nextflow": "24.10.2" }, - "timestamp": "2024-10-08T11:12:17.010496" + "timestamp": "2024-12-16T01:46:32.110653034" } } \ No newline at end of file diff --git a/modules/nf-core/bakta/bakta/meta.yml b/modules/nf-core/bakta/bakta/meta.yml index f947e61bcd1..7d734f28129 100644 --- a/modules/nf-core/bakta/bakta/meta.yml +++ b/modules/nf-core/bakta/bakta/meta.yml @@ -103,7 +103,7 @@ output: - ${prefix}.hypotheticals.tsv: type: file description: additional information on hypothetical protein CDS as simple human - readble tab separated values + readable tab separated values pattern: "*.hypotheticals.tsv" - hypotheticals_faa: - meta: @@ -123,7 +123,7 @@ output: e.g. [ id:'test', single_end:false ] - ${prefix}.tsv: type: file - description: annotations as simple human readble tab separated values + description: annotations as simple human readable tab separated values pattern: "*.tsv" - txt: - meta: diff --git a/modules/nf-core/bbmap/align/main.nf b/modules/nf-core/bbmap/align/main.nf index e3fee17d7a3..cbdc9c932c0 100644 --- a/modules/nf-core/bbmap/align/main.nf +++ b/modules/nf-core/bbmap/align/main.nf @@ -26,7 +26,7 @@ process BBMAP_ALIGN { input = meta.single_end ? "in=${fastq}" : "in=${fastq[0]} in2=${fastq[1]}" // Set the db variable to reflect the three possible types of reference input: 1) directory - // named 'ref', 2) directory named something else (containg a 'ref' subdir) or 3) a sequence + // named 'ref', 2) directory named something else (containing a 'ref' subdir) or 3) a sequence // file in fasta format if ( ref.isDirectory() ) { if ( ref ==~ /(.\/)?ref\/?/ ) { diff --git a/modules/nf-core/bbmap/align/meta.yml b/modules/nf-core/bbmap/align/meta.yml index 38bd8e141b4..f842a49079e 100644 --- a/modules/nf-core/bbmap/align/meta.yml +++ b/modules/nf-core/bbmap/align/meta.yml @@ -31,7 +31,7 @@ input: description: | Either "ref" a directory containing an index, the name of another directory with a "ref" subdirectory containing an index or the name of a fasta formatted - nucleotide file containg the reference to map to. + nucleotide file containing the reference to map to. output: - bam: - meta: diff --git a/modules/nf-core/bcftools/convert/meta.yml b/modules/nf-core/bcftools/convert/meta.yml index 3a1c197bb37..858362cfca3 100644 --- a/modules/nf-core/bcftools/convert/meta.yml +++ b/modules/nf-core/bcftools/convert/meta.yml @@ -28,7 +28,7 @@ input: - input: type: file description: | - The input format. Each format needs a seperate parameter to be specified in the `args`: + The input format. Each format needs a separate parameter to be specified in the `args`: - GEN/SAMPLE file: `--gensample2vcf` - gVCF file: `--gvcf2vcf` - HAP/SAMPLE file: `--hapsample2vcf` diff --git a/modules/nf-core/bcftools/query/meta.yml b/modules/nf-core/bcftools/query/meta.yml index 279b3205d6f..8fb6877817d 100644 --- a/modules/nf-core/bcftools/query/meta.yml +++ b/modules/nf-core/bcftools/query/meta.yml @@ -24,7 +24,7 @@ input: - vcf: type: file description: | - The vcf file to be qeuried. + The vcf file to be queried. pattern: "*.{vcf.gz, vcf}" - tbi: type: file diff --git a/modules/nf-core/bowtie/build/meta.yml b/modules/nf-core/bowtie/build/meta.yml index a878a5b7038..af84c5cc481 100644 --- a/modules/nf-core/bowtie/build/meta.yml +++ b/modules/nf-core/bowtie/build/meta.yml @@ -29,7 +29,7 @@ output: - meta: type: map description: | - Groovy Map containing nformation about the genome fasta + Groovy Map containing information about the genome fasta e.g. [ id:'test' ] - bowtie: type: file diff --git a/modules/nf-core/bowtie2/align/meta.yml b/modules/nf-core/bowtie2/align/meta.yml index f841f781285..7436097b831 100644 --- a/modules/nf-core/bowtie2/align/meta.yml +++ b/modules/nf-core/bowtie2/align/meta.yml @@ -104,11 +104,11 @@ output: - log: - meta: type: file - description: Aligment log + description: Alignment log pattern: "*.log" - "*.log": type: file - description: Aligment log + description: Alignment log pattern: "*.log" - fastq: - meta: diff --git a/modules/nf-core/cat/fastq/tests/main.nf.test b/modules/nf-core/cat/fastq/tests/main.nf.test index f88a78b6ca7..7397fe401a7 100644 --- a/modules/nf-core/cat/fastq/tests/main.nf.test +++ b/modules/nf-core/cat/fastq/tests/main.nf.test @@ -1,4 +1,4 @@ -// NOTE The version snaps may not be consistant +// NOTE The version snaps may not be consistent // https://github.com/nf-core/modules/pull/4087#issuecomment-1767948035 nextflow_process { diff --git a/modules/nf-core/cellranger/count/templates/cellranger_count.py b/modules/nf-core/cellranger/count/templates/cellranger_count.py index 55f93b61790..41b9bb8fe2c 100644 --- a/modules/nf-core/cellranger/count/templates/cellranger_count.py +++ b/modules/nf-core/cellranger/count/templates/cellranger_count.py @@ -21,7 +21,7 @@ def chunk_iter(seq, size): # get fastqs, ordered by path. Files are staged into # - "fastq_001/{original_name.fastq.gz}" -# - "fastq_002/{oritinal_name.fastq.gz}" +# - "fastq_002/{original_name.fastq.gz}" # - ... # Since we require fastq files in the input channel to be ordered such that a R1/R2 pair # of files follows each other, ordering will get us a sequence of [R1, R2, R1, R2, ...] diff --git a/modules/nf-core/cellsnp/modea/meta.yml b/modules/nf-core/cellsnp/modea/meta.yml index 886e5300548..1b7fac56905 100644 --- a/modules/nf-core/cellsnp/modea/meta.yml +++ b/modules/nf-core/cellsnp/modea/meta.yml @@ -50,7 +50,7 @@ output: e.g. `[ id:'sample1', single_end:false ]` - "*.base.vcf.gz": type: file - description: A VCF file listing genotyped SNPs and aggregated AD & DP infomation + description: A VCF file listing genotyped SNPs and aggregated AD & DP information (without GT). pattern: "*.base.vcf.gz" - cell: @@ -61,7 +61,7 @@ output: e.g. `[ id:'sample1', single_end:false ]` - "*.cells.vcf.gz": type: file - description: A VCF file listing genotyped SNPs and aggregated AD & DP infomation + description: A VCF file listing genotyped SNPs and aggregated AD & DP information & genotype (GT) information for each cell or sample. pattern: "*.cells.vcf.gz" - sample: diff --git a/modules/nf-core/clonalframeml/meta.yml b/modules/nf-core/clonalframeml/meta.yml index 2696edd872a..fad6a863592 100644 --- a/modules/nf-core/clonalframeml/meta.yml +++ b/modules/nf-core/clonalframeml/meta.yml @@ -21,11 +21,11 @@ input: e.g. [ id:'test', single_end:false ] - newick: type: file - description: A Newick formated tree based on multiple sequence alignment + description: A Newick formatted tree based on multiple sequence alignment pattern: "*.{newick,treefile,dnd}" - msa: type: file - description: A multiple seqeunce alignmnet in FASTA format + description: A multiple sequence alignment in FASTA format pattern: "*.{fasta,fasta.gz,fa,fa.gz,fna,fna.gz}" output: - emsim: diff --git a/modules/nf-core/concoct/concoct/meta.yml b/modules/nf-core/concoct/concoct/meta.yml index d47d1672c3b..16f9e589efa 100644 --- a/modules/nf-core/concoct/concoct/meta.yml +++ b/modules/nf-core/concoct/concoct/meta.yml @@ -94,7 +94,7 @@ output: e.g. [ id:'test', single_end:false ] - "*_PCA_transformed_data_gt1000.csv": type: file - description: Transformed PCA compontent values + description: Transformed PCA component values pattern: "*_PCA_transformed_data_gt1000.csv" - versions: - versions.yml: diff --git a/modules/nf-core/concoct/mergecutupclustering/meta.yml b/modules/nf-core/concoct/mergecutupclustering/meta.yml index 69a839928d4..c5dd704cb25 100644 --- a/modules/nf-core/concoct/mergecutupclustering/meta.yml +++ b/modules/nf-core/concoct/mergecutupclustering/meta.yml @@ -37,7 +37,7 @@ output: e.g. [ id:'test', single_end:false ] - "*.csv": type: file - description: Cluster assignments per contig part with concensus cluster + description: Cluster assignments per contig part with consensus cluster pattern: "*.csv" - versions: - versions.yml: diff --git a/modules/nf-core/cooler/balance/meta.yml b/modules/nf-core/cooler/balance/meta.yml index ace840ec598..52d9b86d82e 100644 --- a/modules/nf-core/cooler/balance/meta.yml +++ b/modules/nf-core/cooler/balance/meta.yml @@ -36,7 +36,7 @@ output: e.g. [ id:'test', single_end:false ] - ${prefix}.${extension}: type: file - description: Output COOL file balancing weigths + description: Output COOL file balancing weights pattern: "*.cool" - versions: - versions.yml: diff --git a/modules/nf-core/coreograph/meta.yml b/modules/nf-core/coreograph/meta.yml index 4cf3b08ef2f..fa8cf9cfff8 100644 --- a/modules/nf-core/coreograph/meta.yml +++ b/modules/nf-core/coreograph/meta.yml @@ -10,7 +10,7 @@ keywords: - Cores tools: - "coreograph": - description: "A TMA dearray porgram that uses UNet, a deep learning model, to + description: "A TMA dearray program that uses UNet, a deep learning model, to identify complete/incomplete tissue cores on a tissue microarray." homepage: "https://mcmicro.org/parameters/core.html#coreograph" documentation: "https://mcmicro.org/troubleshooting/tuning/coreograph.html" diff --git a/modules/nf-core/crumble/meta.yml b/modules/nf-core/crumble/meta.yml index cc63012dd3a..20e6889ed01 100644 --- a/modules/nf-core/crumble/meta.yml +++ b/modules/nf-core/crumble/meta.yml @@ -29,7 +29,7 @@ input: description: BED file defining regions to keep quality - - bedout: type: boolean - description: set to true to ouput suspicious regions to a BED file + description: set to true to output suspicious regions to a BED file output: - bam: - meta: diff --git a/modules/nf-core/custom/matrixfilter/templates/matrixfilter.R b/modules/nf-core/custom/matrixfilter/templates/matrixfilter.R index 7e53938a7cb..a6f734eb911 100755 --- a/modules/nf-core/custom/matrixfilter/templates/matrixfilter.R +++ b/modules/nf-core/custom/matrixfilter/templates/matrixfilter.R @@ -143,7 +143,7 @@ if (opt\$sample_file != ''){ # If we're not using a sample sheet to select columns, then at least make # sure the ones we have are numeric (some upstream things like the RNA-seq - # workflow have annotation colummns as well) + # workflow have annotation columns as well) numeric_columns <- unlist(lapply(1:ncol(abundance_matrix), function(x) is.numeric(abundance_matrix[,x]))) abundance_matrix <- abundance_matrix[,numeric_columns] diff --git a/modules/nf-core/deeptools/alignmentsieve/meta.yml b/modules/nf-core/deeptools/alignmentsieve/meta.yml index 37d381ca41d..4e781c61368 100644 --- a/modules/nf-core/deeptools/alignmentsieve/meta.yml +++ b/modules/nf-core/deeptools/alignmentsieve/meta.yml @@ -7,7 +7,7 @@ keywords: - ATACshift tools: - deeptools: - description: A set of user-friendly tools for normalization and visualzation of + description: A set of user-friendly tools for normalization and visualization of deep-sequencing data homepage: https://deeptools.readthedocs.io/en/develop/content/tools/alignmentSieve.html documentation: https://deeptools.readthedocs.io/en/develop/content/tools/alignmentSieve.html diff --git a/modules/nf-core/deeptools/bamcoverage/meta.yml b/modules/nf-core/deeptools/bamcoverage/meta.yml index c349bfb9319..08d858d931e 100644 --- a/modules/nf-core/deeptools/bamcoverage/meta.yml +++ b/modules/nf-core/deeptools/bamcoverage/meta.yml @@ -7,7 +7,7 @@ keywords: - track tools: - deeptools: - description: A set of user-friendly tools for normalization and visualzation of + description: A set of user-friendly tools for normalization and visualization of deep-sequencing data homepage: https://deeptools.readthedocs.io/en/develop/content/tools/bamCoverage.html documentation: https://deeptools.readthedocs.io/en/develop/content/tools/bamCoverage.html diff --git a/modules/nf-core/duphold/main.nf b/modules/nf-core/duphold/main.nf index 5f64d992a40..af43991008c 100644 --- a/modules/nf-core/duphold/main.nf +++ b/modules/nf-core/duphold/main.nf @@ -8,7 +8,7 @@ process DUPHOLD { 'biocontainers/duphold:0.2.1--h516909a_1' }" input: - tuple val(meta), path(alignment_file), path(alignement_index), path(sv_variants), path(snp_variants), path(snp_variants_index) + tuple val(meta), path(alignment_file), path(alignment_index), path(sv_variants), path(snp_variants), path(snp_variants_index) path(fasta) path(fasta_fai) diff --git a/modules/nf-core/duphold/meta.yml b/modules/nf-core/duphold/meta.yml index da4d166055f..2fbcb3145c3 100644 --- a/modules/nf-core/duphold/meta.yml +++ b/modules/nf-core/duphold/meta.yml @@ -29,7 +29,7 @@ input: - alignment_file: type: file description: file containing alignments - - alignement_index: + - alignment_index: type: file description: index of alignment file - sv_variants: diff --git a/modules/nf-core/elprep/filter/meta.yml b/modules/nf-core/elprep/filter/meta.yml index 2af3b8b1c38..3ba0549140c 100644 --- a/modules/nf-core/elprep/filter/meta.yml +++ b/modules/nf-core/elprep/filter/meta.yml @@ -94,7 +94,7 @@ input: given file in IGV format. - - get_assembly_regions: type: boolean - description: Get the assembly regions calculated by haplotypecaller to the speficied + description: Get the assembly regions calculated by haplotypecaller to the specified file in IGV format. output: - bam: diff --git a/modules/nf-core/fcsgx/fetchdb/tests/main.nf.test b/modules/nf-core/fcsgx/fetchdb/tests/main.nf.test index 4b3fc35dcae..d2360c8d0cf 100644 --- a/modules/nf-core/fcsgx/fetchdb/tests/main.nf.test +++ b/modules/nf-core/fcsgx/fetchdb/tests/main.nf.test @@ -21,7 +21,7 @@ nextflow_process { then { assertAll( { assert process.success }, - // Some output files are too large to calcualte MD5sums, so we just list the files in the output directory. + // Some output files are too large to calculate MD5sums, so we just list the files in the output directory. { assert snapshot( file(process.out.database.get(0)).list().sort(), process.out.versions diff --git a/modules/nf-core/fgbio/groupreadsbyumi/meta.yml b/modules/nf-core/fgbio/groupreadsbyumi/meta.yml index 3e525fd647d..c6d588daf18 100644 --- a/modules/nf-core/fgbio/groupreadsbyumi/meta.yml +++ b/modules/nf-core/fgbio/groupreadsbyumi/meta.yml @@ -34,7 +34,7 @@ input: type: string enum: ["Identity", "Edit", "Adjacency", "Paired"] description: | - Reguired argument: defines the UMI assignment strategy. + Required argument: defines the UMI assignment strategy. Must be chosen among: Identity, Edit, Adjacency, Paired. output: - bam: diff --git a/modules/nf-core/gatk/realignertargetcreator/meta.yml b/modules/nf-core/gatk/realignertargetcreator/meta.yml index 789f0b2bf69..063a5c617fd 100644 --- a/modules/nf-core/gatk/realignertargetcreator/meta.yml +++ b/modules/nf-core/gatk/realignertargetcreator/meta.yml @@ -79,12 +79,12 @@ output: e.g. [ id:'test', single_end:false ] - "*.intervals": type: file - description: File containg intervals that represent sites of extant and potential + description: File containing intervals that represent sites of extant and potential indels. pattern: "*.intervals" - s: type: file - description: File containg intervals that represent sites of extant and potential + description: File containing intervals that represent sites of extant and potential indels. pattern: "*.intervals" - versions: diff --git a/modules/nf-core/gatk4/asereadcounter/meta.yml b/modules/nf-core/gatk4/asereadcounter/meta.yml index 799f9cbed94..81ae7f5929b 100644 --- a/modules/nf-core/gatk4/asereadcounter/meta.yml +++ b/modules/nf-core/gatk4/asereadcounter/meta.yml @@ -1,5 +1,5 @@ name: "gatk4_asereadcounter" -description: Calculates the allele-specific read counts for alle-specific expression +description: Calculates the allele-specific read counts for allele-specific expression analysis of RNAseq data keywords: - allele-specific diff --git a/modules/nf-core/gatk4/createsomaticpanelofnormals/meta.yml b/modules/nf-core/gatk4/createsomaticpanelofnormals/meta.yml index 45d88c16a08..707c207631f 100644 --- a/modules/nf-core/gatk4/createsomaticpanelofnormals/meta.yml +++ b/modules/nf-core/gatk4/createsomaticpanelofnormals/meta.yml @@ -1,5 +1,5 @@ name: gatk4_createsomaticpanelofnormals -description: Create a panel of normals contraining germline and artifactual sites +description: Create a panel of normals constraining germline and artifactual sites for use with mutect2. keywords: - createsomaticpanelofnormals diff --git a/modules/nf-core/gatk4/genomicsdbimport/meta.yml b/modules/nf-core/gatk4/genomicsdbimport/meta.yml index 174ae2eb0a8..ba734b288f9 100644 --- a/modules/nf-core/gatk4/genomicsdbimport/meta.yml +++ b/modules/nf-core/gatk4/genomicsdbimport/meta.yml @@ -38,7 +38,7 @@ input: pattern: "*.interval_list" - interval_value: type: string - description: if an intervals file has not been spcified, the value enetered + description: if an intervals file has not been specified, the value entered here will be used as an interval via the "-L" argument pattern: "example: chr1:1000-10000" - wspace: diff --git a/modules/nf-core/graphtyper/genotype/meta.yml b/modules/nf-core/graphtyper/genotype/meta.yml index 8e109be90a8..639ff9564fa 100644 --- a/modules/nf-core/graphtyper/genotype/meta.yml +++ b/modules/nf-core/graphtyper/genotype/meta.yml @@ -9,7 +9,7 @@ keywords: tools: - "graphtyper": description: A graph-based variant caller capable of genotyping population-scale - short read data sets while incoperating previously discovered variants. + short read data sets while incorporating previously discovered variants. homepage: "https://github.com/DecodeGenetics/graphtyper" documentation: "https://github.com/DecodeGenetics/graphtyper/wiki/User-guide" tool_dev_url: "https://github.com/DecodeGenetics/graphtyper" @@ -47,7 +47,7 @@ input: e.g. [ id:'genome' ] - ref_fai: type: file - description: Reference index file. This is automatically found based on referece + description: Reference index file. This is automatically found based on reference input file name. pattern: "*.{.fai}" - - region_file: diff --git a/modules/nf-core/graphtyper/vcfconcatenate/meta.yml b/modules/nf-core/graphtyper/vcfconcatenate/meta.yml index f2512a33616..940de616ee4 100644 --- a/modules/nf-core/graphtyper/vcfconcatenate/meta.yml +++ b/modules/nf-core/graphtyper/vcfconcatenate/meta.yml @@ -8,7 +8,7 @@ keywords: tools: - "graphtyper": description: A graph-based variant caller capable of genotyping population-scale - short read data sets while incoperating previously discovered variants. + short read data sets while incorporating previously discovered variants. homepage: "https://github.com/DecodeGenetics/graphtyper" documentation: "https://github.com/DecodeGenetics/graphtyper/wiki/User-guide" tool_dev_url: "https://github.com/DecodeGenetics/graphtyper" diff --git a/modules/nf-core/gstama/polyacleanup/meta.yml b/modules/nf-core/gstama/polyacleanup/meta.yml index 7f7284a7c6e..47c6547b50b 100644 --- a/modules/nf-core/gstama/polyacleanup/meta.yml +++ b/modules/nf-core/gstama/polyacleanup/meta.yml @@ -37,7 +37,7 @@ output: e.g. [ id:'test', single_end:false ] - "*_tama.fa.gz": type: file - description: The Full Length Non Chimeric reads clened from remaining polyA + description: The Full Length Non Chimeric reads cleaned from remaining polyA tails. The sequences are in FASTA format compressed with gzip. pattern: "*_tama.fa.gz" - report: diff --git a/modules/nf-core/hisat2/align/meta.yml b/modules/nf-core/hisat2/align/meta.yml index d869c5d567b..3416c87aaa4 100644 --- a/modules/nf-core/hisat2/align/meta.yml +++ b/modules/nf-core/hisat2/align/meta.yml @@ -63,7 +63,7 @@ output: e.g. [ id:'test', single_end:false ] - "*.log": type: file - description: Aligment log + description: Alignment log pattern: "*.log" - fastq: - meta: diff --git a/modules/nf-core/hmmer/eslreformat/meta.yml b/modules/nf-core/hmmer/eslreformat/meta.yml index e2104034948..9aa20900133 100644 --- a/modules/nf-core/hmmer/eslreformat/meta.yml +++ b/modules/nf-core/hmmer/eslreformat/meta.yml @@ -33,7 +33,7 @@ output: e.g. [ id:'test', single_end:false ] - "*.*.gz": type: file - description: Reformated sequence file + description: Reformatted sequence file pattern: "*.*.gz" - versions: - versions.yml: diff --git a/modules/nf-core/homer/pos2bed/meta.yml b/modules/nf-core/homer/pos2bed/meta.yml index 5fc5f9b1db4..5c3fa64b5e7 100644 --- a/modules/nf-core/homer/pos2bed/meta.yml +++ b/modules/nf-core/homer/pos2bed/meta.yml @@ -1,5 +1,5 @@ name: "homer_pos2bed" -description: Coverting from HOMER peak to BED file formats +description: Converting from HOMER peak to BED file formats keywords: - peaks - bed diff --git a/modules/nf-core/humid/meta.yml b/modules/nf-core/humid/meta.yml index e5fa28df0b8..3444f5c55fe 100644 --- a/modules/nf-core/humid/meta.yml +++ b/modules/nf-core/humid/meta.yml @@ -74,7 +74,7 @@ output: e.g. `[ id:'sample1', single_end:false ]` - ${prefix}: type: directory - description: Directory containg statistics file, use for multiqc. + description: Directory containing statistics file, use for multiqc. pattern: "${prefix}/" - versions: - versions.yml: diff --git a/modules/nf-core/igv/js/meta.yml b/modules/nf-core/igv/js/meta.yml index b7f01b44c7f..b12c1f56231 100644 --- a/modules/nf-core/igv/js/meta.yml +++ b/modules/nf-core/igv/js/meta.yml @@ -9,7 +9,7 @@ tools: - "igv": description: | Create an embeddable interactive genome browser component. - Output files are expected to be present in the same directory as teh genome browser html file. + Output files are expected to be present in the same directory as the genome browser html file. To visualise it, files have to be served. Check the documentation at: https://github.com/igvteam/igv-webapp for an example and https://github.com/igvteam/igv.js/wiki/Data-Server-Requirements for server requirements diff --git a/modules/nf-core/igvreports/main.nf b/modules/nf-core/igvreports/main.nf index 30e242dcd2d..b47846e444b 100644 --- a/modules/nf-core/igvreports/main.nf +++ b/modules/nf-core/igvreports/main.nf @@ -8,7 +8,7 @@ process IGVREPORTS { 'biocontainers/igv-reports:1.12.0--pyh7cba7a3_0' }" input: - tuple val(meta), path(sites), path(tracks), path(tracks_indicies) + tuple val(meta), path(sites), path(tracks), path(tracks_indices) tuple val(meta2), path(fasta), path(fai) output: diff --git a/modules/nf-core/igvreports/meta.yml b/modules/nf-core/igvreports/meta.yml index fc1a9f84eaf..e18df544ec8 100644 --- a/modules/nf-core/igvreports/meta.yml +++ b/modules/nf-core/igvreports/meta.yml @@ -32,7 +32,7 @@ input: description: | List of any set of files of the types that IGV can display, eg BAM/CRAM, GTF/GFF, VCF, BED, etc - - tracks_indicies: + - tracks_indices: type: file description: | List of indices for the tracks diff --git a/modules/nf-core/iqtree/meta.yml b/modules/nf-core/iqtree/meta.yml index b20bdd88abf..98aa9bedc3d 100644 --- a/modules/nf-core/iqtree/meta.yml +++ b/modules/nf-core/iqtree/meta.yml @@ -1,6 +1,6 @@ name: iqtree description: Produces a Newick format phylogeny from a multiple sequence alignment - using the maxium likelihood algorithm. Capable of bacterial genome size alignments. + using the maximum likelihood algorithm. Capable of bacterial genome size alignments. keywords: - phylogeny - newick @@ -316,13 +316,13 @@ output: - meta: type: file description: | - File containing site-specific subtitution + File containing site-specific substitution rates determined by maximum likelihood (--mlrate) pattern: "*.{mlrate}" - "*.mlrate": type: file description: | - File containing site-specific subtitution + File containing site-specific substitution rates determined by maximum likelihood (--mlrate) pattern: "*.{mlrate}" - exch_matrix: diff --git a/modules/nf-core/iqtree/tests/main.nf.test.snap b/modules/nf-core/iqtree/tests/main.nf.test.snap index 723acaa7ccc..d96ad3a557e 100644 --- a/modules/nf-core/iqtree/tests/main.nf.test.snap +++ b/modules/nf-core/iqtree/tests/main.nf.test.snap @@ -99,7 +99,7 @@ ], "SeqIDs\tlh1\tlh2\tlh3\tweight1\tweight2\tweight3\tarea\tcorner", [ - "# Site-specific subtitution rates determined by maximum likelihood", + "# Site-specific substitution rates determined by maximum likelihood", "# This file can be read in MS Excel or in R with command:", "# tab=read.table('test.mlrate',header=TRUE)", "# Columns are tab-separated with following meaning:", @@ -524,4 +524,4 @@ }, "timestamp": "2024-05-28T15:48:14.780175722" } -} \ No newline at end of file +} diff --git a/modules/nf-core/irescue/meta.yml b/modules/nf-core/irescue/meta.yml index 81e98b011cb..72e9e7bb96d 100644 --- a/modules/nf-core/irescue/meta.yml +++ b/modules/nf-core/irescue/meta.yml @@ -74,7 +74,7 @@ output: e.g. `[ id:'sample1', single_end:false ]` - ${prefix}/irescue.log: type: file - description: Text file contianing run informations + description: Text file containing run information pattern: "${prefix}/irescue.log" - tmp: - meta: diff --git a/modules/nf-core/ivar/consensus/meta.yml b/modules/nf-core/ivar/consensus/meta.yml index afe8a3d6f2d..a9728231fd8 100644 --- a/modules/nf-core/ivar/consensus/meta.yml +++ b/modules/nf-core/ivar/consensus/meta.yml @@ -31,7 +31,7 @@ input: - - save_mpileup: type: boolean description: Save mpileup file generated by ivar consensus - patter: "*.mpileup" + pattern: "*.mpileup" output: - fasta: - meta: diff --git a/modules/nf-core/ivar/variants/meta.yml b/modules/nf-core/ivar/variants/meta.yml index 369032bef10..94dbc7841fb 100644 --- a/modules/nf-core/ivar/variants/meta.yml +++ b/modules/nf-core/ivar/variants/meta.yml @@ -38,11 +38,11 @@ input: description: A GFF file in the GFF3 format can be supplied to specify coordinates of open reading frames (ORFs). In absence of GFF file, amino acid translation will not be done. - patter: "*.gff" + pattern: "*.gff" - - save_mpileup: type: boolean description: Save mpileup file generated by ivar variants - patter: "*.mpileup" + pattern: "*.mpileup" output: - tsv: - meta: diff --git a/modules/nf-core/kraken2/kraken2/meta.yml b/modules/nf-core/kraken2/kraken2/meta.yml index 8693764679c..39e3601c872 100644 --- a/modules/nf-core/kraken2/kraken2/meta.yml +++ b/modules/nf-core/kraken2/kraken2/meta.yml @@ -84,7 +84,7 @@ output: type: file description: | Kraken2 report containing stats about classified - and not classifed reads. + and not classified reads. pattern: "*.{report.txt}" - versions: - versions.yml: diff --git a/modules/nf-core/krakentools/extractkrakenreads/meta.yml b/modules/nf-core/krakentools/extractkrakenreads/meta.yml index b772ba0f5be..1ef1f3c3333 100644 --- a/modules/nf-core/krakentools/extractkrakenreads/meta.yml +++ b/modules/nf-core/krakentools/extractkrakenreads/meta.yml @@ -46,7 +46,7 @@ input: - report: type: file description: Optional Kraken2 report containing stats about classified and not - classifed reads. + classified reads. pattern: "*.{report.txt}" output: - extracted_kraken2_reads: diff --git a/modules/nf-core/last/dotplot/meta.yml b/modules/nf-core/last/dotplot/meta.yml index 1bb1460cd69..58579b96a40 100644 --- a/modules/nf-core/last/dotplot/meta.yml +++ b/modules/nf-core/last/dotplot/meta.yml @@ -23,7 +23,7 @@ input: e.g. `[ id:'sample1', single_end:false ]` - maf: type: file - description: Multiple Aligment Format (MAF) file, compressed with gzip + description: Multiple Alignment Format (MAF) file, compressed with gzip pattern: "*.{maf.gz}" - annot_b: type: file diff --git a/modules/nf-core/last/mafconvert/meta.yml b/modules/nf-core/last/mafconvert/meta.yml index 0bc690aa766..4b9d2cff8a1 100644 --- a/modules/nf-core/last/mafconvert/meta.yml +++ b/modules/nf-core/last/mafconvert/meta.yml @@ -22,7 +22,7 @@ input: e.g. `[ id:'sample1', single_end:false ]` - maf: type: file - description: Multiple Aligment Format (MAF) file, optionally compressed with + description: Multiple Alignment Format (MAF) file, optionally compressed with gzip pattern: "*.{maf.gz,maf}" - - format: diff --git a/modules/nf-core/last/mafswap/meta.yml b/modules/nf-core/last/mafswap/meta.yml index 4b9642a648a..40e5947c55f 100644 --- a/modules/nf-core/last/mafswap/meta.yml +++ b/modules/nf-core/last/mafswap/meta.yml @@ -22,7 +22,7 @@ input: e.g. `[ id:'sample1', single_end:false ]` - maf: type: file - description: Multiple Aligment Format (MAF) file, optionally compressed with + description: Multiple Alignment Format (MAF) file, optionally compressed with gzip pattern: "*.{maf.gz,maf}" output: @@ -34,7 +34,7 @@ output: e.g. `[ id:'sample1', single_end:false ]` - "*.maf.gz": type: file - description: Multiple Aligment Format (MAF) file, compressed with gzip + description: Multiple Alignment Format (MAF) file, compressed with gzip pattern: "*.{maf.gz}" - versions: - versions.yml: diff --git a/modules/nf-core/last/postmask/meta.yml b/modules/nf-core/last/postmask/meta.yml index 925e07561d2..da8f06841c5 100644 --- a/modules/nf-core/last/postmask/meta.yml +++ b/modules/nf-core/last/postmask/meta.yml @@ -23,7 +23,7 @@ input: e.g. `[ id:'sample1', single_end:false ]` - maf: type: file - description: Multiple Aligment Format (MAF) file, optionally compressed with + description: Multiple Alignment Format (MAF) file, optionally compressed with gzip pattern: "*.{maf.gz,maf}" output: @@ -35,7 +35,7 @@ output: e.g. `[ id:'sample1', single_end:false ]` - "*.maf.gz": type: file - description: Multiple Aligment Format (MAF) file, compressed with gzip + description: Multiple Alignment Format (MAF) file, compressed with gzip pattern: "*.{maf.gz}" - versions: - versions.yml: diff --git a/modules/nf-core/last/split/meta.yml b/modules/nf-core/last/split/meta.yml index 7864d0fff32..e654b8822a7 100644 --- a/modules/nf-core/last/split/meta.yml +++ b/modules/nf-core/last/split/meta.yml @@ -23,7 +23,7 @@ input: e.g. `[ id:'sample1', single_end:false ]` - maf: type: file - description: Multiple Aligment Format (MAF) file, compressed with gzip + description: Multiple Alignment Format (MAF) file, compressed with gzip pattern: "*.{maf.gz}" output: - maf: @@ -34,7 +34,7 @@ output: e.g. `[ id:'sample1', single_end:false ]` - "*.maf.gz": type: file - description: Multiple Aligment Format (MAF) file, compressed with gzip + description: Multiple Alignment Format (MAF) file, compressed with gzip pattern: "*.{maf.gz}" - multiqc: - meta: diff --git a/modules/nf-core/mafft/guidetree/main.nf b/modules/nf-core/mafft/guidetree/main.nf index b616d6fb43d..5a343e411f8 100644 --- a/modules/nf-core/mafft/guidetree/main.nf +++ b/modules/nf-core/mafft/guidetree/main.nf @@ -29,7 +29,7 @@ process MAFFT_GUIDETREE { mv *.tree ${prefix}.dnd.tmp - # remove all prefices added by mafft which make the output incompatible with other tools + # remove all prefixes added by mafft which make the output incompatible with other tools awk '{gsub(/[0-9]+_/, ""); print}' ${prefix}.dnd.tmp > ${prefix}.dnd cat <<-END_VERSIONS > versions.yml diff --git a/modules/nf-core/mapdamage2/meta.yml b/modules/nf-core/mapdamage2/meta.yml index f27fc17f131..c16423fb52e 100644 --- a/modules/nf-core/mapdamage2/meta.yml +++ b/modules/nf-core/mapdamage2/meta.yml @@ -194,7 +194,7 @@ output: ] - results_*/*.fasta: type: file - description: Allignments in a FASTA file, only if flagged by -d. + description: Alignments in a FASTA file, only if flagged by -d. pattern: "*.{fasta}" - folder: - meta: diff --git a/modules/nf-core/mash/dist/meta.yml b/modules/nf-core/mash/dist/meta.yml index 3b7ce0ad6c7..0b79769f9ba 100644 --- a/modules/nf-core/mash/dist/meta.yml +++ b/modules/nf-core/mash/dist/meta.yml @@ -1,5 +1,5 @@ name: mash_dist -description: Calculate Mash distances between reference and query seqeunces +description: Calculate Mash distances between reference and query sequences keywords: - distance - estimate diff --git a/modules/nf-core/merfin/hist/main.nf b/modules/nf-core/merfin/hist/main.nf index 76fdf6e12f7..686aa0094f3 100644 --- a/modules/nf-core/merfin/hist/main.nf +++ b/modules/nf-core/merfin/hist/main.nf @@ -9,7 +9,7 @@ process MERFIN_HIST { input: tuple val(meta), path(fasta_assembly) // Required Input -sequence files can be FASTA or FASTQ; uncompressed, gz compressed. - tuple val(meta1), path(meryl_db_reads) // Required readmers (raw reads meryl db). As it comes from another tool, it might be relevant to mantain the meta. + tuple val(meta1), path(meryl_db_reads) // Required readmers (raw reads meryl db). As it comes from another tool, it might be relevant to maintain the meta. path(lookup_table) // Optional input vector of probabilities (obtained by genomescope2 with parameter --fitted_hist). path(seqmers) // Optional input for pre-built sequence meryl db (-seqmers). val(peak) // Required input to hard set copy 1 and infer multiplicity to copy number. diff --git a/modules/nf-core/merfin/hist/meta.yml b/modules/nf-core/merfin/hist/meta.yml index ac0bf8f0d6a..2b346a6b890 100644 --- a/modules/nf-core/merfin/hist/meta.yml +++ b/modules/nf-core/merfin/hist/meta.yml @@ -67,7 +67,7 @@ output: The generated 0-centered k* histogram for sequences in . Positive k* values are expected collapsed copies. Negative k* values are expected expanded copies. Closer to 0 means the expected and found k-mers are well - balenced, 1:1. + balanced, 1:1. pattern: "*.{hist}" - log_stderr: - meta: diff --git a/modules/nf-core/merquryfk/merquryfk/meta.yml b/modules/nf-core/merquryfk/merquryfk/meta.yml index 82bfbec4653..67e680452f4 100644 --- a/modules/nf-core/merquryfk/merquryfk/meta.yml +++ b/modules/nf-core/merquryfk/merquryfk/meta.yml @@ -152,7 +152,7 @@ output: e.g. [ id:'test', single_end:false ] - ${prefix}.phased_block.bed: type: file - description: Assembly kmer positions seperated by block in bed format + description: Assembly kmer positions separated by block in bed format pattern: "*.phased.block.bed" - phased_block_stats: - meta: diff --git a/modules/nf-core/metamaps/classify/meta.yml b/modules/nf-core/metamaps/classify/meta.yml index 844adc8adef..8131d12ade9 100644 --- a/modules/nf-core/metamaps/classify/meta.yml +++ b/modules/nf-core/metamaps/classify/meta.yml @@ -70,7 +70,7 @@ output: e.g. [ id:'test', single_end:false ] - "*classification_res.EM.reads2Taxon": type: file - description: Taxon ID assignement of reads + description: Taxon ID assignment of reads pattern: "*.{classification_res.EM.reads2Taxon}" - em: - meta: @@ -110,7 +110,7 @@ output: e.g. [ id:'test', single_end:false ] - "*classification_res.EM.reads2Taxon.krona": type: file - description: Taxon ID assignement of reads in Krona format + description: Taxon ID assignment of reads in Krona format pattern: "*.{classification_res.EM.reads2Taxon.krona}" - versions: - versions.yml: diff --git a/modules/nf-core/mmseqs/easysearch/meta.yml b/modules/nf-core/mmseqs/easysearch/meta.yml index acf1b20d4dc..bcfdde9b783 100644 --- a/modules/nf-core/mmseqs/easysearch/meta.yml +++ b/modules/nf-core/mmseqs/easysearch/meta.yml @@ -1,6 +1,6 @@ # yaml-language-server: $schema=https://raw.githubusercontent.com/nf-core/modules/master/modules/yaml-schema.json name: "mmseqs_easysearch" -description: Searches for the sequences of a fasta file in a databse using MMseqs2 +description: Searches for the sequences of a fasta file in a database using MMseqs2 keywords: - protein sequence - databases diff --git a/modules/nf-core/mygene/templates/mygene.py b/modules/nf-core/mygene/templates/mygene.py index 83bf2175642..9947f2ab4f0 100644 --- a/modules/nf-core/mygene/templates/mygene.py +++ b/modules/nf-core/mygene/templates/mygene.py @@ -21,7 +21,7 @@ class Arguments: """ - Parses the argments, including the ones coming from $task.ext.args. + Parses the arguments, including the ones coming from $task.ext.args. """ def __init__(self) -> None: diff --git a/modules/nf-core/nacho/qc/tests/main.nf.test b/modules/nf-core/nacho/qc/tests/main.nf.test index fe4176bdaf1..c9a28ccfea4 100644 --- a/modules/nf-core/nacho/qc/tests/main.nf.test +++ b/modules/nf-core/nacho/qc/tests/main.nf.test @@ -42,8 +42,8 @@ nextflow_process { assert nacho_qc_png.get(0).get(1).size() == 16 assert nacho_qc_txt.get(0).get(1).size() == 2 assert snapshot( - nacho_qc_reports.get(0).get(1).collect { file(it).name }, //undeterministic .html mqc files - nacho_qc_png.get(0).get(1).collect { file(it).name }, //undeterministic .png mqc files + nacho_qc_reports.get(0).get(1).collect { file(it).name }, //indeterministic .html mqc files + nacho_qc_png.get(0).get(1).collect { file(it).name }, //indeterministic .png mqc files nacho_qc_txt.get(0).get(1), //stable .txt mqc files versions ).match() } @@ -85,8 +85,8 @@ nextflow_process { assert nacho_qc_png.get(0).get(1).size() == 16 assert nacho_qc_txt.get(0).get(1).size() == 2 assert snapshot( - nacho_qc_reports.get(0).get(1).collect { file(it).name }, //undeterministic .html mqc files - nacho_qc_png.get(0).get(1).collect { file(it).name }, //undeterministic .png mqc files + nacho_qc_reports.get(0).get(1).collect { file(it).name }, //indeterministic .html mqc files + nacho_qc_png.get(0).get(1).collect { file(it).name }, //indeterministic .png mqc files nacho_qc_txt.get(0).get(1), //stable .txt mqc files versions ).match() } diff --git a/modules/nf-core/nanoplot/meta.yml b/modules/nf-core/nanoplot/meta.yml index 8af83355ecd..b9be5d98ad6 100644 --- a/modules/nf-core/nanoplot/meta.yml +++ b/modules/nf-core/nanoplot/meta.yml @@ -9,7 +9,7 @@ keywords: tools: - nanoplot: description: | - NanoPlot is a tool for ploting long-read sequencing data and + NanoPlot is a tool for plotting long-read sequencing data and alignment. homepage: http://nanoplot.bioinf.be documentation: https://github.com/wdecoster/NanoPlot diff --git a/modules/nf-core/ngsbits/samplegender/meta.yml b/modules/nf-core/ngsbits/samplegender/meta.yml index fd5a55024c2..5d6bdb58186 100644 --- a/modules/nf-core/ngsbits/samplegender/meta.yml +++ b/modules/nf-core/ngsbits/samplegender/meta.yml @@ -47,7 +47,7 @@ input: pattern: "*.fai" - - method: type: string - description: The method to use to define the gender (posibilities are 'xy', + description: The method to use to define the gender (possibilities are 'xy', 'hetx' and 'sry') pattern: "(xy|hetx|sry)" output: diff --git a/modules/nf-core/ngscheckmate/vafncm/main.nf b/modules/nf-core/ngscheckmate/vafncm/main.nf index f774d0652ae..32e2187687f 100644 --- a/modules/nf-core/ngscheckmate/vafncm/main.nf +++ b/modules/nf-core/ngscheckmate/vafncm/main.nf @@ -28,7 +28,7 @@ process NGSCHECKMATE_VAFNCM { cp ${vafs[0]} zzzzzz.vaf vaf_ncm.py -I . -O . -N ${prefix} $args - # remove the existance of the dummy file + # remove the existence of the dummy file rm zzzzzz.vaf sed -i.bak "/zzzzzz/d" ${prefix}_all.txt diff --git a/modules/nf-core/parabricks/README-fq2bam.md b/modules/nf-core/parabricks/README-fq2bam.md index 61edc01908f..ad9d21921d0 100644 --- a/modules/nf-core/parabricks/README-fq2bam.md +++ b/modules/nf-core/parabricks/README-fq2bam.md @@ -1,6 +1,6 @@ # Parabricks fq2bam -`fq2bam` performs alignment, sorting, (optional) marking of duplicates, and (optional) base quality score recalibration (BQSR). There is no option to control the number of threads used with this tool - all avilable threads on the system are used by default. +`fq2bam` performs alignment, sorting, (optional) marking of duplicates, and (optional) base quality score recalibration (BQSR). There is no option to control the number of threads used with this tool - all available threads on the system are used by default. Alignment and coordinate sorting are always performed. Duplicate marking can be performed by passing the option `markdups=true`. Duplicate marking and BQSR can be performed by passing the options `markdups=true` and `known_sites=$KNOWN_SITES_FILE`. diff --git a/modules/nf-core/parabricks/fq2bam/meta.yml b/modules/nf-core/parabricks/fq2bam/meta.yml index b3e2e7e6ee6..acd5cd0238e 100644 --- a/modules/nf-core/parabricks/fq2bam/meta.yml +++ b/modules/nf-core/parabricks/fq2bam/meta.yml @@ -99,7 +99,7 @@ output: - duplicate_metrics: - duplicate-metrics.txt: type: file - description: (optional) metrics calculated from marking duplcates in the bam + description: (optional) metrics calculated from marking duplicates in the bam file pattern: "*-duplicate-metrics.txt" authors: diff --git a/modules/nf-core/parabricks/fq2bammeth/meta.yml b/modules/nf-core/parabricks/fq2bammeth/meta.yml index 4f295b8806e..5d1cc8df6cd 100644 --- a/modules/nf-core/parabricks/fq2bammeth/meta.yml +++ b/modules/nf-core/parabricks/fq2bammeth/meta.yml @@ -80,7 +80,7 @@ output: - duplicate_metrics: - duplicate-metrics.txt: type: file - description: (optional) metrics calculated from marking duplcates in the bam + description: (optional) metrics calculated from marking duplicates in the bam file pattern: "*-duplicate-metrics.txt" - versions: diff --git a/modules/nf-core/parabricks/mutectcaller/meta.yml b/modules/nf-core/parabricks/mutectcaller/meta.yml index e3c2a37e0ff..baa6ab3e318 100644 --- a/modules/nf-core/parabricks/mutectcaller/meta.yml +++ b/modules/nf-core/parabricks/mutectcaller/meta.yml @@ -55,11 +55,11 @@ input: pattern: "*.fasta" - - panel_of_normals: type: file - description: (Optional) pannel of normals file. + description: (Optional) panel of normals file. pattern: "*.vcf.gz" - - panel_of_normals_index: type: file - description: (Optional) tbi index corresponding to pannel of normals file. + description: (Optional) tbi index corresponding to panel of normals file. pattern: "*.tbi" output: - vcf: @@ -70,7 +70,7 @@ output: e.g. [ id:'test' ] - "*.vcf.gz": type: file - description: Compressed variants file. Will include an annoted vcf file if pannel + description: Compressed variants file. Will include an annotated vcf file if panel of normals is used. pattern: "*.vcf.gz" - stats: diff --git a/modules/nf-core/pbccs/meta.yml b/modules/nf-core/pbccs/meta.yml index 28c53ac0a1d..3d71c10bd79 100644 --- a/modules/nf-core/pbccs/meta.yml +++ b/modules/nf-core/pbccs/meta.yml @@ -1,5 +1,5 @@ name: pbccs -description: Pacbio ccs - Generate Higly Accurate Single-Molecule Consensus Reads +description: Pacbio ccs - Generate Highly Accurate Single-Molecule Consensus Reads keywords: - ccs - pacbio diff --git a/modules/nf-core/popscle/demuxlet/meta.yml b/modules/nf-core/popscle/demuxlet/meta.yml index 3ffb07b9f6e..1a8129ae9d8 100644 --- a/modules/nf-core/popscle/demuxlet/meta.yml +++ b/modules/nf-core/popscle/demuxlet/meta.yml @@ -11,7 +11,7 @@ keywords: tools: - "popscle": description: "A suite of population scale analysis tools for single-cell genomics - data including implementation of Demuxlet / Freemuxlet methods and auxilary + data including implementation of Demuxlet / Freemuxlet methods and auxiliary tools" homepage: "https://github.com/statgen/popscle" documentation: "https://github.com/statgen/popscle" diff --git a/modules/nf-core/popscle/dscpileup/meta.yml b/modules/nf-core/popscle/dscpileup/meta.yml index 70442d830f0..3c95caa5579 100644 --- a/modules/nf-core/popscle/dscpileup/meta.yml +++ b/modules/nf-core/popscle/dscpileup/meta.yml @@ -11,7 +11,7 @@ keywords: tools: - "popscle": description: "A suite of population scale analysis tools for single-cell genomics - data including implementation of Demuxlet / Freemuxlet methods and auxilary + data including implementation of Demuxlet / Freemuxlet methods and auxiliary tools" homepage: "https://github.com/statgen/popscle" documentation: "https://github.com/statgen/popscle" diff --git a/modules/nf-core/popscle/freemuxlet/meta.yml b/modules/nf-core/popscle/freemuxlet/meta.yml index dffcd3431dc..ff28e1dc5b8 100644 --- a/modules/nf-core/popscle/freemuxlet/meta.yml +++ b/modules/nf-core/popscle/freemuxlet/meta.yml @@ -11,7 +11,7 @@ keywords: tools: - "popscle": description: "A suite of population scale analysis tools for single-cell genomics - data including implementation of Demuxlet / Freemuxlet methods and auxilary + data including implementation of Demuxlet / Freemuxlet methods and auxiliary tools" homepage: "https://github.com/statgen/popscle" documentation: "https://github.com/statgen/popscle" diff --git a/modules/nf-core/popscle/freemuxlet/tests/main.nf.test b/modules/nf-core/popscle/freemuxlet/tests/main.nf.test index e8c2225c6e7..baf642e5546 100644 --- a/modules/nf-core/popscle/freemuxlet/tests/main.nf.test +++ b/modules/nf-core/popscle/freemuxlet/tests/main.nf.test @@ -50,7 +50,7 @@ nextflow_process { } - test("demultiplexing - auxilary - files") { + test("demultiplexing - auxiliary - files") { config "./nextflow.config" setup { run("POPSCLE_DSCPILEUP") { @@ -135,7 +135,7 @@ nextflow_process { } - test("demultiplexing - auxilary - files - stub") { + test("demultiplexing - auxiliary - files - stub") { options "-stub" config "./nextflow.config" diff --git a/modules/nf-core/propr/logratio/meta.yml b/modules/nf-core/propr/logratio/meta.yml index 30f8ac887ff..3a28a53c828 100644 --- a/modules/nf-core/propr/logratio/meta.yml +++ b/modules/nf-core/propr/logratio/meta.yml @@ -28,7 +28,7 @@ input: type: file description: | Count matrix, where rows = variables or genes, columns = samples or cells. - This matrix should not contain zeros. Otherwise, they will be first replaced by the minimun value. + This matrix should not contain zeros. Otherwise, they will be first replaced by the minimum value. You may want to handle the zeros with a different method beforehand. pattern: "*.{csv,tsv}" output: diff --git a/modules/nf-core/propr/logratio/templates/logratio.R b/modules/nf-core/propr/logratio/templates/logratio.R index 9f2315da586..6d4dff0d735 100644 --- a/modules/nf-core/propr/logratio/templates/logratio.R +++ b/modules/nf-core/propr/logratio/templates/logratio.R @@ -67,7 +67,7 @@ read_delim_flexible <- function(file, header = TRUE, row.names = 1, check.names #' Check if a variable can be numeric or not #' #' @param x Input variable -#' @retur True if it can be numeric, False otherwise +#' @return True if it can be numeric, False otherwise can_be_numeric <- function(x) { stopifnot(is.atomic(x) || is.list(x)) # check if x is a vector numNAs <- sum(is.na(x)) @@ -223,7 +223,7 @@ mat <- t(mat) # check zeros # log transformation should be applied on non-zero data # otherwise Inf values are generated -if (any(mat == 0)) print("Zeros will be replaced by minimun value before logratio analysis") +if (any(mat == 0)) print("Zeros will be replaced by minimum value before logratio analysis") # compute ALR/CLR diff --git a/modules/nf-core/propr/propd/templates/propd.R b/modules/nf-core/propr/propd/templates/propd.R index f9102096b61..d75e3d2c439 100644 --- a/modules/nf-core/propr/propd/templates/propd.R +++ b/modules/nf-core/propr/propd/templates/propd.R @@ -471,7 +471,7 @@ if (opt\$permutation == 0) { window_size=1 ) - # update maximun theta value to test the FDR values for the next iteration + # update maximum theta value to test the FDR values for the next iteration part <- pd@fdr[which(pd@fdr\$truecounts > 0),] max_cutoff <- ifelse(nrow(part) > 1, min(part\$cutoff), 0) diff --git a/modules/nf-core/propr/propr/meta.yml b/modules/nf-core/propr/propr/meta.yml index cdfc5982b72..b4d7d460126 100644 --- a/modules/nf-core/propr/propr/meta.yml +++ b/modules/nf-core/propr/propr/meta.yml @@ -38,7 +38,7 @@ input: type: file description: | Count matrix, where rows = variables or genes, columns = samples or cells. - This matrix should not contain zeros. Otherwise, they will be replaced by the minimun number. + This matrix should not contain zeros. Otherwise, they will be replaced by the minimum number. It is recommended to handle the zeros beforehand with the method of preference. pattern: "*.{csv,tsv}" output: diff --git a/modules/nf-core/propr/propr/templates/propr.R b/modules/nf-core/propr/propr/templates/propr.R index a9dbd7bddca..fbd725a2a8a 100644 --- a/modules/nf-core/propr/propr/templates/propr.R +++ b/modules/nf-core/propr/propr/templates/propr.R @@ -96,7 +96,7 @@ set_reference <- function(ivar, mat){ return(ivar) } -#' Set the appropiate range for the sequence of cutoffs used in updateCutoffs. +#' Set the appropriate range for the sequence of cutoffs used in updateCutoffs. #' Adjusts the interval to the different metrics. #' #' @param object propr object. Output from propr function. @@ -140,7 +140,7 @@ valCutoff <- function(object, metric, fdrVal = 0.05){ cutoff <- fdr_df\$cutoff[which(fdr_df\$FDR == fdr_threshold)] #select the corresponding cutoff value for the FDR print(cutoff) }else{ - stop("FDR not defined. This metric is not appropiate for the given dataset") + stop("FDR not defined. This metric is not appropriate for the given dataset") } return(cutoff) } @@ -279,7 +279,7 @@ mat <- t(mat) # check zeros # log transformation should be applied on non-zero data # otherwise Inf values are generated -if (any(mat == 0)) print("Warning: Zeros will be replaced by minimun value before logratio analysis") +if (any(mat == 0)) print("Warning: Zeros will be replaced by minimum value before logratio analysis") # set logratio transformation parameter -> ivar # if alr, set the index of the reference gene as ivar diff --git a/modules/nf-core/quartonotebook/main.nf b/modules/nf-core/quartonotebook/main.nf index f3f960533f9..609098e0277 100644 --- a/modules/nf-core/quartonotebook/main.nf +++ b/modules/nf-core/quartonotebook/main.nf @@ -33,7 +33,7 @@ process QUARTONOTEBOOK { script: // FIXME https://github.com/nf-core/modules/issues/7006 // Exit if running this module with -profile conda / -profile mamba on ARM64 - // This is because of issues with getting a homogenous environment across + // This is because of issues with getting a homogeneous environment across // both AMD64 and ARM64 architectures; please find more information at // https://github.com/nf-core/modules/pull/4876#discussion_r1483541037. if (workflow.profile.tokenize(',').intersect(['conda', 'mamba']).size() >= 1) { diff --git a/modules/nf-core/quilt/quilt/meta.yml b/modules/nf-core/quilt/quilt/meta.yml index 958d39cbdd4..057bc7499c5 100644 --- a/modules/nf-core/quilt/quilt/meta.yml +++ b/modules/nf-core/quilt/quilt/meta.yml @@ -83,7 +83,7 @@ input: - posfile: type: file description: (Optional) File with positions of where to impute, lining up one-to-one - with genfile. File is tab seperated with no header, one row per SNP, with + with genfile. File is tab separated with no header, one row per SNP, with col 1 = chromosome, col 2 = physical position (sorted from smallest to largest), col 3 = reference base, col 4 = alternate base. Bases are capitalized. pattern: "*.{txt}" @@ -91,7 +91,7 @@ input: type: file description: (Optional) File with truth phasing results. Supersedes genfile if both options given. File has a header row with a name for each sample, - matching what is found in the bam file. Each subject is then a tab seperated + matching what is found in the bam file. Each subject is then a tab separated column, with 0 = ref and 1 = alt, separated by a vertical bar |, e.g. 0|0 or 0|1. Note therefore this file has one more row than posfile which has no header. diff --git a/modules/nf-core/ribotish/predict/meta.yml b/modules/nf-core/ribotish/predict/meta.yml index e8016a2c9d8..672bef6b29d 100644 --- a/modules/nf-core/ribotish/predict/meta.yml +++ b/modules/nf-core/ribotish/predict/meta.yml @@ -70,7 +70,7 @@ input: - - meta5: type: map description: | - Groovy Map containing information on riboseq P-site offfset parameter + Groovy Map containing information on riboseq P-site offset parameter files - para_ribo: type: file @@ -80,7 +80,7 @@ input: - - meta6: type: map description: | - Groovy Map containing information on TI-seq P-site offfset parameter + Groovy Map containing information on TI-seq P-site offset parameter files - para_ti: type: file diff --git a/modules/nf-core/ribowaltz/meta.yml b/modules/nf-core/ribowaltz/meta.yml index 39f4d836a02..7f0aa25b7d6 100644 --- a/modules/nf-core/ribowaltz/meta.yml +++ b/modules/nf-core/ribowaltz/meta.yml @@ -78,7 +78,7 @@ output: e.g. `[ id:'sample1', single_end:false ]` - offset_plot/*: type: file - description: P-site offset plots for each read length (otional) + description: P-site offset plots for each read length (optional) pattern: "offset_plot/*" - psites: - meta: diff --git a/modules/nf-core/ribowaltz/templates/ribowaltz.r b/modules/nf-core/ribowaltz/templates/ribowaltz.r index 50d5f1719e9..e9fbc12da18 100644 --- a/modules/nf-core/ribowaltz/templates/ribowaltz.r +++ b/modules/nf-core/ribowaltz/templates/ribowaltz.r @@ -100,8 +100,8 @@ export_codon_coverage_tables <- function(sample_name, df.ls, annotation.df) { #' @param sample_name string specifying the sample name associated with the BAM file #' @param cds_coverage dataframe produced by the riboWaltz cds_coverage function with P-sites counts over the entire CDS of transcripts #' @param cds_window_coverage dataframe produced by the riboWaltz cds_coverage function with P-sites counts over the defined CDS window of transcripts using the start_nts and stop_nts params -#' @param exclude_start number of nucleotides from start codon that were excluded when defining the CDS window for counting (provide same calue as start_nts param) -#' @param exclude_stop number of nucleotides from stop codon that were excluded when defining the CDS window for counting (provide same calue as stop_nts param) +#' @param exclude_start number of nucleotides from start codon that were excluded when defining the CDS window for counting (provide same value as start_nts param) +#' @param exclude_stop number of nucleotides from stop codon that were excluded when defining the CDS window for counting (provide same value as stop_nts param) #' #' @return This function does not return a value. It creates and saves two TSV files to disk. @@ -119,7 +119,7 @@ export_cds_coverage_tables <- function(sample_name, cds_coverage, cds_window_cov #' Export plots read-length distribution of reads used for P-site offset identification produced by the `riboWaltz::rlength_distr` function #' #' @param sample_name string specifying the sample name associated with the BAM file -#' @param df_list dataframe list containig data for all samples +#' @param df_list dataframe list containing data for all samples #' #' @return This function does not return a value. It creates and saves a PDF file to disk. @@ -556,7 +556,7 @@ lapply(sample_name.ls, save_metaprofile_psite_plot, df.ls = filtered_psite.ls, a # Codon usage lapply(names(filtered_psite.ls), plot_codon_usage, psite_info_ls = filtered_psite.ls, frequency_normalization = opt\$frequency_normalization) -message("riboWaltz analysis succesfully completed!") +message("riboWaltz analysis successfully completed!") # ========= # Export versions diff --git a/modules/nf-core/rseqc/tin/meta.yml b/modules/nf-core/rseqc/tin/meta.yml index 6e363ecd83e..29fa68b32ea 100644 --- a/modules/nf-core/rseqc/tin/meta.yml +++ b/modules/nf-core/rseqc/tin/meta.yml @@ -1,5 +1,5 @@ name: rseqc_tin -description: Calculte TIN (transcript integrity number) from RNA-seq reads +description: Calculate TIN (transcript integrity number) from RNA-seq reads keywords: - rnaseq - transcript diff --git a/modules/nf-core/rtgtools/vcfeval/meta.yml b/modules/nf-core/rtgtools/vcfeval/meta.yml index 4c59bab5216..12b14df2e81 100644 --- a/modules/nf-core/rtgtools/vcfeval/meta.yml +++ b/modules/nf-core/rtgtools/vcfeval/meta.yml @@ -38,7 +38,7 @@ input: pattern: "*.{vcf.gz.tbi, vcf.tbi}" - truth_bed: type: file - description: A BED file containining the strict regions where VCFeval should + description: A BED file containing the strict regions where VCFeval should only evaluate the fully overlapping variants (optional) This input should be used to provide the golden truth BED files. pattern: "*.bed" diff --git a/modules/nf-core/sam2lca/analyze/meta.yml b/modules/nf-core/sam2lca/analyze/meta.yml index c3152c780d3..bc09b8f0ee6 100644 --- a/modules/nf-core/sam2lca/analyze/meta.yml +++ b/modules/nf-core/sam2lca/analyze/meta.yml @@ -64,7 +64,7 @@ output: - "*.bam": type: file description: Optional sorted BAM/CRAM/SAM file annotated with LCA taxonomic - informations + information pattern: "*.bam" - versions: - versions.yml: diff --git a/modules/nf-core/scoary/meta.yml b/modules/nf-core/scoary/meta.yml index 507bd22efcd..f87c9014377 100644 --- a/modules/nf-core/scoary/meta.yml +++ b/modules/nf-core/scoary/meta.yml @@ -29,7 +29,7 @@ input: pattern: "*.csv" - - tree: type: file - description: A Newick formtted tree for phylogenetic analyses + description: A Newick formatted tree for phylogenetic analyses pattern: "*.{dnd,nwk,treefile}" output: - csv: diff --git a/modules/nf-core/sentieon/datametrics/meta.yml b/modules/nf-core/sentieon/datametrics/meta.yml index 2b59da39c8a..91c60b756ac 100644 --- a/modules/nf-core/sentieon/datametrics/meta.yml +++ b/modules/nf-core/sentieon/datametrics/meta.yml @@ -122,7 +122,7 @@ output: e.g. `[ id:'test', single_end:false ]` - "*mq_metrics.pdf": type: file - description: "PDF containting plot of mean base quality scores" + description: "PDF containing plot of mean base quality scores" pattern: "*.pdf" - qd_plot: - meta: @@ -132,7 +132,7 @@ output: e.g. `[ id:'test', single_end:false ]` - "*qd_metrics.pdf": type: file - description: "PDF containting plot of specific base quality score" + description: "PDF containing plot of specific base quality score" pattern: "*.pdf" - is_plot: - meta: @@ -142,7 +142,7 @@ output: e.g. `[ id:'test', single_end:false ]` - "*is_metrics.pdf": type: file - description: "PDF containting plot of insert sizes" + description: "PDF containing plot of insert sizes" pattern: "*.pdf" - gc_plot: - meta: @@ -152,7 +152,7 @@ output: e.g. `[ id:'test', single_end:false ]` - "*gc_metrics.pdf": type: file - description: "PDF containting plot of GC bias" + description: "PDF containing plot of GC bias" pattern: "*.pdf" - versions: - versions.yml: diff --git a/modules/nf-core/sentieon/gvcftyper/tests/nextflow.config b/modules/nf-core/sentieon/gvcftyper/tests/nextflow.config index 1561a7c4d2d..0b55bb5ec25 100644 --- a/modules/nf-core/sentieon/gvcftyper/tests/nextflow.config +++ b/modules/nf-core/sentieon/gvcftyper/tests/nextflow.config @@ -4,7 +4,7 @@ env { // NOTE This should only happen in GitHub actions or nf-core MegaTests SENTIEON_AUTH_MECH = "$SENTIEON_AUTH_MECH" SENTIEON_AUTH_DATA = secrets.SENTIEON_AUTH_DATA - // NOTE This is how pipepline users will test out Sentieon with a license file + // NOTE This is how pipeline users will test out Sentieon with a license file // nextflow secrets set SENTIEON_LICENSE_BASE64 \$(cat | base64 -w 0) } diff --git a/modules/nf-core/sentieon/qualcal/tests/nextflow.config b/modules/nf-core/sentieon/qualcal/tests/nextflow.config index f168bad2d64..c1e9e48648c 100644 --- a/modules/nf-core/sentieon/qualcal/tests/nextflow.config +++ b/modules/nf-core/sentieon/qualcal/tests/nextflow.config @@ -4,6 +4,6 @@ env { // NOTE This should only happen in GitHub actions or nf-core MegaTests SENTIEON_AUTH_MECH = "$SENTIEON_AUTH_MECH" SENTIEON_AUTH_DATA = secrets.SENTIEON_AUTH_DATA - // NOTE This is how pipepline users will test out Sentieon with a license file + // NOTE This is how pipeline users will test out Sentieon with a license file // nextflow secrets set SENTIEON_LICENSE_BASE64 \$(cat | base64 -w 0) } diff --git a/modules/nf-core/seqkit/grep/meta.yml b/modules/nf-core/seqkit/grep/meta.yml index 309f8197486..8148cb88dd6 100644 --- a/modules/nf-core/seqkit/grep/meta.yml +++ b/modules/nf-core/seqkit/grep/meta.yml @@ -31,7 +31,7 @@ input: type: file description: > pattern file (one record per line). If no pattern is given, a string can be - specificied within the args using '-p pattern_string' + specified within the args using '-p pattern_string' pattern: "*.{txt,tsv}" output: - filter: diff --git a/modules/nf-core/seqsero2/meta.yml b/modules/nf-core/seqsero2/meta.yml index 9761dd7b651..a28831475a1 100644 --- a/modules/nf-core/seqsero2/meta.yml +++ b/modules/nf-core/seqsero2/meta.yml @@ -22,7 +22,7 @@ input: e.g. [ id:'test', single_end:false ] - seqs: type: file - description: FASTQ or FASTA formated sequences + description: FASTQ or FASTA formatted sequences pattern: "*.{fq.gz,fastq.gz,fna.gz,fna,fasta.gz,fasta,fa.gz,fa}" output: - log: diff --git a/modules/nf-core/sgdemux/meta.yml b/modules/nf-core/sgdemux/meta.yml index 3dd52d75aaa..131d33aea08 100644 --- a/modules/nf-core/sgdemux/meta.yml +++ b/modules/nf-core/sgdemux/meta.yml @@ -21,7 +21,7 @@ input: - sample_sheet: type: file description: sample_sheet file (either a Singular Genomics sample sheet, or - a two column csv wih Sample_Barcode and Sample_ID) + a two column csv with Sample_Barcode and Sample_ID) pattern: "*.{csv}" - fastqs_dir: type: directory diff --git a/modules/nf-core/smoove/call/meta.yml b/modules/nf-core/smoove/call/meta.yml index 379ae6e2dae..ce6a0c86a85 100644 --- a/modules/nf-core/smoove/call/meta.yml +++ b/modules/nf-core/smoove/call/meta.yml @@ -1,7 +1,7 @@ name: "smoove_call" description: smoove simplifies and speeds calling and genotyping SVs for short reads. It also improves specificity by removing many spurious alignment signals that are - indicative of low-level noise and often contribute to spurious calls. Developped + indicative of low-level noise and often contribute to spurious calls. Developed by Brent Pedersen. keywords: - structural variants diff --git a/modules/nf-core/survivor/bedpetovcf/meta.yml b/modules/nf-core/survivor/bedpetovcf/meta.yml index 8a1b4f941f1..04cd3011830 100644 --- a/modules/nf-core/survivor/bedpetovcf/meta.yml +++ b/modules/nf-core/survivor/bedpetovcf/meta.yml @@ -1,5 +1,5 @@ name: "survivor_bedpetovcf" -description: Converts a bedpe file ot a VCF file (beta version) +description: Converts a bedpe file to a VCF file (beta version) keywords: - bedpe - conversion diff --git a/modules/nf-core/survivor/stats/meta.yml b/modules/nf-core/survivor/stats/meta.yml index cc89f0aead6..dadd990b620 100644 --- a/modules/nf-core/survivor/stats/meta.yml +++ b/modules/nf-core/survivor/stats/meta.yml @@ -1,5 +1,5 @@ name: "survivor_stats" -description: Report multipe stats over a VCF file +description: Report multiple stats over a VCF file keywords: - survivor - statistics diff --git a/modules/nf-core/tbprofiler/profile/meta.yml b/modules/nf-core/tbprofiler/profile/meta.yml index 98989dda107..dd0e0b4a578 100644 --- a/modules/nf-core/tbprofiler/profile/meta.yml +++ b/modules/nf-core/tbprofiler/profile/meta.yml @@ -43,7 +43,7 @@ output: e.g. [ id:'test', single_end:false ] - results/*.csv: type: file - description: Optional CSV formated result file of resistance and strain type + description: Optional CSV formatted result file of resistance and strain type pattern: "*.csv" - json: - meta: @@ -53,7 +53,7 @@ output: e.g. [ id:'test', single_end:false ] - results/*.json: type: file - description: JSON formated result file of resistance and strain type + description: JSON formatted result file of resistance and strain type pattern: "*.json" - txt: - meta: @@ -73,7 +73,7 @@ output: e.g. [ id:'test', single_end:false ] - vcf/*.vcf.gz: type: file - description: VCF with variant info again refernce genomes + description: VCF with variant info again reference genomes pattern: "*.vcf" - versions: - versions.yml: diff --git a/modules/nf-core/tcoffee/align/main.nf b/modules/nf-core/tcoffee/align/main.nf index 09bb879deed..3cee8b33695 100644 --- a/modules/nf-core/tcoffee/align/main.nf +++ b/modules/nf-core/tcoffee/align/main.nf @@ -10,7 +10,7 @@ process TCOFFEE_ALIGN { input: tuple val(meta) , path(fasta) tuple val(meta2), path(tree) - tuple val(meta3), path(template), path(accessory_informations) + tuple val(meta3), path(template), path(accessory_information) val(compress) output: diff --git a/modules/nf-core/tcoffee/align/meta.yml b/modules/nf-core/tcoffee/align/meta.yml index 518be2b39d5..e5cdd82cb3e 100644 --- a/modules/nf-core/tcoffee/align/meta.yml +++ b/modules/nf-core/tcoffee/align/meta.yml @@ -48,7 +48,7 @@ input: description: T_coffee template file that maps sequences to the accessory information files to be used. pattern: "*" - - accessory_informations: + - accessory_information: type: file description: Accessory files to be used in the alignment. For example, it could be protein structures or secondary structures. diff --git a/modules/nf-core/tcoffee/regressive/main.nf b/modules/nf-core/tcoffee/regressive/main.nf index baf825681b5..2c20b9aad78 100644 --- a/modules/nf-core/tcoffee/regressive/main.nf +++ b/modules/nf-core/tcoffee/regressive/main.nf @@ -10,7 +10,7 @@ process TCOFFEE_REGRESSIVE { input: tuple val(meta) , path(fasta) tuple val(meta2), path(tree) - tuple val(meta3), path(template), path(accessory_informations) + tuple val(meta3), path(template), path(accessory_information) val(compress) output: diff --git a/modules/nf-core/tcoffee/regressive/meta.yml b/modules/nf-core/tcoffee/regressive/meta.yml index 9f9c896744a..52d3719f733 100644 --- a/modules/nf-core/tcoffee/regressive/meta.yml +++ b/modules/nf-core/tcoffee/regressive/meta.yml @@ -48,7 +48,7 @@ input: description: T_coffee template file that maps sequences to the accessory information files to be used. pattern: "*" - - accessory_informations: + - accessory_information: type: file description: Accessory files to be used in the alignment. For example, it could be protein structures or secondary structures. diff --git a/modules/nf-core/tsebra/meta.yml b/modules/nf-core/tsebra/meta.yml index b7808efe05e..e825d87bfd1 100644 --- a/modules/nf-core/tsebra/meta.yml +++ b/modules/nf-core/tsebra/meta.yml @@ -1,6 +1,6 @@ # yaml-language-server: $schema=https://raw.githubusercontent.com/nf-core/modules/master/modules/meta-schema.json name: "tsebra" -description: Transcript Selector for BRAKER TSEBRA combines gene predictions by selecing +description: Transcript Selector for BRAKER TSEBRA combines gene predictions by selecting transcripts based on their extrisic evidence support keywords: - genomics diff --git a/modules/nf-core/universc/README.md b/modules/nf-core/universc/README.md index 793f4f13795..c2ffccab6bc 100644 --- a/modules/nf-core/universc/README.md +++ b/modules/nf-core/universc/README.md @@ -27,7 +27,7 @@ To comply with licensing and respect 10X Genomics Trademarks, the 10X Genomics l has been removed from HTML reports, the tool has been renamed, and proprietary closed-source tools to build Cloupe files are disabled. -It is still suffient to generate summary reports and count matrices compatible with +It is still sufficient to generate summary reports and count matrices compatible with single-cell analysis tools available for 10X Genomics and Cell Ranger output format in Python and R packages. diff --git a/modules/nf-core/vcftools/main.nf b/modules/nf-core/vcftools/main.nf index 24e0fc3b0e8..67bca9af0c3 100644 --- a/modules/nf-core/vcftools/main.nf +++ b/modules/nf-core/vcftools/main.nf @@ -10,7 +10,7 @@ process VCFTOOLS { input: // Owing to the nature of vcftools we here provide solutions to working with optional bed files and optional // alternative variant files, for use with the 'diff' suite of tools. - // Other optional input files can be utilised in a similar way to below but we do not exhaustively itterate through all + // Other optional input files can be utilised in a similar way to below but we do not exhaustively iterate through all // possible options. Instead we leave that to the user. tuple val(meta), path(variant_file) path bed diff --git a/modules/nf-core/vcftools/meta.yml b/modules/nf-core/vcftools/meta.yml index b4c564ecaf2..b9bae4df126 100644 --- a/modules/nf-core/vcftools/meta.yml +++ b/modules/nf-core/vcftools/meta.yml @@ -454,7 +454,7 @@ output: - "*.FORMAT": type: file description: Extracted information from the genotype fields in the VCF file - relating to a specfied FORMAT identifier (optional) + relating to a specified FORMAT identifier (optional) pattern: "*.FORMAT" - info: - meta: diff --git a/modules/nf-core/velocyto/meta.yml b/modules/nf-core/velocyto/meta.yml index 9c4a8f77486..e7d2caef027 100644 --- a/modules/nf-core/velocyto/meta.yml +++ b/modules/nf-core/velocyto/meta.yml @@ -19,7 +19,7 @@ description: | ``` Optional mask must be passed with `ext.args` and option `--mask` This is why I need to stage in the work dir 2 bam files (cellsorted and original). - See also [velocyto turorial](https://velocyto.org/velocyto.py/tutorial/cli.html#notes-on-first-runtime-and-parallelization) + See also [velocyto tutorial](https://velocyto.org/velocyto.py/tutorial/cli.html#notes-on-first-runtime-and-parallelization) keywords: - count diff --git a/modules/nf-core/vg/index/meta.yml b/modules/nf-core/vg/index/meta.yml index c929349e813..35defce18fa 100644 --- a/modules/nf-core/vg/index/meta.yml +++ b/modules/nf-core/vg/index/meta.yml @@ -33,7 +33,7 @@ output: e.g. [ id:'test', single_end:false ] - "*.xg": type: file - description: File containing a succint, queryable version of the input graph(s) + description: File containing a succinct, queryable version of the input graph(s) or read for GCSA or distance indexing pattern: "*.xg" - vg_index: diff --git a/modules/nf-core/wisecondorx/newref/tests/main.nf.test b/modules/nf-core/wisecondorx/newref/tests/main.nf.test index 3645d7734ef..f2f0893758e 100644 --- a/modules/nf-core/wisecondorx/newref/tests/main.nf.test +++ b/modules/nf-core/wisecondorx/newref/tests/main.nf.test @@ -12,7 +12,7 @@ nextflow_process { test("homo_sapiens - [npz]") { - // Stub run because this process needs at least 30 samples to succesfully run + // Stub run because this process needs at least 30 samples to successfully run options "-stub" setup { diff --git a/subworkflows/nf-core/bam_cnv_wisecondorx/meta.yml b/subworkflows/nf-core/bam_cnv_wisecondorx/meta.yml index 30a473492c4..342b3345f3b 100644 --- a/subworkflows/nf-core/bam_cnv_wisecondorx/meta.yml +++ b/subworkflows/nf-core/bam_cnv_wisecondorx/meta.yml @@ -30,7 +30,7 @@ input: Structure: [ val(meta4), path(reference) ] - ch_blacklist: description: | - An optional channel containing a BED file with regions to mask from the analyis + An optional channel containing a BED file with regions to mask from the analysis Structure: [ val(meta5), path(blacklist) ] output: - aberrations_bed: diff --git a/subworkflows/nf-core/bam_tumor_only_somatic_variant_calling_gatk/main.nf b/subworkflows/nf-core/bam_tumor_only_somatic_variant_calling_gatk/main.nf index f6fb0acc7b6..ad14056d449 100644 --- a/subworkflows/nf-core/bam_tumor_only_somatic_variant_calling_gatk/main.nf +++ b/subworkflows/nf-core/bam_tumor_only_somatic_variant_calling_gatk/main.nf @@ -86,7 +86,7 @@ workflow BAM_TUMOR_ONLY_SOMATIC_VARIANT_CALLING_GATK { .combine(ch_stats, by: 0) .combine(ch_segment, by: 0) .combine(ch_contamination, by: 0) - // Adding [] as a placeholder for the optional input file artifact priors, which is only used for tumor-normal samples and therefor isn't needed in this workflow. + // Adding [] as a placeholder for the optional input file artifact priors, which is only used for tumor-normal samples and therefore isn't needed in this workflow. // and [] as a placeholder for entering a contamination estimate value, which is not needed as this workflow uses the contamination table instead. .map{ meta, vcf, tbi, stats, segment, contamination -> [meta, vcf, tbi, stats, [], segment, contamination, [] ] } diff --git a/subworkflows/nf-core/bam_variant_demix_boot_freyja/main.nf b/subworkflows/nf-core/bam_variant_demix_boot_freyja/main.nf index 4f9f0674349..627195db368 100644 --- a/subworkflows/nf-core/bam_variant_demix_boot_freyja/main.nf +++ b/subworkflows/nf-core/bam_variant_demix_boot_freyja/main.nf @@ -53,7 +53,7 @@ workflow BAM_VARIANT_DEMIX_BOOT_FREYJA { // - // Perform bootstrapping to get more accurate estimates of abundancies + // Perform bootstrapping to get more accurate estimates of abundances // ch_lineages = Channel.empty() ch_summarized = Channel.empty() diff --git a/subworkflows/nf-core/fastq_align_bwaaln/main.nf b/subworkflows/nf-core/fastq_align_bwaaln/main.nf index ccf63d5cf95..36d4fc5eb66 100644 --- a/subworkflows/nf-core/fastq_align_bwaaln/main.nf +++ b/subworkflows/nf-core/fastq_align_bwaaln/main.nf @@ -102,7 +102,7 @@ workflow FASTQ_ALIGN_BWAALN { emit: // Note: output channels will contain meta with additional 'id_index' meta - // value to allow association of BAM file with the meta.id of input indicies + // value to allow association of BAM file with the meta.id of input indices bam = ch_bam_for_emit // channel: [ val(meta), path(bam) ] bai = ch_bai_for_emit // channel: [ val(meta), path(bai) ] csi = ch_csi_for_emit // channel: [ val(meta), path(csi) ] diff --git a/subworkflows/nf-core/fastq_align_bwaaln/nextflow.config b/subworkflows/nf-core/fastq_align_bwaaln/nextflow.config index 2ff16551640..f602293907a 100644 --- a/subworkflows/nf-core/fastq_align_bwaaln/nextflow.config +++ b/subworkflows/nf-core/fastq_align_bwaaln/nextflow.config @@ -1,5 +1,5 @@ // IMPORTANT: Add this configuration to your modules.config -// These settings are to ensure you include the reference information within the output file names, to prevent overwritting! +// These settings are to ensure you include the reference information within the output file names, to prevent overwriting! // `meta.id_index` is created and used within the workflow. You must reuse this meta field if you wish to customise the file naming scheme. process { diff --git a/subworkflows/nf-core/fastq_align_hisat2/meta.yml b/subworkflows/nf-core/fastq_align_hisat2/meta.yml index 6f00d4daa27..032144af537 100644 --- a/subworkflows/nf-core/fastq_align_hisat2/meta.yml +++ b/subworkflows/nf-core/fastq_align_hisat2/meta.yml @@ -51,7 +51,7 @@ output: pattern: "*.{bam}" - summary: type: file - description: Aligment log + description: Alignment log pattern: "*.log" - fastq: type: file diff --git a/subworkflows/nf-core/fastq_create_umi_consensus_fgbio/meta.yml b/subworkflows/nf-core/fastq_create_umi_consensus_fgbio/meta.yml index ae22aece780..82807204fb7 100644 --- a/subworkflows/nf-core/fastq_create_umi_consensus_fgbio/meta.yml +++ b/subworkflows/nf-core/fastq_create_umi_consensus_fgbio/meta.yml @@ -52,7 +52,7 @@ input: - groupreadsbyumi_strategy: type: string description: "" - Reguired argument: defines the UMI assignment strategy. + Required argument: defines the UMI assignment strategy. enum: - Identity - Edit diff --git a/subworkflows/nf-core/mmseqs_contig_taxonomy/meta.yml b/subworkflows/nf-core/mmseqs_contig_taxonomy/meta.yml index edf4874b3d7..15126b6e619 100644 --- a/subworkflows/nf-core/mmseqs_contig_taxonomy/meta.yml +++ b/subworkflows/nf-core/mmseqs_contig_taxonomy/meta.yml @@ -34,7 +34,7 @@ output: - taxonomy: type: file description: | - Channel containing the tab seperated file with all assigned taxonomy. + Channel containing the tab separated file with all assigned taxonomy. Structure: [ val(meta), path(tsv) ] pattern: "*.tsv" - db_mmseqs: diff --git a/subworkflows/nf-core/utils_nfvalidation_plugin/main.nf b/subworkflows/nf-core/utils_nfvalidation_plugin/main.nf index 2398c620c5f..73c382fd7db 100644 --- a/subworkflows/nf-core/utils_nfvalidation_plugin/main.nf +++ b/subworkflows/nf-core/utils_nfvalidation_plugin/main.nf @@ -21,7 +21,7 @@ include { validateParameters } from 'plugin/nf-validation' workflow UTILS_NFVALIDATION_PLUGIN { take: print_help // boolean: print help - workflow_command // string: default commmand used to run pipeline + workflow_command // string: default command used to run pipeline pre_help_text // string: string to be printed before help text and summary log post_help_text // string: string to be printed after help text and summary log validate_params // boolean: validate parameters diff --git a/subworkflows/nf-core/vcf_annotate_ensemblvep/main.nf b/subworkflows/nf-core/vcf_annotate_ensemblvep/main.nf index 291eddc11b0..d9c9e834fd9 100644 --- a/subworkflows/nf-core/vcf_annotate_ensemblvep/main.nf +++ b/subworkflows/nf-core/vcf_annotate_ensemblvep/main.nf @@ -7,7 +7,7 @@ include { TABIX_TABIX } from '../../../modules/nf-core/tabix/tabix/main' workflow VCF_ANNOTATE_ENSEMBLVEP { take: - ch_vcf // channel: [ val(meta), path(vcf), [path(custom_file1), path(custom_file2)... (optionnal)]] + ch_vcf // channel: [ val(meta), path(vcf), [path(custom_file1), path(custom_file2)... (optional)]] ch_fasta // channel: [ val(meta2), path(fasta) ] (optional) val_genome // value: genome to use val_species // value: species to use diff --git a/subworkflows/nf-core/vcf_annotate_ensemblvep/meta.yml b/subworkflows/nf-core/vcf_annotate_ensemblvep/meta.yml index 15d42da23fe..12677c684f7 100644 --- a/subworkflows/nf-core/vcf_annotate_ensemblvep/meta.yml +++ b/subworkflows/nf-core/vcf_annotate_ensemblvep/meta.yml @@ -12,7 +12,7 @@ input: - ch_vcf: description: | vcf file to annotate - Structure: [ val(meta), path(vcf), [path(custom_file1), path(custom_file2)... (optionnal)] ] + Structure: [ val(meta), path(vcf), [path(custom_file1), path(custom_file2)... (optional)] ] - ch_fasta: description: | Reference genome fasta file (optional) diff --git a/tests/modules/nf-core/msisensor/msi/main.nf b/tests/modules/nf-core/msisensor/msi/main.nf index 5d052c5b9c5..76905017bc9 100644 --- a/tests/modules/nf-core/msisensor/msi/main.nf +++ b/tests/modules/nf-core/msisensor/msi/main.nf @@ -15,7 +15,7 @@ workflow test_msisensor_msi { // IMPERFECT TEST: // USING SARS-COV2 DATA AS NORMAL:TUMOR PAIR THIS WILL SUFFICE TO // TEST MODULE EXECUTION, BUT NOT FUNCTIONALITY. - // FUNCTIONALITY HAS BEEN TESTED MANUALY USING AUTHOR-PROVIDED TEST + // FUNCTIONALITY HAS BEEN TESTED MANUALLY USING AUTHOR-PROVIDED TEST // DATA (https://github.com/ding-lab/msisensor/tree/master/test) def input = [] diff --git a/tests/modules/nf-core/parabricks/mutectcaller/main.nf b/tests/modules/nf-core/parabricks/mutectcaller/main.nf new file mode 100644 index 00000000000..a240ce74ecf --- /dev/null +++ b/tests/modules/nf-core/parabricks/mutectcaller/main.nf @@ -0,0 +1,113 @@ +#!/usr/bin/env nextflow + +nextflow.enable.dsl = 2 + +include { PARABRICKS_MUTECTCALLER } from '../../../../../modules/nf-core/parabricks/mutectcaller/main.nf' +include { PARABRICKS_MUTECTCALLER as PARABRICKS_MUTECTCALLER_TN } from '../../../../../modules/nf-core/parabricks/mutectcaller/main.nf' +include { PARABRICKS_MUTECTCALLER as PARABRICKS_MUTECTCALLER_TN_INTERVALS } from '../../../../../modules/nf-core/parabricks/mutectcaller/main.nf' +include { PARABRICKS_MUTECTCALLER as PARABRICKS_MUTECTCALLER_PON } from '../../../../../modules/nf-core/parabricks/mutectcaller/main.nf' + +workflow test_parabricks_mutectcaller { + + input = [ + [ id:'test', tumor_id:'tumour' ], + file(params.test_data['homo_sapiens']['illumina']['test2_paired_end_recalibrated_sorted_bam'], checkIfExists: true), + [], // index only needed if using intervals or tumor-normal calling + [], + [], + [] + ] + fasta = [ + [ id: 'homo_sapiens' ], + file(params.test_data['homo_sapiens']['genome']['genome_21_fasta'], checkIfExists: true) + ] + panel_of_normals = [] + panel_of_normals_index = [] + + PARABRICKS_MUTECTCALLER ( input, fasta, panel_of_normals, panel_of_normals_index ) +} + +// tumor-normal calling not passing because of issue with readgroups in the test files +// [PB Error][src/readers.cpp:1314] ID simulation01 maps to tm_simulation01, but PU is nm_simulation01 (different platform), exiting. +workflow test_parabricks_mutectcaller_tn { + input = [ + [ id:'test', tumor_id:'tumour', normal_id:'normal' ], + file(params.test_data['homo_sapiens']['illumina']['test2_paired_end_recalibrated_sorted_bam'], checkIfExists: true), + file(params.test_data['homo_sapiens']['illumina']['test2_paired_end_recalibrated_sorted_bam_bai'], checkIfExists: true), + file(params.test_data['homo_sapiens']['illumina']['test_paired_end_recalibrated_sorted_bam'], checkIfExists: true), + file(params.test_data['homo_sapiens']['illumina']['test_paired_end_recalibrated_sorted_bam_bai'], checkIfExists: true), + [] + ] + fasta = [ + [ id: 'homo_sapiens' ], + file(params.test_data['homo_sapiens']['genome']['genome_21_fasta'], checkIfExists: true) + ] + panel_of_normals = [] + panel_of_normals_index = [] + + PARABRICKS_MUTECTCALLER_TN ( input, fasta, panel_of_normals, panel_of_normals_index ) +} + +workflow test_parabricks_mutectcaller_intervals { + input = [ + [ id:'test', tumor_id:'tumour' ], + file(params.test_data['homo_sapiens']['illumina']['test2_paired_end_recalibrated_sorted_bam'], checkIfExists: true), + file(params.test_data['homo_sapiens']['illumina']['test2_paired_end_recalibrated_sorted_bam_bai'], checkIfExists: true), + [], + [], + file(params.test_data['homo_sapiens']['genome']['genome_21_multi_interval_bed'], checkIfExists: true) + ] + + fasta = [ + [ id: 'homo_sapiens' ], + file(params.test_data['homo_sapiens']['genome']['genome_21_fasta'], checkIfExists: true) + ] + + panel_of_normals = [] + panel_of_normals_index = [] + + PARABRICKS_MUTECTCALLER ( input, fasta, panel_of_normals, panel_of_normals_index ) +} + +workflow test_parabricks_mutectcaller_tn_intervals { + input = [ + [ id:'test', tumor_id:'tumour', normal_id:'normal'], + file(params.test_data['homo_sapiens']['illumina']['test2_paired_end_recalibrated_sorted_bam'], checkIfExists: true), + file(params.test_data['homo_sapiens']['illumina']['test2_paired_end_recalibrated_sorted_bam_bai'], checkIfExists: true), + file(params.test_data['homo_sapiens']['illumina']['test_paired_end_recalibrated_sorted_bam'], checkIfExists: true), + file(params.test_data['homo_sapiens']['illumina']['test_paired_end_recalibrated_sorted_bam_bai'], checkIfExists: true), + file(params.test_data['homo_sapiens']['genome']['genome_21_multi_interval_bed'], checkIfExists: true) + ] + + fasta = [ + [ id: 'homo_sapiens' ], + file(params.test_data['homo_sapiens']['genome']['genome_21_fasta'], checkIfExists: true) + ] + panel_of_normals = [] + panel_of_normals_index = [] + + PARABRICKS_MUTECTCALLER_TN_INTERVALS ( input, fasta, panel_of_normals, panel_of_normals_index ) +} + +// PON test not passing because the tool expects all chromosomes in the PON file to +// be present in the reference genome. +workflow test_parabricks_mutectcaller_pon { + input = [ + [ id:'test', tumor_id:'tumour' ], + file(params.test_data['homo_sapiens']['illumina']['test2_paired_end_recalibrated_sorted_bam'], checkIfExists: true), + file(params.test_data['homo_sapiens']['illumina']['test2_paired_end_recalibrated_sorted_bam_bai'], checkIfExists: true), + [], + [], + file(params.test_data['homo_sapiens']['genome']['genome_21_multi_interval_bed'], checkIfExists: true) + ] + + fasta = [ + [ id: 'homo_sapiens' ], + file(params.test_data['homo_sapiens']['genome']['genome_21_fasta'], checkIfExists: true) + ] + + panel_of_normals = file(params.test_data['homo_sapiens']['genome']['mills_and_1000g_indels_21_vcf_gz'], checkIfExists: true) + panel_of_normals_index = file(params.test_data['homo_sapiens']['genome']['mills_and_1000g_indels_21_vcf_gz_tbi'], checkIfExists: true) + + PARABRICKS_MUTECTCALLER_PON ( input, fasta, panel_of_normals, panel_of_normals_index ) +} diff --git a/tests/modules/nf-core/sentieon/license_message.py b/tests/modules/nf-core/sentieon/license_message.py index c4a34f92407..17ca5270575 100644 --- a/tests/modules/nf-core/sentieon/license_message.py +++ b/tests/modules/nf-core/sentieon/license_message.py @@ -99,7 +99,7 @@ def parse_args(argv=None): encrypt_parser.add_argument("--message", required=True, help="Message to encrypt") encrypt_parser.set_defaults(func=handle_encrypt_message) - decrypt_parser = subparsers.add_parser("decrypt", help="Decyrpt a message") + decrypt_parser = subparsers.add_parser("decrypt", help="Decrypt a message") decrypt_parser.add_argument("--key", required=True, help="The encryption key") decrypt_parser.add_argument("--message", required=True, help="Message to decrypt") decrypt_parser.add_argument(