Skip to content
Snippets Groups Projects
Verified Commit 5d11b597 authored by Laurent Modolo's avatar Laurent Modolo
Browse files

example_variant_calling.nf: fix input channel

parent 2dcade89
No related branches found
No related tags found
No related merge requests found
...@@ -8,22 +8,29 @@ include { ...@@ -8,22 +8,29 @@ include {
mapping; mapping;
} from "./nf_modules/bwa/main.nf" } from "./nf_modules/bwa/main.nf"
include {
sort_bam;
} from "./nf_modules/samtools/main.nf"
include { include {
germline_cohort_data_variant_calling; germline_cohort_data_variant_calling;
} from "./nf_modules/gatk4/main.nf" addParams( } from "./nf_modules/gatk4/main.nf" addParams(
variant_calling_out: "vcf/", variant_calling_out: "vcf/",
) )
params.fastq = ""
params.fasta = ""
channel channel
.fromFilePairs( params.fastq, size: -1) .fromFilePairs( params.fastq, size: -1)
.set { fastq_files } .set { fastq_files }
channel channel
.fromPath( params.fasta ) .fromPath( params.fasta )
.ifEmpty { error "Cannot find any fasta files matching: ${params.fasta}" }
.map { it -> [it.simpleName, it]} .map { it -> [it.simpleName, it]}
.set { fasta_files } .set { fasta_files }
workflow { workflow {
mapping(fasta_files, fastq_files) mapping(fasta_files, fastq_files)
germline_cohort_data_variant_calling(mapping.out.bam, fasta_files) sort_bam(mapping.out.bam)
germline_cohort_data_variant_calling(sort_bam.out.bam, fasta_files)
} }
0% Loading or .
You are about to add 0 people to the discussion. Proceed with caution.
Finish editing this message first!
Please register or to comment