diff --git a/different_errors_detected.csv b/different_errors_detected.csv new file mode 100644 index 0000000000000000000000000000000000000000..9eb6d79c6862a5f6a5cfe26b5ccd4297c5d7f302 --- /dev/null +++ b/different_errors_detected.csv @@ -0,0 +1,15 @@ +Error description Number of workflows +Incorrect number of parameters given for a process or a subworkflow call 16 +Channel trying to be created with a name already given to an existing element 27 +Multiple channels are given by an emit even though only expecting one 1 +Tried to access an emit even though the element its emitting has not been called 16 +Tried to include a file which doesn't exist 14 +An include was present in a main or subworkflow 1 +In a pipe operator, the first thing called does not exist 11 +Syntax error in the code (e.g. not the same of parentheses) 35 +Element (process or subworkflow) is expected to be defined in a file but is not 8 +A subworkflow either emits nothing or too many values for use in an operation 20 +A subworkflow or process was defined badly (e.g. multiple input sections, multiple main sections...) 10 +Unknown element used in a pipe operator. 1 +Ternary conditional operator used with a tuple. 2 +Tuple associated with a call. 5 diff --git a/failed_2_analyse.txt b/failed_2_analyse.txt new file mode 100644 index 0000000000000000000000000000000000000000..f5e9fea70a9424d1c6d1ff4cf322276e2a63281a --- /dev/null +++ b/failed_2_analyse.txt @@ -0,0 +1,538 @@ +- 9 ../../../Workflow-Corpus-Open-License/UMCUGenetics/NF-IAP + [10] Error in the file '../../../Workflow-Corpus-Open-License/UMCUGenetics/NF-IAP/nf-iap.nf': Something went wrong in an include, possibly at line 88. No such file: '../../../Workflow-Corpus-Open-License/UMCUGenetics/NF-IAP/NextflowModules/Utils/fastq.nf'. + +- 10 ../../../Workflow-Corpus-Open-License/UMCUGenetics/DxNextflowWGS + [10] Error in the file '../../../Workflow-Corpus-Open-License/UMCUGenetics/DxNextflowWGS/WGS.nf': Something went wrong in an include, possibly at line 5. No such file: '../../../Workflow-Corpus-Open-License/UMCUGenetics/DxNextflowWGS/NextflowModules/Utils/fastq.nf'. + +- 11 ../../../Workflow-Corpus-Open-License/UMCUGenetics/DxNextflowWES + [10] Error in the file '../../../Workflow-Corpus-Open-License/UMCUGenetics/DxNextflowWES/WES_Fingerprint.nf': Something went wrong in an include, possibly at line 5. No such file: '../../../Workflow-Corpus-Open-License/UMCUGenetics/DxNextflowWES/NextflowModules/Utils/bam.nf'. + +- 16 ../../../Workflow-Corpus-Open-License/Gregor-Mendel-Institute/aradeepopsis + [3] Error in the file '../../../Workflow-Corpus-Open-License/Gregor-Mendel-Institute/aradeepopsis/workflows/aradeepopsis.nf': Don't know how to handle '( params.masks ? MASKS : SEGMENT )' in a pipe operator, possibly at line 56. Try using the recommended operator composition. + +- 24 ../../../Workflow-Corpus-Open-License/brwnj/smoove-nf + [5] Error in the file '../../../Workflow-Corpus-Open-License/brwnj/smoove-nf/main.nf': A ternary conditional operator was used with an tuple, possibly at line 297. BioFlow-Insight doesn't support this yet (see specification list), try defining the operation in a different way. + +- 26 ../../../Workflow-Corpus-Open-License/brwnj/covviz + [5] Error in the file '../../../Workflow-Corpus-Open-License/brwnj/covviz/main.nf': A ternary conditional operator was used with an tuple, possibly at line 125. BioFlow-Insight doesn't support this yet (see specification list), try defining the operation in a different way. + +- 34 ../../../Workflow-Corpus-Open-License/genomic-medicine-sweden/jasen + [4] Error in the file '../../../Workflow-Corpus-Open-License/genomic-medicine-sweden/jasen/workflows/bacterial_base.nf': 'quast' is trying to be created as a channel, possibly at line 16. It already exists as a process or a subworkflow in the nextflow file. + +- 41 ../../../Workflow-Corpus-Open-License/CenterForMedicalGeneticsGhent/nf-cmgg-germline + [2] Error in the file '../../../Workflow-Corpus-Open-License/CenterForMedicalGeneticsGhent/nf-cmgg-germline/workflows/cmgg-germline.nf': Not the same number of parameters given as input for the process 'SAMTOOLS_FAIDX', possibly at line 250. + +- 42 ../../../Workflow-Corpus-Open-License/CenterForMedicalGeneticsGhent/nf-cmgg-structural + [2] Error in the file '../../../Workflow-Corpus-Open-License/CenterForMedicalGeneticsGhent/nf-cmgg-structural/workflows/cmgg-structural.nf': Not the same number of parameters given as input for the process 'SAMTOOLS_FAIDX', possibly at line 135. + +- 47 ../../../Workflow-Corpus-Open-License/jnoms/virID + [14] Error in the file '../../../Workflow-Corpus-Open-License/jnoms/virID/virID.nf': 'bwa_mem_contigs' is neither a process, subworkflow or an operator. In the executor 'contigs + .join(process_read_pairs.out) | bwa_mem_contigs'. + +- 54 ../../../Workflow-Corpus-Open-License/replikation/What_the_Phage + [10] Error in the file '../../../Workflow-Corpus-Open-License/replikation/What_the_Phage/phage_deprecated.nf': Something went wrong in an include, possibly at line 135. No such file: '../../../Workflow-Corpus-Open-License/replikation/What_the_Phage/modules/checkV.nf'. + +- 55 ../../../Workflow-Corpus-Open-License/TORCH-Consortium/MAGMA + [20] Error in the file '../../../Workflow-Corpus-Open-License/TORCH-Consortium/MAGMA/main.nf': To much to unpack : The subworkflow 'VALIDATE_FASTQS_WF' emits over one channel in a operation, possibly at line 31. + +- 59 ../../../Workflow-Corpus-Open-License/Hammarn/Nextflow_test + [16] Error in the file '../../../Workflow-Corpus-Open-License/Hammarn/Nextflow_test/main.nf': No 'main' workflow was found. + +- 61 ../../../Workflow-Corpus-Open-License/maxulysse/nextflow_params_opt + [16] Error in the file '../../../Workflow-Corpus-Open-License/maxulysse/nextflow_params_opt/main.nf': No 'main' workflow was found. + +- 64 ../../../Workflow-Corpus-Open-License/abhi18av/nextflow-datascience-titanic-survival-analysis + [10] Error in the file '../../../Workflow-Corpus-Open-License/abhi18av/nextflow-datascience-titanic-survival-analysis/main.nf': Something went wrong in an include, possibly at line 17. No such file: '../../../Workflow-Corpus-Open-License/abhi18av/nextflow-datascience-titanic-survival-analysis/modules/data/test_train_split/test_train_split.nf'. + +- 65 ../../../Workflow-Corpus-Open-License/abhi18av/nextflow-module-pattern + [16] Error in the file '../../../Workflow-Corpus-Open-License/abhi18av/nextflow-module-pattern/workflow.nf': No 'main' workflow was found. + +- 66 ../../../Workflow-Corpus-Open-License/abhi18av/nextflow_grid_search + [16] Error in the file '../../../Workflow-Corpus-Open-License/abhi18av/nextflow_grid_search/stacked_ensemble_grid_search.nf': No 'main' workflow was found. + +- 67 ../../../Workflow-Corpus-Open-License/mgimenez720/plaSquid + [2] Error in the file '../../../Workflow-Corpus-Open-License/mgimenez720/plaSquid/workflows/RIPsearch.nf': Not the same number of parameters given as input for the process 'FilterDom', possibly at line 49. + +- 68 ../../../Workflow-Corpus-Open-License/bahlolab/PLASTER + [18] Error in the file '../../../Workflow-Corpus-Open-License/bahlolab/PLASTER/nf/functions.nf': 'path' is expected to be defined in the file, but it could not be found. + +- 70 ../../../Workflow-Corpus-Open-License/EpiDiverse/ewas + [9] Error in the file '../../../Workflow-Corpus-Open-License/EpiDiverse/ewas/main.nf': A tuple is associated with an call, possibly at line 283. BioFlow-Insight doesn't support this (see specification list), try defining the operation in a different way. + +- 71 ../../../Workflow-Corpus-Open-License/EpiDiverse/wgbs + [9] Error in the file '../../../Workflow-Corpus-Open-License/EpiDiverse/wgbs/main.nf': A tuple is associated with an call, possibly at line 166. BioFlow-Insight doesn't support this (see specification list), try defining the operation in a different way. + +- 72 ../../../Workflow-Corpus-Open-License/EpiDiverse/dmr + [9] Error in the file '../../../Workflow-Corpus-Open-License/EpiDiverse/dmr/main.nf': A tuple is associated with an call, possibly at line 210. BioFlow-Insight doesn't support this (see specification list), try defining the operation in a different way. + +- 80 ../../../Workflow-Corpus-Open-License/TRON-Bioinformatics/tronflow-copy-number-calling + [10] Error in the file '../../../Workflow-Corpus-Open-License/TRON-Bioinformatics/tronflow-copy-number-calling/main.nf': Something went wrong in an include, possibly at line 7. No such file: '../../../Workflow-Corpus-Open-License/TRON-Bioinformatics/tronflow-copy-number-calling/nf-core-modules/modules/nf-core/samtools/merge/main.nf'. + +- 86 ../../../Workflow-Corpus-Open-License/data-intuitive/diflow + [16] Error in the file '../../../Workflow-Corpus-Open-License/data-intuitive/diflow/main.nf': No 'main' workflow was found. + +- 92 ../../../Workflow-Corpus-Open-License/sanger-tol/blobtoolkit + [14] Error in the file '../../../Workflow-Corpus-Open-License/sanger-tol/blobtoolkit/subworkflows/local/minimap_alignment.nf': 'set { ch_aligned }' is neither a process, subworkflow or an operator. In the executor 'Channel.empty() + | mix ( MINIMAP2_HIC.out.bam ) + | mix ( MINIMAP2_ILMN.out.bam ) + | mix ( MINIMAP2_CCS.out.bam ) + | mix ( MINIMAP2_CLR.out.bam ) + | mix ( MINIMAP2_ONT.out.bam ) + | set { ch_aligned }', possibly at line 68. + +- 93 ../../../Workflow-Corpus-Open-License/sanger-tol/sequencecomposition + [8] Error in the file '../../../Workflow-Corpus-Open-License/sanger-tol/sequencecomposition/subworkflows/local/fasta_windows.nf': The call for 'TABIX_BGZIP ( ch_freq_bed.mix(ch_tsv) )' coudn't be found, before its use in the operation 'ch_compressed_bed = TABIX_BGZIP ( ch_freq_bed.mix(ch_tsv) ).output', possibly at line 67. Either because the call wasn't made before the operation or that the element it is calling doesn't exist. + +- 98 ../../../Workflow-Corpus-Open-License/sanger-tol/readmapping + [14] Error in the file '../../../Workflow-Corpus-Open-License/sanger-tol/readmapping/subworkflows/local/prepare_genome.nf': 'set { ch_bwamem }' is neither a process, subworkflow or an operator. In the executor 'Channel.fromPath ( params.bwamem2_index ) + | combine ( ch_fasta ) + | map { bwa, meta, fa -> [ meta, bwa ] } + | set { ch_bwamem }', possibly at line 39. + +- 99 ../../../Workflow-Corpus-Open-License/sanger-tol/genomenote + [14] Error in the file '../../../Workflow-Corpus-Open-License/sanger-tol/genomenote/subworkflows/local/genome_statistics.nf': 'set { ch_fastk }' is neither a process, subworkflow or an operator. In the executor 'ch_pacbio.file + | map { meta, bam -> [ meta + [ id: meta.id.split('_')[0..-2].join('_') ], bam ] } + | groupTuple ( by: [0] ) + | set { ch_fastk }', possibly at line 62. + +- 101 ../../../Workflow-Corpus-Open-License/montilab/nf-gwas-pipeline + [4] Error in the file '../../../Workflow-Corpus-Open-License/montilab/nf-gwas-pipeline/gwas.nf': 'pcrelate' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file. + +- 110 ../../../Workflow-Corpus-Open-License/NYU-Molecular-Pathology/NGS580-nf + [4] Error in the file '../../../Workflow-Corpus-Open-License/NYU-Molecular-Pathology/NGS580-nf/main.nf': 'snp_pileup' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file. + +- 111 ../../../Workflow-Corpus-Open-License/NYU-Molecular-Pathology/LG-PACT + [4] Error in the file '../../../Workflow-Corpus-Open-License/NYU-Molecular-Pathology/LG-PACT/main.nf': 'snp_pileup' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file. + +- 118 ../../../Workflow-Corpus-Open-License/seanpm2001/SNU_2D_ProgrammingTools_IDE_NextFlow + [16] Error in the file '../../../Workflow-Corpus-Open-License/seanpm2001/SNU_2D_ProgrammingTools_IDE_NextFlow/LICENSE.nf': Not the same number of opening and closing parentheses '()' in the file. + +- 119 ../../../Workflow-Corpus-Open-License/seanpm2001/Learn-NextFlow + [16] Error in the file '../../../Workflow-Corpus-Open-License/seanpm2001/Learn-NextFlow/LICENSE.nf': Not the same number of opening and closing parentheses '()' in the file. + +- 120 ../../../Workflow-Corpus-Open-License/seanpm2001/AI2001_Category-Source_Code-SC-Nextflow + [16] Error in the file '../../../Workflow-Corpus-Open-License/seanpm2001/AI2001_Category-Source_Code-SC-Nextflow/LICENSE.nf': Not the same number of opening and closing parentheses '()' in the file. + +- 121 ../../../Workflow-Corpus-Open-License/SamStudio8/elan-nextflow + [2] Error in the file '../../../Workflow-Corpus-Open-License/SamStudio8/elan-nextflow/workflows/elan.nf': Not the same number of parameters given as input for the process 'announce_uploads', possibly at line 14. + +- 123 ../../../Workflow-Corpus-Open-License/robsyme/nf-repeatmasking + [4] Error in the file '../../../Workflow-Corpus-Open-License/robsyme/nf-repeatmasking/main.nf': 'recentLTRs' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file. + +- 125 ../../../Workflow-Corpus-Open-License/TARGENE/targene-pipeline + [20] Error in the file '../../../Workflow-Corpus-Open-License/TARGENE/targene-pipeline/workflows/targene.nf': The subworkflow 'SVPWorkflow' doesn't emit anything. It is given to an operation, possibly at line 71. + +- 130 ../../../Workflow-Corpus-Open-License/HSPH-QBRC/target-pipeline + [9] Error in the file '../../../Workflow-Corpus-Open-License/HSPH-QBRC/target-pipeline/pipeline.nf': A tuple is associated with an call, possibly at line 288. BioFlow-Insight doesn't support this (see specification list), try defining the operation in a different way. + +- 133 ../../../Workflow-Corpus-Open-License/JBris/nextflow-graph-machine-learning + [9] Error in the file '../../../Workflow-Corpus-Open-License/JBris/nextflow-graph-machine-learning/gnn_pipeline.nf': A tuple is associated with an call, possibly at line 34. BioFlow-Insight doesn't support this (see specification list), try defining the operation in a different way. + +- 134 ../../../Workflow-Corpus-Open-License/AndersenLab/ril-nf + [4] Error in the file '../../../Workflow-Corpus-Open-License/AndersenLab/ril-nf/main.nf': 'fq_coverage' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file. + +- 135 ../../../Workflow-Corpus-Open-License/AndersenLab/alignment-nf + [14] Error in the file '../../../Workflow-Corpus-Open-License/AndersenLab/alignment-nf/main.nf': '(coverage_id & idxstats_id & flagstat_id & stats_id)' is neither a process, subworkflow or an operator. In the executor 'alignment.out.map { row, bam, bai -> ["id", row.id, bam, bai ]} | (coverage_id & idxstats_id & flagstat_id & stats_id)'. + +- 144 ../../../Workflow-Corpus-Open-License/phac-nml/mikrokondo + [20] Error in the file '../../../Workflow-Corpus-Open-License/phac-nml/mikrokondo/main.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 87. + +- 161 ../../../Workflow-Corpus-Open-License/CDCgov/mycosnp-nf + [18] Error in the file '../../../Workflow-Corpus-Open-License/CDCgov/mycosnp-nf/subworkflows/local/snpeff_build.nf': 'SNPEFF_BUILD' is expected to be defined in the file, but it could not be found. + +- 162 ../../../Workflow-Corpus-Open-License/CDCgov/tostadas + [2] Error in the file '../../../Workflow-Corpus-Open-License/CDCgov/tostadas/workflows/tostadas.nf': Not the same number of parameters given as input for the process 'UPDATE_SUBMISSION', possibly at line 203. + +- 164 ../../../Workflow-Corpus-Open-License/break-through-cancer/btc-spatial-pipelines + [10] Error in the file '../../../Workflow-Corpus-Open-License/break-through-cancer/btc-spatial-pipelines/workflows/spatial.nf': Something went wrong in an include, possibly at line 46. No such file: '../../../Workflow-Corpus-Open-License/break-through-cancer/btc-spatial-pipelines/modules/bayestme/nextflow/subworkflows/bayestme/bayestme_basic_visium_analysis/main.nf'. + +- 167 ../../../Workflow-Corpus-Open-License/cbcrg/msa-af2-nf + [8] Error in the file '../../../Workflow-Corpus-Open-License/cbcrg/msa-af2-nf/main.nf': The call for 'run_seq_aln' coudn't be found, before its use in the operation 'run_seq_aln.out.seq_aln_output.combine(run_psicoffee.out.psicoffee_output, by: 0).combine(dssp_to_fasta.out.dssp_output, by: 0).combine(run_struct_aln.out.struct_output, by: 0).combine(templates, by: 0).combine(structures, by: 0).combine(run_alphafold2.out.af2_models.groupTuple(), by: 0).set{comp_and_eval_input}', possibly at line 73. Either because the call wasn't made before the operation or that the element it is calling doesn't exist. + +- 168 ../../../Workflow-Corpus-Open-License/cbcrg/nf-phdcourse20 + [16] Error in the file '../../../Workflow-Corpus-Open-License/cbcrg/nf-phdcourse20/rnaseq-flow.nf': No 'main' workflow was found. + +- 179 ../../../Workflow-Corpus-Open-License/TheJacksonLaboratory/cs-nf-pipelines + [8] Error in the file '../../../Workflow-Corpus-Open-License/TheJacksonLaboratory/cs-nf-pipelines/subworkflows/hs_pta.nf': The call for 'PICARD_MARKDUPLICATES' coudn't be found, before its use in the operation 'apply_bqsr = PICARD_MARKDUPLICATES.out.dedup_bam.join(GATK_BASERECALIBRATOR.out.table)', possibly at line 175. Either because the call wasn't made before the operation or that the element it is calling doesn't exist. + +- 187 ../../../Workflow-Corpus-Open-License/SLU-AMB/read-preprocessing + [16] Error in the file '../../../Workflow-Corpus-Open-License/SLU-AMB/read-preprocessing/main.nf': No 'main' workflow was found. + +- 192 ../../../Workflow-Corpus-Open-License/Clinical-Genomics-Lund/nextflow-modules + [16] Error in the file '../../../Workflow-Corpus-Open-License/Clinical-Genomics-Lund/nextflow-modules/bacteria-example.nf': No 'main' workflow was found. + +- 213 ../../../Workflow-Corpus-Open-License/aertslab/SpatialNF + [16] Error in the file '../../../Workflow-Corpus-Open-License/aertslab/SpatialNF/main.nf': No 'main' workflow was found. + +- 216 ../../../Workflow-Corpus-Open-License/Euro-BioImaging/BatchConvert + [22] Error in the file '../../../Workflow-Corpus-Open-License/Euro-BioImaging/BatchConvert/modules/processes.nf': Multiple 'input:' were found in the process 'Convert_EachFileFromRoot2SeparateOMETIFF'. + +- 219 ../../../Workflow-Corpus-Open-License/lepsalex/results + [16] Error in the file '../../../Workflow-Corpus-Open-License/lepsalex/results/debug/calls.nf': No 'main' workflow was found. + +- 221 ../../../Workflow-Corpus-Open-License/HadrienG/nanoflow + [4] Error in the file '../../../Workflow-Corpus-Open-License/HadrienG/nanoflow/main.nf': 'assembly' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file. + +- 222 ../../../Workflow-Corpus-Open-License/HadrienG/nextflow_rna + [16] Error in the file '../../../Workflow-Corpus-Open-License/HadrienG/nextflow_rna/rna.nf': No 'main' workflow was found. + +- 223 ../../../Workflow-Corpus-Open-License/crukci-bioinformatics/nextflow-support + [16] Error in the file '../../../Workflow-Corpus-Open-License/crukci-bioinformatics/nextflow-support/functions.nf': No 'main' workflow was found. + +- 228 ../../../Workflow-Corpus-Open-License/EBI-Metagenomics/emg-viral-pipeline + [2] Error in the file '../../../Workflow-Corpus-Open-License/EBI-Metagenomics/emg-viral-pipeline/virify.nf': Not the same number of parameters given as input for the subworklfow 'annotate' in the call, possibly at line 649. + +- 229 ../../../Workflow-Corpus-Open-License/cidgoh/nf-ncov-voc + [22] Error in the file '../../../Workflow-Corpus-Open-License/cidgoh/nf-ncov-voc/modules/local/custom.nf': Multiple 'output:' were found in the process 'processGVCF'? + +- 231 ../../../Workflow-Corpus-Open-License/B-UMMI/DEN-IM + [4] Error in the file '../../../Workflow-Corpus-Open-License/B-UMMI/DEN-IM/DEN-IM.nf': 'compile_status_buffer' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file. + +- 237 ../../../Workflow-Corpus-Open-License/jemunro/Tidy-nf + [16] Error in the file '../../../Workflow-Corpus-Open-License/jemunro/Tidy-nf/example.nf': No 'main' workflow was found. + +- 241 ../../../Workflow-Corpus-Open-License/fmalmeida/MpGAP + [22] Error in the file '../../../Workflow-Corpus-Open-License/fmalmeida/MpGAP/workflows/hybrid.nf': Multiple 'main:' were found in the subworkflow 'HYBRID'. + +- 249 ../../../Workflow-Corpus-Open-License/biocorecrg/contamination-nf + [16] Error in the file '../../../Workflow-Corpus-Open-License/biocorecrg/contamination-nf/main.nf': Not the same number of opening and closing curlies '{}' in the file. + +- 254 ../../../Workflow-Corpus-Open-License/NCBI-Hackathons/SPeW + [16] Error in the file '../../../Workflow-Corpus-Open-License/NCBI-Hackathons/SPeW/align.nf': Not the same number of opening and closing curlies '{}' in the file. + +- 257 ../../../Workflow-Corpus-Open-License/nextflow-io/nf-ffq + [16] Error in the file '../../../Workflow-Corpus-Open-License/nextflow-io/nf-ffq/ffq.nf': No 'main' workflow was found. + +- 258 ../../../Workflow-Corpus-Open-License/nextflow-io/elixir-workshop-21 + [10] Error in the file '../../../Workflow-Corpus-Open-License/nextflow-io/elixir-workshop-21/main.nf': Something went wrong in an include, possibly at line 76. No such file: '../../../Workflow-Corpus-Open-License/nextflow-io/elixir-workshop-21/${subwork_folder}/fastqc.nf'. + +- 273 ../../../Workflow-Corpus-Open-License/LieberInstitute/SPEAQeasy + [10] Error in the file '../../../Workflow-Corpus-Open-License/LieberInstitute/SPEAQeasy/main.nf': Something went wrong in an include, possibly at line 449. No such file: '../../../Workflow-Corpus-Open-License/LieberInstitute/SPEAQeasy/${workflow.projectDir}/modules/pull_annotation.nf'. + +- 274 ../../../Workflow-Corpus-Open-License/hoelzer-lab/rnaflow + [4] Error in the file '../../../Workflow-Corpus-Open-License/hoelzer-lab/rnaflow/main.nf': 'sortmerna' is trying to be created as a channel, possibly at line 475. It already exists as a process or a subworkflow in the nextflow file. + +- 278 ../../../Workflow-Corpus-Open-License/bschiffthaler/nf-modules + [16] Error in the file '../../../Workflow-Corpus-Open-License/bschiffthaler/nf-modules/multiqc.nf': No 'main' workflow was found. + +- 295 ../../../Workflow-Corpus-Open-License/bactopia/bactopia + [10] Error in the file '../../../Workflow-Corpus-Open-License/bactopia/bactopia/workflows/teton.nf': Something went wrong in an include, possibly at line 33. No such file: '../../../Workflow-Corpus-Open-License/bactopia/bactopia/modules/local/bactopia/gather_samples/main.nf'. + +- 296 ../../../Workflow-Corpus-Open-License/DLBPointon/HymenopteraAnalysis + [18] Error in the file '../../../Workflow-Corpus-Open-License/DLBPointon/HymenopteraAnalysis/modules/nf-core/modules/blast/makeblastdb/main.nf': 'SIGS_BLAST_MAKEBLASTDB' is expected to be defined in the file, but it could not be found. + +- 300 ../../../Workflow-Corpus-Open-License/esteinig/nf-mvp + [18] Error in the file '../../../Workflow-Corpus-Open-License/esteinig/nf-mvp/lib/utils.nf': 'getSubsampleReads' is expected to be defined in the file, but it could not be found. + +- 305 ../../../Workflow-Corpus-Open-License/vib-singlecell-nf/vsn-pipelines + [16] Error in the file '../../../Workflow-Corpus-Open-License/vib-singlecell-nf/vsn-pipelines/main.nf': No 'main' workflow was found. + +- 307 ../../../Workflow-Corpus-Open-License/dmalzl/howto-nf + [18] Error in the file '../../../Workflow-Corpus-Open-License/dmalzl/howto-nf/workflows/chipseq.nf': 'CHIPSEQ' is expected to be defined in the file, but it could not be found. + +- 312 ../../../Workflow-Corpus-Open-License/BU-ISCIII/bacterial_wgs_training + [4] Error in the file '../../../Workflow-Corpus-Open-License/BU-ISCIII/bacterial_wgs_training/main.nf': 'srst2_resistance' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file. + +- 326 ../../../Workflow-Corpus-Open-License/Schaudge/nextflow-in-practice + [22] Error in the file '../../../Workflow-Corpus-Open-License/Schaudge/nextflow-in-practice/somatic_vardict_pindel.nf': Multiple 'when:' were found in the process 'cnv_oncocnv_tumor_controls'. + +- 338 ../../../Workflow-Corpus-Open-License/jtmccr1/beast_analysis + [22] Error in the file '../../../Workflow-Corpus-Open-License/jtmccr1/beast_analysis/beast_analysis.nf': Multiple 'input:' were found in the process 'mcc'. + +- 345 ../../../Workflow-Corpus-Open-License/bguo068/posseleff_empirical + [2] Error in the file '../../../Workflow-Corpus-Open-License/bguo068/posseleff_empirical/01_filter_vcf.nf': Not the same number of parameters given as input for the process 'BCFTOOLS_VIEW_FILTER_SAMPLE_BY_IMISS1', possibly at line 165. + +- 350 ../../../Workflow-Corpus-Open-License/TalusBio/nf-encyclopedia + [14] Error in the file '../../../Workflow-Corpus-Open-License/TalusBio/nf-encyclopedia/subworkflows/encyclopedia.nf': 'set { global_files }' is neither a process, subworkflow or an operator. In the executor 'Channel.empty() | set { global_files }', possibly at line 89. + +- 354 ../../../Workflow-Corpus-Open-License/AusSRC/WALLABY_pipelines + [16] Error in the file '../../../Workflow-Corpus-Open-License/AusSRC/WALLABY_pipelines/main.nf': Not the same number of opening and closing parentheses '()' in the file. + +- 356 ../../../Workflow-Corpus-Open-License/NBISweden/K9-WGS-Pipeline + [4] Error in the file '../../../Workflow-Corpus-Open-License/NBISweden/K9-WGS-Pipeline/main.nf': 'hardfilters_snp' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file. + +- 357 ../../../Workflow-Corpus-Open-License/NBISweden/pipelines-nextflow + [2] Error in the file '../../../Workflow-Corpus-Open-License/NBISweden/pipelines-nextflow/subworkflows/abinitio_training/main.nf': Not the same number of parameters given as input for the process 'BLAST_BLASTP', possibly at line 54. + +- 369 ../../../Workflow-Corpus-Open-License/shreyasanjay22/NextflowPipeline + [16] Error in the file '../../../Workflow-Corpus-Open-License/shreyasanjay22/NextflowPipeline/rnaseq_script.nf': No 'main' workflow was found. + +- 383 ../../../Workflow-Corpus-Open-License/PavriLab/hicer-nf + [20] Error in the file '../../../Workflow-Corpus-Open-License/PavriLab/hicer-nf/workflows/hicer.nf': To much to unpack : The subworkflow 'PREPARE_GENOME' emits over one channel in a operation, possibly at line 146. + +- 386 ../../../Workflow-Corpus-Open-License/IARCbioinfo/nf_coverage_demo + [4] Error in the file '../../../Workflow-Corpus-Open-License/IARCbioinfo/nf_coverage_demo/plot_coverage.nf': 'coverage' is trying to be created as a channel, possibly at line 3. It already exists as a process or a subworkflow in the nextflow file. + +- 394 ../../../Workflow-Corpus-Open-License/IARCbioinfo/gene-fusions-nf + [4] Error in the file '../../../Workflow-Corpus-Open-License/IARCbioinfo/gene-fusions-nf/main.nf': 'arriba' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file. + +- 400 ../../../Workflow-Corpus-Open-License/jianhong/universalModule + [10] Error in the file '../../../Workflow-Corpus-Open-License/jianhong/universalModule/chipseq.nf': Something went wrong in an include, possibly at line 14. No such file: '../../../Workflow-Corpus-Open-License/jianhong/universalModule/loadModule(checksum,.nf'. + +- 414 ../../../Workflow-Corpus-Open-License/wassermanlab/Variant_catalogue_pipeline + [4] Error in the file '../../../Workflow-Corpus-Open-License/wassermanlab/Variant_catalogue_pipeline/subworkflow/SNV.nf': 'SNV' is trying to be created as a channel, possibly at line 27. It already exists as a process or a subworkflow in the nextflow file. + +- 419 ../../../Workflow-Corpus-Open-License/BrianLohman/cellranger-nf + [16] Error in the file '../../../Workflow-Corpus-Open-License/BrianLohman/cellranger-nf/main.nf': An odd number of '"""' was found in the code. + +- 428 ../../../Workflow-Corpus-Open-License/limrp/nextflow_subworkflow + [2] Error in the file '../../../Workflow-Corpus-Open-License/limrp/nextflow_subworkflow/subworkflows/local/fasta_metaprodigal_cdhit.nf': Not the same number of parameters given as input for the process 'PRODIGAL', possibly at line 21. + +- 429 ../../../Workflow-Corpus-Open-License/zajakin/sRNAflow + [16] Error in the file '../../../Workflow-Corpus-Open-License/zajakin/sRNAflow/sRNAflow.nf': No 'main' workflow was found. + +- 436 ../../../Workflow-Corpus-Open-License/kullrich/snpless-nf + [4] Error in the file '../../../Workflow-Corpus-Open-License/kullrich/snpless-nf/main.nf': 'genmap' is trying to be created as a channel, possibly at line 263. It already exists as a process or a subworkflow in the nextflow file. + +- 437 ../../../Workflow-Corpus-Open-License/BPHL-Molecular/Sanibel + [2] Error in the file '../../../Workflow-Corpus-Open-License/BPHL-Molecular/Sanibel/flaq_amr_plus2.nf': Not the same number of parameters given as input for the process 'plusAnalyses'. + +- 444 ../../../Workflow-Corpus-Open-License/evotools/nSPECTRa + [4] Error in the file '../../../Workflow-Corpus-Open-License/evotools/nSPECTRa/include/workflow/mutyper.nf': 'chromosomeList' is trying to be created as a channel, possibly at line 10. It already exists as a process or a subworkflow in the nextflow file. + +- 445 ../../../Workflow-Corpus-Open-License/evotools/nf-LO + [18] Error in the file '../../../Workflow-Corpus-Open-License/evotools/nf-LO/modules/processes/blat.nf': 'blat_custom' is expected to be defined in the file, but it could not be found. + +- 449 ../../../Workflow-Corpus-Open-License/yash-puligundla/samtools-head-nf + [16] Error in the file '../../../Workflow-Corpus-Open-License/yash-puligundla/samtools-head-nf/main.nf': No 'main' workflow was found. + +- 450 ../../../Workflow-Corpus-Open-License/jaumereig/geneidBLASTx-nf + [10] Error in the file '../../../Workflow-Corpus-Open-License/jaumereig/geneidBLASTx-nf/main.nf': Something went wrong in an include, possibly at line 68. No such file: '../../../Workflow-Corpus-Open-License/jaumereig/geneidBLASTx-nf/${subwork_folder}/tools.nf'. + +- 453 ../../../Workflow-Corpus-Open-License/palfalvi/rnaseq + [8] Error in the file '../../../Workflow-Corpus-Open-License/palfalvi/rnaseq/main.nf': The call for 'run_fastSE_qc' coudn't be found, before its use in the operation 'salmon_quantSE.out.collect().concat(run_fastSE_qc.out.collect())', possibly at line 217. Either because the call wasn't made before the operation or that the element it is calling doesn't exist. + +- 457 ../../../Workflow-Corpus-Open-License/MrOlm/nf-genomeresolvedmetagenomics + [16] Error in the file '../../../Workflow-Corpus-Open-License/MrOlm/nf-genomeresolvedmetagenomics/main.nf': No 'main' workflow was found. + +- 460 ../../../Workflow-Corpus-Open-License/raimondsre/population_scale_wgs_nextflow + [4] Error in the file '../../../Workflow-Corpus-Open-License/raimondsre/population_scale_wgs_nextflow/main.nf': 'PCA' is trying to be created as a channel, possibly at line 1. It already exists as a process or a subworkflow in the nextflow file. + +- 461 ../../../Workflow-Corpus-Open-License/sanger-bentley-group/GBS-Typer-sanger-nf + [2] Error in the file '../../../Workflow-Corpus-Open-License/sanger-bentley-group/GBS-Typer-sanger-nf/main.nf': Not the same number of parameters given as input for the process 'freebayes', possibly at line 159. + +- 462 ../../../Workflow-Corpus-Open-License/sanger-bentley-group/gps-pipeline + [18] Error in the file '../../../Workflow-Corpus-Open-License/sanger-bentley-group/gps-pipeline/modules/messages.nf': 'startMessage' is expected to be defined in the file, but it could not be found. + +- 463 ../../../Workflow-Corpus-Open-License/mpieva/quicksand + [4] Error in the file '../../../Workflow-Corpus-Open-License/mpieva/quicksand/workflows/00_setup.nf': 'setup' is trying to be created as a channel, possibly at line 6. It already exists as a process or a subworkflow in the nextflow file. + +- 471 ../../../Workflow-Corpus-Open-License/soulj/SkeletalVis-SingleCell + [2] Error in the file '../../../Workflow-Corpus-Open-License/soulj/SkeletalVis-SingleCell/main.nf': Not the same number of parameters given as input for the process 'ENA_DOWNLOAD', possibly at line 123. + +- 472 ../../../Workflow-Corpus-Open-License/haniffalab/webatlas-pipeline + [16] Error in the file '../../../Workflow-Corpus-Open-License/haniffalab/webatlas-pipeline/main.nf': No 'main' workflow was found. + +- 494 ../../../Workflow-Corpus-Open-License/RenzoTale88/nf-LO + [18] Error in the file '../../../Workflow-Corpus-Open-License/RenzoTale88/nf-LO/modules/processes/blat.nf': 'blat_custom' is expected to be defined in the file, but it could not be found. + +- 496 ../../../Workflow-Corpus-Open-License/UPHL-BioNGS/walkercreek + [22] Error in the file '../../../Workflow-Corpus-Open-License/UPHL-BioNGS/walkercreek/subworkflows/local/preprocessing_read_qc.nf': Multiple 'emit:' were found in the subworkflow 'PREPROCESSING_READ_QC'. + +- 498 ../../../Workflow-Corpus-Open-License/UPHL-BioNGS/Cecret + [4] Error in the file '../../../Workflow-Corpus-Open-License/UPHL-BioNGS/Cecret/subworkflows/msa.nf': 'msa' is trying to be created as a channel, possibly at line 7. It already exists as a process or a subworkflow in the nextflow file. + +- 499 ../../../Workflow-Corpus-Open-License/UPHL-BioNGS/Donut_Falls + [4] Error in the file '../../../Workflow-Corpus-Open-License/UPHL-BioNGS/Donut_Falls/workflows/assembly.nf': 'assembly' is trying to be created as a channel, possibly at line 11. It already exists as a process or a subworkflow in the nextflow file. + +- 500 ../../../Workflow-Corpus-Open-License/UPHL-BioNGS/Grandeur + [4] Error in the file '../../../Workflow-Corpus-Open-License/UPHL-BioNGS/Grandeur/subworkflows/average_nucleotide_identity.nf': 'datasets_summary' is trying to be created as a channel, possibly at line 6. It already exists as a process or a subworkflow in the nextflow file. + +- 505 ../../../Workflow-Corpus-Open-License/ikmb/nf-template + [2] Error in the file '../../../Workflow-Corpus-Open-License/ikmb/nf-template/main.nf': Not the same number of parameters given as input for the subworklfow 'MAIN' in the call, possibly at line 38. + +- 510 ../../../Workflow-Corpus-Open-License/h3abionet/TADA + [22] Error in the file '../../../Workflow-Corpus-Open-License/h3abionet/TADA/main.nf': Multiple 'when:' were found in the process 'ToQIIME2Aln'. + +- 516 ../../../Workflow-Corpus-Open-License/NorwegianVeterinaryInstitute/nextflow_patterns + [8] Error in the file '../../../Workflow-Corpus-Open-License/NorwegianVeterinaryInstitute/nextflow_patterns/emit_example.nf': The call for 'doo_foo' coudn't be found, before its use in the operation 'doo_foo.out.foo_item', possibly at line 44. Either because the call wasn't made before the operation or that the element it is calling doesn't exist. + +- 519 ../../../Workflow-Corpus-Open-License/guigolab/FA-nf + [16] Error in the file '../../../Workflow-Corpus-Open-License/guigolab/FA-nf/main.nf': Not the same number of opening and closing parentheses '()' in the file. + +- 522 ../../../Workflow-Corpus-Open-License/guigolab/geneidx + [10] Error in the file '../../../Workflow-Corpus-Open-License/guigolab/geneidx/main.nf': Something went wrong in an include, possibly at line 34. No such file: '../../../Workflow-Corpus-Open-License/guigolab/geneidx/${wk_folder}/GENEIDX.nf'. + +- 523 ../../../Workflow-Corpus-Open-License/guigolab/ipsa-nf + [4] Error in the file '../../../Workflow-Corpus-Open-License/guigolab/ipsa-nf/ipsa.nf': 'ssjA06' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file. + +- 527 ../../../Workflow-Corpus-Open-License/WangLab-ComputationalBiology/btc-scrna-pipeline + [10] Error in the file '../../../Workflow-Corpus-Open-License/WangLab-ComputationalBiology/btc-scrna-pipeline/subworkflows/local/input_check.nf': Something went wrong in an include, possibly at line 5. No such file: '../../../Workflow-Corpus-Open-License/WangLab-ComputationalBiology/btc-scrna-pipeline/modules/local/samplesheet_check.nf'. + +- 541 ../../../Workflow-Corpus-Open-License/Plant-Food-Research-Open/assembly_qc + [14] Error in the file '../../../Workflow-Corpus-Open-License/Plant-Food-Research-Open/assembly_qc/subworkflows/local/tidk.nf': 'set { ch_list_of_a_posteriori_tidk_plots }' is neither a process, subworkflow or an operator. In the executor 'ch_explored_repeat_seq + .join( + ch_sorted_hap_file + ) + | SEARCH_A_POSTERIORI_REPEAT_SEQ + | PLOT_A_POSTERIORI_REPEAT_SEQ + | collect + | set { ch_list_of_a_posteriori_tidk_plots }', possibly at line 18. + +- 545 ../../../Workflow-Corpus-Open-License/nf-core/raredisease + [20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/raredisease/workflows/raredisease.nf': To much to unpack : The subworkflow 'PREPARE_REFERENCES' emits over one channel in a operation, possibly at line 164. + +- 549 ../../../Workflow-Corpus-Open-License/nf-core/genomeannotator + [8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/genomeannotator/workflows/genomeannotator.nf': The call for 'AUGUSTUS_TRAINING' coudn't be found, before its use in the operation 'ch_aug_config_final = AUGUSTUS_TRAINING.out.aug_config_folder', possibly at line 293. Either because the call wasn't made before the operation or that the element it is calling doesn't exist. + +- 550 ../../../Workflow-Corpus-Open-License/nf-core/circrna + [20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/circrna/workflows/circrna.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 115. + +- 551 ../../../Workflow-Corpus-Open-License/nf-core/ampliseq + [20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/ampliseq/workflows/ampliseq.nf': To much to unpack : The subworkflow 'CUTADAPT_WORKFLOW' emits over one channel in a operation, possibly at line 323. + +- 552 ../../../Workflow-Corpus-Open-License/nf-core/readsimulator + [8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/readsimulator/workflows/readsimulator/main.nf': The call for 'MERGE_FASTAS' coudn't be found, before its use in the operation 'ch_fasta = MERGE_FASTAS.out.fasta + .map { + meta, fasta -> + return fasta + }', possibly at line 109. Either because the call wasn't made before the operation or that the element it is calling doesn't exist. + +- 553 ../../../Workflow-Corpus-Open-License/nf-core/chipseq + [8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/chipseq/subworkflows/local/prepare_genome.nf': The call for 'UNTAR' coudn't be found, before its use in the operation 'ch_versions = ch_versions.mix(UNTAR.out.versions)', possibly at line 177. Either because the call wasn't made before the operation or that the element it is calling doesn't exist. + +- 554 ../../../Workflow-Corpus-Open-License/nf-core/crisprseq + [8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/crisprseq/workflows/crisprseq_targeted.nf': Tried to access the emit 'PREPROCESSING_SUMMARY.out.versions' but the Process 'PREPROCESSING_SUMMARY' has not been called in the subworkflow 'CRISPRSEQ_TARGETED'. + +- 555 ../../../Workflow-Corpus-Open-License/nf-core/rnafusion + [20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/rnafusion/workflows/rnafusion.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 126. + +- 559 ../../../Workflow-Corpus-Open-License/nf-core/mag + [2] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/mag/subworkflows/local/binning.nf': Not the same number of parameters given as input for the subworklfow 'FASTA_BINNING_CONCOCT' in the call, possibly at line 97. + +- 564 ../../../Workflow-Corpus-Open-License/nf-core/mhcquant + [22] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/mhcquant/modules/local/samplesheet_check.nf': Multiple 'when:' were found in the process 'SAMPLESHEET_CHECK'. + +- 565 ../../../Workflow-Corpus-Open-License/nf-core/airrflow + [14] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/airrflow/subworkflows/local/assembled_input_check.nf': 'fa]$/ + tsv: it[0].filename =~ /tsv$/ + } + .set{ ch_metadata }' is neither a process, subworkflow or an operator. In the executor 'ch_validated_input + .splitCsv(header: true, sep:'\t') + .map { get_meta(it) } + .branch { it -> + fasta: it[0].filename =~ /[fasta|fa]$/ + tsv: it[0].filename =~ /tsv$/ + } + .set{ ch_metadata }', possibly at line 21. + +- 567 ../../../Workflow-Corpus-Open-License/nf-core/rnasplice + [20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/rnasplice/workflows/rnasplice.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 161. + +- 569 ../../../Workflow-Corpus-Open-License/nf-core/demultiplex + [8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/demultiplex/workflows/demultiplex.nf': Tried to access the emit 'UNTAR.out.versions' but the Process 'UNTAR' has not been called in the subworkflow 'DEMULTIPLEX'. + +- 572 ../../../Workflow-Corpus-Open-License/nf-core/smrnaseq + [20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/smrnaseq/workflows/smrnaseq.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 104. + +- 573 ../../../Workflow-Corpus-Open-License/nf-core/dualrnaseq + [4] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/dualrnaseq/main.nf': 'salmon_index' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file. + +- 574 ../../../Workflow-Corpus-Open-License/nf-core/nascent + [8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/nascent/subworkflows/local/prepare_genome.nf': The call for 'UNTAR_DRAGMAP_INDEX' coudn't be found, before its use in the operation 'ch_versions = ch_versions.mix(UNTAR_DRAGMAP_INDEX.out.versions)', possibly at line 122. Either because the call wasn't made before the operation or that the element it is calling doesn't exist. + +- 577 ../../../Workflow-Corpus-Open-License/nf-core/configs + [16] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/configs/configtest.nf': No 'main' workflow was found. + +- 579 ../../../Workflow-Corpus-Open-License/nf-core/modules + [16] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/modules/main.nf': No 'main' workflow was found. + +- 581 ../../../Workflow-Corpus-Open-License/nf-core/ssds + [8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/ssds/subworkflows/local/sort_and_index_bam.nf': The call for 'SAMTOOLS_SORTSAM' coudn't be found, before its use in the operation 'ch_versions = ch_versions.mix(SAMTOOLS_SORTSAM.out.versions.first())', possibly at line 17. Either because the call wasn't made before the operation or that the element it is calling doesn't exist. + +- 583 ../../../Workflow-Corpus-Open-License/nf-core/phageannotator + [20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/phageannotator/workflows/phageannotator/main.nf': To much to unpack : The subworkflow 'FASTQ_VIRUS_ENRICHMENT_VIROMEQC' emits over one channel in a operation, possibly at line 78. + +- 585 ../../../Workflow-Corpus-Open-License/nf-core/metaboigniter + [14] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/metaboigniter/subworkflows/local/mergems1ms2.nf': 'OPENMS_FILEMERGER' is neither a process, subworkflow or an operator. In the executor 'mzml_files.filter{meta,file->meta.level != "MS2"}.combine(OPENMS_FILEFILTERMS2.out.mzml.map{it[1]}).groupTuple(by:[0,1]) | OPENMS_FILEMERGER', possibly at line 19. + +- 586 ../../../Workflow-Corpus-Open-License/nf-core/epitopeprediction + [8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/epitopeprediction/workflows/epitopeprediction.nf': The call for 'SHOW_SUPPORTED_MODELS' coudn't be found, before its use in the operation 'ch_versions = ch_versions.mix(SHOW_SUPPORTED_MODELS.out.versions.ifEmpty(null))', possibly at line 180. Either because the call wasn't made before the operation or that the element it is calling doesn't exist. + +- 590 ../../../Workflow-Corpus-Open-License/nf-core/genomeassembler + [2] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/genomeassembler/subworkflows/local/evaluate_gene_space.nf': Not the same number of parameters given as input for the process 'BUSCO', possibly at line 10. + +- 591 ../../../Workflow-Corpus-Open-License/nf-core/circdna + [20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/circdna/workflows/circdna.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 190. + +- 592 ../../../Workflow-Corpus-Open-License/nf-core/fetchngs + [2] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/fetchngs/main.nf': Not the same number of parameters given as input for the subworklfow 'SYNAPSE' in the call, possibly at line 46. + +- 593 ../../../Workflow-Corpus-Open-License/nf-core/multiplesequencealign + [22] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/multiplesequencealign/modules/local/prepare_shiny.nf': Multiple 'when:' were found in the process 'PREPARE_SHINY'. + +- 597 ../../../Workflow-Corpus-Open-License/nf-core/taxprofiler + [20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/taxprofiler/subworkflows/local/shortread_preprocessing.nf': To much to unpack : The subworkflow 'SHORTREAD_FASTP' emits over one channel in a operation, possibly at line 21. + +- 598 ../../../Workflow-Corpus-Open-License/nf-core/metatdenovo + [20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/metatdenovo/workflows/metatdenovo.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 146. + +- 599 ../../../Workflow-Corpus-Open-License/nf-core/viralrecon + [20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/viralrecon/workflows/illumina.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 163. + +- 600 ../../../Workflow-Corpus-Open-License/nf-core/scrnaseq + [20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/scrnaseq/workflows/scrnaseq.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 121. + +- 602 ../../../Workflow-Corpus-Open-License/nf-core/rnadnavar + [8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/rnadnavar/subworkflows/local/prepare_genome/main.nf': The call for 'GUNZIP_GFF' coudn't be found, before its use in the operation 'ch_gff = GUNZIP_GFF.out.gunzip.map{ meta, gff -> [gff] }.collect()', possibly at line 98. Either because the call wasn't made before the operation or that the element it is calling doesn't exist. + +- 606 ../../../Workflow-Corpus-Open-License/nf-core/rnavar + [20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/rnavar/workflows/rnavar.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 138. + +- 610 ../../../Workflow-Corpus-Open-License/nf-core/nanoseq + [8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/nanoseq/subworkflows/local/rna_modifications_xpore_m6anet.nf': Tried to access the emit 'NANOPOLISH_INDEX_EVENTALIGN.out.nanopolish_outputs' but the Process 'NANOPOLISH_INDEX_EVENTALIGN' has not been called in the subworkflow 'RNA_MODIFICATION_XPORE_M6ANET'. + +- 612 ../../../Workflow-Corpus-Open-License/nf-core/radseq + [20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/radseq/workflows/radseq.nf': To much to unpack : The subworkflow 'CDHIT_RAINBOW' emits over one channel in a operation, possibly at line 97. + +- 613 ../../../Workflow-Corpus-Open-License/nf-core/atacseq + [8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/atacseq/subworkflows/local/prepare_genome.nf': The call for 'UNTAR' coudn't be found, before its use in the operation 'ch_versions = ch_versions.mix(UNTAR.out.versions)', possibly at line 199. Either because the call wasn't made before the operation or that the element it is calling doesn't exist. + +- 614 ../../../Workflow-Corpus-Open-License/nf-core/proteinfold + [20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/proteinfold/workflows/alphafold2.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 81. + +- 620 ../../../Workflow-Corpus-Open-License/nf-core/quantms + [14] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/quantms/workflows/quantms.nf': 'set {ch_db_for_decoy_creation_or_null}' is neither a process, subworkflow or an operator. In the executor 'CREATE_INPUT_CHANNEL.out.ch_meta_config_iso.mix(CREATE_INPUT_CHANNEL.out.ch_meta_config_lfq).first() + | combine( ch_db_for_decoy_creation ) + | map { it[-1] } + | set {ch_db_for_decoy_creation_or_null}', possibly at line 135. + +- 623 ../../../Workflow-Corpus-Open-License/lisemangiante/test_nextflow + [4] Error in the file '../../../Workflow-Corpus-Open-License/lisemangiante/test_nextflow/plot_coverage.nf': 'coverage' is trying to be created as a channel, possibly at line 3. It already exists as a process or a subworkflow in the nextflow file. + +- 635 ../../../Workflow-Corpus-Open-License/matsengrp/phip-flow + [14] Error in the file '../../../Workflow-Corpus-Open-License/matsengrp/phip-flow/workflows/edgeR_BEER.nf': In the executor 'ds | to_csv | run_edgeR | run_BEER | (append_assay_csvs_to_xarray & publish_rds)', '(append_assay_csvs_to_xarray & publish_rds)' is neither a process, subworkflow or an operator (in the file '../../../Workflow-Corpus-Open-License/matsengrp/phip-flow/workflows/edgeR_BEER.nf') + +- 644 ../../../Workflow-Corpus-Open-License/Ensembl/ensembl-genes-nf + [16] Error in the file '../../../Workflow-Corpus-Open-License/Ensembl/ensembl-genes-nf/modules.nf': No 'main' workflow was found. + +- 645 ../../../Workflow-Corpus-Open-License/cnr-ibba/nf-resequencing-mem + [20] Error in the file '../../../Workflow-Corpus-Open-License/cnr-ibba/nf-resequencing-mem/workflows/resequencing-mem.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 67. + +- 647 ../../../Workflow-Corpus-Open-License/alam1988/Nextflow + [12] Error in the file '../../../Workflow-Corpus-Open-License/alam1988/Nextflow/main.nf': An include ('include { SRA_DOWNLOAD } from './sra_download'') was found in the main in the file '../../../Workflow-Corpus-Open-License/alam1988/Nextflow/main.nf'. FlowInsight does not support this -> see specification list. + +- 650 ../../../Workflow-Corpus-Open-License/chrisjackson-pellicle/hybpiper-nf + [22] Error in the file '../../../Workflow-Corpus-Open-License/chrisjackson-pellicle/hybpiper-nf/hybpiper.nf': Multiple 'take:' were found in the subworkflow 'fix_targetfile_main'. + +- 658 ../../../Workflow-Corpus-Open-License/VEuPathDB/MicrobiomeDB + [16] Error in the file '../../../Workflow-Corpus-Open-License/VEuPathDB/MicrobiomeDB/main.nf': No 'main' workflow was found. + +- 659 ../../../Workflow-Corpus-Open-License/VEuPathDB/bowtie-mapping-nextflow + [6] Error in the file '../../../Workflow-Corpus-Open-License/VEuPathDB/bowtie-mapping-nextflow/modules/bowtieMapping.nf': One channel was expected in the emit 'makeIndex.out'. Even though multiple emits are defined for the workflow 'makeIndex' + +- 663 ../../../Workflow-Corpus-Open-License/PlantGGHLab/qiime2-nf + [16] Error in the file '../../../Workflow-Corpus-Open-License/PlantGGHLab/qiime2-nf/main.nf': No 'main' workflow was found. + +- 670 ../../../Workflow-Corpus-Open-License/bhagesh-codebeast/nextflowdualrnaseq + [4] Error in the file '../../../Workflow-Corpus-Open-License/bhagesh-codebeast/nextflowdualrnaseq/main.nf': 'salmon_index' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file. + +- 672 ../../../Workflow-Corpus-Open-License/msk-mind/clam-nf + [4] Error in the file '../../../Workflow-Corpus-Open-License/msk-mind/clam-nf/main.nf': 'GET_SLIDES' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file. + +- 673 ../../../Workflow-Corpus-Open-License/msk-mind/oncofusion-nf + [4] Error in the file '../../../Workflow-Corpus-Open-License/msk-mind/oncofusion-nf/main.nf': 'GET_SLIDES' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file. + +- 675 ../../../Workflow-Corpus-Open-License/sifrimlab/ST-nextflow-pipeline + [16] Error in the file '../../../Workflow-Corpus-Open-License/sifrimlab/ST-nextflow-pipeline/main.nf': No 'main' workflow was found. + diff --git a/study.ipynb b/study.ipynb index 4c49c9bc977fc417636d2d550ab932c3d1bbf073..53e186af295aa81a01401ee6b4686108ad6b6ce7 100644 --- a/study.ipynb +++ b/study.ipynb @@ -1,259 +1,1339 @@ { "cells": [ { - "cell_type": "code", - "execution_count": 1, + "cell_type": "markdown", "metadata": {}, - "outputs": [], "source": [ - "import os\n", - "import json" + "# Analysis of a large dataset of workflows" ] }, { - "cell_type": "code", - "execution_count": null, + "cell_type": "markdown", "metadata": {}, - "outputs": [], "source": [ - "from github_crawler.download_corpus import" + "> Important: Even though the code presented here allows for obtaining the results of the analysis of the large dataset of workflows, including downloading and analyzing the workflows, it does not necessarily guarantee full reproducibility. Since the workflows are downloaded from GitHub, they can continue to evolve (e.g., updates or modifications, or even deletion). In such cases, the results may vary. For the results presented in the paper, the workflows were downloaded on the 16th of February 2024." ] }, { "cell_type": "code", - "execution_count": 7, + "execution_count": 1, "metadata": {}, "outputs": [ - { - "name": "stdout", - "output_type": "stream", - "text": [ - "* 1/752\n", - "Downloading...'HadrienG/nextflow_rna'\n" - ] - }, - { - "name": "stderr", - "output_type": "stream", - "text": [ - "mkdir: opérande manquant\n", - "Saisissez « mkdir --help » pour plus d'informations.\n", - "Clonage dans '../../../Workflow-Corpus-Open-License/HadrienG/nextflow_rna'...\n" - ] - }, - { - "name": "stdout", - "output_type": "stream", - "text": [ - "\n", - "\n", - "\n", - "* 2/752\n", - "Downloading...'IARCbioinfo/CODEX-nf'\n" - ] - }, - { - "name": "stderr", - "output_type": "stream", - "text": [ - "mkdir: opérande manquant\n", - "Saisissez « mkdir --help » pour plus d'informations.\n", - "Clonage dans '../../../Workflow-Corpus-Open-License/IARCbioinfo/CODEX-nf'...\n" - ] - }, - { - "name": "stdout", - "output_type": "stream", - "text": [ - "\n", - "\n", - "\n", - "* 3/752\n", - "Downloading...'AndersenLab/ril-nf'\n" - ] - }, - { - "name": "stderr", - "output_type": "stream", - "text": [ - "mkdir: opérande manquant\n", - "Saisissez « mkdir --help » pour plus d'informations.\n", - "Clonage dans '../../../Workflow-Corpus-Open-License/AndersenLab/ril-nf'...\n" - ] - }, - { - "name": "stdout", - "output_type": "stream", - "text": [ - "\n", - "\n", - "\n", - "* 4/752\n", - "Downloading...'robsyme/markerdev'\n" - ] - }, - { - "name": "stderr", - "output_type": "stream", - "text": [ - "mkdir: opérande manquant\n", - "Saisissez « mkdir --help » pour plus d'informations.\n", - "Clonage dans '../../../Workflow-Corpus-Open-License/robsyme/markerdev'...\n" - ] - }, - { - "name": "stdout", - "output_type": "stream", - "text": [ - "\n", - "\n", - "\n", - "* 5/752\n", - "\n", - "\n", - "\n", - "* 6/752\n", - "Downloading...'ctmrbio/BACTpipe'\n" - ] - }, { "name": "stderr", "output_type": "stream", "text": [ - "mkdir: opérande manquant\n", - "Saisissez « mkdir --help » pour plus d'informations.\n", - "Clonage dans '../../../Workflow-Corpus-Open-License/ctmrbio/BACTpipe'...\n" + "/usr/lib/python3/dist-packages/scipy/__init__.py:146: UserWarning: A NumPy version >=1.17.3 and <1.25.0 is required for this version of SciPy (detected version 1.26.1\n", + " warnings.warn(f\"A NumPy version >={np_minversion} and <{np_maxversion}\"\n" ] - }, + } + ], + "source": [ + "import os\n", + "import json\n", + "import glob\n", + "import pandas as pd\n", + "import matplotlib as plt\n", + "import seaborn as sns\n", + "import re\n", + "\n", + "current_path= os.getcwd()\n", + "os.chdir(\"github-crawler/\")\n", + "from download_corpus import download\n", + "os.chdir(current_path)\n", + "\n", + "os.chdir(\"bioflow-insight/\")\n", + "from src.nextflow_file import Nextflow_File\n", + "from src.workflow import Workflow\n", + "from src.bioflowinsighterror import BioFlowInsightError\n", + "os.chdir(current_path)\n" + ] + }, + { + "cell_type": "code", + "execution_count": 2, + "metadata": {}, + "outputs": [], + "source": [ + "sns.set(style = 'darkgrid', palette = \"Accent\")\n", + "taille = (9, 5)" + ] + }, + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Parameters" + ] + }, + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "These parameters allow the user to choose what elements of the analysis they want to be done." + ] + }, + { + "cell_type": "code", + "execution_count": 3, + "metadata": {}, + "outputs": [], + "source": [ + "#Bool to download workflow\n", + "download_files = False\n", + "#Path to folder containing workflows (where they will also be downloaded)\n", + "path_2_workflows = \"../../../Workflow-Corpus-Open-License\"\n", + "#Bool to run analysis ~6minutes on a 13th Gen Intel® Core™ i5-1335U × 12 (32gb of ram)\n", + "run_analysis_on_corpus = True\n", + "#Bool to analyse the results\n", + "analyse_results = True\n" + ] + }, + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Creating the corpus" + ] + }, + { + "cell_type": "code", + "execution_count": 4, + "metadata": {}, + "outputs": [], + "source": [ + "#Read crawler results\n", + "with open(\"./github-crawler/wf_crawl_nextflow.json\") as json_file:\n", + " crawler = json.load(json_file)\n", + "_ = crawler.pop(\"last_date\")\n", + "\n", + "#Downloading the files\n", + "if(download_files):\n", + " download(path_2_workflows, crawler)" + ] + }, + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Running the analysis on the corpus" + ] + }, + { + "cell_type": "code", + "execution_count": 5, + "metadata": {}, + "outputs": [ { "name": "stdout", "output_type": "stream", "text": [ - "\n", - "\n", - "\n", - "* 7/752\n", - "Downloading...'danielecook/nextflow-tutorial'\n" + "In total there are 678 workflows.\n" ] - }, - { - "name": "stderr", - "output_type": "stream", - "text": [ - "mkdir: opérande manquant\n", - "Saisissez « mkdir --help » pour plus d'informations.\n", - "Clonage dans '../../../Workflow-Corpus-Open-License/danielecook/nextflow-tutorial'...\n" - ] - }, + } + ], + "source": [ + "workflows = glob.glob(f'{path_2_workflows}/*/*', recursive=False)\n", + "\n", + "print(f\"In total there are {len(workflows)} workflows.\")" + ] + }, + { + "cell_type": "code", + "execution_count": 6, + "metadata": {}, + "outputs": [ { "name": "stdout", "output_type": "stream", "text": [ - "\n", - "\n", - "\n", - "* 8/752\n", - "Downloading...'IARCbioinfo/bamsurgeon-nf'\n" + "0 ../../../Workflow-Corpus-Open-License/KevinMenden/hybrid-assembly\n", + "1 ../../../Workflow-Corpus-Open-License/ezorita/chip-nf\n", + "2 ../../../Workflow-Corpus-Open-License/GiantSpaceRobot/tsRNAsearch\n", + "3 ../../../Workflow-Corpus-Open-License/ctmrbio/BACTpipe\n", + "4 ../../../Workflow-Corpus-Open-License/wtsi-hgi/nf_cellbender\n", + "5 ../../../Workflow-Corpus-Open-License/grbot/run-fastqc\n", + "6 ../../../Workflow-Corpus-Open-License/grbot/nextflow-hack17-tutorial\n", + "7 ../../../Workflow-Corpus-Open-License/hunglin59638/plott\n", + "8 ../../../Workflow-Corpus-Open-License/codingene/nextflow-base\n", + "9 ../../../Workflow-Corpus-Open-License/UMCUGenetics/NF-IAP\n", + "[10] Error in the file '../../../Workflow-Corpus-Open-License/UMCUGenetics/NF-IAP/nf-iap.nf': Something went wrong in an include, possibly at line 88. No such file: '../../../Workflow-Corpus-Open-License/UMCUGenetics/NF-IAP/NextflowModules/Utils/fastq.nf'.\n", + "10 ../../../Workflow-Corpus-Open-License/UMCUGenetics/DxNextflowWGS\n", + "[10] Error in the file '../../../Workflow-Corpus-Open-License/UMCUGenetics/DxNextflowWGS/WGS.nf': Something went wrong in an include, possibly at line 5. No such file: '../../../Workflow-Corpus-Open-License/UMCUGenetics/DxNextflowWGS/NextflowModules/Utils/fastq.nf'.\n", + "11 ../../../Workflow-Corpus-Open-License/UMCUGenetics/DxNextflowWES\n", + "[10] Error in the file '../../../Workflow-Corpus-Open-License/UMCUGenetics/DxNextflowWES/WES_Fingerprint.nf': Something went wrong in an include, possibly at line 5. No such file: '../../../Workflow-Corpus-Open-License/UMCUGenetics/DxNextflowWES/NextflowModules/Utils/bam.nf'.\n", + "12 ../../../Workflow-Corpus-Open-License/Aveglia/vAMPirus\n", + "13 ../../../Workflow-Corpus-Open-License/telatin/cleanup\n", + "14 ../../../Workflow-Corpus-Open-License/Gregor-Mendel-Institute/nf-methylpy\n", + "15 ../../../Workflow-Corpus-Open-License/Gregor-Mendel-Institute/kWIP-nf\n", + "16 ../../../Workflow-Corpus-Open-License/Gregor-Mendel-Institute/aradeepopsis\n", + "[3] Error in the file '../../../Workflow-Corpus-Open-License/Gregor-Mendel-Institute/aradeepopsis/workflows/aradeepopsis.nf': Don't know how to handle '( params.masks ? MASKS : SEGMENT )' in a pipe operator, possibly at line 56. Try using the recommended operator composition.\n", + "17 ../../../Workflow-Corpus-Open-License/marcodelapierre/trinity-nf\n", + "18 ../../../Workflow-Corpus-Open-License/marcodelapierre/toy-gpu-nf\n", + "19 ../../../Workflow-Corpus-Open-License/marcodelapierre/nanopore-nf\n", + "20 ../../../Workflow-Corpus-Open-License/marcodelapierre/hello-nextflow\n", + "21 ../../../Workflow-Corpus-Open-License/marcodelapierre/illumina-nf\n", + "22 ../../../Workflow-Corpus-Open-License/maxemil/ALE-pipeline\n", + "23 ../../../Workflow-Corpus-Open-License/maxemil/Biodiversity-pipeline\n", + "24 ../../../Workflow-Corpus-Open-License/brwnj/smoove-nf\n", + "[5] Error in the file '../../../Workflow-Corpus-Open-License/brwnj/smoove-nf/main.nf': A ternary conditional operator was used with an tuple, possibly at line 297. BioFlow-Insight doesn't support this yet (see specification list), try defining the operation in a different way.\n", + "25 ../../../Workflow-Corpus-Open-License/brwnj/facets-nf\n", + "26 ../../../Workflow-Corpus-Open-License/brwnj/covviz\n", + "[5] Error in the file '../../../Workflow-Corpus-Open-License/brwnj/covviz/main.nf': A ternary conditional operator was used with an tuple, possibly at line 125. BioFlow-Insight doesn't support this yet (see specification list), try defining the operation in a different way.\n", + "27 ../../../Workflow-Corpus-Open-License/brwnj/idplot\n", + "28 ../../../Workflow-Corpus-Open-License/phc-health/nextflow-pangolin\n", + "29 ../../../Workflow-Corpus-Open-License/phipsonlab/NextClone\n", + "30 ../../../Workflow-Corpus-Open-License/SFGLab/ConsensuSV-nf-pipeline\n", + "31 ../../../Workflow-Corpus-Open-License/canceromics/MeRIPseqPipe\n", + "32 ../../../Workflow-Corpus-Open-License/AustralianBioCommons/Nextflow_DSL2_template\n", + "33 ../../../Workflow-Corpus-Open-License/AustralianBioCommons/hifi-assembly-workflow\n", + "34 ../../../Workflow-Corpus-Open-License/genomic-medicine-sweden/jasen\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/genomic-medicine-sweden/jasen/workflows/bacterial_base.nf': 'quast' is trying to be created as a channel, possibly at line 16. It already exists as a process or a subworkflow in the nextflow file.\n", + "35 ../../../Workflow-Corpus-Open-License/stracquadaniolab/cubseq-nf\n", + "36 ../../../Workflow-Corpus-Open-License/stracquadaniolab/quick-rnaseq-nf\n", + "37 ../../../Workflow-Corpus-Open-License/APHA-CSU/hello-nextflow\n", + "38 ../../../Workflow-Corpus-Open-License/eipm/hello-mess-nf\n", + "39 ../../../Workflow-Corpus-Open-License/amchakra/tosca\n", + "40 ../../../Workflow-Corpus-Open-License/ksumngs/v-met\n", + "41 ../../../Workflow-Corpus-Open-License/CenterForMedicalGeneticsGhent/nf-cmgg-germline\n", + "[2] Error in the file '../../../Workflow-Corpus-Open-License/CenterForMedicalGeneticsGhent/nf-cmgg-germline/workflows/cmgg-germline.nf': Not the same number of parameters given as input for the process 'SAMTOOLS_FAIDX', possibly at line 250.\n", + "42 ../../../Workflow-Corpus-Open-License/CenterForMedicalGeneticsGhent/nf-cmgg-structural\n", + "[2] Error in the file '../../../Workflow-Corpus-Open-License/CenterForMedicalGeneticsGhent/nf-cmgg-structural/workflows/cmgg-structural.nf': Not the same number of parameters given as input for the process 'SAMTOOLS_FAIDX', possibly at line 135.\n", + "43 ../../../Workflow-Corpus-Open-License/gerlichlab/scshic_pipeline\n", + "44 ../../../Workflow-Corpus-Open-License/pblaney/mgp1000\n", + "45 ../../../Workflow-Corpus-Open-License/Midnighter/nextflow-utility-services\n", + "46 ../../../Workflow-Corpus-Open-License/Midnighter/nf-slack\n", + "47 ../../../Workflow-Corpus-Open-License/jnoms/virID\n", + "[14] Error in the file '../../../Workflow-Corpus-Open-License/jnoms/virID/virID.nf': 'bwa_mem_contigs' is neither a process, subworkflow or an operator. In the executor 'contigs\n", + " .join(process_read_pairs.out) | bwa_mem_contigs'.\n", + "48 ../../../Workflow-Corpus-Open-License/BioImageTools/ome-zarr-image-analysis-nextflow\n", + "49 ../../../Workflow-Corpus-Open-License/BioImageTools/baysor-nextflow-module\n", + "50 ../../../Workflow-Corpus-Open-License/NajlaBioinfo/nextflow_tmpl\n", + "51 ../../../Workflow-Corpus-Open-License/didrikolofsson/rmappet\n", + "52 ../../../Workflow-Corpus-Open-License/lemaslab/rump\n", + "53 ../../../Workflow-Corpus-Open-License/replikation/docker_pipelines\n", + "54 ../../../Workflow-Corpus-Open-License/replikation/What_the_Phage\n", + "[10] Error in the file '../../../Workflow-Corpus-Open-License/replikation/What_the_Phage/phage_deprecated.nf': Something went wrong in an include, possibly at line 135. No such file: '../../../Workflow-Corpus-Open-License/replikation/What_the_Phage/modules/checkV.nf'.\n", + "55 ../../../Workflow-Corpus-Open-License/TORCH-Consortium/MAGMA\n", + "[20] Error in the file '../../../Workflow-Corpus-Open-License/TORCH-Consortium/MAGMA/main.nf': To much to unpack : The subworkflow 'VALIDATE_FASTQS_WF' emits over one channel in a operation, possibly at line 31.\n", + "56 ../../../Workflow-Corpus-Open-License/wleepang/demo-genomics-workflow-nextflow\n", + "57 ../../../Workflow-Corpus-Open-License/sbilge/nextflow-clinvap\n", + "58 ../../../Workflow-Corpus-Open-License/NickSwainston/nextflow_tutorial\n", + "59 ../../../Workflow-Corpus-Open-License/Hammarn/Nextflow_test\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/Hammarn/Nextflow_test/main.nf': No 'main' workflow was found.\n", + "60 ../../../Workflow-Corpus-Open-License/rdemko2332/downloadFromSra\n", + "61 ../../../Workflow-Corpus-Open-License/maxulysse/nextflow_params_opt\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/maxulysse/nextflow_params_opt/main.nf': No 'main' workflow was found.\n", + "62 ../../../Workflow-Corpus-Open-License/adamd3/BactSeq\n", + "63 ../../../Workflow-Corpus-Open-License/yuukiiwa/CombiPIPE\n", + "64 ../../../Workflow-Corpus-Open-License/abhi18av/nextflow-datascience-titanic-survival-analysis\n", + "[10] Error in the file '../../../Workflow-Corpus-Open-License/abhi18av/nextflow-datascience-titanic-survival-analysis/main.nf': Something went wrong in an include, possibly at line 17. No such file: '../../../Workflow-Corpus-Open-License/abhi18av/nextflow-datascience-titanic-survival-analysis/modules/data/test_train_split/test_train_split.nf'.\n", + "65 ../../../Workflow-Corpus-Open-License/abhi18av/nextflow-module-pattern\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/abhi18av/nextflow-module-pattern/workflow.nf': No 'main' workflow was found.\n", + "66 ../../../Workflow-Corpus-Open-License/abhi18av/nextflow_grid_search\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/abhi18av/nextflow_grid_search/stacked_ensemble_grid_search.nf': No 'main' workflow was found.\n", + "67 ../../../Workflow-Corpus-Open-License/mgimenez720/plaSquid\n", + "[2] Error in the file '../../../Workflow-Corpus-Open-License/mgimenez720/plaSquid/workflows/RIPsearch.nf': Not the same number of parameters given as input for the process 'FilterDom', possibly at line 49.\n", + "68 ../../../Workflow-Corpus-Open-License/bahlolab/PLASTER\n", + "[18] Error in the file '../../../Workflow-Corpus-Open-License/bahlolab/PLASTER/nf/functions.nf': 'path' is expected to be defined in the file, but it could not be found.\n", + "69 ../../../Workflow-Corpus-Open-License/EpiDiverse/snp\n", + "70 ../../../Workflow-Corpus-Open-License/EpiDiverse/ewas\n", + "[9] Error in the file '../../../Workflow-Corpus-Open-License/EpiDiverse/ewas/main.nf': A tuple is associated with an call, possibly at line 283. BioFlow-Insight doesn't support this (see specification list), try defining the operation in a different way.\n", + "71 ../../../Workflow-Corpus-Open-License/EpiDiverse/wgbs\n", + "[9] Error in the file '../../../Workflow-Corpus-Open-License/EpiDiverse/wgbs/main.nf': A tuple is associated with an call, possibly at line 166. BioFlow-Insight doesn't support this (see specification list), try defining the operation in a different way.\n", + "72 ../../../Workflow-Corpus-Open-License/EpiDiverse/dmr\n", + "[9] Error in the file '../../../Workflow-Corpus-Open-License/EpiDiverse/dmr/main.nf': A tuple is associated with an call, possibly at line 210. BioFlow-Insight doesn't support this (see specification list), try defining the operation in a different way.\n", + "73 ../../../Workflow-Corpus-Open-License/TCLamnidis/contammix_pipeline\n", + "74 ../../../Workflow-Corpus-Open-License/TRON-Bioinformatics/tronflow-lofreq\n", + "75 ../../../Workflow-Corpus-Open-License/TRON-Bioinformatics/tronflow-bam-preprocessing\n", + "76 ../../../Workflow-Corpus-Open-License/TRON-Bioinformatics/tronflow-alignment\n", + "77 ../../../Workflow-Corpus-Open-License/TRON-Bioinformatics/tronflow-template\n", + "78 ../../../Workflow-Corpus-Open-License/TRON-Bioinformatics/tronflow-vcf-postprocessing\n", + "79 ../../../Workflow-Corpus-Open-License/TRON-Bioinformatics/tronflow-hla-hd\n", + "80 ../../../Workflow-Corpus-Open-License/TRON-Bioinformatics/tronflow-copy-number-calling\n", + "[10] Error in the file '../../../Workflow-Corpus-Open-License/TRON-Bioinformatics/tronflow-copy-number-calling/main.nf': Something went wrong in an include, possibly at line 7. No such file: '../../../Workflow-Corpus-Open-License/TRON-Bioinformatics/tronflow-copy-number-calling/nf-core-modules/modules/nf-core/samtools/merge/main.nf'.\n", + "81 ../../../Workflow-Corpus-Open-License/TRON-Bioinformatics/covigator-ngs-pipeline\n", + "82 ../../../Workflow-Corpus-Open-License/TRON-Bioinformatics/tronflow-mutect2\n", + "83 ../../../Workflow-Corpus-Open-License/TRON-Bioinformatics/tronflow-strelka2\n", + "84 ../../../Workflow-Corpus-Open-License/TRON-Bioinformatics/tronflow-haplotype-caller\n", + "85 ../../../Workflow-Corpus-Open-License/wishabc/nf-aligning\n", + "86 ../../../Workflow-Corpus-Open-License/data-intuitive/diflow\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/data-intuitive/diflow/main.nf': No 'main' workflow was found.\n", + "87 ../../../Workflow-Corpus-Open-License/mribeirodantas/nf-whisper\n", + "88 ../../../Workflow-Corpus-Open-License/ewels/lightweight-template\n", + "89 ../../../Workflow-Corpus-Open-License/darcyabjones/snptree\n", + "90 ../../../Workflow-Corpus-Open-License/darcyabjones/mumflow\n", + "91 ../../../Workflow-Corpus-Open-License/bioinformaticsclouds/nextflow\n", + "92 ../../../Workflow-Corpus-Open-License/sanger-tol/blobtoolkit\n", + "[14] Error in the file '../../../Workflow-Corpus-Open-License/sanger-tol/blobtoolkit/subworkflows/local/minimap_alignment.nf': 'set { ch_aligned }' is neither a process, subworkflow or an operator. In the executor 'Channel.empty()\n", + " | mix ( MINIMAP2_HIC.out.bam )\n", + " | mix ( MINIMAP2_ILMN.out.bam )\n", + " | mix ( MINIMAP2_CCS.out.bam )\n", + " | mix ( MINIMAP2_CLR.out.bam )\n", + " | mix ( MINIMAP2_ONT.out.bam )\n", + " | set { ch_aligned }', possibly at line 68.\n", + "93 ../../../Workflow-Corpus-Open-License/sanger-tol/sequencecomposition\n", + "[8] Error in the file '../../../Workflow-Corpus-Open-License/sanger-tol/sequencecomposition/subworkflows/local/fasta_windows.nf': The call for 'TABIX_BGZIP ( ch_freq_bed.mix(ch_tsv) )' coudn't be found, before its use in the operation 'ch_compressed_bed = TABIX_BGZIP ( ch_freq_bed.mix(ch_tsv) ).output', possibly at line 67. Either because the call wasn't made before the operation or that the element it is calling doesn't exist.\n", + "94 ../../../Workflow-Corpus-Open-License/sanger-tol/treeval\n", + "95 ../../../Workflow-Corpus-Open-License/sanger-tol/curationpretext\n", + "96 ../../../Workflow-Corpus-Open-License/sanger-tol/gda\n", + "97 ../../../Workflow-Corpus-Open-License/sanger-tol/genomeassembly\n", + "98 ../../../Workflow-Corpus-Open-License/sanger-tol/readmapping\n", + "[14] Error in the file '../../../Workflow-Corpus-Open-License/sanger-tol/readmapping/subworkflows/local/prepare_genome.nf': 'set { ch_bwamem }' is neither a process, subworkflow or an operator. In the executor 'Channel.fromPath ( params.bwamem2_index )\n", + " | combine ( ch_fasta )\n", + " | map { bwa, meta, fa -> [ meta, bwa ] }\n", + " | set { ch_bwamem }', possibly at line 39.\n", + "99 ../../../Workflow-Corpus-Open-License/sanger-tol/genomenote\n", + "[14] Error in the file '../../../Workflow-Corpus-Open-License/sanger-tol/genomenote/subworkflows/local/genome_statistics.nf': 'set { ch_fastk }' is neither a process, subworkflow or an operator. In the executor 'ch_pacbio.file\n", + " | map { meta, bam -> [ meta + [ id: meta.id.split('_')[0..-2].join('_') ], bam ] }\n", + " | groupTuple ( by: [0] )\n", + " | set { ch_fastk }', possibly at line 62.\n", + "100 ../../../Workflow-Corpus-Open-License/edgano/TCoffee-NatureProtocol-nf\n", + "101 ../../../Workflow-Corpus-Open-License/montilab/nf-gwas-pipeline\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/montilab/nf-gwas-pipeline/gwas.nf': 'pcrelate' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file.\n", + "102 ../../../Workflow-Corpus-Open-License/montilab/shine-nf\n", + "103 ../../../Workflow-Corpus-Open-License/montilab/pipeliner-2\n", + "104 ../../../Workflow-Corpus-Open-License/mmolari/genome-assembly\n", + "105 ../../../Workflow-Corpus-Open-License/dfornika/cpo-pipeline-nextflow\n", + "106 ../../../Workflow-Corpus-Open-License/dfornika/depth-analysis-nextflow\n", + "107 ../../../Workflow-Corpus-Open-License/rbpisupati/nf-haplocaller\n", + "108 ../../../Workflow-Corpus-Open-License/NYU-Molecular-Pathology/lyz-nf\n", + "109 ../../../Workflow-Corpus-Open-License/NYU-Molecular-Pathology/demux-nf\n", + "110 ../../../Workflow-Corpus-Open-License/NYU-Molecular-Pathology/NGS580-nf\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/NYU-Molecular-Pathology/NGS580-nf/main.nf': 'snp_pileup' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file.\n", + "111 ../../../Workflow-Corpus-Open-License/NYU-Molecular-Pathology/LG-PACT\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/NYU-Molecular-Pathology/LG-PACT/main.nf': 'snp_pileup' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file.\n", + "112 ../../../Workflow-Corpus-Open-License/tomsing1/nf-tutorial-blast\n", + "113 ../../../Workflow-Corpus-Open-License/idfarbanecha/benchmark-MeSS-CAMISIM\n", + "114 ../../../Workflow-Corpus-Open-License/DHQP/SNVPhyl_Nextflow\n", + "115 ../../../Workflow-Corpus-Open-License/nibscbioinformatics/nf-core-bagobugs\n", + "116 ../../../Workflow-Corpus-Open-License/dchebotarov/nextflow-variant-calling\n", + "117 ../../../Workflow-Corpus-Open-License/HPCBio/16S-rDNA-dada2-pipeline\n", + "118 ../../../Workflow-Corpus-Open-License/seanpm2001/SNU_2D_ProgrammingTools_IDE_NextFlow\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/seanpm2001/SNU_2D_ProgrammingTools_IDE_NextFlow/LICENSE.nf': Not the same number of opening and closing parentheses '()' in the file.\n", + "119 ../../../Workflow-Corpus-Open-License/seanpm2001/Learn-NextFlow\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/seanpm2001/Learn-NextFlow/LICENSE.nf': Not the same number of opening and closing parentheses '()' in the file.\n", + "120 ../../../Workflow-Corpus-Open-License/seanpm2001/AI2001_Category-Source_Code-SC-Nextflow\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/seanpm2001/AI2001_Category-Source_Code-SC-Nextflow/LICENSE.nf': Not the same number of opening and closing parentheses '()' in the file.\n", + "121 ../../../Workflow-Corpus-Open-License/SamStudio8/elan-nextflow\n", + "[2] Error in the file '../../../Workflow-Corpus-Open-License/SamStudio8/elan-nextflow/workflows/elan.nf': Not the same number of parameters given as input for the process 'announce_uploads', possibly at line 14.\n", + "122 ../../../Workflow-Corpus-Open-License/hnawar/nextflow-cloudrun\n", + "123 ../../../Workflow-Corpus-Open-License/robsyme/nf-repeatmasking\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/robsyme/nf-repeatmasking/main.nf': 'recentLTRs' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file.\n", + "124 ../../../Workflow-Corpus-Open-License/robsyme/markerdev\n", + "125 ../../../Workflow-Corpus-Open-License/TARGENE/targene-pipeline\n", + "[20] Error in the file '../../../Workflow-Corpus-Open-License/TARGENE/targene-pipeline/workflows/targene.nf': The subworkflow 'SVPWorkflow' doesn't emit anything. It is given to an operation, possibly at line 71.\n", + "126 ../../../Workflow-Corpus-Open-License/Boehringer-Ingelheim/flowml-pipeline\n", + "127 ../../../Workflow-Corpus-Open-License/dgarrimar/mvgwas-nf\n", + "128 ../../../Workflow-Corpus-Open-License/dgarrimar/gemma-nf\n", + "129 ../../../Workflow-Corpus-Open-License/axelwalter/diametalyzer\n", + "130 ../../../Workflow-Corpus-Open-License/HSPH-QBRC/target-pipeline\n", + "[9] Error in the file '../../../Workflow-Corpus-Open-License/HSPH-QBRC/target-pipeline/pipeline.nf': A tuple is associated with an call, possibly at line 288. BioFlow-Insight doesn't support this (see specification list), try defining the operation in a different way.\n", + "131 ../../../Workflow-Corpus-Open-License/oist/LuscombeU_Nextflow_Pipeline_Template\n", + "132 ../../../Workflow-Corpus-Open-License/jhayer/baargin\n", + "133 ../../../Workflow-Corpus-Open-License/JBris/nextflow-graph-machine-learning\n", + "[9] Error in the file '../../../Workflow-Corpus-Open-License/JBris/nextflow-graph-machine-learning/gnn_pipeline.nf': A tuple is associated with an call, possibly at line 34. BioFlow-Insight doesn't support this (see specification list), try defining the operation in a different way.\n", + "134 ../../../Workflow-Corpus-Open-License/AndersenLab/ril-nf\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/AndersenLab/ril-nf/main.nf': 'fq_coverage' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file.\n", + "135 ../../../Workflow-Corpus-Open-License/AndersenLab/alignment-nf\n", + "[14] Error in the file '../../../Workflow-Corpus-Open-License/AndersenLab/alignment-nf/main.nf': '(coverage_id & idxstats_id & flagstat_id & stats_id)' is neither a process, subworkflow or an operator. In the executor 'alignment.out.map { row, bam, bai -> [\"id\", row.id, bam, bai ]} | (coverage_id & idxstats_id & flagstat_id & stats_id)'.\n", + "136 ../../../Workflow-Corpus-Open-License/AndersenLab/nil-ril-nf\n", + "137 ../../../Workflow-Corpus-Open-License/AndersenLab/sv-nf\n", + "138 ../../../Workflow-Corpus-Open-License/AndersenLab/cegwas2-nf\n", + "139 ../../../Workflow-Corpus-Open-License/MaestSi/UMInator\n", + "140 ../../../Workflow-Corpus-Open-License/MaestSi/CharONT2\n", + "141 ../../../Workflow-Corpus-Open-License/MaestSi/nf-m6anet\n", + "142 ../../../Workflow-Corpus-Open-License/MaestSi/pycoMethFlow\n", + "143 ../../../Workflow-Corpus-Open-License/MaestSi/ONTrack2\n", + "144 ../../../Workflow-Corpus-Open-License/phac-nml/mikrokondo\n", + "[20] Error in the file '../../../Workflow-Corpus-Open-License/phac-nml/mikrokondo/main.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 87.\n", + "145 ../../../Workflow-Corpus-Open-License/lescailab/fenicsmpi\n", + "146 ../../../Workflow-Corpus-Open-License/Pooran-Dewari/SNP_array_nextflow\n", + "147 ../../../Workflow-Corpus-Open-License/Pooran-Dewari/Nextflow-pipeline-Extract-precise-location-of-gimme-maelstrom-TF-motifs\n", + "148 ../../../Workflow-Corpus-Open-License/lars20070/nextflow_lfq\n", + "149 ../../../Workflow-Corpus-Open-License/shaunchuah/cfdna_nextflow\n", + "150 ../../../Workflow-Corpus-Open-License/boulund/metagenome_pipeline\n", + "151 ../../../Workflow-Corpus-Open-License/PGScatalog/pgsc_calc\n", + "152 ../../../Workflow-Corpus-Open-License/ODiogoSilva/innuca-nf\n", + "153 ../../../Workflow-Corpus-Open-License/zamanianlab/Core_smRNAseq-nf\n", + "154 ../../../Workflow-Corpus-Open-License/sysbiomelab/meteor_pipeline\n", + "155 ../../../Workflow-Corpus-Open-License/lstevens17/nemAsm\n", + "156 ../../../Workflow-Corpus-Open-License/grst/minimal-nextflow-template\n", + "157 ../../../Workflow-Corpus-Open-License/grst/nextflow-notebook-pipeline\n", + "158 ../../../Workflow-Corpus-Open-License/grst/bd_rhapsody_velocyto\n", + "159 ../../../Workflow-Corpus-Open-License/grst/universal_analysis_pipeline\n", + "160 ../../../Workflow-Corpus-Open-License/friederhadlich/nextflow_ultraLowInput\n", + "161 ../../../Workflow-Corpus-Open-License/CDCgov/mycosnp-nf\n", + "[18] Error in the file '../../../Workflow-Corpus-Open-License/CDCgov/mycosnp-nf/subworkflows/local/snpeff_build.nf': 'SNPEFF_BUILD' is expected to be defined in the file, but it could not be found.\n", + "162 ../../../Workflow-Corpus-Open-License/CDCgov/tostadas\n", + "[2] Error in the file '../../../Workflow-Corpus-Open-License/CDCgov/tostadas/workflows/tostadas.nf': Not the same number of parameters given as input for the process 'UPDATE_SUBMISSION', possibly at line 203.\n", + "163 ../../../Workflow-Corpus-Open-License/MarieLataretu/nextflow-mwe\n", + "164 ../../../Workflow-Corpus-Open-License/break-through-cancer/btc-spatial-pipelines\n", + "[10] Error in the file '../../../Workflow-Corpus-Open-License/break-through-cancer/btc-spatial-pipelines/workflows/spatial.nf': Something went wrong in an include, possibly at line 46. No such file: '../../../Workflow-Corpus-Open-License/break-through-cancer/btc-spatial-pipelines/modules/bayestme/nextflow/subworkflows/bayestme/bayestme_basic_visium_analysis/main.nf'.\n", + "165 ../../../Workflow-Corpus-Open-License/SarahMaman/NextflowRNAseq\n", + "166 ../../../Workflow-Corpus-Open-License/angelovangel/nxf-kraken2\n", + "167 ../../../Workflow-Corpus-Open-License/cbcrg/msa-af2-nf\n", + "[8] Error in the file '../../../Workflow-Corpus-Open-License/cbcrg/msa-af2-nf/main.nf': The call for 'run_seq_aln' coudn't be found, before its use in the operation 'run_seq_aln.out.seq_aln_output.combine(run_psicoffee.out.psicoffee_output, by: 0).combine(dssp_to_fasta.out.dssp_output, by: 0).combine(run_struct_aln.out.struct_output, by: 0).combine(templates, by: 0).combine(structures, by: 0).combine(run_alphafold2.out.af2_models.groupTuple(), by: 0).set{comp_and_eval_input}', possibly at line 73. Either because the call wasn't made before the operation or that the element it is calling doesn't exist.\n", + "168 ../../../Workflow-Corpus-Open-License/cbcrg/nf-phdcourse20\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/cbcrg/nf-phdcourse20/rnaseq-flow.nf': No 'main' workflow was found.\n", + "169 ../../../Workflow-Corpus-Open-License/cbcrg/nf-phdcourse19\n", + "170 ../../../Workflow-Corpus-Open-License/cbcrg/nf-phdcourse21\n", + "171 ../../../Workflow-Corpus-Open-License/cloud303-kloucks/nextflow-debugging\n", + "172 ../../../Workflow-Corpus-Open-License/noamteyssier/pipseq_nextflow\n", + "173 ../../../Workflow-Corpus-Open-License/noamteyssier/10x_rna_velocity_nextflow\n", + "174 ../../../Workflow-Corpus-Open-License/noamteyssier/sciseq_rna_velocity_nextflow\n", + "175 ../../../Workflow-Corpus-Open-License/uct-cbio/bacterial_variant_calling\n", + "176 ../../../Workflow-Corpus-Open-License/ameynert/nf-indelible\n", + "177 ../../../Workflow-Corpus-Open-License/OtimusOne/AFPAP\n", + "178 ../../../Workflow-Corpus-Open-License/nf-wrap/main\n", + "179 ../../../Workflow-Corpus-Open-License/TheJacksonLaboratory/cs-nf-pipelines\n", + "[8] Error in the file '../../../Workflow-Corpus-Open-License/TheJacksonLaboratory/cs-nf-pipelines/subworkflows/hs_pta.nf': The call for 'PICARD_MARKDUPLICATES' coudn't be found, before its use in the operation 'apply_bqsr = PICARD_MARKDUPLICATES.out.dedup_bam.join(GATK_BASERECALIBRATOR.out.table)', possibly at line 175. Either because the call wasn't made before the operation or that the element it is calling doesn't exist.\n", + "180 ../../../Workflow-Corpus-Open-License/TheJacksonLaboratory/nextflow-sra-cloud\n", + "181 ../../../Workflow-Corpus-Open-License/TheJacksonLaboratory/pdx-nextflow\n", + "182 ../../../Workflow-Corpus-Open-License/TheJacksonLaboratory/crf_nextflow_basics\n", + "183 ../../../Workflow-Corpus-Open-License/TheJacksonLaboratory/ChIA-PIPE_nextflow\n", + "184 ../../../Workflow-Corpus-Open-License/TheJacksonLaboratory/mmrSVD\n", + "185 ../../../Workflow-Corpus-Open-License/evanfloden/stable-diffusion-nf\n", + "186 ../../../Workflow-Corpus-Open-License/evanfloden/nf-module-demo\n", + "187 ../../../Workflow-Corpus-Open-License/SLU-AMB/read-preprocessing\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/SLU-AMB/read-preprocessing/main.nf': No 'main' workflow was found.\n", + "188 ../../../Workflow-Corpus-Open-License/HealthInnovationEast/cgpwgs-nf\n", + "189 ../../../Workflow-Corpus-Open-License/HealthInnovationEast/ExpansionHunter\n", + "190 ../../../Workflow-Corpus-Open-License/becavin-lab/nf-blast\n", + "191 ../../../Workflow-Corpus-Open-License/rsuchecki/nextflow-walkthrough\n", + "192 ../../../Workflow-Corpus-Open-License/Clinical-Genomics-Lund/nextflow-modules\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/Clinical-Genomics-Lund/nextflow-modules/bacteria-example.nf': No 'main' workflow was found.\n", + "193 ../../../Workflow-Corpus-Open-License/FischbachLab/nf-reads-profiler\n", + "194 ../../../Workflow-Corpus-Open-License/FischbachLab/nf-blast\n", + "195 ../../../Workflow-Corpus-Open-License/utia-gc/ngs\n", + "196 ../../../Workflow-Corpus-Open-License/qbicsoftware-archive/qbic-workflow-nf-template\n", + "197 ../../../Workflow-Corpus-Open-License/qbicsoftware-archive/qbic-wf-megSAP\n", + "198 ../../../Workflow-Corpus-Open-License/qbicsoftware-archive/qbic-workflow-nf-rnaseq\n", + "199 ../../../Workflow-Corpus-Open-License/JacobLay/NextflowIntro\n", + "200 ../../../Workflow-Corpus-Open-License/OpenMSConsulting/NextflowLFQ\n", + "201 ../../../Workflow-Corpus-Open-License/vibbits/chipseq-nextflow\n", + "202 ../../../Workflow-Corpus-Open-License/OlgaChern/nextflow_gentrius_sim\n", + "203 ../../../Workflow-Corpus-Open-License/bkohrn/picard_demux_nextflow\n", + "204 ../../../Workflow-Corpus-Open-License/manuelesimi/hello-nextflow\n", + "205 ../../../Workflow-Corpus-Open-License/kkerns85/midas_nf_tower\n", + "206 ../../../Workflow-Corpus-Open-License/microgenlab/porefile\n", + "207 ../../../Workflow-Corpus-Open-License/open2c/distiller-nf\n", + "208 ../../../Workflow-Corpus-Open-License/MiGurke/nfmap\n", + "209 ../../../Workflow-Corpus-Open-License/MiGurke/nfvacal\n", + "210 ../../../Workflow-Corpus-Open-License/MiGurke/nfcongeneus\n", + "211 ../../../Workflow-Corpus-Open-License/tluquez/QUARS\n", + "212 ../../../Workflow-Corpus-Open-License/zhanyinx/metagenomics\n", + "213 ../../../Workflow-Corpus-Open-License/aertslab/SpatialNF\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/aertslab/SpatialNF/main.nf': No 'main' workflow was found.\n", + "214 ../../../Workflow-Corpus-Open-License/aertslab/scenic-nf\n", + "215 ../../../Workflow-Corpus-Open-License/systems-genomics-lab/next-bgc\n", + "216 ../../../Workflow-Corpus-Open-License/Euro-BioImaging/BatchConvert\n", + "[22] Error in the file '../../../Workflow-Corpus-Open-License/Euro-BioImaging/BatchConvert/modules/processes.nf': Multiple 'input:' were found in the process 'Convert_EachFileFromRoot2SeparateOMETIFF'.\n", + "217 ../../../Workflow-Corpus-Open-License/bioShaun/om-nf-prepare\n", + "218 ../../../Workflow-Corpus-Open-License/bioShaun/xms-rnaseq-nf\n", + "219 ../../../Workflow-Corpus-Open-License/lepsalex/results\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/lepsalex/results/debug/calls.nf': No 'main' workflow was found.\n", + "220 ../../../Workflow-Corpus-Open-License/lepsalex/nextflow-pcawg-bwa-mem-workflow\n", + "221 ../../../Workflow-Corpus-Open-License/HadrienG/nanoflow\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/HadrienG/nanoflow/main.nf': 'assembly' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file.\n", + "222 ../../../Workflow-Corpus-Open-License/HadrienG/nextflow_rna\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/HadrienG/nextflow_rna/rna.nf': No 'main' workflow was found.\n", + "223 ../../../Workflow-Corpus-Open-License/crukci-bioinformatics/nextflow-support\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/crukci-bioinformatics/nextflow-support/functions.nf': No 'main' workflow was found.\n", + "224 ../../../Workflow-Corpus-Open-License/hoelzer/nf-hmmsearch\n", + "225 ../../../Workflow-Corpus-Open-License/hoelzer/dammit-nf\n", + "226 ../../../Workflow-Corpus-Open-License/hoelzer/virify\n", + "227 ../../../Workflow-Corpus-Open-License/peterk87/nf-flu\n", + "228 ../../../Workflow-Corpus-Open-License/EBI-Metagenomics/emg-viral-pipeline\n", + "[2] Error in the file '../../../Workflow-Corpus-Open-License/EBI-Metagenomics/emg-viral-pipeline/virify.nf': Not the same number of parameters given as input for the subworklfow 'annotate' in the call, possibly at line 649.\n", + "229 ../../../Workflow-Corpus-Open-License/cidgoh/nf-ncov-voc\n", + "[22] Error in the file '../../../Workflow-Corpus-Open-License/cidgoh/nf-ncov-voc/modules/local/custom.nf': Multiple 'output:' were found in the process 'processGVCF'?\n", + "230 ../../../Workflow-Corpus-Open-License/jagedn/nextflow-groogle-sheet\n", + "231 ../../../Workflow-Corpus-Open-License/B-UMMI/DEN-IM\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/B-UMMI/DEN-IM/DEN-IM.nf': 'compile_status_buffer' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file.\n", + "232 ../../../Workflow-Corpus-Open-License/openproblems-bio/openproblems-v2\n", + "233 ../../../Workflow-Corpus-Open-License/PRIDE-Archive/pride-molecule-indexer\n", + "234 ../../../Workflow-Corpus-Open-License/DaneVass/BARtab\n", + "235 ../../../Workflow-Corpus-Open-License/LeoniePohl/nextflow-diffexp-testpipeline\n", + "236 ../../../Workflow-Corpus-Open-License/stenglein-lab/viral_variant_caller\n", + "237 ../../../Workflow-Corpus-Open-License/jemunro/Tidy-nf\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/jemunro/Tidy-nf/example.nf': No 'main' workflow was found.\n", + "238 ../../../Workflow-Corpus-Open-License/mattfemia/scrnaseq-pipeline\n", + "239 ../../../Workflow-Corpus-Open-License/MHH-RCUG/nf_wochenende\n", + "240 ../../../Workflow-Corpus-Open-License/DarianHole/test-nextflow\n", + "241 ../../../Workflow-Corpus-Open-License/fmalmeida/MpGAP\n", + "[22] Error in the file '../../../Workflow-Corpus-Open-License/fmalmeida/MpGAP/workflows/hybrid.nf': Multiple 'main:' were found in the subworkflow 'HYBRID'.\n", + "242 ../../../Workflow-Corpus-Open-License/fmalmeida/bacannot\n", + "243 ../../../Workflow-Corpus-Open-License/uel3/UnO_nf\n", + "244 ../../../Workflow-Corpus-Open-License/nttg8100/Simple-RNA-seq-Nextflow-with-Salmon\n", + "245 ../../../Workflow-Corpus-Open-License/fredjaya/msmc-nf\n", + "246 ../../../Workflow-Corpus-Open-License/pgonzale60/nxf_pipelines\n", + "247 ../../../Workflow-Corpus-Open-License/noepozzan/small-peptide-pipeline\n", + "248 ../../../Workflow-Corpus-Open-License/lukfor/pgs-calc-nf\n", + "249 ../../../Workflow-Corpus-Open-License/biocorecrg/contamination-nf\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/biocorecrg/contamination-nf/main.nf': Not the same number of opening and closing curlies '{}' in the file.\n", + "250 ../../../Workflow-Corpus-Open-License/biocorecrg/nf-cloud-gpu-test\n", + "251 ../../../Workflow-Corpus-Open-License/biocorecrg/MOP2\n", + "252 ../../../Workflow-Corpus-Open-License/biocorecrg/nextflow_detached_db_wrapper\n", + "253 ../../../Workflow-Corpus-Open-License/NCBI-Hackathons/ATACFlow\n", + "254 ../../../Workflow-Corpus-Open-License/NCBI-Hackathons/SPeW\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/NCBI-Hackathons/SPeW/align.nf': Not the same number of opening and closing curlies '{}' in the file.\n", + "255 ../../../Workflow-Corpus-Open-License/breichholf/smRNAseq\n", + "256 ../../../Workflow-Corpus-Open-License/nextflow-io/cwl2nxf\n", + "257 ../../../Workflow-Corpus-Open-License/nextflow-io/nf-ffq\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/nextflow-io/nf-ffq/ffq.nf': No 'main' workflow was found.\n", + "258 ../../../Workflow-Corpus-Open-License/nextflow-io/elixir-workshop-21\n", + "[10] Error in the file '../../../Workflow-Corpus-Open-License/nextflow-io/elixir-workshop-21/main.nf': Something went wrong in an include, possibly at line 76. No such file: '../../../Workflow-Corpus-Open-License/nextflow-io/elixir-workshop-21/${subwork_folder}/fastqc.nf'.\n", + "259 ../../../Workflow-Corpus-Open-License/nextflow-io/gccbosc18-training\n", + "260 ../../../Workflow-Corpus-Open-License/nextflow-io/socks\n", + "261 ../../../Workflow-Corpus-Open-License/JackCurragh/Nextflow-Template\n", + "262 ../../../Workflow-Corpus-Open-License/ZuberLab/mageck-nf\n", + "263 ../../../Workflow-Corpus-Open-License/ZuberLab/vbcf-nf\n", + "264 ../../../Workflow-Corpus-Open-License/ZuberLab/crispr-mageck-nf\n", + "265 ../../../Workflow-Corpus-Open-License/ZuberLab/guidemapper-nf\n", + "266 ../../../Workflow-Corpus-Open-License/ZuberLab/crispr-process-nf\n", + "267 ../../../Workflow-Corpus-Open-License/ZuberLab/crispr-nf\n", + "268 ../../../Workflow-Corpus-Open-License/ZuberLab/sra-nf\n", + "269 ../../../Workflow-Corpus-Open-License/oxfordfun/FunSnippy\n", + "270 ../../../Workflow-Corpus-Open-License/mmatthews06/nextflow-playground\n", + "271 ../../../Workflow-Corpus-Open-License/ricomnl/bioinformatics-pipeline-tutorial\n", + "272 ../../../Workflow-Corpus-Open-License/dolphinnext/rnaseq\n", + "273 ../../../Workflow-Corpus-Open-License/LieberInstitute/SPEAQeasy\n", + "[10] Error in the file '../../../Workflow-Corpus-Open-License/LieberInstitute/SPEAQeasy/main.nf': Something went wrong in an include, possibly at line 449. No such file: '../../../Workflow-Corpus-Open-License/LieberInstitute/SPEAQeasy/${workflow.projectDir}/modules/pull_annotation.nf'.\n", + "274 ../../../Workflow-Corpus-Open-License/hoelzer-lab/rnaflow\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/hoelzer-lab/rnaflow/main.nf': 'sortmerna' is trying to be created as a channel, possibly at line 475. It already exists as a process or a subworkflow in the nextflow file.\n", + "275 ../../../Workflow-Corpus-Open-License/isugifNF/blast\n", + "276 ../../../Workflow-Corpus-Open-License/vmikk/BatchBlaster\n", + "277 ../../../Workflow-Corpus-Open-License/vmikk/PhyloNext\n", + "278 ../../../Workflow-Corpus-Open-License/bschiffthaler/nf-modules\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/bschiffthaler/nf-modules/multiqc.nf': No 'main' workflow was found.\n", + "279 ../../../Workflow-Corpus-Open-License/pcrxn/ProkkaFlow\n", + "280 ../../../Workflow-Corpus-Open-License/alneberg/trigger_error_nf\n", + "281 ../../../Workflow-Corpus-Open-License/opencobra/jeweler\n", + "282 ../../../Workflow-Corpus-Open-License/faithman/variant-nf\n", + "283 ../../../Workflow-Corpus-Open-License/digenoma-lab/nf-groot\n", + "284 ../../../Workflow-Corpus-Open-License/digenoma-lab/k-count-nf\n", + "285 ../../../Workflow-Corpus-Open-License/ATpoint/nf_findMotifs\n", + "286 ../../../Workflow-Corpus-Open-License/eQTL-Catalogue/colocalisation\n", + "287 ../../../Workflow-Corpus-Open-License/eQTL-Catalogue/susie-workflow\n", + "288 ../../../Workflow-Corpus-Open-License/veidenberg/tools-api-nextflow\n", + "289 ../../../Workflow-Corpus-Open-License/RibosomeCRCL/ribomethseq-nf\n", + "290 ../../../Workflow-Corpus-Open-License/anajung/CZI_addon\n", + "291 ../../../Workflow-Corpus-Open-License/cometsong/gbrs_nxf\n", + "292 ../../../Workflow-Corpus-Open-License/cometsong/ATAC_Seq_nxf\n", + "293 ../../../Workflow-Corpus-Open-License/jvierstra/nf-rnaseq\n", + "294 ../../../Workflow-Corpus-Open-License/RHReynolds/mkfastq\n", + "295 ../../../Workflow-Corpus-Open-License/bactopia/bactopia\n", + "[10] Error in the file '../../../Workflow-Corpus-Open-License/bactopia/bactopia/workflows/teton.nf': Something went wrong in an include, possibly at line 33. No such file: '../../../Workflow-Corpus-Open-License/bactopia/bactopia/modules/local/bactopia/gather_samples/main.nf'.\n", + "296 ../../../Workflow-Corpus-Open-License/DLBPointon/HymenopteraAnalysis\n", + "[18] Error in the file '../../../Workflow-Corpus-Open-License/DLBPointon/HymenopteraAnalysis/modules/nf-core/modules/blast/makeblastdb/main.nf': 'SIGS_BLAST_MAKEBLASTDB' is expected to be defined in the file, but it could not be found.\n", + "297 ../../../Workflow-Corpus-Open-License/tiagofilipe12/pATLASflow\n", + "298 ../../../Workflow-Corpus-Open-License/usafsam/mad_river_wf\n", + "299 ../../../Workflow-Corpus-Open-License/sebgoti/spatial-pipeline\n", + "300 ../../../Workflow-Corpus-Open-License/esteinig/nf-mvp\n", + "[18] Error in the file '../../../Workflow-Corpus-Open-License/esteinig/nf-mvp/lib/utils.nf': 'getSubsampleReads' is expected to be defined in the file, but it could not be found.\n", + "301 ../../../Workflow-Corpus-Open-License/cedarwarman/pollen_cv_nextflow\n", + "302 ../../../Workflow-Corpus-Open-License/lehtiolab/nf-msconvert\n", + "303 ../../../Workflow-Corpus-Open-License/lehtiolab/ddamsproteomics\n", + "304 ../../../Workflow-Corpus-Open-License/stajichlab/nf-comparative-genomics\n", + "305 ../../../Workflow-Corpus-Open-License/vib-singlecell-nf/vsn-pipelines\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/vib-singlecell-nf/vsn-pipelines/main.nf': No 'main' workflow was found.\n", + "306 ../../../Workflow-Corpus-Open-License/oalmelid/lift-over-nf\n", + "307 ../../../Workflow-Corpus-Open-License/dmalzl/howto-nf\n", + "[18] Error in the file '../../../Workflow-Corpus-Open-License/dmalzl/howto-nf/workflows/chipseq.nf': 'CHIPSEQ' is expected to be defined in the file, but it could not be found.\n", + "308 ../../../Workflow-Corpus-Open-License/eastgenomics/mutect2_nextflow\n", + "309 ../../../Workflow-Corpus-Open-License/eastgenomics/VerifyBamID_nextflow\n", + "310 ../../../Workflow-Corpus-Open-License/BU-ISCIII/bacterial_assembly-nf\n", + "311 ../../../Workflow-Corpus-Open-License/BU-ISCIII/panelLowFreq-nf\n", + "312 ../../../Workflow-Corpus-Open-License/BU-ISCIII/bacterial_wgs_training\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/BU-ISCIII/bacterial_wgs_training/main.nf': 'srst2_resistance' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file.\n", + "313 ../../../Workflow-Corpus-Open-License/AllenInstitute/deepinterpolation_nextflow\n", + "314 ../../../Workflow-Corpus-Open-License/sergpolly/random-nextflow-utils\n", + "315 ../../../Workflow-Corpus-Open-License/CIBERER-pipelines/mosaicism_nextflow\n", + "316 ../../../Workflow-Corpus-Open-License/EnriqueDoster/bioinformatic-nextflow-pipelines\n", + "317 ../../../Workflow-Corpus-Open-License/AlfredUg/QuasiFlow\n", + "318 ../../../Workflow-Corpus-Open-License/Sage-Bionetworks-Workflows/nf-model2data\n", + "319 ../../../Workflow-Corpus-Open-License/Sage-Bionetworks-Workflows/nf-synstage\n", + "320 ../../../Workflow-Corpus-Open-License/Sage-Bionetworks-Workflows/nf-synindex\n", + "321 ../../../Workflow-Corpus-Open-License/Sage-Bionetworks-Workflows/nf-genie\n", + "322 ../../../Workflow-Corpus-Open-License/vntasis/stan-nf\n", + "323 ../../../Workflow-Corpus-Open-License/maxibor/kraken-nf\n", + "324 ../../../Workflow-Corpus-Open-License/maxibor/organdiet\n", + "325 ../../../Workflow-Corpus-Open-License/nkrumm/hello\n", + "326 ../../../Workflow-Corpus-Open-License/Schaudge/nextflow-in-practice\n", + "[22] Error in the file '../../../Workflow-Corpus-Open-License/Schaudge/nextflow-in-practice/somatic_vardict_pindel.nf': Multiple 'when:' were found in the process 'cnv_oncocnv_tumor_controls'.\n", + "327 ../../../Workflow-Corpus-Open-License/GunzIvan28/nextflow-rMAP-devt\n", + "328 ../../../Workflow-Corpus-Open-License/CCBR/CHAMPAGNE\n", + "329 ../../../Workflow-Corpus-Open-License/CCBR/CCBR_NextflowTemplate\n", + "330 ../../../Workflow-Corpus-Open-License/gleisonm/nextflow_bigscape\n", + "331 ../../../Workflow-Corpus-Open-License/aws-samples/aws-gatk-recipe-nextflow-pipeline\n", + "332 ../../../Workflow-Corpus-Open-License/thanhleviet/nextflow-ratt\n", + "333 ../../../Workflow-Corpus-Open-License/transXpress/transXpress-nextflow\n", + "334 ../../../Workflow-Corpus-Open-License/marc-jones/nextflow-example\n", + "335 ../../../Workflow-Corpus-Open-License/kenibrewer/shapeseq\n", + "336 ../../../Workflow-Corpus-Open-License/kenibrewer/simplenextflow\n", + "337 ../../../Workflow-Corpus-Open-License/gwright99/hello-nonmain\n", + "338 ../../../Workflow-Corpus-Open-License/jtmccr1/beast_analysis\n", + "[22] Error in the file '../../../Workflow-Corpus-Open-License/jtmccr1/beast_analysis/beast_analysis.nf': Multiple 'input:' were found in the process 'mcc'.\n", + "339 ../../../Workflow-Corpus-Open-License/crashGoBoom/nf-video\n", + "340 ../../../Workflow-Corpus-Open-License/Dowell-Lab/RNAseq-Flow\n", + "341 ../../../Workflow-Corpus-Open-License/Dowell-Lab/Bidirectional-Flow\n", + "342 ../../../Workflow-Corpus-Open-License/Dowell-Lab/Analysis-Flow\n", + "343 ../../../Workflow-Corpus-Open-License/Dowell-Lab/ChIP-Flow\n", + "344 ../../../Workflow-Corpus-Open-License/bguo068/snp_call_nf\n", + "345 ../../../Workflow-Corpus-Open-License/bguo068/posseleff_empirical\n", + "[2] Error in the file '../../../Workflow-Corpus-Open-License/bguo068/posseleff_empirical/01_filter_vcf.nf': Not the same number of parameters given as input for the process 'BCFTOOLS_VIEW_FILTER_SAMPLE_BY_IMISS1', possibly at line 165.\n", + "346 ../../../Workflow-Corpus-Open-License/salzman-lab/SpliZ\n", + "347 ../../../Workflow-Corpus-Open-License/KohlbacherLab/nextflow-clinvap\n", + "348 ../../../Workflow-Corpus-Open-License/ChrisgKent/flye-on-cluster\n", + "349 ../../../Workflow-Corpus-Open-License/RenneLab/CnR-flow\n", + "350 ../../../Workflow-Corpus-Open-License/TalusBio/nf-encyclopedia\n", + "[14] Error in the file '../../../Workflow-Corpus-Open-License/TalusBio/nf-encyclopedia/subworkflows/encyclopedia.nf': 'set { global_files }' is neither a process, subworkflow or an operator. In the executor 'Channel.empty() | set { global_files }', possibly at line 89.\n", + "351 ../../../Workflow-Corpus-Open-License/shenwei356/blast-nf\n", + "352 ../../../Workflow-Corpus-Open-License/ralsallaq/metaGx_nf\n", + "353 ../../../Workflow-Corpus-Open-License/ikmb-denbi/genome-annotation\n", + "354 ../../../Workflow-Corpus-Open-License/AusSRC/WALLABY_pipelines\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/AusSRC/WALLABY_pipelines/main.nf': Not the same number of opening and closing parentheses '()' in the file.\n", + "355 ../../../Workflow-Corpus-Open-License/sauriiiin/rnaseeker\n", + "356 ../../../Workflow-Corpus-Open-License/NBISweden/K9-WGS-Pipeline\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/NBISweden/K9-WGS-Pipeline/main.nf': 'hardfilters_snp' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file.\n", + "357 ../../../Workflow-Corpus-Open-License/NBISweden/pipelines-nextflow\n", + "[2] Error in the file '../../../Workflow-Corpus-Open-License/NBISweden/pipelines-nextflow/subworkflows/abinitio_training/main.nf': Not the same number of parameters given as input for the process 'BLAST_BLASTP', possibly at line 54.\n", + "358 ../../../Workflow-Corpus-Open-License/FloWuenne/nextflow_saige_dsl2\n", + "359 ../../../Workflow-Corpus-Open-License/FloWuenne/meta-METAL_nextflow_dsl2\n", + "360 ../../../Workflow-Corpus-Open-License/olgabot/nextflow-test-aws\n", + "361 ../../../Workflow-Corpus-Open-License/heuermh/minnebar15-workflow\n", + "362 ../../../Workflow-Corpus-Open-License/kviljoen/uct-srst2\n", + "363 ../../../Workflow-Corpus-Open-License/kviljoen/EMIRGE_nextflow\n", + "364 ../../../Workflow-Corpus-Open-License/tuzov/nf-cg-helloworld\n", + "365 ../../../Workflow-Corpus-Open-License/t-neumann/salmon-nf\n", + "366 ../../../Workflow-Corpus-Open-License/FredHutch/souper-star\n", + "367 ../../../Workflow-Corpus-Open-License/FredHutch/VMAA\n", + "368 ../../../Workflow-Corpus-Open-License/FredHutch/workflow-template-nextflow\n", + "369 ../../../Workflow-Corpus-Open-License/shreyasanjay22/NextflowPipeline\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/shreyasanjay22/NextflowPipeline/rnaseq_script.nf': No 'main' workflow was found.\n", + "370 ../../../Workflow-Corpus-Open-License/richelbilderbeek/nextflow_example_4\n", + "371 ../../../Workflow-Corpus-Open-License/richelbilderbeek/nextflow_cookbook_1_print_hello_world\n", + "372 ../../../Workflow-Corpus-Open-License/richelbilderbeek/nextflow_cookbook_1\n", + "373 ../../../Workflow-Corpus-Open-License/richelbilderbeek/nextflow_example_5\n", + "374 ../../../Workflow-Corpus-Open-License/danielecook/nextflow-tutorial\n", + "375 ../../../Workflow-Corpus-Open-License/rnajena/RNAswarm\n", + "376 ../../../Workflow-Corpus-Open-License/tdelhomme/vcf_ancestry-nf\n", + "377 ../../../Workflow-Corpus-Open-License/tdelhomme/SimulateLowCovSeq-nf\n", + "378 ../../../Workflow-Corpus-Open-License/tdelhomme/variantfiltering-nf\n", + "379 ../../../Workflow-Corpus-Open-License/tdelhomme/RegionalEnrichment-nf\n", + "380 ../../../Workflow-Corpus-Open-License/tdelhomme/SV-simulation-nf\n", + "381 ../../../Workflow-Corpus-Open-License/PavriLab/repliseq-nf\n", + "382 ../../../Workflow-Corpus-Open-License/PavriLab/geneIS-nf\n", + "383 ../../../Workflow-Corpus-Open-License/PavriLab/hicer-nf\n", + "[20] Error in the file '../../../Workflow-Corpus-Open-License/PavriLab/hicer-nf/workflows/hicer.nf': To much to unpack : The subworkflow 'PREPARE_GENOME' emits over one channel in a operation, possibly at line 146.\n", + "384 ../../../Workflow-Corpus-Open-License/gp201/Freyja_pathogen_workflow_alpha\n", + "385 ../../../Workflow-Corpus-Open-License/IARCbioinfo/LiftOver-nf\n", + "386 ../../../Workflow-Corpus-Open-License/IARCbioinfo/nf_coverage_demo\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/IARCbioinfo/nf_coverage_demo/plot_coverage.nf': 'coverage' is trying to be created as a channel, possibly at line 3. It already exists as a process or a subworkflow in the nextflow file.\n", + "387 ../../../Workflow-Corpus-Open-License/IARCbioinfo/TCGA_platypus-nf\n", + "388 ../../../Workflow-Corpus-Open-License/IARCbioinfo/CODEX-nf\n", + "389 ../../../Workflow-Corpus-Open-License/IARCbioinfo/purple-nf\n", + "390 ../../../Workflow-Corpus-Open-License/IARCbioinfo/table_annovar-nf\n", + "391 ../../../Workflow-Corpus-Open-License/IARCbioinfo/octopus-nf\n", + "392 ../../../Workflow-Corpus-Open-License/IARCbioinfo/damage-estimator-nf\n", + "393 ../../../Workflow-Corpus-Open-License/IARCbioinfo/NGSCheckMate-nf\n", + "394 ../../../Workflow-Corpus-Open-License/IARCbioinfo/gene-fusions-nf\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/IARCbioinfo/gene-fusions-nf/main.nf': 'arriba' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file.\n", + "395 ../../../Workflow-Corpus-Open-License/IARCbioinfo/gatk4-DataPreProcessing-nf\n", + "396 ../../../Workflow-Corpus-Open-License/IARCbioinfo/template-nf\n", + "397 ../../../Workflow-Corpus-Open-License/IARCbioinfo/ampliconarchitect-nf\n", + "398 ../../../Workflow-Corpus-Open-License/IARCbioinfo/bamsurgeon-nf\n", + "399 ../../../Workflow-Corpus-Open-License/IARCbioinfo/BQSR-nf\n", + "400 ../../../Workflow-Corpus-Open-License/jianhong/universalModule\n", + "[10] Error in the file '../../../Workflow-Corpus-Open-License/jianhong/universalModule/chipseq.nf': Something went wrong in an include, possibly at line 14. No such file: '../../../Workflow-Corpus-Open-License/jianhong/universalModule/loadModule(checksum,.nf'.\n", + "401 ../../../Workflow-Corpus-Open-License/jianhong/nextflowTutorial\n", + "402 ../../../Workflow-Corpus-Open-License/likelet/ExomePipe\n", + "403 ../../../Workflow-Corpus-Open-License/bentsherman/tesseract\n", + "404 ../../../Workflow-Corpus-Open-License/BCCDC-PHL/dragonflye-nf\n", + "405 ../../../Workflow-Corpus-Open-License/BCCDC-PHL/covflo\n", + "406 ../../../Workflow-Corpus-Open-License/BCCDC-PHL/fluflo\n", + "407 ../../../Workflow-Corpus-Open-License/bhargava-morampalli/cdnaseqont-nextflow\n", + "408 ../../../Workflow-Corpus-Open-License/pandora414/ssnp\n", + "409 ../../../Workflow-Corpus-Open-License/pandora414/lncRNA\n", + "410 ../../../Workflow-Corpus-Open-License/austinreidmanny/tvv-nf\n", + "411 ../../../Workflow-Corpus-Open-License/stevekm/nextflow-communicator\n", + "412 ../../../Workflow-Corpus-Open-License/stevekm/newfile-detector-nf\n", + "413 ../../../Workflow-Corpus-Open-License/keoughkath/GBGCnf\n", + "414 ../../../Workflow-Corpus-Open-License/wassermanlab/Variant_catalogue_pipeline\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/wassermanlab/Variant_catalogue_pipeline/subworkflow/SNV.nf': 'SNV' is trying to be created as a channel, possibly at line 27. It already exists as a process or a subworkflow in the nextflow file.\n", + "415 ../../../Workflow-Corpus-Open-License/team113sanger/t113_irods_to_lustre\n", + "416 ../../../Workflow-Corpus-Open-License/BrianLohman/pdx-nf\n", + "417 ../../../Workflow-Corpus-Open-License/BrianLohman/ctseq-nf\n", + "418 ../../../Workflow-Corpus-Open-License/BrianLohman/RNAseq-variant-calling-nf\n", + "419 ../../../Workflow-Corpus-Open-License/BrianLohman/cellranger-nf\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/BrianLohman/cellranger-nf/main.nf': An odd number of '\"\"\"' was found in the code.\n", + "420 ../../../Workflow-Corpus-Open-License/WarrenLab/longread-polish-nf\n", + "421 ../../../Workflow-Corpus-Open-License/WarrenLab/longread-svs-nf\n", + "422 ../../../Workflow-Corpus-Open-License/WarrenLab/shortread-polish-nf\n", + "423 ../../../Workflow-Corpus-Open-License/WarrenLab/purge-haplotigs-nf\n", + "424 ../../../Workflow-Corpus-Open-License/WarrenLab/minigraph-cactus-nf\n", + "425 ../../../Workflow-Corpus-Open-License/WarrenLab/cellranger-nf\n", + "426 ../../../Workflow-Corpus-Open-License/WarrenLab/hic-scaffolding-nf\n", + "427 ../../../Workflow-Corpus-Open-License/limrp/nextflow_metagenomics\n", + "428 ../../../Workflow-Corpus-Open-License/limrp/nextflow_subworkflow\n", + "[2] Error in the file '../../../Workflow-Corpus-Open-License/limrp/nextflow_subworkflow/subworkflows/local/fasta_metaprodigal_cdhit.nf': Not the same number of parameters given as input for the process 'PRODIGAL', possibly at line 21.\n", + "429 ../../../Workflow-Corpus-Open-License/zajakin/sRNAflow\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/zajakin/sRNAflow/sRNAflow.nf': No 'main' workflow was found.\n", + "430 ../../../Workflow-Corpus-Open-License/seqeralabs/nf-canary\n", + "431 ../../../Workflow-Corpus-Open-License/arontommi/RNAseq-VAX\n", + "432 ../../../Workflow-Corpus-Open-License/ObenaufLab/snv-calling-nf\n", + "433 ../../../Workflow-Corpus-Open-License/ObenaufLab/sv-calling-nf\n", + "434 ../../../Workflow-Corpus-Open-License/ObenaufLab/virus-detection-nf\n", + "435 ../../../Workflow-Corpus-Open-License/Streit-lab/enhancer_annotation_and_motif_analysis\n", + "436 ../../../Workflow-Corpus-Open-License/kullrich/snpless-nf\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/kullrich/snpless-nf/main.nf': 'genmap' is trying to be created as a channel, possibly at line 263. It already exists as a process or a subworkflow in the nextflow file.\n", + "437 ../../../Workflow-Corpus-Open-License/BPHL-Molecular/Sanibel\n", + "[2] Error in the file '../../../Workflow-Corpus-Open-License/BPHL-Molecular/Sanibel/flaq_amr_plus2.nf': Not the same number of parameters given as input for the process 'plusAnalyses'.\n", + "438 ../../../Workflow-Corpus-Open-License/PAIN-initiative/nextflow-scRNAseq\n", + "439 ../../../Workflow-Corpus-Open-License/Ratoncito/callingcards\n", + "440 ../../../Workflow-Corpus-Open-License/x-kiana/nextflow_pipeline\n", + "441 ../../../Workflow-Corpus-Open-License/cellgeni/nf-workshop\n", + "442 ../../../Workflow-Corpus-Open-License/cellgeni/rnaseq\n", + "443 ../../../Workflow-Corpus-Open-License/cellgeni/scmapIndex\n", + "444 ../../../Workflow-Corpus-Open-License/evotools/nSPECTRa\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/evotools/nSPECTRa/include/workflow/mutyper.nf': 'chromosomeList' is trying to be created as a channel, possibly at line 10. It already exists as a process or a subworkflow in the nextflow file.\n", + "445 ../../../Workflow-Corpus-Open-License/evotools/nf-LO\n", + "[18] Error in the file '../../../Workflow-Corpus-Open-License/evotools/nf-LO/modules/processes/blat.nf': 'blat_custom' is expected to be defined in the file, but it could not be found.\n", + "446 ../../../Workflow-Corpus-Open-License/Sydney-Informatics-Hub/fastqc-nf\n", + "447 ../../../Workflow-Corpus-Open-License/Sydney-Informatics-Hub/bamQC-nf\n", + "448 ../../../Workflow-Corpus-Open-License/Sydney-Informatics-Hub/Germline-StructuralV-nf\n", + "449 ../../../Workflow-Corpus-Open-License/yash-puligundla/samtools-head-nf\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/yash-puligundla/samtools-head-nf/main.nf': No 'main' workflow was found.\n", + "450 ../../../Workflow-Corpus-Open-License/jaumereig/geneidBLASTx-nf\n", + "[10] Error in the file '../../../Workflow-Corpus-Open-License/jaumereig/geneidBLASTx-nf/main.nf': Something went wrong in an include, possibly at line 68. No such file: '../../../Workflow-Corpus-Open-License/jaumereig/geneidBLASTx-nf/${subwork_folder}/tools.nf'.\n", + "451 ../../../Workflow-Corpus-Open-License/mlf-core/nextflow-lcep\n", + "452 ../../../Workflow-Corpus-Open-License/wbazant/nextflow-hello-dsl2\n", + "453 ../../../Workflow-Corpus-Open-License/palfalvi/rnaseq\n", + "[8] Error in the file '../../../Workflow-Corpus-Open-License/palfalvi/rnaseq/main.nf': The call for 'run_fastSE_qc' coudn't be found, before its use in the operation 'salmon_quantSE.out.collect().concat(run_fastSE_qc.out.collect())', possibly at line 217. Either because the call wasn't made before the operation or that the element it is calling doesn't exist.\n", + "454 ../../../Workflow-Corpus-Open-License/samlhao/nf-core-abricate\n", + "455 ../../../Workflow-Corpus-Open-License/samlhao/hgtsimulation\n", + "456 ../../../Workflow-Corpus-Open-License/samlhao/nextflow-spid\n", + "457 ../../../Workflow-Corpus-Open-License/MrOlm/nf-genomeresolvedmetagenomics\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/MrOlm/nf-genomeresolvedmetagenomics/main.nf': No 'main' workflow was found.\n", + "458 ../../../Workflow-Corpus-Open-License/robomics/generate_higlass_gene_track\n", + "459 ../../../Workflow-Corpus-Open-License/alexthiery/modify-gtf\n", + "460 ../../../Workflow-Corpus-Open-License/raimondsre/population_scale_wgs_nextflow\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/raimondsre/population_scale_wgs_nextflow/main.nf': 'PCA' is trying to be created as a channel, possibly at line 1. It already exists as a process or a subworkflow in the nextflow file.\n", + "461 ../../../Workflow-Corpus-Open-License/sanger-bentley-group/GBS-Typer-sanger-nf\n", + "[2] Error in the file '../../../Workflow-Corpus-Open-License/sanger-bentley-group/GBS-Typer-sanger-nf/main.nf': Not the same number of parameters given as input for the process 'freebayes', possibly at line 159.\n", + "462 ../../../Workflow-Corpus-Open-License/sanger-bentley-group/gps-pipeline\n", + "[18] Error in the file '../../../Workflow-Corpus-Open-License/sanger-bentley-group/gps-pipeline/modules/messages.nf': 'startMessage' is expected to be defined in the file, but it could not be found.\n", + "463 ../../../Workflow-Corpus-Open-License/mpieva/quicksand\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/mpieva/quicksand/workflows/00_setup.nf': 'setup' is trying to be created as a channel, possibly at line 6. It already exists as a process or a subworkflow in the nextflow file.\n", + "464 ../../../Workflow-Corpus-Open-License/Mxrcon/Savio_alignments_nf\n", + "465 ../../../Workflow-Corpus-Open-License/csiro-crop-informatics/repset\n", + "466 ../../../Workflow-Corpus-Open-License/csiro-crop-informatics/nextflow-embl-abr-webinar\n", + "467 ../../../Workflow-Corpus-Open-License/mhebrard/TrimFlow\n", + "468 ../../../Workflow-Corpus-Open-License/jowkar/xenocell_nextflow\n", + "469 ../../../Workflow-Corpus-Open-License/tthyer/nextflow-scratch\n", + "470 ../../../Workflow-Corpus-Open-License/julesjacobsen/nextflow-test\n", + "471 ../../../Workflow-Corpus-Open-License/soulj/SkeletalVis-SingleCell\n", + "[2] Error in the file '../../../Workflow-Corpus-Open-License/soulj/SkeletalVis-SingleCell/main.nf': Not the same number of parameters given as input for the process 'ENA_DOWNLOAD', possibly at line 123.\n", + "472 ../../../Workflow-Corpus-Open-License/haniffalab/webatlas-pipeline\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/haniffalab/webatlas-pipeline/main.nf': No 'main' workflow was found.\n", + "473 ../../../Workflow-Corpus-Open-License/bts76-pitt/BCR_nextflow\n", + "474 ../../../Workflow-Corpus-Open-License/dnieuw/ENA_SARS_Cov2_nanopore\n", + "475 ../../../Workflow-Corpus-Open-License/nf-modules-hub/mykrobe\n", + "476 ../../../Workflow-Corpus-Open-License/nf-modules-hub/tb-profiler\n", + "477 ../../../Workflow-Corpus-Open-License/nf-modules-hub/mtbseq\n", + "478 ../../../Workflow-Corpus-Open-License/nf-modules-hub/gzip\n", + "479 ../../../Workflow-Corpus-Open-License/nf-modules-hub/snippy\n", + "480 ../../../Workflow-Corpus-Open-License/nf-modules-hub/trimmomatic\n", + "481 ../../../Workflow-Corpus-Open-License/nf-modules-hub/rd-analyzer\n", + "482 ../../../Workflow-Corpus-Open-License/nf-modules-hub/prokka\n", + "483 ../../../Workflow-Corpus-Open-License/nf-modules-hub/spotyping\n", + "484 ../../../Workflow-Corpus-Open-License/nf-modules-hub/kvarq\n", + "485 ../../../Workflow-Corpus-Open-License/nf-modules-hub/multiqc\n", + "486 ../../../Workflow-Corpus-Open-License/nf-modules-hub/nextflow_hub_process\n", + "487 ../../../Workflow-Corpus-Open-License/nf-modules-hub/quast\n", + "488 ../../../Workflow-Corpus-Open-License/nf-modules-hub/spades\n", + "489 ../../../Workflow-Corpus-Open-License/nf-modules-hub/rclone\n", + "490 ../../../Workflow-Corpus-Open-License/nf-modules-hub/fastqc\n", + "491 ../../../Workflow-Corpus-Open-License/mja/ukb-release-nf\n", + "492 ../../../Workflow-Corpus-Open-License/asereewit/rsv_ampseq\n", + "493 ../../../Workflow-Corpus-Open-License/scilus/dmriqc_flow\n", + "494 ../../../Workflow-Corpus-Open-License/RenzoTale88/nf-LO\n", + "[18] Error in the file '../../../Workflow-Corpus-Open-License/RenzoTale88/nf-LO/modules/processes/blat.nf': 'blat_custom' is expected to be defined in the file, but it could not be found.\n", + "495 ../../../Workflow-Corpus-Open-License/khigashi1987/CUTRUN_Nextflow\n", + "496 ../../../Workflow-Corpus-Open-License/UPHL-BioNGS/walkercreek\n", + "[22] Error in the file '../../../Workflow-Corpus-Open-License/UPHL-BioNGS/walkercreek/subworkflows/local/preprocessing_read_qc.nf': Multiple 'emit:' were found in the subworkflow 'PREPROCESSING_READ_QC'. \n", + "497 ../../../Workflow-Corpus-Open-License/UPHL-BioNGS/Nextstrain_Build\n", + "498 ../../../Workflow-Corpus-Open-License/UPHL-BioNGS/Cecret\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/UPHL-BioNGS/Cecret/subworkflows/msa.nf': 'msa' is trying to be created as a channel, possibly at line 7. It already exists as a process or a subworkflow in the nextflow file.\n", + "499 ../../../Workflow-Corpus-Open-License/UPHL-BioNGS/Donut_Falls\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/UPHL-BioNGS/Donut_Falls/workflows/assembly.nf': 'assembly' is trying to be created as a channel, possibly at line 11. It already exists as a process or a subworkflow in the nextflow file.\n", + "500 ../../../Workflow-Corpus-Open-License/UPHL-BioNGS/Grandeur\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/UPHL-BioNGS/Grandeur/subworkflows/average_nucleotide_identity.nf': 'datasets_summary' is trying to be created as a channel, possibly at line 6. It already exists as a process or a subworkflow in the nextflow file.\n", + "501 ../../../Workflow-Corpus-Open-License/jallen73/teloSealer\n", + "502 ../../../Workflow-Corpus-Open-License/sidorov-si/nextflow-example-start\n", + "503 ../../../Workflow-Corpus-Open-License/gongyh/nf-core-scp\n", + "504 ../../../Workflow-Corpus-Open-License/gongyh/nf-core-scgs\n", + "505 ../../../Workflow-Corpus-Open-License/ikmb/nf-template\n", + "[2] Error in the file '../../../Workflow-Corpus-Open-License/ikmb/nf-template/main.nf': Not the same number of parameters given as input for the subworklfow 'MAIN' in the call, possibly at line 38.\n", + "506 ../../../Workflow-Corpus-Open-License/ikmb/gwas-qc\n", + "507 ../../../Workflow-Corpus-Open-License/ikmb/gwas-assoc\n", + "508 ../../../Workflow-Corpus-Open-License/ikmb/finemapping\n", + "509 ../../../Workflow-Corpus-Open-License/ikmb/TOFU-MAaPO\n", + "510 ../../../Workflow-Corpus-Open-License/h3abionet/TADA\n", + "[22] Error in the file '../../../Workflow-Corpus-Open-License/h3abionet/TADA/main.nf': Multiple 'when:' were found in the process 'ToQIIME2Aln'.\n", + "511 ../../../Workflow-Corpus-Open-License/phue/GWAS-nf\n", + "512 ../../../Workflow-Corpus-Open-License/athbaltzis/paralogs-nf\n", + "513 ../../../Workflow-Corpus-Open-License/athbaltzis/diff-AS-nf\n", + "514 ../../../Workflow-Corpus-Open-License/apeltzer/IGCG-featureCounts\n", + "515 ../../../Workflow-Corpus-Open-License/Biocentric/DeepVariantNF\n", + "516 ../../../Workflow-Corpus-Open-License/NorwegianVeterinaryInstitute/nextflow_patterns\n", + "[8] Error in the file '../../../Workflow-Corpus-Open-License/NorwegianVeterinaryInstitute/nextflow_patterns/emit_example.nf': The call for 'doo_foo' coudn't be found, before its use in the operation 'doo_foo.out.foo_item', possibly at line 44. Either because the call wasn't made before the operation or that the element it is calling doesn't exist.\n", + "517 ../../../Workflow-Corpus-Open-License/vierstralab/nf-genotyping\n", + "518 ../../../Workflow-Corpus-Open-License/vierstralab/nf-index\n", + "519 ../../../Workflow-Corpus-Open-License/guigolab/FA-nf\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/guigolab/FA-nf/main.nf': Not the same number of opening and closing parentheses '()' in the file.\n", + "520 ../../../Workflow-Corpus-Open-License/guigolab/selenoprofiles-nf\n", + "521 ../../../Workflow-Corpus-Open-License/guigolab/sqtlseeker2-nf\n", + "522 ../../../Workflow-Corpus-Open-License/guigolab/geneidx\n", + "[10] Error in the file '../../../Workflow-Corpus-Open-License/guigolab/geneidx/main.nf': Something went wrong in an include, possibly at line 34. No such file: '../../../Workflow-Corpus-Open-License/guigolab/geneidx/${wk_folder}/GENEIDX.nf'.\n", + "523 ../../../Workflow-Corpus-Open-License/guigolab/ipsa-nf\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/guigolab/ipsa-nf/ipsa.nf': 'ssjA06' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file.\n", + "524 ../../../Workflow-Corpus-Open-License/quinlan-lab/STRling-nf\n", + "525 ../../../Workflow-Corpus-Open-License/mtuong/nextflow-tychus\n", + "526 ../../../Workflow-Corpus-Open-License/UCL-BLIC/nf-ginkgo\n", + "527 ../../../Workflow-Corpus-Open-License/WangLab-ComputationalBiology/btc-scrna-pipeline\n", + "[10] Error in the file '../../../Workflow-Corpus-Open-License/WangLab-ComputationalBiology/btc-scrna-pipeline/subworkflows/local/input_check.nf': Something went wrong in an include, possibly at line 5. No such file: '../../../Workflow-Corpus-Open-License/WangLab-ComputationalBiology/btc-scrna-pipeline/modules/local/samplesheet_check.nf'.\n", + "528 ../../../Workflow-Corpus-Open-License/connor-lab/qc_nextflow\n", + "529 ../../../Workflow-Corpus-Open-License/lconde-ucl/rnaseq_variant_calling\n", + "530 ../../../Workflow-Corpus-Open-License/lconde-ucl/wgsalign\n", + "531 ../../../Workflow-Corpus-Open-License/lconde-ucl/DGE\n", + "532 ../../../Workflow-Corpus-Open-License/lconde-ucl/runthis\n", + "533 ../../../Workflow-Corpus-Open-License/lconde-ucl/merge_fastq\n", + "534 ../../../Workflow-Corpus-Open-License/nmdp-bioinformatics/flow-GFE\n", + "535 ../../../Workflow-Corpus-Open-License/nmdp-bioinformatics/flow-OptiType\n", + "536 ../../../Workflow-Corpus-Open-License/FilipThorn/nf_mito-mania\n", + "537 ../../../Workflow-Corpus-Open-License/sheynkman-lab/Long-Read-Proteogenomics\n", + "538 ../../../Workflow-Corpus-Open-License/erikrikarddaniel/magmap\n", + "539 ../../../Workflow-Corpus-Open-License/erikrikarddaniel/pfitmap-nextflow\n", + "540 ../../../Workflow-Corpus-Open-License/genepi/nf-gwas\n", + "541 ../../../Workflow-Corpus-Open-License/Plant-Food-Research-Open/assembly_qc\n", + "[14] Error in the file '../../../Workflow-Corpus-Open-License/Plant-Food-Research-Open/assembly_qc/subworkflows/local/tidk.nf': 'set { ch_list_of_a_posteriori_tidk_plots }' is neither a process, subworkflow or an operator. In the executor 'ch_explored_repeat_seq\n", + " .join(\n", + " ch_sorted_hap_file\n", + " )\n", + " | SEARCH_A_POSTERIORI_REPEAT_SEQ\n", + " | PLOT_A_POSTERIORI_REPEAT_SEQ\n", + " | collect\n", + " | set { ch_list_of_a_posteriori_tidk_plots }', possibly at line 18.\n", + "542 ../../../Workflow-Corpus-Open-License/photocyte/luciferase-PPX-predictor-nf\n", + "543 ../../../Workflow-Corpus-Open-License/luslab/nf-clip\n", + "544 ../../../Workflow-Corpus-Open-License/lskatz/Kessel-run\n", + "545 ../../../Workflow-Corpus-Open-License/nf-core/raredisease\n", + "[20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/raredisease/workflows/raredisease.nf': To much to unpack : The subworkflow 'PREPARE_REFERENCES' emits over one channel in a operation, possibly at line 164.\n", + "546 ../../../Workflow-Corpus-Open-License/nf-core/cutandrun\n", + "547 ../../../Workflow-Corpus-Open-License/nf-core/cageseq\n", + "548 ../../../Workflow-Corpus-Open-License/nf-core/hlatyping\n", + "549 ../../../Workflow-Corpus-Open-License/nf-core/genomeannotator\n", + "[8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/genomeannotator/workflows/genomeannotator.nf': The call for 'AUGUSTUS_TRAINING' coudn't be found, before its use in the operation 'ch_aug_config_final = AUGUSTUS_TRAINING.out.aug_config_folder', possibly at line 293. Either because the call wasn't made before the operation or that the element it is calling doesn't exist.\n", + "550 ../../../Workflow-Corpus-Open-License/nf-core/circrna\n", + "[20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/circrna/workflows/circrna.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 115.\n", + "551 ../../../Workflow-Corpus-Open-License/nf-core/ampliseq\n", + "[20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/ampliseq/workflows/ampliseq.nf': To much to unpack : The subworkflow 'CUTADAPT_WORKFLOW' emits over one channel in a operation, possibly at line 323.\n", + "552 ../../../Workflow-Corpus-Open-License/nf-core/readsimulator\n", + "[8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/readsimulator/workflows/readsimulator/main.nf': The call for 'MERGE_FASTAS' coudn't be found, before its use in the operation 'ch_fasta = MERGE_FASTAS.out.fasta\n", + " .map {\n", + " meta, fasta ->\n", + " return fasta\n", + " }', possibly at line 109. Either because the call wasn't made before the operation or that the element it is calling doesn't exist.\n", + "553 ../../../Workflow-Corpus-Open-License/nf-core/chipseq\n", + "[8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/chipseq/subworkflows/local/prepare_genome.nf': The call for 'UNTAR' coudn't be found, before its use in the operation 'ch_versions = ch_versions.mix(UNTAR.out.versions)', possibly at line 177. Either because the call wasn't made before the operation or that the element it is calling doesn't exist.\n", + "554 ../../../Workflow-Corpus-Open-License/nf-core/crisprseq\n", + "[8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/crisprseq/workflows/crisprseq_targeted.nf': Tried to access the emit 'PREPROCESSING_SUMMARY.out.versions' but the Process 'PREPROCESSING_SUMMARY' has not been called in the subworkflow 'CRISPRSEQ_TARGETED'.\n", + "555 ../../../Workflow-Corpus-Open-License/nf-core/rnafusion\n", + "[20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/rnafusion/workflows/rnafusion.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 126.\n", + "556 ../../../Workflow-Corpus-Open-License/nf-core/hic\n", + "557 ../../../Workflow-Corpus-Open-License/nf-core/createpanelrefs\n", + "558 ../../../Workflow-Corpus-Open-License/nf-core/diaproteomics\n", + "559 ../../../Workflow-Corpus-Open-License/nf-core/mag\n", + "[2] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/mag/subworkflows/local/binning.nf': Not the same number of parameters given as input for the subworklfow 'FASTA_BINNING_CONCOCT' in the call, possibly at line 97.\n", + "560 ../../../Workflow-Corpus-Open-License/nf-core/nanostring\n", + "561 ../../../Workflow-Corpus-Open-License/nf-core/detaxizer\n", + "562 ../../../Workflow-Corpus-Open-License/nf-core/variantcatalogue\n", + "563 ../../../Workflow-Corpus-Open-License/nf-core/funcscan\n", + "564 ../../../Workflow-Corpus-Open-License/nf-core/mhcquant\n", + "[22] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/mhcquant/modules/local/samplesheet_check.nf': Multiple 'when:' were found in the process 'SAMPLESHEET_CHECK'.\n", + "565 ../../../Workflow-Corpus-Open-License/nf-core/airrflow\n", + "[14] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/airrflow/subworkflows/local/assembled_input_check.nf': 'fa]$/\n", + " tsv: it[0].filename =~ /tsv$/\n", + " }\n", + " .set{ ch_metadata }' is neither a process, subworkflow or an operator. In the executor 'ch_validated_input\n", + " .splitCsv(header: true, sep:'\\t')\n", + " .map { get_meta(it) }\n", + " .branch { it ->\n", + " fasta: it[0].filename =~ /[fasta|fa]$/\n", + " tsv: it[0].filename =~ /tsv$/\n", + " }\n", + " .set{ ch_metadata }', possibly at line 21.\n", + "566 ../../../Workflow-Corpus-Open-License/nf-core/pangenome\n", + "567 ../../../Workflow-Corpus-Open-License/nf-core/rnasplice\n", + "[20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/rnasplice/workflows/rnasplice.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 161.\n", + "568 ../../../Workflow-Corpus-Open-License/nf-core/bacass\n", + "569 ../../../Workflow-Corpus-Open-License/nf-core/demultiplex\n", + "[8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/demultiplex/workflows/demultiplex.nf': Tried to access the emit 'UNTAR.out.versions' but the Process 'UNTAR' has not been called in the subworkflow 'DEMULTIPLEX'.\n", + "570 ../../../Workflow-Corpus-Open-License/nf-core/exoseq\n", + "571 ../../../Workflow-Corpus-Open-License/nf-core/differentialabundance\n", + "572 ../../../Workflow-Corpus-Open-License/nf-core/smrnaseq\n", + "[20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/smrnaseq/workflows/smrnaseq.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 104.\n", + "573 ../../../Workflow-Corpus-Open-License/nf-core/dualrnaseq\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/dualrnaseq/main.nf': 'salmon_index' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file.\n", + "574 ../../../Workflow-Corpus-Open-License/nf-core/nascent\n", + "[8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/nascent/subworkflows/local/prepare_genome.nf': The call for 'UNTAR_DRAGMAP_INDEX' coudn't be found, before its use in the operation 'ch_versions = ch_versions.mix(UNTAR_DRAGMAP_INDEX.out.versions)', possibly at line 122. Either because the call wasn't made before the operation or that the element it is calling doesn't exist.\n", + "575 ../../../Workflow-Corpus-Open-License/nf-core/marsseq\n", + "576 ../../../Workflow-Corpus-Open-License/nf-core/kmermaid\n", + "577 ../../../Workflow-Corpus-Open-License/nf-core/configs\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/configs/configtest.nf': No 'main' workflow was found.\n", + "578 ../../../Workflow-Corpus-Open-License/nf-core/spatialtranscriptomics\n", + "579 ../../../Workflow-Corpus-Open-License/nf-core/modules\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/modules/main.nf': No 'main' workflow was found.\n", + "580 ../../../Workflow-Corpus-Open-License/nf-core/eager\n", + "581 ../../../Workflow-Corpus-Open-License/nf-core/ssds\n", + "[8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/ssds/subworkflows/local/sort_and_index_bam.nf': The call for 'SAMTOOLS_SORTSAM' coudn't be found, before its use in the operation 'ch_versions = ch_versions.mix(SAMTOOLS_SORTSAM.out.versions.first())', possibly at line 17. Either because the call wasn't made before the operation or that the element it is calling doesn't exist.\n", + "582 ../../../Workflow-Corpus-Open-License/nf-core/rnaseq\n", + "583 ../../../Workflow-Corpus-Open-License/nf-core/phageannotator\n", + "[20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/phageannotator/workflows/phageannotator/main.nf': To much to unpack : The subworkflow 'FASTQ_VIRUS_ENRICHMENT_VIROMEQC' emits over one channel in a operation, possibly at line 78.\n", + "584 ../../../Workflow-Corpus-Open-License/nf-core/omicsgenetraitassociation\n", + "585 ../../../Workflow-Corpus-Open-License/nf-core/metaboigniter\n", + "[14] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/metaboigniter/subworkflows/local/mergems1ms2.nf': 'OPENMS_FILEMERGER' is neither a process, subworkflow or an operator. In the executor 'mzml_files.filter{meta,file->meta.level != \"MS2\"}.combine(OPENMS_FILEFILTERMS2.out.mzml.map{it[1]}).groupTuple(by:[0,1]) | OPENMS_FILEMERGER', possibly at line 19.\n", + "586 ../../../Workflow-Corpus-Open-License/nf-core/epitopeprediction\n", + "[8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/epitopeprediction/workflows/epitopeprediction.nf': The call for 'SHOW_SUPPORTED_MODELS' coudn't be found, before its use in the operation 'ch_versions = ch_versions.mix(SHOW_SUPPORTED_MODELS.out.versions.ifEmpty(null))', possibly at line 180. Either because the call wasn't made before the operation or that the element it is calling doesn't exist.\n", + "587 ../../../Workflow-Corpus-Open-License/nf-core/vipr\n", + "588 ../../../Workflow-Corpus-Open-License/nf-core/methylseq\n", + "589 ../../../Workflow-Corpus-Open-License/nf-core/viralintegration\n", + "590 ../../../Workflow-Corpus-Open-License/nf-core/genomeassembler\n", + "[2] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/genomeassembler/subworkflows/local/evaluate_gene_space.nf': Not the same number of parameters given as input for the process 'BUSCO', possibly at line 10.\n", + "591 ../../../Workflow-Corpus-Open-License/nf-core/circdna\n", + "[20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/circdna/workflows/circdna.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 190.\n", + "592 ../../../Workflow-Corpus-Open-License/nf-core/fetchngs\n", + "[2] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/fetchngs/main.nf': Not the same number of parameters given as input for the subworklfow 'SYNAPSE' in the call, possibly at line 46.\n", + "593 ../../../Workflow-Corpus-Open-License/nf-core/multiplesequencealign\n", + "[22] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/multiplesequencealign/modules/local/prepare_shiny.nf': Multiple 'when:' were found in the process 'PREPARE_SHINY'.\n", + "594 ../../../Workflow-Corpus-Open-License/nf-core/isoseq\n", + "595 ../../../Workflow-Corpus-Open-License/nf-core/pathogensurveillance\n", + "596 ../../../Workflow-Corpus-Open-License/nf-core/phyloplace\n", + "597 ../../../Workflow-Corpus-Open-License/nf-core/taxprofiler\n", + "[20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/taxprofiler/subworkflows/local/shortread_preprocessing.nf': To much to unpack : The subworkflow 'SHORTREAD_FASTP' emits over one channel in a operation, possibly at line 21.\n", + "598 ../../../Workflow-Corpus-Open-License/nf-core/metatdenovo\n", + "[20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/metatdenovo/workflows/metatdenovo.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 146.\n", + "599 ../../../Workflow-Corpus-Open-License/nf-core/viralrecon\n", + "[20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/viralrecon/workflows/illumina.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 163.\n", + "600 ../../../Workflow-Corpus-Open-License/nf-core/scrnaseq\n", + "[20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/scrnaseq/workflows/scrnaseq.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 121.\n", + "601 ../../../Workflow-Corpus-Open-License/nf-core/fastquorum\n", + "602 ../../../Workflow-Corpus-Open-License/nf-core/rnadnavar\n", + "[8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/rnadnavar/subworkflows/local/prepare_genome/main.nf': The call for 'GUNZIP_GFF' coudn't be found, before its use in the operation 'ch_gff = GUNZIP_GFF.out.gunzip.map{ meta, gff -> [gff] }.collect()', possibly at line 98. Either because the call wasn't made before the operation or that the element it is calling doesn't exist.\n", + "603 ../../../Workflow-Corpus-Open-License/nf-core/bamtofastq\n", + "604 ../../../Workflow-Corpus-Open-License/nf-core/clipseq\n", + "605 ../../../Workflow-Corpus-Open-License/nf-core/neutronstar\n", + "606 ../../../Workflow-Corpus-Open-License/nf-core/rnavar\n", + "[20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/rnavar/workflows/rnavar.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 138.\n", + "607 ../../../Workflow-Corpus-Open-License/nf-core/createtaxdb\n", + "608 ../../../Workflow-Corpus-Open-License/nf-core/gwas\n", + "609 ../../../Workflow-Corpus-Open-License/nf-core/coproid\n", + "610 ../../../Workflow-Corpus-Open-License/nf-core/nanoseq\n", + "[8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/nanoseq/subworkflows/local/rna_modifications_xpore_m6anet.nf': Tried to access the emit 'NANOPOLISH_INDEX_EVENTALIGN.out.nanopolish_outputs' but the Process 'NANOPOLISH_INDEX_EVENTALIGN' has not been called in the subworkflow 'RNA_MODIFICATION_XPORE_M6ANET'.\n", + "611 ../../../Workflow-Corpus-Open-License/nf-core/sarek\n", + "612 ../../../Workflow-Corpus-Open-License/nf-core/radseq\n", + "[20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/radseq/workflows/radseq.nf': To much to unpack : The subworkflow 'CDHIT_RAINBOW' emits over one channel in a operation, possibly at line 97.\n", + "613 ../../../Workflow-Corpus-Open-License/nf-core/atacseq\n", + "[8] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/atacseq/subworkflows/local/prepare_genome.nf': The call for 'UNTAR' coudn't be found, before its use in the operation 'ch_versions = ch_versions.mix(UNTAR.out.versions)', possibly at line 199. Either because the call wasn't made before the operation or that the element it is calling doesn't exist.\n", + "614 ../../../Workflow-Corpus-Open-License/nf-core/proteinfold\n", + "[20] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/proteinfold/workflows/alphafold2.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 81.\n", + "615 ../../../Workflow-Corpus-Open-License/nf-core/proteomicslfq\n", + "616 ../../../Workflow-Corpus-Open-License/nf-core/bactmap\n", + "617 ../../../Workflow-Corpus-Open-License/nf-core/mnaseseq\n", + "618 ../../../Workflow-Corpus-Open-License/nf-core/metapep\n", + "619 ../../../Workflow-Corpus-Open-License/nf-core/crisprvar\n", + "620 ../../../Workflow-Corpus-Open-License/nf-core/quantms\n", + "[14] Error in the file '../../../Workflow-Corpus-Open-License/nf-core/quantms/workflows/quantms.nf': 'set {ch_db_for_decoy_creation_or_null}' is neither a process, subworkflow or an operator. In the executor 'CREATE_INPUT_CHANNEL.out.ch_meta_config_iso.mix(CREATE_INPUT_CHANNEL.out.ch_meta_config_lfq).first() \n", + " | combine( ch_db_for_decoy_creation ) \n", + " | map { it[-1] } \n", + " | set {ch_db_for_decoy_creation_or_null}', possibly at line 135.\n", + "621 ../../../Workflow-Corpus-Open-License/nf-core/imcyto\n", + "622 ../../../Workflow-Corpus-Open-License/andrecossa5/mito_preprocessing\n", + "623 ../../../Workflow-Corpus-Open-License/lisemangiante/test_nextflow\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/lisemangiante/test_nextflow/plot_coverage.nf': 'coverage' is trying to be created as a channel, possibly at line 3. It already exists as a process or a subworkflow in the nextflow file.\n", + "624 ../../../Workflow-Corpus-Open-License/dakoner/nextflow-example\n", + "625 ../../../Workflow-Corpus-Open-License/lifebit-ai/DeepVariant\n", + "626 ../../../Workflow-Corpus-Open-License/lifebit-ai/roary\n", + "627 ../../../Workflow-Corpus-Open-License/lifebit-ai/Plant-RNASeq\n", + "628 ../../../Workflow-Corpus-Open-License/lifebit-ai/onemetagenome\n", + "629 ../../../Workflow-Corpus-Open-License/jb-adams/variable-length-inputs-nf\n", + "630 ../../../Workflow-Corpus-Open-License/JingQiChong/nf_CRACpipeline\n", + "631 ../../../Workflow-Corpus-Open-License/juneb4869/new_meripseqpipe\n", + "632 ../../../Workflow-Corpus-Open-License/rmhubley/pseudo-it-nextflow\n", + "633 ../../../Workflow-Corpus-Open-License/louperelo/longmetarg\n", + "634 ../../../Workflow-Corpus-Open-License/j3551ca/BEAST-FLOW\n", + "635 ../../../Workflow-Corpus-Open-License/matsengrp/phip-flow\n", + "[14] Error in the file '../../../Workflow-Corpus-Open-License/matsengrp/phip-flow/workflows/edgeR_BEER.nf': In the executor 'ds | to_csv | run_edgeR | run_BEER | (append_assay_csvs_to_xarray & publish_rds)', '(append_assay_csvs_to_xarray & publish_rds)' is neither a process, subworkflow or an operator (in the file '../../../Workflow-Corpus-Open-License/matsengrp/phip-flow/workflows/edgeR_BEER.nf')\n", + "636 ../../../Workflow-Corpus-Open-License/raonyguimaraes/nextflow-hello\n", + "637 ../../../Workflow-Corpus-Open-License/MazdaX/nf-cage\n", + "638 ../../../Workflow-Corpus-Open-License/qbic-pipelines/rnadeseq\n", + "639 ../../../Workflow-Corpus-Open-License/qbic-pipelines/cellranger\n", + "640 ../../../Workflow-Corpus-Open-License/CollinsLabBioComp/nextflow-sc_dge\n", + "641 ../../../Workflow-Corpus-Open-License/dholab/nf-iWES\n", + "642 ../../../Workflow-Corpus-Open-License/avantonder/bovisanalyzer\n", + "643 ../../../Workflow-Corpus-Open-License/bigbio/pgdb\n", + "644 ../../../Workflow-Corpus-Open-License/Ensembl/ensembl-genes-nf\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/Ensembl/ensembl-genes-nf/modules.nf': No 'main' workflow was found.\n", + "645 ../../../Workflow-Corpus-Open-License/cnr-ibba/nf-resequencing-mem\n", + "[20] Error in the file '../../../Workflow-Corpus-Open-License/cnr-ibba/nf-resequencing-mem/workflows/resequencing-mem.nf': To much to unpack : The subworkflow 'INPUT_CHECK' emits over one channel in a operation, possibly at line 67.\n", + "646 ../../../Workflow-Corpus-Open-License/cnr-ibba/nf-neestimator\n", + "647 ../../../Workflow-Corpus-Open-License/alam1988/Nextflow\n", + "[12] Error in the file '../../../Workflow-Corpus-Open-License/alam1988/Nextflow/main.nf': An include ('include { SRA_DOWNLOAD } from './sra_download'') was found in the main in the file '../../../Workflow-Corpus-Open-License/alam1988/Nextflow/main.nf'. FlowInsight does not support this -> see specification list.\n", + "648 ../../../Workflow-Corpus-Open-License/OLC-Bioinformatics/BaitCapture\n", + "649 ../../../Workflow-Corpus-Open-License/nvnieuwk/nf-samplesheet-conversion\n", + "650 ../../../Workflow-Corpus-Open-License/chrisjackson-pellicle/hybpiper-nf\n", + "[22] Error in the file '../../../Workflow-Corpus-Open-License/chrisjackson-pellicle/hybpiper-nf/hybpiper.nf': Multiple 'take:' were found in the subworkflow 'fix_targetfile_main'.\n", + "651 ../../../Workflow-Corpus-Open-License/chrisjackson-pellicle/paragone-nf\n", + "652 ../../../Workflow-Corpus-Open-License/VEuPathDB/marker-gene-analysis-16s-DADA2-nextflow\n", + "653 ../../../Workflow-Corpus-Open-License/VEuPathDB/psipred-nextflow\n", + "654 ../../../Workflow-Corpus-Open-License/VEuPathDB/dnaseq-nextflow\n", + "655 ../../../Workflow-Corpus-Open-License/VEuPathDB/mitoprot-nextflow\n", + "656 ../../../Workflow-Corpus-Open-License/VEuPathDB/gpi-anchor-prediction-nextflow\n", + "657 ../../../Workflow-Corpus-Open-License/VEuPathDB/hmmer-nextflow\n", + "658 ../../../Workflow-Corpus-Open-License/VEuPathDB/MicrobiomeDB\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/VEuPathDB/MicrobiomeDB/main.nf': No 'main' workflow was found.\n", + "659 ../../../Workflow-Corpus-Open-License/VEuPathDB/bowtie-mapping-nextflow\n", + "[6] Error in the file '../../../Workflow-Corpus-Open-License/VEuPathDB/bowtie-mapping-nextflow/modules/bowtieMapping.nf': One channel was expected in the emit 'makeIndex.out'. Even though multiple emits are defined for the workflow 'makeIndex'\n", + "660 ../../../Workflow-Corpus-Open-License/PMCC-BioinformaticsCore/dinoflow\n", + "661 ../../../Workflow-Corpus-Open-License/Papatheodorou-Group/BENGAL\n", + "662 ../../../Workflow-Corpus-Open-License/OligoGeneticDiseases/oligo-nf\n", + "663 ../../../Workflow-Corpus-Open-License/PlantGGHLab/qiime2-nf\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/PlantGGHLab/qiime2-nf/main.nf': No 'main' workflow was found.\n", + "664 ../../../Workflow-Corpus-Open-License/Arcadia-Science/metagenomics\n", + "665 ../../../Workflow-Corpus-Open-License/Arcadia-Science/seqqc\n", + "666 ../../../Workflow-Corpus-Open-License/ifremer-bioinformatics/samba\n", + "667 ../../../Workflow-Corpus-Open-License/dalmolingroup/bulkrna\n", + "668 ../../../Workflow-Corpus-Open-License/abyssum/NeoFuse2\n", + "669 ../../../Workflow-Corpus-Open-License/dhslab/nf-core-wgsnano\n", + "670 ../../../Workflow-Corpus-Open-License/bhagesh-codebeast/nextflowdualrnaseq\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/bhagesh-codebeast/nextflowdualrnaseq/main.nf': 'salmon_index' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file.\n", + "671 ../../../Workflow-Corpus-Open-License/George-Marchment/hackathon\n", + "672 ../../../Workflow-Corpus-Open-License/msk-mind/clam-nf\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/msk-mind/clam-nf/main.nf': 'GET_SLIDES' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file.\n", + "673 ../../../Workflow-Corpus-Open-License/msk-mind/oncofusion-nf\n", + "[4] Error in the file '../../../Workflow-Corpus-Open-License/msk-mind/oncofusion-nf/main.nf': 'GET_SLIDES' is trying to be created as a channel. It already exists as a process or a subworkflow in the nextflow file.\n", + "674 ../../../Workflow-Corpus-Open-License/daupt/hello-nextflow\n", + "675 ../../../Workflow-Corpus-Open-License/sifrimlab/ST-nextflow-pipeline\n", + "[16] Error in the file '../../../Workflow-Corpus-Open-License/sifrimlab/ST-nextflow-pipeline/main.nf': No 'main' workflow was found.\n", + "676 ../../../Workflow-Corpus-Open-License/crickbabs/BABS-MNASeqPE\n", + "677 ../../../Workflow-Corpus-Open-License/crickbabs/BABS-ATACSeqPE\n" ] - }, - { - "name": "stderr", - "output_type": "stream", - "text": [ - "mkdir: opérande manquant\n", - "Saisissez « mkdir --help » pour plus d'informations.\n", - "Clonage dans '../../../Workflow-Corpus-Open-License/IARCbioinfo/bamsurgeon-nf'...\n" - ] - }, + } + ], + "source": [ + "DSL_tab = []\n", + "if(run_analysis_on_corpus):\n", + " index = 0\n", + " errors_string = \"\"\n", + " nb_errors = 0\n", + " for wf in workflows:\n", + " print(index, wf)\n", + "\n", + " try:\n", + " nextflow_files = glob.glob(f'{wf}/**/*.nf', recursive=True)\n", + " try:\n", + " file = '/'.join(nextflow_files[0].split('/')[:-1])+\"/main.nf\"\n", + " with open(file, 'r') as f:\n", + " txt= f.read()\n", + " except:\n", + " file =nextflow_files[0]\n", + "\n", + " w = Nextflow_File(file, duplicate=False, display_info=False)\n", + " w.initialise()\n", + "\n", + " DSL_tab.append({\"workflow\":wf, \"DSL\":w.get_DSL()})\n", + "\n", + " except BioFlowInsightError as e:\n", + " nb_errors+=1\n", + " errors_string+= f\"- {index} {wf} \\n {str(e)} \\n\\n\"\n", + " text_file = open(\"failed_2_analyse.txt\", \"w\")\n", + " n = text_file.write(errors_string)\n", + " text_file.close()\n", + " print(str(e))\n", + "\n", + " \n", + " index+=1\n" + ] + }, + { + "cell_type": "code", + "execution_count": 7, + "metadata": {}, + "outputs": [ { "name": "stdout", "output_type": "stream", "text": [ - "\n", - "\n", - "\n", - "* 9/752\n", - "Downloading...'nextflow-io/cwl2nxf'\n" + "Analysed 75.37% (511) of the workflows succesfully. The others failed.\n" ] - }, + } + ], + "source": [ + "if(run_analysis_on_corpus):\n", + " print(f\"Analysed {100-nb_errors/len(workflows)*100:.2f}% ({len(workflows)-nb_errors}) of the workflows succesfully. The others failed.\")" + ] + }, + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Analysing the results" + ] + }, + { + "cell_type": "code", + "execution_count": 8, + "metadata": {}, + "outputs": [], + "source": [ + "if(analyse_results):\n", + " df = pd.DataFrame(DSL_tab)\n", + " df.groupby([\"DSL\"]).count()" + ] + }, + { + "cell_type": "code", + "execution_count": 9, + "metadata": {}, + "outputs": [ { - "name": "stderr", - "output_type": "stream", - "text": [ - "mkdir: opérande manquant\n", - "Saisissez « mkdir --help » pour plus d'informations.\n", - "Clonage dans '../../../Workflow-Corpus-Open-License/nextflow-io/cwl2nxf'...\n" - ] + "data": { + "image/png": "iVBORw0KGgoAAAANSUhEUgAAAfAAAAGZCAYAAAB2V2N0AAAAOXRFWHRTb2Z0d2FyZQBNYXRwbG90bGliIHZlcnNpb24zLjUuMSwgaHR0cHM6Ly9tYXRwbG90bGliLm9yZy/YYfK9AAAACXBIWXMAAA9hAAAPYQGoP6dpAABbi0lEQVR4nO3dd3gU1f4/8PfsJpvdTe+EBAIEElqAIC0RAbGgYqGIFwuCKAqKfBG9Yrl2UfGneL1wRRG8ImJFVFSwICBC6NKlhB4S0nu2ZHfn/P6Iu7IkgQSSzM7m/XoeHs3s7M5n27z3nDlzRhJCCBAREZGqaJQugIiIiBqOAU5ERKRCDHAiIiIVYoATERGpEAOciIhIhRjgREREKsQAJyIiUiEGOBERkQoxwImIiFSoQQG+fPlyJCUluf4lJyfj8ssvx7hx4/Dee++hsLCwxn3mzp2LpKSkBhVlNpsxd+5cbNmypUH3q21bQ4cOxQMPPNCgx7mQ7777Dh9++GGttyUlJWHu3LmNur3GtmnTJowaNQq9evVCUlISVq9eXet6p0+fdnu/u3Xrhv79+2P06NF45ZVXkJGRUev9jh49in/+85+46qqrkJycjP79+2PkyJF48cUXUVFR4VrviSeeQEpKSpM8x+bk/F6cPn1a6VJqcL6HixYtarTHzM3Nxdy5c3HgwIFGe0xP88QTTyApKQnDhw+Hw+GocXtSUhJefPHFJtv+kSNHMHfu3Do/U2+99RaGDBmCrl27ok+fPgCAcePGYdy4cU1Wk6dz7v+LioouuK63vH4+F3OnV199FR06dIDdbkdhYSF27NiB999/Hx988AHeeustpKWludYdM2YMrrjiigY9vtlsxrx58zB16lT079+/3ve7mG1djO+//x4ZGRmYMGFCjds+//xztGrVqslruFhCCEyfPh3t2rXD/PnzYTAY0L59+/PeZ9y4cbjxxhshyzLKy8vx559/4quvvsLHH3+MGTNm4L777nOt++eff+L2229HQkICHnroIcTGxqK4uBgHDx7EypUrMXHiRAQEBDT102xWQ4YMweeff46oqCilS2kWeXl5mDdvHmJjY9GlSxely2lSR44cwfLlyzFmzJhm3+68efPQr18/xMXFud22evVqvPvuu5g8eTIGDRoEnU7XrLWpnTe9fhcV4J06dUJycrLr72HDhmHChAm44447MHXqVPz888+IiIgAALRq1arJA81sNsNgMDTLti6kV69eim7/QvLy8lBSUoKrr74aqamp9bpPTEyM2/MaPHgw7rnnHkydOhX/7//9P3Tq1AmDBw8GACxevBgajQYfffSRW1Bfd911mD59OtQy9b7D4YDD4ajXlzssLAxhYWHNUBU1J6PRiK5du2Lu3Lm46aaboNfrlS4JAFw9X3fffTfCw8MVrkZ5FosFfn5+9V7fm16/RjsG3rp1a8ycOROVlZX47LPPXMtr69betGkTxo0bh/79+6NHjx4YMmQIHn74YZjNZpw+fdoVLPPmzXN13z7xxBNuj7d//35MmzYNffv2xTXXXFPntpx++eUX3HTTTUhOTsZVV12Fjz76yO32urpBt2zZgqSkJFd3/rhx47Bu3TpkZWW5dS871daFfvjwYUyZMgV9+/ZFcnIybrnlFnz99de1buf777/HW2+9hYEDB6J3796YMGECjh07dv4X/y/bt2/H+PHjkZKSgp49e2Ls2LFYt26d6/a5c+di0KBBAIA33ngDSUlJGDp0aL0e+1x6vR6zZs2Cr6+vW/dsSUkJ/P394e/vX+v9JEm6qO05FRUVoXv37vj3v/9d47ajR48iKSnJ7b3Nz8/Hs88+i0GDBqF79+4YOnQo5s2bB7vd7lrH2c38/vvv45133sHQoUORnJyMzZs3Q5ZlvPPOOxg2bBh69OiBPn364KabbsLixYtd96/rs7Ns2TLcfPPNSE5ORr9+/fDQQw/h6NGjbus4DyOcPHkSkyZNQkpKCgYPHozXXnsNVVVVbut+8sknuPnmm5GSkoKUlBRcd911mDNnTr1eN1mWMX/+fAwZMgTJyckYNWoUNm3aVGO9EydO4NFHH0Vqaiq6d++O66+/HkuXLnXdvmXLFtx6660AgCeffNL1+Z87dy7WrVuHpKQk7Nmzx7X+Tz/9hKSkJNx///1u27npppvw8MMPu/4WQmDp0qW45ZZb0KNHD/Tt2xfTpk1DZmZmjRrT09Mxfvx49O7d2/U5P/e5OPcFGRkZmDFjBi677DKkpaXhySefRHl5eb1eMwB47LHHkJubW2N/UZuKigrMnj0bQ4cORffu3XHFFVdg1qxZMJlMrnWeffZZJCcnY9++fa5lsixj/PjxSEtLQ15eHpYvX47/+7//A1AdMs7XePny5Rg6dKjrs5+WlnbBQ3YlJSV4/vnnccUVV6B79+646qqr8NZbb7l9tqZNm4bhw4e73W/y5MlISkrCqlWrXMv279+PpKQkrFmzps7tjR49utb3+tzPxc8//4ykpCQcOnTItexC+y/g7+/ahg0b8OSTT2LAgAHo2bNnje+K09GjR3HVVVdhzJgxKCws9KjXz2w2uz4vzn3EqFGj8P3339dZz7kuqgVel8GDB0Or1WL79u11rnP69Gk88MAD6NOnD2bNmoWgoCDk5ubi999/h81mQ1RUFBYuXIj77rsPt956q6vr6twWzsMPP4wbbrgBY8eOdfuC1ObAgQN45ZVXMHXqVEREROC7777DrFmzYLPZcO+99zboOT733HN45plnkJmZiXnz5l1w/WPHjmHs2LEIDw/H008/jdDQUKxYsQJPPPEECgoKMGnSJLf158yZg969e2PWrFmoqKjAG2+8gSlTpmDlypXQarV1bmfr1q2YOHEiEhMTMWvWLOh0Onz66aeYPHky5syZgxtuuAFjxoxB586dMXXqVFe3+KV0H0VHR6Nbt27YuXMn7HY7fHx80KtXL6xbtw6PPfYY/vGPf6BHjx6N2nIJCwvDkCFD8M0332DatGnQaP7+Dbp8+XL4+vripptuAlAd3mPGjIFGo8FDDz2Etm3bYufOnZg/fz6ysrLw6quvuj32kiVL0K5dO8ycORMBAQGIj4/HwoULMW/ePEyZMgV9+vSB3W7HsWPHLhgC7733HubMmYMbb7wRjz76KIqLizFv3jz84x//wLJly9CuXTvXujabDVOmTMGtt96KiRMnYtu2bXjnnXcQEBCAqVOnAgB++OEHvPDCCxg3bhxmzpwJjUaDkydP4siRI/V63ZYuXYrWrVvjqaeegizLWLhwISZNmoQlS5a4xiEcOXIEY8eORUxMDGbOnInIyEhs2LABL7/8MoqLizF16lR069YNr776Kp588klMmTIFQ4YMAVDd0xYYGAhfX19s2rQJPXr0AFAdtnq9Htu2bYPNZoOvry8KCwuRkZGB22+/3VXfs88+i6+//hrjxo3DY489htLSUvz3v//F2LFj8e2337p69L799lvMnDkTV111FWbPng0fHx98/vnnuPfee7Fo0aIavUrO/cStt96Kw4cP48033wSAGu99XVJSUnDNNdfg/fffx2233YaQkJBa1zObzbjrrruQk5Pj2nlnZGTgP//5Dw4fPowPP/wQkiTh6aefxp49ezB9+nQsX74cQUFBmDdvHrZu3YqFCxciKioKQ4YMwYwZMzBnzhw8++yz6NatGwCgbdu26Ny5M5YuXYply5Zh4cKFCAwMrLPX0Wq14u6770ZmZiYefvhhJCUlYfv27ViwYAEOHDiABQsWAKgOsp9++gl5eXmIioqC3W7H1q1bodfrkZ6ejuuvv971Xvr4+KBfv351vl5paWn4+OOPXe91QUEBDh8+7Hqssz8XERERrsZPffZfZ3vqqacwZMgQvP766zCbzfDxqRllW7duxdSpU9GnTx+8+eabMBgMmDdvnse8fq+++ipWrFiB6dOno0uXLjCbzTh8+DBKSkrqfH1rEA3w1VdficTERLFnz54610lLSxPXX3+96+///Oc/IjEx0fX3jz/+KBITE8WBAwfqfIzCwkKRmJgo/vOf/9S4zfl4b7/9dp23ne3KK68USUlJNbZ3zz33iN69ewuTyeT23DIzM93W27x5s0hMTBSbN292Lbv//vvFlVdeWWvt59b9yCOPiO7du4vs7Gy39e677z7Rs2dPUVZW5radSZMmua23cuVKkZiYKHbu3Fnr9pxuu+02kZqaKioqKlzL7Ha7uPHGG8WgQYOELMtCCCEyMzNFYmKiWLhw4Xkfr77rTp8+XSQmJoqCggIhhBBWq1U8+OCDIjExUSQmJoouXbqIESNGiDlz5ojCwkK3+86cOVP06tXrgnWc69dffxWJiYliw4YNbs914MCB4uGHH3Yte+aZZ0SvXr1EVlaW2/0XLVokEhMTRUZGhtvzvPrqq0VVVZXbug888IC45ZZbzlvPuZ+d0tJS0aNHjxrvZXZ2tujevbuYMWOGa9nMmTNFYmKiWLlypdu6kyZNEsOGDXP9/eKLL4o+ffqct47aOJ/bwIEDhcVicS0vLy8X/fr1ExMmTHAtmzhxohg0aJAoLy93e4wXX3xRJCcni5KSEiGEEHv27BGJiYniq6++qrG922+/Xdx9992uv6+55hoxe/Zs0blzZ7F161YhhBArVqwQiYmJ4vjx40IIIXbu3CkSExPFBx984PZYZ86cET169BCvv/66EEIIk8kk+vXrJx544AG39RwOh7j55pvFrbfe6lrm3Be8//77bus+//zzIjk52fV9qMvZn82jR4+KLl26iNdee811e2JionjhhRdcf7/33nuic+fONfaNzv3dunXrXMtOnDghevfuLR588EGRnp4uOnfuLN566y23+61atarGfufc53bu9+muu+4Sd911l+vvTz/9tNbP1oIFC9y+PydPnhSJiYni66+/FkIIsX37dpGYmChef/11MXToUNf97rnnHvGPf/yjztdMCCHS09NFYmKi2LZtmxBCiG+//VakpKSI559/XowbN8613rXXXuv2Pajv/sv5XXv88cfP+7p88803olu3buKll14SDofDI1+/G2+8UTz44IPneTUvrNFPIxMXOMbZpUsX+Pr64plnnsHXX39daxdZfVx77bX1XrdTp07o3Lmz27Ibb7wRFRUV2L9//0Vtv742b96M1NRUxMTEuC0fOXIkzGYzdu7c6bb83C5t5y/U7OzsOrdhMpmwe/duDBs2zK3rWqvV4uabb0ZOTk69u+Eb6tz3W6fT4b///S9WrlyJJ598EjfccAOKiorw7rvv4vrrr2+UOgYNGoTIyEgsX77ctWzDhg3Iy8vD6NGjXcvWrVuH/v37u34VO/85DyNs3brV7XGHDh0KX19ft2XJyck4ePAgnn/+efz+++9uo+jrsnPnTlgsFowcOdJteUxMDAYMGIDNmze7LZckqdb3/ez3PDk5GWVlZZgxYwZWr15dr5G2Z7v22mvdjhMGBATgyiuvxLZt2+BwOGC1WrF582Zcc8010Ov1NV4vq9WKXbt2XXA7qamp+OOPP2CxWJCVlYWTJ09i+PDh6NKlCzZu3AiguiXSunVrVy/E2rVrIUkSbr75ZrftRkREoHPnzq73aefOnSgpKcHIkSPd1pNlGVdccQX27t1bozeuttfVarXWesZMXTp06IBbb70VH3/8cZ3fw7Vr16JTp07o0qWLW20DBw6EJElun7X4+Hi89NJLWL16tas38uzDCY1l8+bNMBqNuO6669yWjxo1CgBchx3atm2L2NhY19/p6elITEzEzTffjNOnT+PUqVOoqqrCjh073AYo16Z3797w8/NDenq667H69euHK664Ajt37oTZbMaZM2dw4sQJ12NdzP7rfPv/d999F08++SQee+wx/Otf/3LrpWuIpn79kpOTsX79erzxxhvYsmULLBZLg2ts1C50k8mEkpISJCYm1rlO27Zt8eGHH2LhwoV48cUXYTKZ0KZNG4wbNw7jx4+v97YaMuLX2f1W27IGdVdchJKSEkRGRtZY7qz/3O2f20Xn7OI+35tbVlYGIUSDttNYsrOzodPpEBwc7LY8ISEBCQkJAKpDfvHixXj11Vfx9ttv4+23376kbfr4+ODmm2/Gxx9/jLKyMgQFBWH58uWIjIzEwIEDXesVFhZi7dq1ri7IcxUXF7v9Xdvr98ADD8BoNGLFihX47LPPoNVq0adPHzz22GNuAznP5nyt63o/nDs3J4PBUGMQjk6ng9Vqdf09YsQIOBwOfPnll5g2bRpkWUZycjKmT5+Oyy+/vNY6zlbXd8Bms8FkMsFkMsFut2PJkiVYsmRJrY9x7utVm9TUVMybNw87duxAdnY2QkND0bVrV6SmpmLTpk2YPn2660etU2FhIYQQdYZDmzZtAAAFBQUAqo851qW0tBRGo9H198V8n2ozdepUrFixAm+//TZmz55d4/bCwkKcPHmy3p+1IUOGICIiAgUFBZgwYcJ5D49drJKSEkRERNQYdxIeHg4fHx+3fUJqaip+//13ANUBdPnllyMpKQkRERFIT09HfHw8LBbLBQPcz88PvXv3Rnp6OqZNm4ZNmzbhvvvuQ79+/SDLMrZv347c3FwAcD3Wxey/alvXacWKFYiOjq7R7d5QTf36/etf/0KrVq2wcuVKvP/++/Dz88PAgQPx+OOPux1iO59GDfB169bB4XCc9xgJAPTp0wd9+vSBw+HAvn37sGTJErzyyiuIiIioMRigMTi/+LUtc37BnTvQcwdD1GendT4hISHIz8+vsTwvLw8AEBoaekmPDwBBQUHQaDRNvp1z5ebmYv/+/ejbt2+tx6CcJEnChAkT8N///rfOc8cbavTo0Vi0aBF++OEH3HDDDVizZg3Gjx/vtiMMDQ1FUlISpk+fXutjnPsjsLYBdj4+Prjnnntwzz33oKysDOnp6Xjrrbdw3333Yd26dTAYDDXu4/xM1fV+XOx7MXr0aIwePRomkwnbtm3D3Llz8cADD+Cnn35CbGzsee9b13fA19cXRqMRPj4+0Gq1uOWWW3DHHXfU+hjnns5Um549e8JoNCI9PR1ZWVlITU2FJElITU3F//73P+zZswfZ2dluO7LQ0FBIkoSlS5fWOibDucz5uj3zzDPo2bNnrdtvqlHFUVFRGD9+PBYsWIB77rmnxu2hoaHw8/PDK6+8Uuv9z33Pn3vuOVRWVqJTp06YNWsW+vTpU+NH8KUKCQnB7t27IYRw+2wXFhbCbre71ZSamoply5Zhz5492LNnD6ZMmQIAGDBgANLT05GdnQ2j0Vjn63621NRU/Oc//8GePXuQk5ODtLQ0BAQEIDk5Genp6cjLy0O7du1cvZIXs/8632DYhQsX4pFHHsGdd96JDz/88ILfjbo09etnNBoxbdo0TJs2DQUFBVi/fj3efPNNTJ48GT/++GO9amy0LvTs7Gy8/vrrCAwMxNixY+t1H61Wi549e+K5554DAFd39sX+Sq5LRkYGDh486Lbs+++/h7+/v+sXs/NNPntUJIBaR1zqdLp615aamorNmze7fnU6ffvttzAYDI1y2pnzg/HLL7+41SXLMlasWIFWrVpd8FzvhrJYLHj66adht9vdzgN3fuHOlZubi4qKikY7VzohIQE9e/bE8uXL8f3336OqqsrVteU0ZMgQHD58GG3btkVycnKNf9HR0Q3aZlBQEK677jrccccdKCkpQVZWVq3rpaSkQK/XY8WKFW7Lc3JysHnzZgwYMKBhT/YcRqMRgwcPxuTJk2Gz2eo1kO3nn392a9FXVFRg7dq16NOnD7RaLQwGA/r3748///zTNUnTuf+cO6zzfT99fX3Rt29fpKenY/Pmza6gdm7n7bffdgW605AhQyCEQG5ubq3bdR5G6t27N4KCgnDkyJFa10tOTm7Sc3onTZqE4OBg10C4sw0ZMgSZmZkICQmpta6zf/x8+eWXWLFiBZ555hnMnz8fZWVlePLJJ90erzH2gampqTCZTDUmavrmm29ct5+9riRJrvenb9++ruVbtmzBxo0b0bdv3xqHmOrart1ux9tvv41WrVq5euJSU1NrfC6Axt9/tW7d2vVj8M4778SJEyfqfd9zn0dzvX4REREYNWoUhg8fjuPHj8NsNterxotqgWdkZMDhcMBut6OoqAjbt2/H8uXLodVqMW/evPOeE/vpp59i8+bNGDJkCGJiYmC1WvHVV18B+LtLJSAgALGxsfj111+RmpqK4OBghIaG1qsFUJuoqChMmTIFU6dORWRkJFasWIGNGzfisccec7WgkpOT0b59e7z++utwOBwICgrC6tWrsWPHjhqPl5iYiJ9//hmffPIJunfvDkmS6uxOfeihh7B27VrcfffdeOihhxAcHIzvvvsO69atwz//+U8EBgZe1HM614wZMzBx4kTcfffdmDhxInx9ffHJJ58gIyMDc+bMuaTTt86cOYNdu3a5JnI5cOAAvvrqK2RnZ+OJJ55w67Z+9tlnUVZWhmuvvRaJiYnQaDQ4duyY6/zwc0fdOxyOWn9tGgwG17nldRk9ejSeffZZ5OXlISUlBR06dHC7fdq0aUhPT8fYsWMxbtw4tG/fHlVVVTh9+jTWr1+PF1544YLzBkyePBmdOnVC9+7dERYWhqysLCxevBixsbGIj4+v9T5BQUF48MEHMWfOHDz++OMYPnw4SkpK8N///hd+fn6ukeUN8a9//Qt6vR69e/dGZGQk8vPzsWDBAgQGBtb52TubVqt19STIsoz3338fFRUVbsden376adxxxx248847cfvttyM2NhaVlZU4deoU1qxZ4zqVqm3bttDr9fjuu++QkJAAo9GIqKgo1w+i1NRUvPbaawD+/k7r9XqkpKRgw4YNSEpKcmspX3bZZfjHP/6Bp556Cvv27UPfvn1hMBiQn5+PHTt2IDExEXfccQf8/f3xr3/9C0888QRKS0sxbNgwhIeHo6ioCAcPHkRRURFeeOGFBr+29RUQEIDJkyfXOoJ9/Pjx+Pnnn3HXXXdhwoQJSEpKgizLOHPmDDZs2ICJEyeiZ8+eOHToEF5++WWMHDnSNV5j1qxZmDZtGj788EPX5FCdOnUCAHzxxRfw9/eHn58f4uLiGtR7M2LECCxduhQzZ85EVlYWEhMTsWPHDrz33nsYPHiwW4iGh4ejU6dO2LBhA/r37+/aL6alpaGkpAQlJSU1fmTUpXv37ggODsaGDRvcflSnpaXhnXfecf3/2Rp7/xUVFYUlS5bgvvvuw1133YUPPvjgvId2a9PUr9+YMWMwZMgQJCUlITg4GEePHsW3336LlJSUWnv2anNRAe4sxNfXF0FBQUhISMCkSZMwZsyYC05o4RzMMnfuXOTn58NoNCIxMRHz5893C4JZs2bh9ddfx5QpU1BVVYWRI0e6dgoN1aVLF4waNQpz587FiRMnEBUVhSeffNJtJjWtVot3330XL730Ep577jnodDoMHz4czz77bI3zGu+++25kZGTgrbfeQnl5OYQQNVruTh06dMBnn32GOXPm4MUXX4TFYkFCQgJeffXVGi3GS9GvXz98+OGHmDt3Lp588knIsozOnTtj/vz5uPLKKy/psZ3HRbVaLQICAhAXF4crr7wSt912Gzp27Oi27l133YWVK1fiyy+/RG5uLsxmM0JDQ5GSkoLZs2fX6HGwWq2uc17PFhsbe97zTQFg+PDheOWVV5CTk1NrKEZFRWHZsmV45513sGjRIuTm5sLf3x+xsbG44oorEBQUdMHn3r9/f/z000/48ssvUVFRgcjISKSlpeHBBx88b2vkgQceQFhYGJYsWYKVK1dCr9ejX79+mDFjRr2Pb52tT58+WL58OVatWoXS0lKEhobisssuw+zZs+s1icydd94Jq9WKl19+GYWFhejUqRPee+89XHbZZa51OnbsiOXLl+Odd97Bv//9bxQVFSEwMBDx8fFuP6YMBgNeeeUVzJs3D/feey9sNhumTp3q+jHgbJm0a9fOrfsyLS0NW7ZsqfU46osvvoiePXvi888/x6effgpZlhEVFYXevXu7Tj0CgFtuuQWtW7fGwoULXd3QYWFh6NKlS41Bg03hjjvuwJIlS2qc8280GrF06VIsWLAAn3/+OU6fPg29Xo+YmBikpaUhNjYWJpMJ06dPR1xcnKvXEaieCOvOO+/EG2+84Xq+bdq0wVNPPYWPPvoId999NxwOR4P3GX5+fvjoo4/w1ltvYeHChSguLkZ0dDQmTpxY6/clLS0Nhw8fdnt/nIMNT5w4Ue+JnzQaDfr164dffvnF7bF69eoFo9EIi8VSY4bNpth/hYWFYfHixbj//vsxbtw4LFy4sF4/dp2a+vUbMGAA1qxZg8WLF8NsNiM6OhojRozA5MmT612jJC40bJyIiIg8Dq9GRkREpEIMcCIiIhVigBMREakQA5yIiEiFGOBEREQqxAAnIiJSIQY4ERGRCjHAiYiIVIgBTkREpEIMcCIiIhVigBMREakQA5yIiEiFGOBEREQqxAAnIiJSIQY4ERGRCjHAiYiIVIgBTkREpEIMcCIiIhXyUboAIvJMc+fOxbx58wAAkiTB398frVu3Rt++fXHnnXciISHBta7ZbMaiRYuwcuVKZGVlQa/XIy4uDgMHDsQjjzziWi8pKQmPP/447r333lq3efLkSSxatAi7d+9GRkYGOnTogO+//75pnyiRSjHAiahOer0eixcvBgBUVlbi8OHD+Pzzz/HFF19g1qxZuOWWWwAAU6dOxb59+/DAAw+gS5cuKCsrw969e7F69Wq3AL+QjIwM/Pbbb+jZsydkWYYQokmeF5E3YIATUZ00Gg169erl+vvyyy/HHXfcgfvvvx9PP/00evfuDYfDgQ0bNmD27NkYMWKEa91hw4ZhxowZDdre0KFDcfXVVwMAnnjiCezbt68xngaRV+IxcCJqED8/PzzzzDOw2Wz48ssvUVZWBgCIjIyssa5G07BdTEPXJ2rJ+G0hogbr2LEjoqOjsXPnTnTo0AFGoxGvvfYa1q5di8rKSqXLI2oRGOBEdFFiYmJQUFCAgIAAzJo1C1lZWZg8eTL69u2LUaNGYf78+TCZTEqXSeS1GOBEdFGEEJAkCQBwww03YO3atZg9ezZuueUWFBcX49///jdGjx7NECdqIgxwIrooOTk5iIiIcP0dHByMESNG4NVXX8WaNWvw4IMP4tixY1i2bJmCVRJ5LwY4ETVYRkYGcnNzkZKSUuvtkiS5zvU+evRoc5ZG1GIwwImoQaxWK1566SXodDqMGTMGFRUVsFgsNdY7ceIEgNpHpxPRpeN54ERUJ1mWsWvXLgCAyWRyTeSSmZmJ1157DXFxcdi7dy+mTJmCkSNH4rLLLoPRaMTRo0exYMECBAYGYuTIkW6PefjwYfz4449uywwGAwYPHgyz2YzffvsNAJCVlYWKigrXuv369UNYWFjTP2kilZAEpzoiolqcO5Wq0WhEbGxsjalUy8rKsHjxYmzcuBEnTpxAZWUloqOj0bdvX0yePBnx8fGux0xKSqp1W7GxsVizZg1Onz6Nq666qtZ1PvroI/Tv37+RnyWRejHAiYiIVIjHwImIiFSIAU5ERKRCDHAiIiIVYoATERGpEAOciIhIhRjgREREKsQAJyIiUiHOxEbUAgghIPD3lA8aib/didSOAU7kwWQhQwgBjaRxXboTABzCAbPdDIfsgEM4IAvZ9c8h/l529v87/0mSBL1WD4OPAQYfA/y0fvDT+EGr0dbYvkM4AFE9ExtDn8izMMCJFOQQDkhwD0eHcKDCVoFSaylKrCUoqypz/SutKkVZVRlMdpNbi7ox+Eg+MPgYEOAb4PbP39cfgb6BCDeEI0IfAR+NT521E1Hz4VSqRM1EFjKAv7uvS6wlyKzIRHZlNootxU0azo1FgoRQv1BEGaIQZYxClCEKMcYYhOpDXc/LITvYYidqBgxwoiYghIAMGVqpulu6wlaB0xWnkVWRhezKbGRXZsPsMCtcZePRSlqE68MRbYyuDndDFFoZWyHYLxhAdajX1kVPRBePAU7UCGQhQ4IESZJgsVtwutI9rMtt5UqXqAg/rR/aBbZDh+AO6BTcCWH6MNeAOrbQiS4NA5zoIjmEA1pJC4dw4GTZSRwsPogjpUdQZC1SujSPFawLRoegDkgITkDH4I7Q++jdfvwQUf0xwIkawNkVbHVYcaj4EA6VHMKR0iOwOqxKl6Y6EiS0MrZyhXmbgDbQarTsbieqJwY40Xmc3d1bai3Fn8V/4lDxIZyqOOUalEaNw1fji/jAeCQEJ6B7WHcE6gJdvRxEVBMDnOgcZ4d2dkU2DhQfwKGSQ8gz5yldWoshQUL7oPboFdELXcO6Qitpedyc6BwMcKK/yEKGRtKgrKoMW3O3YnfB7hY7+MyT+Gn90C2sG1IiUtAmsI3rfSJq6Rjg1OI5B1EdKT2CrblbcaT0iMeeh93ShfmFoWdET6REpiBIF8Tj5dSiMcCpRXK24sx2M7bnbceOvB0oqSpRuiyqJwkS2gW2Q8/InugW1g0+kg+72KnFYYBTi+IcFHWq/BS25m7FgeID1fN9k2rpNDp0C+uGga0HIlwfzi52ajEY4OT1nB9xm2zDroJd2J63nQPSvJAECV1Cu2Bw7GBEG6MZ5OT1GODktZwfbZPdhN+yfsOugl2okqsUroqaQ2JIIga3HozYgFieikZeiwFOXkkWMqocVVifvR7b8rbBJtuULokU0CGoAwbHDkZ8YDyDnLwOA5y8iixkOGQHNuZsxKacTZwhjQAAbQPaYlDsIHQM7siR6+Q1GODkFRzCAQhgS+4WbDizASa7SemSyAO19m+NQa0HoXNoZ7bISfUY4KRqDuGABAl/5P+B9VnrUWYrU7okUoEoQxSGtR2GhOAEDnYj1WKAkyo5u0H3Fu7F2tNreQUwuihdQrvghvgb4O/rzxAn1WGAk6oIISBJEjJKMrA6czVyzblKl0Qqp9PoMKj1IKTFpEEIwePjpBoMcFINWciwOqz4/sT32F+0X+lyyMtE6CNwY7sb0S6oneuHIpEnY4CTx3Meo9xTsAc/nvqRA9SoSXUP647r46+HwcfAbnXyaAxw8miykFFpq8SK4yuQUZqhdDnUQvhp/DA4djAGtBoAAcHR6uSRGODkkZyt7m2527A6czWsMs/npuYXZYjCje1uRNvAtuxWJ4/DACePIwsZpVWl+ObYNzhZflLpcojQM6InhscPh1bScpAbeQwGOHkMh3BAAw02ntmIdVnrYBd2pUsicgnzC8NtHW9DtDGaLXHyCAxw8ghCCORb8vHNsW+QXZmtdDlEtdJKWlzT5hoMaDWAE8CQ4hjgpCjnTnBD9gaszVrLa3OTKiSFJGFkh5Hw1fpygBsphgFOinEIB+yyHcuPLsehkkNKl0PUIEG6IIxJGIO4gDh2qZMiGOCkCFnIyDPn4fOMz1FsLVa6HKKLooEGg2MHY1DrQRAQ7FKnZsUAp2blPBVne952/HjyRw5UI6/QIagDbk24FXofPUOcmg0DnJqNLGQIIbDixArsLtitdDlEjcrfxx+jEkahQ1AHdqlTs2CAU7NwCAcsdgs+OfwJsiqzlC6HqElIkDAwZiCuanMVJ36hJscApyYnCxk5phx8evhTlNvKlS6HqMl1D+uOkQkjIUFilzo1GQY4NbndBbvx3fHveLybWpT2ge1xe+Lt0Gq0PNWMmgQDnJqE82P1S+YvSM9JV7gaImVEG6Jxd+e7offRM8Sp0THAqdHJQgYAfH3sa+wt3KtwNUTKCtGF4O7OdyPEL4Td6dSoGODUqGQhQ0Bg2ZFlOFB8QOlyiDyCwceAOxPvRGv/1gxxajQMcGo0spAhCxmfZ3zOa3cTncNX44tbE25FYkgiR6dTo2CAU6OQhQyHcGDpoaU4UX5C6XKIPJIGGtzQ7gb0ieqjdCnkBRjgdMlkIcMu27Hk0BJkVmQqXQ6RxxvUehCGxg3lueJ0SRjgdElkIaPKUYXFBxfjjOmM0uUQqUZKRApubn8zADDE6aIwwOmiOWQHrA4rPjz4IfLMeUqXQ6Q6vSJ6YUSHEUqXQSrlo3QBpE4O4YDJbsKHBz9EoaVQ6XKIVGlXwS74anwxvN1wpUshFeL5DNRgDuFARVUFFv25iOFNdIm25W3DL6d+UboMUiEGODWILGRU2iqx6M9FKKkqUbocIq+wMWcj1mWtU7oMUhkGONWbLGTYZBuWHFqCMluZ0uUQeZV1WeuQfobTDlP9McCpXpxjHT/L+Az55nyFqyHyTj9n/oxdBbvAscVUHwxwqhdJkrDi+AocLzuudClEXm3F8RU4VnbMdU0BorowwKlefsv6DbsKdildBpHXc05HnGvKhUM4lC6HPBgDnM5LFjL2FOzB2qy1SpdC1GJUyVX4+NDHKK8qZ4hTnRjgVCdZyDhdcRrfHv9W6VKIWpxKeyUWH1wMq93K7nSqFWdio1o5hAOl1lK8v/99mB1mpcshAEfXHcXWRVvh4+eDMQvHuJZ/Ou7TOu8TGBOIG1+/8YKPbbfY8ecPf+LU5lOoLKiEj94HIW1C0G9iPwS2CgQAVFVWYduH23Bmzxno/HXoemNXdBza0e1xCo4UYM0razDspWEIjg2+yGdKZ2sb0BYTukzgZUipBs7ERjU45zdfcmgJw9tDmIpM2PnpThhCDbCZbG63XfPcNTXWLzxaiD8+/gNxl8Vd8LFtFhvWvLIG5hIzut7YFSFtQlBlrkJBRgHsVrtrvT8++QPFJ4uROiUV5WfKsf3D7QiKDUJUUhQAQHbI2PbBNnQZ3oXh3YhOVZzC6szVuLbttUqXQh6GAU5uZCFDCIGlh5ei2FqsdDn0l23/24aopCjo/HXI3OZ+xbeIjhE11j+y5gggAQlDEi742HuW7UFZdhmuf+V6BEQFuJbH9XYP/+xd2eh9V2/E9ooFegFn9pxB9q5sV4AfXHkQDrsDXW/uehHPkM4nPScdbQPbIjEkkS1xcuEngdxoJA2+OvoVTlecVroU+svxjceRdzAPfSbU7xrSNrMNmVszEdU5CoHRgedd126149i6Y2jTr41beNdGtsnw8fv7N7+P3gcOW/UAq4q8Cuz7Zh/63dMPWl9tveqkhvnm2Dcoqyrj8XByYQucXGQhY2vuVvxZ/KfSpdBfLKUW/PHxH+j1j14whhnrdZ+Tm0/CbrUjYfCFW99FJ4pgt9oR2CoQ2/63DSc3n4TD6kBI2xB0H9W9urX9l4hOEcj4JQMRCREozy3HmT1nMOD+AQCAbR9uQ/yAeER1ibq4J0oXZHFY8FnGZ5jUdRIEeB1xYguc/uIQDhRaCrE6c7XSpdBZti/ejqCYIHS8quOFV/7Lsd+OwdfoizZ921xwXXNR9RiHA98fQMnpEqQ+kIqB0wfCR++D9XPW48yev6/x3vuu3qgsqMTXU7/G6pdWI35APNr0a4PjG4+j+GQxet3eq8HPjxomx5SDH07+wPAmAGyBk5MAvjzyJezCfuF1qVlkbstE1s4sXPfydfXeYZeeLkXh0UJ0uroTtLoLd2U7T0LR+Ggw5LEh8DX4AgCiu0Tj+39+j33f7kNMjxgAQFBMEIbPHo6K/ArojDr4BfrBWmHFzqU70fuu3vAL8EPG6gwcXHUQVaYqxCTHoM/4PtD56y7yFaDa/JH/B9oGtkWP8B48Ht7C8d0nAMBPmT8hz5yndBn0F5vFhu2LtyPxmkQYQgyoqqxCVWUVZEf18c+qyirYLTV/bB397SiA+g1eAwC/AD8A1d3jzvAGAB8/H0R1jkLxCfeBjJJGQmB0IPwCq++389OdCG0XinZp7ZCzPwe7Pt+FtIfScNMbN8FabsWOj3c0/MnTBf1w4gcUWgo5yUsLxxZ4C+cQDhwrPYatuVuVLoXOYi23wlJqwcFVB3Fw1cEat381+SvE9o7FoEcGuZY57A6c2HgCYe3DEBofWq/thLQNqfM2Ic5/nDX3QC5ObT6FG169AQBwZvcZtOreCuEdwgEAna7phK0L+blqCjbZhs8yPsPkbpMhaSS2xFsoBngLJgsZVrsV3xz7RulS6ByGYAOGPjW0xvI/v/sT+QfzMfifg12tZ6esP7JgLbcieVRy/bcTYkBExwjkH86HzWxztcLtVjvyD+YjvGN4rfdz2BzY9sE2dB/Z3TV6XUC4nTdut9h5Va0mVGgpxDfHv8GYjmMuvDJ5JQZ4C6aRNFh+bDkq7ZVKl0Ln0Oq0iO4SXWP58fXHIWmkWm879tsxaHVaxKfF1/m4n43/DFGdozD0yb9/HPS6vRfWvLoGa19fi67DuwIScHDVQVjLregxuketj7N/xX5ofbXofH1n17KY5Bgc/ukwDv10CIHRgdj3zd/Hz6lp7C/aj7Y5bdE3ui9b4S0QA7yFcp4ydqT0iNKlUCOoLKxEzt4cxF8eD52x7kFjQhYQsnurODIxEkOfGIo9y/YgfX46gOrJYYY+NRQRnWpOElOaVYqDPxzE0KeGQqP9OzRikmPQa2wvHFx1EDaTDa26t8Jld13WSM+Q6vJL5i9IDE1EsC6YId7CcC70FsghHCiyFOG9fe9x1DmRF2gf1B7jO49XugxqZvy51hLxlDEir3K87Dh2F+zmLG0tDAO8BeIpY0Te56dTP6HKUcWBgy0IA7wFcQgHsiuzsS13m9KlEFEjM9lN+OnUT5ylrQVhgLcgWkmLH078AAH+QifyRjsLduJU+Sk4ZE7w0hIwwFsIWcjYlb8LWZVZSpdCRE1oxfEVABvhLQIDvIVwyA6sPs0LlRB5uwJLAX7P/p3HwlsABngLIITAuux1qLBVKF0KETWDDdkbUGwt5qh0L8cA93KykFFSVYLNOZuVLoWImold2LHi+ApO7OLl+O56OY2kwaqTq3jVIqIW5kT5CezK38VWuBdjgHsxh3DgaOlRHC45rHQpRKSAnzN/hk22KV0GNREGuBeTIGHVyVVKl0FECjHZTUg/k85WuJdigHspWcjYkrsFBZYCpUshIgVtzt3MVriXYoB7ISEELA4Lfsv6TelSiEhhVocVG89sZCvcCzHAvZAkSViduRoWh0XpUojIA2zJ2YIqR5XSZVAjY4B7GSEEyqvKsatgl9KlEJGHsMpshXsjBrgX4heViM61NXcrW+FehgHuZawOK/7I/0PpMojIw1hlKzac2cAf916EAe5FnCPPq2T+yiaimrbmboXVYeU86V6CAe5FnAFORFSbKrkKG85sULoMaiQMcC/hEA78kf8HTHaT0qUQkQfblrsNFoeFrXAvwAD3EhposClnk9JlEJGHq5Kr8Hv270qXQY2AAe4FHMKBfUX7UGwtVroUIlKBbXnbOE+EF2CAewGtpMXGMxuVLoOIVMIm27AjbwdHpKscA1zlnFccyzHlKF0KEanIH/l/8HrhKsd3T+W0kpajSomowYqsRThZfpKtcBVjgKuYLGScqTyD42XHlS6FiFRoe952tsJVjO+cikmQeN43EV20A0UHYHVYlS6DLhIDXMUcwoEDRQeULoOIVMou7NhVsAsO4VC6FLoIDHCVcggHDhUfglXmr2ciunh/5P0BraRVugy6CAxwldJKWuwp3KN0GUSkcrnmXGRXZnMwmwoxwFXKYrfgSOkRpcsgIi+wPW87JEhKl0ENxABXIefMazxuRUSNYV/hPtiFXekyqIEY4CqklbTYW7hX6TKIyEtUyVXYW7iXjQKVYYCrUHlVOU6Vn1K6DCLyIhzMpj4McJWRhYzdBbshwEsBElHjOV15GoWWQqXLoAZggKuMRtKw+5yImsTB4oPsRlcRBriKCCGQb85HrjlX6VKIyAtllGSwG11FGOAqIiCwu2C30mUQkZfKrMhElaNK6TKonhjgKsLucyJqSs7LE7MbXR0Y4CqSa8pFaVWp0mUQkRc7XHIYGkaDKvBdUgmHXP3LmIioKR0pPQJJ4qxsasAAVwmtRosT5SeULoOIvFy5rRx5pjwIwVNVPR0DXCVkIeNk+UmlyyCiFuBQySHI4MVNPB0DXAWEEMg15cLq4KVDiajp8XQydWCAq4AsZBwrO6Z0GUTUQpyuOM0GgwowwFVAq9HieNlxpcsgohZChoyMkgw4ZJ5O5skY4CogC5kXLyGiZpVRmgGtht3onowB7uGEEDhTeQZVMmdHIqLmw9NWPR8D3MPx+DcRKaHCVoHyqnKly6DzYIB7OK1GixNlJ5Qug4haoKzKLMiCp5N5Kga4h3MIB05V8Pg3ETW/HFMOBDihi6digHswIQSyK7Nhk21Kl0JELVBOZQ7PB/dgDHAPJgsZJ8s4+xoRKeOM6YzSJdB5+ChdwMVKS0tDamqq619sbKzSJTU6rUaLHFOO0mUQUQtVWlUKi90CvY9e6VKoFqoN8BtuuAGbNm3CDz/8AEmS0KZNG6SmpiItLQ0DBgxAcHCw0iU2inxzvtIlEFELlmPKQXxgPK9Q5oEkofJLzuTl5SE9PR3p6enYvHkz8vPzIUkSunbtimXLlild3iWRhYxZ22fBITgbEhEp49o216J/dH9O6uKBVNsCd4qKisKIESMwbNgwbNmyBUuWLMHGjRuxf/9+pUu7ZMXWYoY3ESkqx5TD8PZQqg1wWZaxZ88eV+t79+7dAICePXvi4YcfRlpamsIVXhpZyMip5PFvIlIWx+F4LtUGeP/+/VFZWYnExESkpqbi/vvvR9++fWEwGJQurVEICOi0OiQEJ6DQXIjSqlKej0lEza7AXAC7bIePRrVx4bVU+46Ul5fDz88PUVFRiI6ORkxMjNeENwBAAAnBCegU0gkAYJftKLIUIc+chwJLAQrMBSi0FKLQUsh50omoyciQkW/OR4x/jNKl0DlUO4ituLgYmzZtwqZNm5Ceno6srCxERkYiLS3N9S8yMlLpMhudLGQIIdyOSZVXlSPfnI98S74r2AvMBSizlSlYKRF5i5va3YReEb14LNzDqDbAz3Xq1Cls3LgRP//8MzZv3gxJkvDnn38qXVazEUJAFjI0ksZ1uodNtqHQUog8U151qJ/VcrcLu8IVE5FapLZKxTVtroFG4txfnkS1XehONpsNO3fuRHp6OjZt2oR9+/ZBCIGQkBClS2tWkiTVmPLQV+OLVsZWiDJEQUC4bhdCoNxWjjzT393xBZbqfxW2CiXKJyIPVmGrYHh7INW2wD/44AOkp6djx44dMJvNMBgM6N27t2uGtq5duypdoserrdVe5ahCgaUA+eZ8t2AvshTxlDaiFqp9YHuM7zJe6TLoHKoN8G7duiE5Odk1lWpKSgp8fX2VLstrOIQDEiTXr25ZyCirKqseROcM9r/+a7KbFK6WiJpSpD4SD/V4SOky6ByqDfCKigoEBAQoXUaLU1ur3WK31NpqL7YW81rCRF7AoDVg5mUzlS6DzqHaY+Bnh/fx48dRUlKC0NBQtGvXTrmiWoDajrXrffSIC4hDjDEGkuTeai+xlri32i0FKDQXwuwwK1E+EV0Es8MMh3Dw0qIeRrUBDgCrVq3C66+/jpycv2cKatWqFWbOnInrrrtOwcpapnNPMdFIGoTpwxDiF4JOwZ3cbjfbzdWnvpnz3UbHl1hLIIOtdiJPY7KZEKgLVLoMOotqA/y3337DjBkz0LFjRzz66KOIiopCbm4uVqxYgRkzZsBgMGDw4MFKl3lRZFnAYXdAkiT4+P49clwIQJKguqsCaSQNcE7JBh8D2ga2Rax/rFur3SE7UGwtrjFhTYGlAFaHVYHqiQgAym3lDHAPo9pj4GPHjkVAQAAWLFgAjebv0xuEELjvvvtQWVmJzz77TMEKL54sC5w4kIeThwvgq9PCGKCDMdCv+l+ADv5BeuiNvq4gF3L1JKsajbqC/Xxqm7Cm0lbp1mp3TljDaWaJmt7YTmORFJKkugaEN1NtC/zgwYOYM2eOW3gD1a3TO+64A4899phClV06jUaCqaJ6elRblQOlRWaUFrkfM5YkCYYAXxgD3IPdGKiDj8/ZrXYBSZJU96WrrdXu7+sPo48RbQLauLXa7bIdxdZi5Jpy3YKd08wSNZ4KWwVkIfM4uAdRbYBrNBrYbLZab7Pb7aoLrHOZK88fPEIImMqrYCqvAs6Uu93m66eFvzPYA6tb7/6BevgZfFyviyxXt1jV1mqvbRCdj8YHkYZIhOvDa7TaK6oqkGfOQ74lH4XmQtdAurIqTjNL1BCc5MnzqDbAk5OTsXDhQgwePBh6vd61vKqqCh988AF69uypYHWXzmKq/cdJfdisDpRYTSgpdD8/W6ORYAjQ/dVqr/6vf5AfjAF+0PpUt2a97Vh7gC4A/r7+iA+Mr3WaWbdT3zjNLFGdOBub51FtgD/88MOYMGECrr76alx33XWIiIhAfn4+fv75Z5SUlGDx4sVKl3jRZIcMu63xZz2TZYHKMisqy2oOBtPpfVzB7v/X8Xb/QD/4GXzd7q/GYL+oaWadp75xmlkiANUBrrbvvrdT7SA2ANi6dSvefPNN7NmzB0IIaDQa9OjRA48++ij69u2rdHkXzWKyYdNPh5UuAwCg0UrVwe4cSBfgB/9gPxj9ddBoz261q/NYe13qmma20FJY47x2TjNLLUFcQBzu63qf0mXQWVQd4E5msxllZWUICgryimuClxaa8Mf640qXcUF+Bl9XV7yzxe4f5Aed398dO7IsIAGQVHas/Xw4zSy1RNGGaExJnqJ0GXQW1Xahn81gMHhFcAPVp4RZzBd//Ls5Wc02WM02FOdVui3X+mjcWuzGwOoR8gZ/nWvQnPNYu9oG0QGo0R2vkTQI8QtBsC4YCUEJ7tPMOiwoMBfUmLCmyFrEaWZJVfh59TyqCvBvvvmmQeuPGDGiSepoSgICVRZ1BHhdHHYZ5SUWlJdYatymN/qeE+x+8A/wg++5rXYvOdau19Z/mlnn6W+cZpY8EWdI9Dyq6kLv3LlzvdeVJAkHDhxowmqahpAFju7PReaRQqVLaVY+vhq30fHGv7rjDUadq/u9pUxYY7abUWAucM1G5wx2TjNLSgrRhWB6r+lKl0FnUVUL/Ndff1W6hCYnaSRUWVveaUx2m4yyYjPKis+dsAbQ++vcB9EFVR9v9+ZpZtsEtkFr/9Y1ppktsZYg15zruiiMcyAdp5mlpsYfj55HVQH+0UcfYcKECYiJiUF2djYiIyO98hrgDju/KE5CAOaKKpgrqlCY434al7dPM3vuxWG0Gi3CDeEI1Yeed5pZ59zxnGaWGhOPgXse1XWhf/HFF+jRowe6dOmCzz//HD169FC6rEa38/cTKCmovPCKVCtvn2a2Ls5T386dZtYmq3tMBXkGCRL0PvoLr0jNRlUt8ODgYBQUFACo3ll5K4ed5xRfigZNM/tXl7yfwddrp5n10ajqa05E9aSqb3bPnj3x9NNPu1rds2fPRmBg7Ze3kyQJ8+fPb87yGg270JtOS51mloi8j6oC/LnnnsMrr7yCI0eOQJIknDx5EjqdrtZ11byDtTPAm12jTDML75qwhog8m6qOgZ/t7OPh3mb9dwfYCleBljrNLBF5BlW1wM/20UcfISEhoc7bq6qq6mydezqGtzrIDoGKUgsqSmtOWNNSp5klouaj2gDfunUr+vXrV+ttNpsNU6dOxYIFC5q5qksnZFV2iNA5Wuo0s0TUfFQb4PPnz0dcXFyN6VJlWcajjz6KHTt2KFMY0Xm01GlmiajxqTbAn3rqKTzzzDOIiYlB//79AVS3XGbOnIn169fj/fffV7hCooaxmGywmGwoynWfsKb+08xWX1KXiFoG1Qb4nXfeidOnT+Phhx/Gp59+ioSEBDz33HNYtWoV3nnnHfVeD5wNKzrHpUwzS0TeS7Wj0J2mTZuGffv24YorrsCyZcswZ84cDBs2TOmyLpoQAuu++VPpMkjlnNPMnt39TnQpErpFwxjop3QZdBbVB7jVasX48eOxZ88evPLKK6q8hOjZGOBE5IkuG9IeQaFGpcugs6jq5/nkyZPrvC0oKAg//vgjfvzxRwDqnomNiMjTcOCk51FVgB8+fLjO24xGo9vt/LARETUe7lM9j6oCfM2aNUqX0OQkSYJGK0F2qPrIBhF5Gec1AchzqPIdsVgsePTRR7F9+3alS2kS/KIQkafhfsnzqPId0ev1+PXXX732kqLOa1YTEXkKBrjnUe070rlz5/MeE1czflGIyNNotdwveRrVviOPPfYYFi1ahK1btypdSqPzYYATkQdho8IzqWoQ29leeOEFVFZWYvz48QgKCkJUVJTb7ZIkYcWKFQpVd2m0vvyyEJHnYKPCM6k2wENCQhASEqJ0GU1Cy2PgRORB2KjwTKoN8CVLlihdQpMQQsBXxwAnIs/hq1NtVHg1/qzyMEII+On5ZSEiz8F9kmdS9btSUlKCDz/8EJs3b0ZxcTFCQ0ORlpaG8ePHIzg4WOnyLpIEP4Ov0kUQEbn4GXwhhOBsbB5GtS3w3NxcjBo1Cu+++y7Ky8vRunVrlJeX45133sHIkSORm5urdIkXRaNhgBORZ9Hpfbx23g01U20LfM6cObBYLPjiiy/Qo0cP1/I9e/ZgypQpeOutt/Daa68pWOHF0zPAiciD+Ol92fr2QKptgf/++++YPn26W3gDQI8ePTBt2jSsX79eocounY7Hm4jIg/gZfRjgHki1AV5eXo7Y2Nhab4uLi0N5eXkzV9R4tD4aTpxARB6DvYKeSbUpERcXh3Xr1tV62/r16xEXF9e8BTUyjvokIk+h8+P+yBOp9l0ZNWoU3nzzTQghMGLECERGRiI/Px8rVqzAxx9/jEcffVTpEi+JIUAHU0WV0mUQUQvnZ/CBhvOgeyTVBvh9992HzMxMfPzxx1i6dKlruRACt912G+69914Fq7s0QhYwBvqhMKdC6VKIqIUzBvgpXQLVQRIqPzfg2LFj2Lx5M0pLSxESEoIBAwagffv2Spd1SWRZIOdUCQ7tzFa6FCJq4WI7hKFTj1YcxOaBVNsCHz16NC6//HKkpqbi1ltvhU6nU7qkRqPRSAgI4q9eIlKeMdCPk7h4KNUGeGRkJD755BMsWLAAfn5+6N27N9LS0pCamoru3bsrXd4lMwYywIlIef6BfgxvD6XqLnSHw4Hdu3cjPT0dmzdvxq5du+BwOBAUFIQBAwbg7bffVrrES7Lhh4OwVTmULoOIWrDLb0jiKHQPpeoAP9eePXvw9ttvY+PGjZAkCQcOHFC6pEvyx/rjKC00KV0GEbVQWh8NBt3URekyqA6q/lmVn5+P9PR0pKenY9OmTcjPz0dMTAxGjRqFtLQ0pcu7JEIIBATrGeBEpBiOxfFsqg3wm266CUeOHEFQUBD69++PKVOmIDU1Fe3atVO6tEYhBBAYalC6DCJqwQJDjRzA5sFUG+AZGRnQ6/UYNmwYBg0ahAEDBiAgIEDpshqNRiMhOIwBTkTKCQrVQwiA+e2ZVHsMfP/+/a6u8x07dsDhcKB79+5IS0tDWloaUlJSoNVqlS7zkggh8Pv3B+Gwy0qXQkQtUOqwTtAbvecUXW+j2gA/W1VVFXbs2IGNGzciPT0dBw4cgNFoxI4dO5Qu7ZLt/P0ESgoqlS6DiFoYH18trrixs9Jl0Hl4xQS3+fn5OH36NLKzs3HmzBkIIWA2m5Uu65IJWSCI3ehEpICgUL3SJdAFqPYY+E8//eTqQs/MzIQQAu3atcP111+P1NRUDBgwQOkSG0UQB7IRkQICQw0QsoCk4QFwT6XaLvTOnTsjMjISqampSE1NRVpaGqKjo5Uuq9FVWezYuOqQ0mUQUQvTI7UtwqIDOALdg6m2Bf7999+jY8eOSpfR5HR6Hxj8dTBX8tKiRNQ8JAkIifBneHs41R4DbwnhDVSPRA+J9Fe6DCJqQQJDDdD6qDYeWgy+Qx5OCCA0ggFORM0nNDIAQlbl0dUWhQHu4TQaCWHRDHAiaj5hUf4Ae889HgNcBXx1PvDnnMRE1Aw0WglBYUYe/1YBBrgKCCEQFu0908QSkecKCTdCw1PHVIEBrhLhDHAiagahUQGQefxbFRjgKiBJEoLD/eHjy7eLiJpWZOsgtsBVgomgEhqNhPDoQKXLICIvZgz0g8GfFy9RCwa4SsiyQGRskNJlEJEXi2wdyNPHVIQBrhLVLfAAaLTs2iKiphEVG8zTx1SEAa4iGq0GYVEczEZEjU9v9EVAsJ6nj6kIA1xFZFkgsjW70Ymo8UXEBEGl17ZqsRjgKqLRSIhoHchfyETU6KI4xkZ1GOAq4+Oj5dSqRNSo/Ay+CAozsHGgMgxwlZFlgZj4UKXLICIv0qptiNIl0EVggKuMRiMholUgfHVapUshIi/Rul2I0iXQRWCAq5EERLcJVroKIvICweFG6I06dp+rEANcpWLasRudiC5dTHwI5z5XKQa4CkmShIAgPQKC9UqXQkQqptVqEBUXzLnPVYoBrlKyLDjwhIguSWRsIMNbxRjgKqXRSIiJD+HUqkR00WLbhwHsPVctBriKaX00aNUmROkyiEiFAkP0CAozQmILXLUY4CrXplO40iUQkQrFJoRz8JrKMcBVTJIkGAP8EBbFmdmIqP58dVpEc/Ca6jHAVU6WBdp0jFC6DCJSkdgOYeBp3+rHAFc5jUZCWHQAjIE6pUshIhXQaCTEJYRz4hYvwAD3ArIsENeBx8KJ6MKi2wTDx5e7fm/Ad9ELOE8p0/n5KF0KEXkwSQLikyKVLoMaCQPcS0iShLaJbIUTUd2i4oJh8Oe8596CAe4lJI2E2PZhbIUTUa0kCWjfJQpC8NQxb8EA9yJshRNRXdj69j4McC/CVjgR1Yatb+/EAPcy1a1wnhdORH9j69s7McC9THUrPJStcCICwNa3N2OAeyFJktC+C08VISIgpl0o9EZftr69EAPcC0kaCTHtQuEf5Kd0KUSkIB9fDTp0jVa6DGoiDHAvJQTQqUeM0mUQkYLikyLh46th69tLMcC9lEYjITTSH+GtApUuhYgUYPDXcc5zL8cA92JCFujUoxW/wEQtUEJ3dp17Owa4F5M0EvRGX8R2CFW6FCJqRiERRkS2DuL1vr0cA7wFaN8lCr46rdJlEFEzkKTq8S+yzNPGvB0D3MtJkgStVoNOPVopXQoRNYO4hHD4B/mx9d0CMMBbAEkjIbpNCMKiA5QuhYiakN7oiw5dozjupYVggLcQQhZISmkNrZZvOZG3SkppXd2HTi0C9+YthKSR4Kf3QfuunKGNyBtFtwlGWFQAu85bEAZ4CyJJEuISwhEYole6FCJqRL46LTr1iOF85y2MJPiOtyiyLGAqt2L72qPgO9/0Dh3dh7fef7bW2x5/8FV0aJsEWXZgzcYf8GfGLmTnnEKluQLhIZHo2bUfhg0ZBaPBv0HbrLJZ8fLbM5BXcAajbrgb1w4a4bqt0lSBT79dgD8P7YTRGIBhg0fiiv7Xut3/+KnDmLPgWTw17Q3ERMU1+DlT8+vSJxbRscGQ2PpuUXjJqhZGo5HgH+SHdp2jcPxAntLltBgjht2JxITubstaR7cFAFTZqvD96s/Rt+dAXN73agQYg5CZfQwr1yzDngPb8eTDr0PnW/957Vf8/CmsVdZab/vqhw+RmX0c94z9P+Tmn8En3yxAq6g4dGrfFQDgcDjw8fL5uHbwCIa3SkS2DkKrNiFKl0EKYIC3QJIkIT4pAkV5FSgtNCldTosQGRGDDm2Tar1N56vDy4+/iwD/v6e9TUrojtCQCLy/9A3s3LcZ/VMG12s7xzMzsC59Je4ZOx3vL32jxu17D+3AbTdORHLnPkjuDOw//Af2HdzhCvBffv8Wdocd1105+iKeJTU3P70POvduDSEER563QDwG3lIJoFvfOPj48iOgNI1G6xbeTu3bdAIAFJcU1Otx7HYbliybh8Gp1yM+tmOt69hsNuh0f7fm/XR62OxVAID8whys/PVL3DlyMnx9fBv6NEgBXfvEQaPlxUpaKu69WyhJI0Hn54PEXq2VLqVF+Ozb9/HgU7di+nN34j+LXsSREwcueJ+DR/YCAGKi29RrGz/8+iWsVVbcfO3tda6TEJ+EdZtWoayiBEdOHMCfh3ehQ3xnAMCn3yxAn54DkdihW722R8pq0ykcwRFGjjpvwdiF3oJJGgnRccEozClHbmap0uV4JYPeiKGXD0dih+7wNwYiv/AMfl7/LeYseAYPTXga3RJTar1fcWkhvvnxY8THJSC5c58Lbicz+zh+Xv8NHhz/JPx0epSjrNb1xtw0Ee8sfgWPvzwRAJDW5ypclpyGLTt/Q+aZ47j39kcu/slSswkI1qND12i2vFs4BngLJ4RAUq/WKC00wWKyKV2O12kb2wFtYzu4/u7Uvit6dRuAl/49HctXflRrgFeayjHvfy9DQOC+2x+FRnP+jjKHw4GPls1Dnx6X1/mDwKlVZCyenzEXBUW5MBr8EeAfhEpTOZZ9/z+MuWki/I2BWLdpFVb/vgJmiwldE3th7M2T4G/kLH6eQqOV0K1fHBjdxC70Fk6SJEgaCd37t2FXXDMxGvyR3LkPsnJOosrmPlq80lSBtxe9gJKyIvzfvc8hMvzCc9j/uvE7FBTlYvhVt8FkroTJXAmLtXpwot1mg8lcCVl2uNbXaDSIiohBgH8QAOCrHxajTesO6NdrEA4e2YOvVy3BpDsexUv/fAcVlWX48vsPGvHZ06XqnNIaBn8dTxkjtsCp+tSygGA9OvZohcO7zihdTosgUH0SvnRWO6o6vJ9HQVEept/3POJi2tXrsbJzMmG2mPDsGw/VuG3FL59ixS+f4ulpb6JN6/Y1bj90dB+279mIZ6a/BQDYd+gPdO3UC/Fx1YPghqRejyVfvdPQp0dNJLZDGKJ5yhj9hQFOAKpb4rHtw1BWZEbOqRKly/FqlaYK7D2wHW1i2sPXV+da9vai51FQmIv/u+85t273C7luyEikXnal27KyihIs+nQOBvUfhst6XF5rS95mt+GTr9/F8Ktv+/t2IWC1WVzrWKssnN3LQwSHG9EpmVcVpL8xwMlFiOoLnlSWWVBeYrnwHeiCFn36FsJCItA2LgEBxiDkFZ7B6t9XoKyiFOPHPAygeua0/3zwIjKzj2PMjRPhkB04duqQ6zEC/YPdAvjBp25Fp/bd8MikFwAAraLi0OqcSVcKiqon6YkIj0bSORPIOK1asww+Pr64euDNrmVdE1OwJv0HrNn4AyLDW+GHX7+84HF1ano6vQ+S+7cBD3zT2Rjg5CJJEoQQSE5ti21rjsJmdVz4TnResTHx2LF7I9Zv+QnWKgv8DQFIaNcF99w2De3+Os+7rLwUJ08fAQB88d2iGo8xoPeVmHDbw66/ZVmGLMuXVNeZvNP4Zf23mHH/i9Bqta7lXRN7YdT147H6929hMpvQNbEnbrtp4iVtiy6NpJGQPKANtL5ajjonN5wLnWqQZYHyYjN2/n6C3adECkvsFYPW7UIZ3lQDR6FTDRqNhKAwA5JSYpQuhahFi0sIR2z7MIY31YoBTrWSJAkx8aFo15nXDydSQmTrIHRMjla6DPJgDHA6r/ZdohATH6J0GUQtSnCYAV378mpwdH4McDov58j0sCjOxEXUHAwBOvRIi4ckgV3ndF4McDov5w6k+4A2CAjWK1wNkXfz9dOi1+XxvMIY1QsDnC5IkiRIkoSel8dDb+RlJomagtZHg55p8dDpfTmtMdULA5zqRaOR4OOrRcoV7eFnYIgTNSaNVkLPtHgEBOkZ3lRvDHCqN41Ggk7vg5Qr2kGn5xxARI1Bo5HQIzUeQaEGXqCEGoQBTg2i0UjwM/ii9xXtofNjiBNdCo1GQnJqW4REGBne1GAMcGowjUaCn9EXKVe0g69Oe+E7EFENklR9Gd/QSH8OWKOLwgCni6LRSND765ByRTv4MMSJGkSSgG794hAWHcDwpovGudDpksiygLnCil0bTqLKale6HCKPp9FI6NYvDuGtAhnedEkY4HTJZFmgymLDzt9PwGKyKV0OkcfSajVITm2DkAh2m9OlY4BTo5BlAbvNgV0bTqCyzKp0OUQex8dXi55pbREYwtHm1DgY4NRohCzgcMjYnX4SZUVmpcsh8hh+eh/0HNgOBn8dz/OmRsMAp0YlhICQBfZuzkRRXoXS5RApzhigQ6+B7eDr58PwpkbFAKdGJ4QABHBwZzZyTpUoXQ6RYkLCjUhObQuNVsPwpkbHAKcmIYSAJEk4lVGAo/tylS6HqNnFxIcgqVdrAOAxb2oSDHBqUkIIFOVWYP+203DYZaXLIWoWHZOj0aZjhOuHLFFTYIBTkxOygKmyCnvST/I0M/JqWh8NuvXlBC3UPBjg1CxkWcBhl7F38ymUFpqULoeo0emNvuiZFg+Dv45d5tQsGODUbIQsIAAc3ZeD00eLlC6HqNGEtwpA1z5xHKxGzYoBTorIP1OGgzuyYLfxuDiplyQBHbpFo20nHu+m5scAJ0UIWcBqsWPf1kyUF3PSF1IfP4MvuveLQ2CogcFNimCAk2Jkufqjxy51Uht2mZMnYICTRyg4U4aDf2TDVuVQuhSiOkkaCR26RrHLnDwCA5w8gpAF7HYHDv6RjYIz5UqXQ1RDYIgeXfvEwRCgY3CTR2CAk8dwtmhyM0tweHcO7Da2xkl5kiShXedIxCdFAIKzqpHnYICTxxGygM3mwME/slCYwwuikHICgvXo2icWxkA/trrJ4zDAySM5W+NnThbjyN4cnm5GzUqSJMQnRaBdUiQEwIFq5JEY4OTRnMfGj+zN5ZXNqFmERvojsVdM9YxqbHWTB2OAk8dztsZLi0w4vOsMKkotSpdEXshP74OOya0QFRcMIQse6yaPxwAn1ZBlAUkCso4V4fiBPHarU6OQJAltOoahXZcoSJLE7nJSDQY4qY6rW31fLnJOlihdDqkYu8tJzRjgpErObvXKMguO7MtFUS5Hq1P9BYbokdA9GqGRAewuJ9VigJOqOXe+JfmVOLI/l/Oq03kZAnTo0DUaUbFBkGXB7nJSNQY4eQXnzrjgTBmO/ZmHyjKr0iWRB/HT+6Bd50jEtAuFEDwtjLwDA5y8inOgW35WGU4eLuCI9RbOz+CLNh3DEds+FOAANfIyDHDySs4WeVFuBU4ezkdJgUnpkqgZGQP90DYxAq3igjkRC3ktBjh5NWeQlxWbcfJQPi+U4uWCQg2IT4pARAyPcZP3Y4BTi+Ac7GaqsOJURiHyMkvhcPA8cm8gSUB4TCDaJIQjJMKfwU0tBgOcWhTnx112CJw5VYLs40Uc8KZSfgYfxMSHIrZ9GHR6HwY3tTgMcGqxnDv80iITso4VIT+rDLLMr4OnC4sOQGz7MIS3CuDlPalFY4BTi+fsXrfbHDhzsgR5p0tRxvPJPYrBX4foNsGIaRcKvcGXrW0iMMCJ3DiDwWKyITezBLmnS9nFrhCdnw8iY4PQqm0IgkINELIAJHDKU6K/MMCJ6uAa+FZuRU5mCfJOl8FcWaV0WV5N5+eDiNaBiI4LRnC40bWcoU1UEwOc6AKcXxFJkmCurELBmXIU5pSjpNBU3SqkSxIUakB4qwCEtwpEYIjB7fUmoroxwIkayNnN7nDIKM6rQEFOBYpyy2E125UuTRV8fDUIi6oO7PBWgfDVadk9TnQRGOBEl+Ds4LGYqlBcYEJpQSVKC00wVbC7Haiehzw4wojgcH+ERhhhDPSDJEkciEZ0iRjgRI3IORe7JEmwVTlQ8leYlxWbUVlmgd3m3ZPHaDQS/IP8EBhiQHC4EaGR/vAz+AIAA5uokTHAiZrQ2YEOAFazDeUlZlSUWlBRakVFqUW1A+P89D4ICNYjIFgP/2A9AkP0MPjrIEkShBC86hdRE2OAEzWzc8NNdsiwmG0wV1TBXFkFi8kGs6kKlkobLKYqxVrtGq0EvVEHg9EXen8dDP6+0Bt1MAbooDfqoPXRVD+fvwbycUIVoubFACfyENXBLiBJkttgLodDhs3qQJXVjiqLDbYqB+w2R/V/q2TIsgxZFpBlAXHuf0V1t7VGo4Gkqb6cpkYruf7f11cLXz8tfHU+8NVpodP7uP7fGdDnq42IlMMAJ1IRZ+sdEAAkt+55JR+LiJofA5yIiEiFNBdehYiIiDwNA5yIiEiFGOBEREQqxAAnIiJSIQY4ERGRCjHAiYiIVMhH6QKIPM3cuXMxb948ANXnRfv7+6N169bo27cv7rzzTiQkJLjWNZvNWLRoEVauXImsrCzo9XrExcVh4MCBeOSRR1zrJSUl4fHHH8e9995b6zZXrVqF7777Dvv370dpaSnatGmD22+/HWPHjoVGw9/ZRFQTA5yoFnq9HosXLwYAVFZW4vDhw/j888/xxRdfYNasWbjlllsAAFOnTsW+ffvwwAMPoEuXLigrK8PevXuxevVqtwC/kP/9739o3bo1Hn/8cYSHh2PLli2YNWsWMjMzMXPmzCZ5jkSkbgxwolpoNBr06tXL9ffll1+OO+64A/fffz+efvpp9O7dGw6HAxs2bMDs2bMxYsQI17rDhg3DjBkzGrS9d999F2FhYa6/BwwYAJPJhKVLl+KRRx6BTqe71KdERF6GfXNE9eTn54dnnnkGNpsNX375JcrKygAAkZGRNdZtaLf32eHt1KVLF1itVpSUlFxUvUTk3RjgRA3QsWNHREdHY+fOnejQoQOMRiNee+01rF27FpWVlY26rR07diAkJATh4eGN+rhE5B0Y4EQNFBMTg4KCAgQEBGDWrFnIysrC5MmT0bdvX4waNQrz58+HyWS6pG3s3bsXy5cvx/jx46HVahupciLyJgxwogZyXlYTAG644QasXbsWs2fPxi233ILi4mL8+9//xujRoy86xPPz8zFt2jQkJydj0qRJjVk6EXkRBjhRA+Xk5CAiIsL1d3BwMEaMGIFXX30Va9aswYMPPohjx45h2bJlDX7s8vJyTJo0CXq9HvPnz4evr29jlk5EXoQBTtQAGRkZyM3NRUpKSq23S5LkOtf76NGjDXpsq9WKKVOmoKCgAAsXLkRoaOgl10tE3ounkRHVk9VqxUsvvQSdTocxY8agoqICPj4+0Ov1buudOHECQO2j0+tit9vxf//3fzh48CA+/vhjxMbGNmbpROSFGOBEtZBlGbt27QIAmEwm10QumZmZeO211xAXF4e9e/diypQpGDlyJC677DIYjUYcPXoUCxYsQGBgIEaOHOn2mIcPH8aPP/7otsxgMGDw4MF48cUXsXbtWvzzn/+ExWJxbRuoHvkeEBDQ1E+ZiFRGEkIIpYsg8iTnTqVqNBoRGxtbYyrVsrIyLF68GBs3bsSJEydQWVmJ6Oho9O3bF5MnT0Z8fLzrMZOSkmrdVmxsLNasWYOhQ4ciKyur1nU++ugj9O/fv5GfJRGpHQOciIhIhTiIjYiISIUY4ERERCrEACciIlIhBjgREZEKMcCJiIhUiAFORESkQgxwIiIiFWKAExERqRADnIiISIUY4ERERCrEACciIlIhBjgREZEKMcCJiIhUiAFORESkQgxwIiIiFWKAExERqRADnIiISIUY4ERERCrEACciIlIhBjgREZEKMcCJiIhUiAFORESkQv8fgEydiAKYkM0AAAAASUVORK5CYII=", + "text/plain": [ + "<Figure size 640x480 with 1 Axes>" + ] + }, + "metadata": {}, + "output_type": "display_data" } ], "source": [ + "if(analyse_results):\n", + " def autopct_george(group):\n", + " def flatten(l):\n", + " return [item for sublist in l for item in sublist]\n", + " #https://stackoverflow.com/questions/73616867/pie-chart-from-count-of-values-showing-the-percentage\n", + " #https://stackoverflow.com/a/71515035/2901002\n", + " def autopct_format(values):\n", + " def my_format(pct):\n", + " total = sum(values)\n", + " val = int(round(pct*total/100.0))\n", + " return '{:.1f}%'.format(pct, v=val)\n", + " return my_format\n", + " return autopct_format(flatten(group.values.tolist()))\n", "\n", - "current_path= os.getcwd()\n", - "os.chdir(\"github-crawler/\")\n", - "from download_corpus import *\n", - "os.chdir(current_path)\n" + " group = df.groupby(['DSL']).count()\n", + " explode = [0.03]*len(group)\n", + " _ = group.plot(kind='pie', y='workflow', autopct=autopct_george(group), explode=explode, legend=False, title='Distribution of DSL versions between Nextflow workflows')\n" + ] + }, + { + "cell_type": "markdown", + "metadata": {}, + "source": [ + "## Anlysing Errors" ] }, { "cell_type": "code", - "execution_count": null, + "execution_count": 10, "metadata": {}, "outputs": [], "source": [ - "download_files = True\n", - "repo_to_download = \"../Workflow-Corpus-Open-Licence/\"" + "pattern = r\"\\n *\\[(\\d+)\\] \"\n", + "with open('failed_2_analyse.txt') as f:\n", + " errors = f.read()" ] }, { "cell_type": "code", - "execution_count": 4, + "execution_count": 11, "metadata": {}, "outputs": [], "source": [ - "#Read crawler results\n", - "with open(\"./github-crawler/wf_crawl_nextflow.json\") as json_file:\n", - " crawler = json.load(json_file)\n", - "\n", - "_ = crawler.pop(\"last_date\")" + "dico_nb_errors = {}\n", + "for match in re.finditer(pattern, errors):\n", + " type_error = match.group(1)\n", + " try:\n", + " tmp = dico_nb_errors[type_error]\n", + " except:\n", + " dico_nb_errors[type_error] = 0\n", + " dico_nb_errors[type_error]+=1" ] }, { "cell_type": "code", - "execution_count": 2, + "execution_count": 12, "metadata": {}, "outputs": [], "source": [ - "if(download_files):\n", - " current_directory = os.getcwd()\n", - " os.chdir(current_directory+'/'+repo_to_download)" + "dico_type_errors = {\n", + "'2' : \"Incorrect number of parameters given for a process or a subworkflow call\",\n", + "'4' : \"Channel trying to be created with a name already given to an existing element\",\n", + "'6' : \"Multiple channels are given by an emit even though only expecting one\",\n", + "'8' : \"Tried to access an emit even though the element its emitting has not been called\",\n", + "'10' : \"Tried to include a file which doesn't exist\",\n", + "'12' : \"An include was present in a main or subworkflow\",\n", + "'14' : \"In a pipe operator, the first thing called does not exist\",\n", + "'16' : \"Syntax error in the code (e.g. not the same of parentheses)\",\n", + "'18' : \"Element (process or subworkflow) is expected to be defined in a file but is not\",\n", + "'20' : \"A subworkflow either emits nothing or too many values for use in an operation\", \n", + "'22' : \"A subworkflow or process was defined badly (e.g. multiple input sections, multiple main sections...)\",\n", + "\n", + "#'1' : \"presence of an import java or groovy (NOT USED RIGHT NOW)\",\n", + "'3' : \"Unknown element used in a pipe operator.\",\n", + "'5' : \"Ternary conditional operator used with a tuple.\",\n", + "#'7' : \"Tuple with emit (ch1, ch2) = emit.out\",\n", + "'9' : \"Tuple associated with a call.\"#e.g. (ch1, ch2) = wf()\n", + "}" ] }, { "cell_type": "code", - "execution_count": 4, + "execution_count": 13, "metadata": {}, "outputs": [ { "data": { + "text/html": [ + "<div>\n", + "<style scoped>\n", + " .dataframe tbody tr th:only-of-type {\n", + " vertical-align: middle;\n", + " }\n", + "\n", + " .dataframe tbody tr th {\n", + " vertical-align: top;\n", + " }\n", + "\n", + " .dataframe thead th {\n", + " text-align: right;\n", + " }\n", + "</style>\n", + "<table border=\"1\" class=\"dataframe\">\n", + " <thead>\n", + " <tr style=\"text-align: right;\">\n", + " <th></th>\n", + " <th>Error description</th>\n", + " <th>Number of workflows</th>\n", + " </tr>\n", + " </thead>\n", + " <tbody>\n", + " <tr>\n", + " <th>2</th>\n", + " <td>Incorrect number of parameters given for a pro...</td>\n", + " <td>16</td>\n", + " </tr>\n", + " <tr>\n", + " <th>4</th>\n", + " <td>Channel trying to be created with a name alrea...</td>\n", + " <td>27</td>\n", + " </tr>\n", + " <tr>\n", + " <th>6</th>\n", + " <td>Multiple channels are given by an emit even th...</td>\n", + " <td>1</td>\n", + " </tr>\n", + " <tr>\n", + " <th>8</th>\n", + " <td>Tried to access an emit even though the elemen...</td>\n", + " <td>16</td>\n", + " </tr>\n", + " <tr>\n", + " <th>10</th>\n", + " <td>Tried to include a file which doesn't exist</td>\n", + " <td>14</td>\n", + " </tr>\n", + " <tr>\n", + " <th>12</th>\n", + " <td>An include was present in a main or subworkflow</td>\n", + " <td>1</td>\n", + " </tr>\n", + " <tr>\n", + " <th>14</th>\n", + " <td>In a pipe operator, the first thing called doe...</td>\n", + " <td>11</td>\n", + " </tr>\n", + " <tr>\n", + " <th>16</th>\n", + " <td>Syntax error in the code (e.g. not the same of...</td>\n", + " <td>35</td>\n", + " </tr>\n", + " <tr>\n", + " <th>18</th>\n", + " <td>Element (process or subworkflow) is expected t...</td>\n", + " <td>8</td>\n", + " </tr>\n", + " <tr>\n", + " <th>20</th>\n", + " <td>A subworkflow either emits nothing or too many...</td>\n", + " <td>20</td>\n", + " </tr>\n", + " <tr>\n", + " <th>22</th>\n", + " <td>A subworkflow or process was defined badly (e....</td>\n", + " <td>10</td>\n", + " </tr>\n", + " <tr>\n", + " <th>3</th>\n", + " <td>Unknown element used in a pipe operator.</td>\n", + " <td>1</td>\n", + " </tr>\n", + " <tr>\n", + " <th>5</th>\n", + " <td>Ternary conditional operator used with a tuple.</td>\n", + " <td>2</td>\n", + " </tr>\n", + " <tr>\n", + " <th>9</th>\n", + " <td>Tuple associated with a call.</td>\n", + " <td>5</td>\n", + " </tr>\n", + " </tbody>\n", + "</table>\n", + "</div>" + ], "text/plain": [ - "'/home/gmarchment/Documents/These/Work/Workflow-Corpus-Open-Licence'" + " Error description Number of workflows\n", + "2 Incorrect number of parameters given for a pro... 16\n", + "4 Channel trying to be created with a name alrea... 27\n", + "6 Multiple channels are given by an emit even th... 1\n", + "8 Tried to access an emit even though the elemen... 16\n", + "10 Tried to include a file which doesn't exist 14\n", + "12 An include was present in a main or subworkflow 1\n", + "14 In a pipe operator, the first thing called doe... 11\n", + "16 Syntax error in the code (e.g. not the same of... 35\n", + "18 Element (process or subworkflow) is expected t... 8\n", + "20 A subworkflow either emits nothing or too many... 20\n", + "22 A subworkflow or process was defined badly (e.... 10\n", + "3 Unknown element used in a pipe operator. 1\n", + "5 Ternary conditional operator used with a tuple. 2\n", + "9 Tuple associated with a call. 5" ] }, - "execution_count": 4, + "execution_count": 13, "metadata": {}, "output_type": "execute_result" } ], "source": [ - "os.getcwd()" + "df = pd.DataFrame([dico_type_errors, dico_nb_errors]).T\n", + "df.columns = [\"Error description\", \"Number of workflows\"]\n", + "df.to_csv(\"different_errors_detected.csv\", sep='\\t', index=False)\n", + "df" ] - }, - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [] } ], "metadata": {