Skip to content
Snippets Groups Projects
Select Git revision
  • 8e7f26a14af8e3bbde3d3ea797eaf1f3279eb42d
  • master default protected
  • dev
  • v2.0.0
  • v0.4.0
  • v0.3.0
  • v0.2.9
  • v0.2.8
  • v0.2.7
  • v0.2.6
  • v0.1.0
  • v0.2.5
  • v0.2.4
  • v0.2.3
  • v0.2.2
  • v0.2.1
  • v0.2.0
  • v0.1.2
18 results

example_variant_calling.nf

Blame
  • Forked from LBMC / nextflow
    This fork has diverged from the upstream repository.
    example_variant_calling.nf 678 B
    nextflow.enable.dsl=2
    
    /*
    Testing pipeline for marseq scRNASeq analysis
    */
    
    include {
      mapping;
    } from "./nf_modules/bwa/main.nf"
    
    include {
      sort_bam;
    } from "./nf_modules/samtools/main.nf"
    
    include {
      germline_cohort_data_variant_calling;
    } from "./nf_modules/gatk4/main.nf" addParams(
      variant_calling_out: "vcf/",
    )
    
    params.fastq = ""
    params.fasta = ""
    
    channel
      .fromFilePairs( params.fastq, size: -1)
      .set { fastq_files }
    channel
      .fromPath( params.fasta )
      .map { it -> [it.simpleName, it]}
      .set { fasta_files }
    
    workflow {
      mapping(fasta_files, fastq_files)
      sort_bam(mapping.out.bam)
      germline_cohort_data_variant_calling(sort_bam.out.bam, fasta_files)
    }