Skip to content
Snippets Groups Projects
main.nf 37.9 KiB
Newer Older
#!/usr/bin/env nextflow
/*
========================================================================================
                         nf-core/hic
========================================================================================
 nf-core/hic Analysis Pipeline.
 #### Homepage / Documentation
 https://github.com/nf-core/hic
----------------------------------------------------------------------------------------
*/

def helpMessage() {
nservant's avatar
nservant committed
    // Add to this help message with new command line parameters
nservant's avatar
nservant committed
    log.info nfcoreHeader()
    Usage:

    The typical command for running the pipeline is as follows:

nservant's avatar
nservant committed
    nextflow run nf-core/hic --reads '*_R{1,2}.fastq.gz' -profile conda
nservant's avatar
nservant committed
      --reads [file]                            Path to input data (must be surrounded with quotes)
      -profile [str]                            Configuration profile to use. Can use multiple (comma separated)
                                                Available: conda, docker, singularity, awsbatch, test and more.

    References                                  If not specified in the configuration file or you wish to overwrite any of the references.
      --genome [str]                            Name of iGenomes reference
      --bwt2_index [file]                       Path to Bowtie2 index
      --fasta [file]                            Path to Fasta reference
      --chromosome_size [file]                  Path to chromosome size file
      --restriction_fragments [file]            Path to restriction fragment file (bed)
      --save_reference [bool]                   Save reference genome to output folder. Default: False
      --save_aligned_intermediates [bool]       Save intermediates alignment files. Default: False
nservant's avatar
nservant committed
    Alignments
nservant's avatar
nservant committed
      --bwt2_opts_end2end [str]                 Options for bowtie2 end-to-end mappinf (first mapping step). See hic.config for default.
      --bwt2_opts_trimmed [str]                 Options for bowtie2 mapping after ligation site trimming. See hic.config for default.
      --min_mapq [int]                          Minimum mapping quality values to consider. Default: 10
      --restriction_site [str]                  Cutting motif(s) of restriction enzyme(s) (comma separated). Default: 'A^AGCTT'
      --ligation_site [str]                     Ligation motifs to trim (comma separated). Default: 'AAGCTAGCTT'
      --rm_singleton [bool]                     Remove singleton reads. Default: true
      --rm_multi [bool]                         Remove multi-mapped reads. Default: true
      --rm_dup [bool]                           Remove duplicates. Default: true
nservant's avatar
nservant committed
 
    Contacts calling
nservant's avatar
nservant committed
      --min_restriction_fragment_size [int]     Minimum size of restriction fragments to consider. Default: None
      --max_restriction_fragment_size [int]     Maximum size of restriction fragments to consider. Default: None
      --min_insert_size [int]                   Minimum insert size of mapped reads to consider. Default: None
      --max_insert_size [int]                   Maximum insert size of mapped reads to consider. Default: None
      --save_interaction_bam [bool]             Save BAM file with interaction tags (dangling-end, self-circle, etc.). Default: False
nservant's avatar
nservant committed

nservant's avatar
nservant committed
      --dnase [bool]                            Run DNase Hi-C mode. All options related to restriction fragments are not considered. Default: False
      --min_cis_dist [int]                      Minimum intra-chromosomal distance to consider. Default: None
nservant's avatar
nservant committed

nservant's avatar
nservant committed
    Contact maps
nservant's avatar
nservant committed
      --bin_size [int]                          Bin size for contact maps (comma separated). Default: '1000000,500000'
      --ice_max_iter [int]                      Maximum number of iteration for ICE normalization. Default: 100
      --ice_filter_low_count_perc [float]       Percentage of low counts columns/rows to filter before ICE normalization. Default: 0.02
      --ice_filter_high_count_perc [float]      Percentage of high counts columns/rows to filter before ICE normalization. Default: 0
      --ice_eps [float]                         Convergence criteria for ICE normalization. Default: 0.1
nservant's avatar
nservant committed

nservant's avatar
nservant committed
    Workflow
nservant's avatar
nservant committed
      --skip_maps [bool]                        Skip generation of contact maps. Useful for capture-C. Default: False
      --skip_ice [bool]                         Skip ICE normalization. Default: False
      --skip_cool [bool]                        Skip generation of cool files. Default: False
      --skip_multiqc [bool]                     Skip MultiQC. Default: False
nservant's avatar
nservant committed

nservant's avatar
nservant committed
    Other
nservant's avatar
nservant committed
      --split_fastq [bool]                      Size of read chuncks to use to speed up the workflow. Default: None
      --outdir [file]                           The output directory where the results will be saved. Default: './results'
      --email [email]                           Set this parameter to your e-mail address to get a summary e-mail with details of the run sent to you when the workflow exits. Default: None
      --email_on_fail [email]                   Same as --email, except only send mail if the workflow is not successful
      --max_multiqc_email_size [str]            Theshold size for MultiQC report to be attached in notification email. If file generated by pipeline exceeds the threshold, it will not be attached (Default: 25MB)
      -name [str]                               Name for the pipeline run. If not specified, Nextflow will automatically generate a random mnemonic. Default: None
nservant's avatar
nservant committed
    AWSBatch
nservant's avatar
nservant committed
      --awsqueue [str]                          The AWSBatch JobQueue that needs to be set when running on AWSBatch
      --awsregion [str]                         The AWS Region for your AWS Batch job to run on
/**********************************************************
 * SET UP CONFIGURATION VARIABLES
 */

nservant's avatar
nservant committed
// Show help message
if (params.help){
    helpMessage()
    exit 0
}

nservant's avatar
nservant committed
// Check if genome exists in the config file
if (params.genomes && params.genome && !params.genomes.containsKey(params.genome)) {
    exit 1, "The provided genome '${params.genome}' is not available in the iGenomes file. Currently the available genomes are ${params.genomes.keySet().join(", ")}"
}

nservant's avatar
nservant committed
// Check Digestion or DNase Hi-C mode
if (!params.dnase && !params.ligation_site) {
   exit 1, "Ligation motif not found. For DNase Hi-C, please use '--dnase' option"
}

nservant's avatar
nservant committed
// Reference index path configuration
params.bwt2_index = params.genome ? params.genomes[ params.genome ].bowtie2 ?: false : false
nservant's avatar
nservant committed
params.fasta = params.genome ? params.genomes[ params.genome ].fasta ?: false : false
// Has the run name been specified by the user?
//  this has the bonus effect of catching both -name and --name
custom_runName = params.name
if (!(workflow.runName ==~ /[a-z]+_[a-z]+/)) {
    custom_runName = workflow.runName
if (workflow.profile.contains('awsbatch')) {
    // AWSBatch sanity checking
    if (!params.awsqueue || !params.awsregion) exit 1, "Specify correct --awsqueue and --awsregion parameters on AWSBatch!"
    // Check outdir paths to be S3 buckets if running on AWSBatch
    // related: https://github.com/nextflow-io/nextflow/issues/813
    if (!params.outdir.startsWith('s3:')) exit 1, "Outdir not on S3 - specify S3 Bucket to run on AWSBatch!"
    // Prevent trace files to be stored on S3 since S3 does not support rolling files.
    if (params.tracedir.startsWith('s3:')) exit 1, "Specify a local tracedir or run without trace! S3 cannot be used for tracefiles."
ch_multiqc_config = file("$baseDir/assets/multiqc_config.yaml", checkIfExists: true)
ch_multiqc_custom_config = params.multiqc_config ? Channel.fromPath(params.multiqc_config, checkIfExists: true) : Channel.empty()
ch_output_docs = file("$baseDir/docs/output.md", checkIfExists: true)
/**********************************************************
 * SET UP CHANNELS
 */

/*
 * input read files
 */
nservant's avatar
nservant committed
if (params.readPaths){

   raw_reads = Channel.create()
   raw_reads_2 = Channel.create()

   Channel
      .from( params.readPaths )
      .map { row -> [ row[0], [file(row[1][0]), file(row[1][1])]] }
      .separate( raw_reads, raw_reads_2 ) { a -> [tuple(a[0], a[1][0]), tuple(a[0], a[1][1])] }
nservant's avatar
nservant committed
 }else{
nservant's avatar
nservant committed

   raw_reads = Channel.create()
   raw_reads_2 = Channel.create()

   Channel
      .fromFilePairs( params.reads )
      .separate( raw_reads, raw_reads_2 ) { a -> [tuple(a[0], a[1][0]), tuple(a[0], a[1][1])] }
}
nservant's avatar
nservant committed
if ( params.split_fastq ){
nservant's avatar
nservant committed
   raw_reads_full = raw_reads.concat( raw_reads_2 )
   raw_reads = raw_reads_full.splitFastq( by: params.splitFastq , file: true)
 }else{
   raw_reads = raw_reads.concat( raw_reads_2 ).dump(tag: "data")
// SPlit fastq files
// https://www.nextflow.io/docs/latest/operator.html#splitfastq

 * Other input channels
nservant's avatar
nservant committed
// Reference genome
if ( params.bwt2_index ){
nservant's avatar
nservant committed
   lastPath = params.bwt2_index.lastIndexOf(File.separator)
   bwt2_dir =  params.bwt2_index.substring(0,lastPath+1)
   bwt2_base = params.bwt2_index.substring(lastPath+1)

   Channel.fromPath( bwt2_dir , checkIfExists: true)
nservant's avatar
nservant committed
      .ifEmpty { exit 1, "Genome index: Provided index not found: ${params.bwt2_index}" }
      .into { bwt2_index_end2end; bwt2_index_trim }
nservant's avatar
nservant committed
}
else if ( params.fasta ) {
nservant's avatar
nservant committed
    lastPath = params.fasta.lastIndexOf(File.separator)
    bwt2_base = params.fasta.substring(lastPath+1)

   Channel.fromPath( params.fasta )
nservant's avatar
nservant committed
	.ifEmpty { exit 1, "Genome index: Fasta file not found: ${params.fasta}" }
nservant's avatar
nservant committed
        .set { fasta_for_index }
}
else {
   exit 1, "No reference genome specified!"
}
nservant's avatar
nservant committed
// Chromosome size
if ( params.chromosome_size ){
   Channel.fromPath( params.chromosome_size , checkIfExists: true)
nservant's avatar
nservant committed
         .into {chromosome_size; chromosome_size_cool}
nservant's avatar
nservant committed
}
else if ( params.fasta ){
   Channel.fromPath( params.fasta )
nservant's avatar
nservant committed
	.ifEmpty { exit 1, "Chromosome sizes: Fasta file not found: ${params.fasta}" }
nservant's avatar
nservant committed
       	.set { fasta_for_chromsize }
}
else {
   exit 1, "No chromosome size specified!"
}

// Restriction fragments
if ( params.restriction_fragments ){
   Channel.fromPath( params.restriction_fragments, checkIfExists: true )
nservant's avatar
nservant committed
      .set {res_frag_file}
nservant's avatar
nservant committed
}
else if ( params.fasta && params.restriction_site ){
   Channel.fromPath( params.fasta )
nservant's avatar
nservant committed
           .ifEmpty { exit 1, "Restriction fragments: Fasta file not found: ${params.fasta}" }
nservant's avatar
nservant committed
           .set { fasta_for_resfrag }
nservant's avatar
nservant committed
}
nservant's avatar
nservant committed
else {
    exit 1, "No restriction fragments file specified!"
}

// Resolutions for contact maps
nservant's avatar
nservant committed
map_res = Channel.from( params.bin_size.tokenize(',') )
nservant's avatar
nservant committed
// Stage config files
ch_multiqc_config = Channel.fromPath(params.multiqc_config)
ch_output_docs = Channel.fromPath("$baseDir/docs/output.md")

/**********************************************************
 * SET UP LOGS
 */
nservant's avatar
nservant committed
log.info nfcoreHeader()
nservant's avatar
nservant committed
if(workflow.revision) summary['Pipeline Release'] = workflow.revision
nservant's avatar
nservant committed
summary['Run Name']         = custom_runName ?: workflow.runName
summary['Reads']            = params.reads
nservant's avatar
nservant committed
summary['splitFastq']       = params.split_fastq
nservant's avatar
nservant committed
summary['Fasta Ref']        = params.fasta
nservant's avatar
nservant committed
summary['Restriction Motif']= params.restriction_site
nservant's avatar
nservant committed
summary['Ligation Motif']   = params.ligation_site
summary['DNase Mode']       = params.dnase
summary['Remove Dup']       = params.rm_dup
nservant's avatar
nservant committed
summary['Min MAPQ']         = params.min_mapq
summary['Min Fragment Size']= params.min_restriction_fragment_size
summary['Max Fragment Size']= params.max_restriction_framgnet_size
summary['Min Insert Size']  = params.min_insert_size
summary['Max Insert Size']  = params.max_insert_size
summary['Min CIS dist']     = params.min_cis_dist
nservant's avatar
nservant committed
summary['Maps resolution']  = params.bin_size
summary['Max Memory']       = params.max_memory
summary['Max CPUs']         = params.max_cpus
summary['Max Time']         = params.max_time
summary['Output dir']       = params.outdir
summary['Working dir']      = workflow.workDir
summary['Container Engine'] = workflow.containerEngine
if(workflow.containerEngine)
nservant's avatar
nservant committed
   summary['Container']     = workflow.container
summary['Current home']     = "$HOME"
summary['Current user']     = "$USER"
summary['Current path']     = "$PWD"
summary['Working dir']      = workflow.workDir
summary['Output dir']       = params.outdir
summary['Script dir']       = workflow.projectDir
summary['Config Profile']   = workflow.profile
if(workflow.profile == 'awsbatch'){
nservant's avatar
nservant committed
   summary['AWS Region']    = params.awsregion
   summary['AWS Queue']     = params.awsqueue
nservant's avatar
nservant committed
summary['Config Profile'] = workflow.profile
if(params.config_profile_description) summary['Config Description'] = params.config_profile_description
if(params.config_profile_contact)     summary['Config Contact']     = params.config_profile_contact
if(params.config_profile_url)         summary['Config URL']         = params.config_profile_url
if(params.email) {
  summary['E-mail Address']  = params.email
  summary['MultiQC maxsize'] = params.maxMultiqcEmailFileSize
}
log.info summary.collect { k,v -> "${k.padRight(18)}: $v" }.join("\n")
nservant's avatar
nservant committed
log.info "-\033[2m--------------------------------------------------\033[0m-"
nservant's avatar
nservant committed
// Check the hostnames against configured profiles
checkHostname()
Channel.from(summary.collect{ [it.key, it.value] })
    .map { k,v -> "<dt>$k</dt><dd><samp>${v ?: '<span style=\"color:#999999;\">N/A</a>'}</samp></dd>" }
    .reduce { a, b -> return [a, b].join("\n            ") }
    .map { x -> """
    id: 'nf-core-hic-summary'
    description: " - this information is collected when the pipeline is started."
    section_name: 'nf-core/hic Workflow Summary'
    section_href: 'https://github.com/nf-core/hic'
    plot_type: 'html'
    data: |
        <dl class=\"dl-horizontal\">
    """.stripIndent() }
    .set { ch_workflow_summary }

/*
 * Parse software version numbers
 */
process get_software_versions {
   publishDir "${params.outdir}/pipeline_info", mode: 'copy',
   saveAs: {filename ->
       if (filename.indexOf(".csv") > 0) filename
       else null
   }
   output:
   file 'software_versions_mqc.yaml' into software_versions_yaml
   file "software_versions.csv"
   script:
   """
   echo $workflow.manifest.version > v_pipeline.txt
   echo $workflow.nextflow.version > v_nextflow.txt
   bowtie2 --version > v_bowtie2.txt
nservant's avatar
nservant committed
   python --version > v_python.txt 2>&1
   samtools --version > v_samtools.txt
nservant's avatar
nservant committed
   multiqc --version > v_multiqc.txt
   scrape_software_versions.py &> software_versions_mqc.yaml
   """
nservant's avatar
nservant committed
/****************************************************
 * PRE-PROCESSING
 */

if(!params.bwt2_index && params.fasta){
    process makeBowtie2Index {
        tag "$bwt2_base"
nservant's avatar
nservant committed
        label 'process_highmem'
        publishDir path: { params.save_reference ? "${params.outdir}/reference_genome" : params.outdir },
                   saveAs: { params.save_reference ? it : null }, mode: 'copy'
nservant's avatar
nservant committed

        input:
        file fasta from fasta_for_index

        output:
        file "bowtie2_index" into bwt2_index_end2end
	file "bowtie2_index" into bwt2_index_trim
nservant's avatar
nservant committed

        script:
        bwt2_base = fasta.toString() - ~/(\.fa)?(\.fasta)?(\.fas)?$/
nservant's avatar
nservant committed
        """
        mkdir bowtie2_index
	bowtie2-build ${fasta} bowtie2_index/${bwt2_base}
nservant's avatar
nservant committed
	"""
      }
 }


if(!params.chromosome_size && params.fasta){
    process makeChromSize {
        tag "$fasta"
nservant's avatar
nservant committed
	label 'process_low''
        publishDir path: { params.save_reference ? "${params.outdir}/reference_genome" : params.outdir },
                   saveAs: { params.save_reference ? it : null }, mode: 'copy'
nservant's avatar
nservant committed

        input:
        file fasta from fasta_for_chromsize

        output:
        file "*.size" into chromosome_size, chromosome_size_cool
nservant's avatar
nservant committed

        script:
        """
	samtools faidx ${fasta}
	cut -f1,2 ${fasta}.fai > chrom.size
nservant's avatar
nservant committed
      }
 }

nservant's avatar
nservant committed
if(!params.restriction_fragments && params.fasta && !params.dnase){
nservant's avatar
nservant committed
    process getRestrictionFragments {
nservant's avatar
nservant committed
        tag "$fasta ${params.restriction_site}"
	label 'process_low'
        publishDir path: { params.save_reference ? "${params.outdir}/reference_genome" : params.outdir },
                   saveAs: { params.save_reference ? it : null }, mode: 'copy'
nservant's avatar
nservant committed

        input:
        file fasta from fasta_for_resfrag

        output:
nservant's avatar
nservant committed
        file "*.bed" into res_frag_file
nservant's avatar
nservant committed

        script:
        """
nservant's avatar
nservant committed
	digest_genome.py -r ${params.restriction_site} -o restriction_fragments.bed ${fasta}
nservant's avatar
nservant committed
	"""
      }
 }

/****************************************************
 * MAIN WORKFLOW
 */
 * STEP 1 - Two-steps Reads Mapping
*/
process bowtie2_end_to_end {
   tag "$prefix"
nservant's avatar
nservant committed
   label 'process_medium'
   publishDir path: { params.save_aligned_intermediates ? "${params.outdir}/mapping" : params.outdir },
   	      saveAs: { params.save_aligned_intermediates ? it : null }, mode: 'copy'
nservant's avatar
nservant committed
   set val(sample), file(reads) from raw_reads
   file index from bwt2_index_end2end.collect()
nservant's avatar
nservant committed
   set val(prefix), file("${prefix}_unmap.fastq") into unmapped_end_to_end
   set val(prefix), file("${prefix}.bam") into end_to_end_bam
nservant's avatar
nservant committed
   prefix = reads.toString() - ~/(\.fq)?(\.fastq)?(\.gz)?$/
   def bwt2_opts = params.bwt2_opts_end2end

   if (!params.dnase){
   """
   bowtie2 --rg-id BMG --rg SM:${prefix} \\
	${bwt2_opts} \\
	-p ${task.cpus} \\
	-x ${index}/${bwt2_base} \\
	--un ${prefix}_unmap.fastq \\
 	-U ${reads} | samtools view -F 4 -bS - > ${prefix}.bam
   """
   }else{
   """
   bowtie2 --rg-id BMG --rg SM:${prefix} \\
	${bwt2_opts} \\
	-p ${task.cpus} \\
	-x ${index}/${bwt2_base} \\
	--un ${prefix}_unmap.fastq \\
 	-U ${reads} > ${prefix}.bam
   """
   }
process trim_reads {
   tag "$prefix"
nservant's avatar
nservant committed
   label 'process_low'
   publishDir path: { params.save_aligned_intermediates ? "${params.outdir}/mapping" : params.outdir },
   	      saveAs: { params.save_aligned_intermediates ? it : null }, mode: 'copy'
nservant's avatar
nservant committed
   when:
nservant's avatar
nservant committed
   !params.dnase
nservant's avatar
nservant committed

nservant's avatar
nservant committed
   set val(prefix), file(reads) from unmapped_end_to_end
nservant's avatar
nservant committed
   set val(prefix), file("${prefix}_trimmed.fastq") into trimmed_reads
nservant's avatar
nservant committed
   """
   cutsite_trimming --fastq $reads \\
                    --cutsite  ${params.ligation_site} \\
                    --out ${prefix}_trimmed.fastq
   """
}

process bowtie2_on_trimmed_reads {
   tag "$prefix"
nservant's avatar
nservant committed
   label 'process_medium'
   publishDir path: { params.save_aligned_intermediates ? "${params.outdir}/mapping" : params.outdir },
   	      saveAs: { params.save_aligned_intermediates ? it : null }, mode: 'copy'
nservant's avatar
nservant committed
   when:
nservant's avatar
nservant committed
   !params.dnase
nservant's avatar
nservant committed

nservant's avatar
nservant committed
   set val(prefix), file(reads) from trimmed_reads
   file index from bwt2_index_trim.collect()
nservant's avatar
nservant committed
   set val(prefix), file("${prefix}_trimmed.bam") into trimmed_bam
nservant's avatar
nservant committed
   prefix = reads.toString() - ~/(_trimmed)?(\.fq)?(\.fastq)?(\.gz)?$/
   """
   bowtie2 --rg-id BMG --rg SM:${prefix} \\
           ${params.bwt2_opts_trimmed} \\
           -p ${task.cpus} \\
           -x ${index}/${bwt2_base} \\
           -U ${reads} | samtools view -bS - > ${prefix}_trimmed.bam
   """
nservant's avatar
nservant committed
if (!params.dnase){
   process merge_mapping_steps{
      tag "$sample = $bam1 + $bam2"
nservant's avatar
nservant committed
      label 'process_medium'
      publishDir path: { params.save_aligned_intermediates ? "${params.outdir}/mapping" : params.outdir },
   	      saveAs: { params.save_aligned_intermediates ? it : null }, mode: 'copy'
nservant's avatar
nservant committed
      input:
nservant's avatar
nservant committed
      set val(prefix), file(bam1), file(bam2) from end_to_end_bam.join( trimmed_bam )
nservant's avatar
nservant committed
      output:
nservant's avatar
nservant committed
      set val(sample), file("${prefix}_bwt2merged.bam") into bwt2_merged_bam
      set val(oname), file("${prefix}.mapstat") into all_mapstat
nservant's avatar
nservant committed
      script:
      sample = prefix.toString() - ~/(_R1|_R2|_val_1|_val_2|_1$|_2)/
      tag = prefix.toString() =~/_R1|_val_1|_1/ ? "R1" : "R2"
nservant's avatar
nservant committed
      oname = prefix.toString() - ~/(\.[0-9]+)$/
      """
      samtools merge -@ ${task.cpus} \\
    	             -f ${prefix}_bwt2merged.bam \\
                     ${bam1} ${bam2}
nservant's avatar
nservant committed
      samtools sort -@ ${task.cpus} -m 800M \\
      	            -n -T /tmp/ \\
	            -o ${prefix}_bwt2merged.sorted.bam \\
	            ${prefix}_bwt2merged.bam
nservant's avatar
nservant committed
      mv ${prefix}_bwt2merged.sorted.bam ${prefix}_bwt2merged.bam

      echo "## ${prefix}" > ${prefix}.mapstat
      echo -n "total_${tag}\t" >> ${prefix}.mapstat
      samtools view -c ${prefix}_bwt2merged.bam >> ${prefix}.mapstat
      echo -n "mapped_${tag}\t" >> ${prefix}.mapstat
      samtools view -c -F 4 ${prefix}_bwt2merged.bam >> ${prefix}.mapstat
      echo -n "global_${tag}\t" >> ${prefix}.mapstat
      samtools view -c -F 4 ${bam1} >> ${prefix}.mapstat
      echo -n "local_${tag}\t"  >> ${prefix}.mapstat
      samtools view -c -F 4 ${bam2} >> ${prefix}.mapstat
      """
nservant's avatar
nservant committed
   }
}else{
   process dnase_mapping_stats{
      tag "$sample = $bam1"
nservant's avatar
nservant committed
      label 'process_medium'
      publishDir path: { params.save_aligned_intermediates ? "${params.outdir}/mapping" : params.outdir },
   	      saveAs: { params.save_aligned_intermediates ? it : null }, mode: 'copy'
nservant's avatar
nservant committed

      input:
nservant's avatar
nservant committed
      set val(prefix), file(bam1) from end_to_end_bam
nservant's avatar
nservant committed

      output:
nservant's avatar
nservant committed
      set val(sample), file(bam1) into bwt2_merged_bam
      set val(oname), file("${prefix}.mapstat") into all_mapstat
nservant's avatar
nservant committed

      script:
      sample = prefix.toString() - ~/(_R1|_R2|_val_1|_val_2|_1|_2)/
      tag = prefix.toString() =~/_R1|_val_1|_1/ ? "R1" : "R2"
nservant's avatar
nservant committed
      oname = prefix.toString() - ~/(\.[0-9]+)$/
      """
      echo "## ${prefix}" > ${prefix}.mapstat
      echo -n "total_${tag}\t" >> ${prefix}.mapstat
      samtools view -c ${bam1} >> ${prefix}.mapstat
      echo -n "mapped_${tag}\t" >> ${prefix}.mapstat
      samtools view -c -F 4 ${bam1} >> ${prefix}.mapstat
      echo -n "global_${tag}\t" >> ${prefix}.mapstat
      samtools view -c -F 4 ${bam1} >> ${prefix}.mapstat
      echo -n "local_${tag}\t0"  >> ${prefix}.mapstat
      """
nservant's avatar
nservant committed
   }
process combine_mapped_files{
   tag "$sample = $r1_prefix + $r2_prefix"
nservant's avatar
nservant committed
   label 'process_low'
nservant's avatar
nservant committed
   publishDir "${params.outdir}/mapping", mode: 'copy',
   	      saveAs: {filename -> filename.indexOf(".pairstat") > 0 ? "stats/$filename" : "$filename"}

nservant's avatar
nservant committed
   set val(sample), file(aligned_bam) from bwt2_merged_bam.groupTuple()
nservant's avatar
nservant committed
   set val(sample), file("${sample}_bwt2pairs.bam") into paired_bam
   set val(oname), file("*.pairstat") into all_pairstat
nservant's avatar
nservant committed
   r1_bam = aligned_bam[0]
   r1_prefix = r1_bam.toString() - ~/_bwt2merged.bam$/
   r2_bam = aligned_bam[1]
   r2_prefix = r2_bam.toString() - ~/_bwt2merged.bam$/
   oname = sample.toString() - ~/(\.[0-9]+)$/

   def opts = "-t"
   opts = params.rm_singleton ? "${opts}" : "--single ${opts}"
   opts = params.rm_multi ? "${opts}" : "--multi ${opts}"
   if ("$params.min_mapq".isInteger()) opts="${opts} -q ${params.min_mapq}"
   """
   mergeSAM.py -f ${r1_bam} -r ${r2_bam} -o ${sample}_bwt2pairs.bam ${opts}
   """
 * STEP2 - DETECT VALID PAIRS
*/

nservant's avatar
nservant committed
if (!params.dnase){
   process get_valid_interaction{
      tag "$sample"
nservant's avatar
nservant committed
      label 'process_low'
nservant's avatar
nservant committed
      publishDir "${params.outdir}/hic_results/data", mode: 'copy',
   	      saveAs: {filename -> filename.indexOf("*stat") > 0 ? "stats/$filename" : "$filename"}
nservant's avatar
nservant committed
      input:
nservant's avatar
nservant committed
      set val(sample), file(pe_bam) from paired_bam
      file frag_file from res_frag_file.collect()
nservant's avatar
nservant committed

      output:
nservant's avatar
nservant committed
      set val(sample), file("*.validPairs") into valid_pairs
      set val(sample), file("*.validPairs") into valid_pairs_4cool
      set val(sample), file("*.DEPairs") into de_pairs
      set val(sample), file("*.SCPairs") into sc_pairs
      set val(sample), file("*.REPairs") into re_pairs
      set val(sample), file("*.FiltPairs") into filt_pairs
      set val(sample), file("*RSstat") into all_rsstat
nservant's avatar
nservant committed
      if (params.split_fastq){
nservant's avatar
nservant committed
         sample = sample.toString() - ~/(\.[0-9]+)$/
      }

      def opts = ""
      if ("$params.min_cis_dist".isInteger()) opts="${opts} -d ${params.min_cis_dist}"
      if ("$params.min_insert_size".isInteger()) opts="${opts} -s ${params.min_insert_size}"
      if ("$params.max_insert_size".isInteger()) opts="${opts} -l ${params.max_insert_size}"
      if ("$params.min_restriction_fragment_size".isInteger()) opts="${opts} -t ${params.min_restriction_fragment_size}"
      if ("$params.max_restriction_fragment_size".isInteger()) opts="${opts} -m ${params.max_restriction_fragment_size}"
nservant's avatar
nservant committed
      if (params.save_interaction_bam) opts="${opts} --sam"
nservant's avatar
nservant committed
      """
      mapped_2hic_fragments.py -f ${frag_file} -r ${pe_bam} --all ${opts}
      """
nservant's avatar
nservant committed
   }
}
else{
   process get_valid_interaction_dnase{
      tag "$sample"
nservant's avatar
nservant committed
      label 'process_low'
nservant's avatar
nservant committed
      publishDir "${params.outdir}/hic_results/data", mode: 'copy',
   	      saveAs: {filename -> filename.indexOf("*stat") > 0 ? "stats/$filename" : "$filename"}
nservant's avatar
nservant committed
      input:
nservant's avatar
nservant committed
      set val(sample), file(pe_bam) from paired_bam
nservant's avatar
nservant committed
      output:
nservant's avatar
nservant committed
      set val(sample), file("*.validPairs") into valid_pairs
      set val(sample), file("*.validPairs") into valid_pairs_4cool
      set val(sample), file("*RSstat") into all_rsstat
nservant's avatar
nservant committed
      if (params.split_fastq){
nservant's avatar
nservant committed
         sample = sample.toString() - ~/(\.[0-9]+)$/
      }

      def opts = ""
      if ("$params.min_cis_dist".isInteger()) opts="${opts} -d ${params.min_cis_dist}"
      """
      mapped_2hic_dnase.py -r ${pe_bam} ${opts}
      """
/*
 * STEP3 - BUILD MATRIX
*/

nservant's avatar
nservant committed
process remove_duplicates {
   tag "$sample"
nservant's avatar
nservant committed
   label 'process_highmem'
nservant's avatar
nservant committed
   publishDir "${params.outdir}/hic_results/data", mode: 'copy',
   	      saveAs: {filename -> filename.indexOf("*stat") > 0 ? "stats/$sample/$filename" : "$filename"}
nservant's avatar
nservant committed
   input:
nservant's avatar
nservant committed
   set val(sample), file(vpairs) from valid_pairs.groupTuple()
nservant's avatar
nservant committed

   output:
nservant's avatar
nservant committed
   set val(sample), file("*.allValidPairs") into all_valid_pairs
   set val(sample), file("*.allValidPairs") into all_valid_pairs_4cool
   file("stats/") into all_mergestat
nservant's avatar
nservant committed

   script:
   if ( params.rm_dup ){
   """
   mkdir -p stats/${sample}
nservant's avatar
nservant committed

   ## Sort valid pairs and remove read pairs with same starts (i.e duplicated read pairs)
nservant's avatar
nservant committed
   sort -T /tmp/ -S 50% -k2,2V -k3,3n -k5,5V -k6,6n -m ${vpairs} | \
   awk -F"\\t" 'BEGIN{c1=0;c2=0;s1=0;s2=0}(c1!=\$2 || c2!=\$5 || s1!=\$3 || s2!=\$6){print;c1=\$2;c2=\$5;s1=\$3;s2=\$6}' > ${sample}.allValidPairs
nservant's avatar
nservant committed

nservant's avatar
nservant committed
   echo -n "valid_interaction\t" > stats/${sample}/${sample}_allValidPairs.mergestat
   cat ${vpairs} | wc -l >> stats/${sample}/${sample}_allValidPairs.mergestat
   echo -n "valid_interaction_rmdup\t" >> stats/${sample}/${sample}_allValidPairs.mergestat
   cat ${sample}.allValidPairs | wc -l >> stats/${sample}/${sample}_allValidPairs.mergestat
nservant's avatar
nservant committed

   ## Count short range (<20000) vs long range contacts
nservant's avatar
nservant committed
   awk 'BEGIN{cis=0;trans=0;sr=0;lr=0} \$2 == \$5{cis=cis+1; d=\$6>\$3?\$6-\$3:\$3-\$6; if (d<=20000){sr=sr+1}else{lr=lr+1}} \$2!=\$5{trans=trans+1}END{print "trans_interaction\\t"trans"\\ncis_interaction\\t"cis"\\ncis_shortRange\\t"sr"\\ncis_longRange\\t"lr}' ${sample}.allValidPairs >> stats/${sample}/${sample}_allValidPairs.mergestat

   """
   }else{
   """
   mkdir -p stats/${sample}
   cat ${vpairs} > ${sample}.allValidPairs
   echo -n "valid_interaction\t" > stats/${sample}/${sample}_allValidPairs.mergestat
   cat ${vpairs} | wc -l >> stats/${sample}/${sample}_allValidPairs.mergestat
   echo -n "valid_interaction_rmdup\t" >> stats/${sample}/${sample}_allValidPairs.mergestat
   cat ${sample}.allValidPairs | wc -l >> stats/${sample}/${sample}_allValidPairs.mergestat
nservant's avatar
nservant committed

   ## Count short range (<20000) vs long range contacts 
nservant's avatar
nservant committed
   awk 'BEGIN{cis=0;trans=0;sr=0;lr=0} \$2 == \$5{cis=cis+1; d=\$6>\$3?\$6-\$3:\$3-\$6; if (d<=20000){sr=sr+1}else{lr=lr+1}} \$2!=\$5{trans=trans+1}END{print "trans_interaction\\t"trans"\\ncis_interaction\\t"cis"\\ncis_shortRange\\t"sr"\\ncis_longRange\\t"lr}' ${sample}.allValidPairs >> stats/${sample}/${sample}_allValidPairs.mergestat
   """
nservant's avatar
nservant committed
process merge_sample {
   tag "$ext"
nservant's avatar
nservant committed
   label 'process_low'
nservant's avatar
nservant committed
   publishDir "${params.outdir}/hic_results/stats/${sample}", mode: 'copy'

   input:
nservant's avatar
nservant committed
   set val(prefix), file(fstat) from all_mapstat.groupTuple().concat(all_pairstat.groupTuple(), all_rsstat.groupTuple())
nservant's avatar
nservant committed

nservant's avatar
nservant committed
   output:
   file("mstats/") into all_mstats
nservant's avatar
nservant committed

  script:
  sample = prefix.toString() - ~/(_R1|_R2|_val_1|_val_2|_1|_2)/
  if ( (fstat =~ /.mapstat/) ){ ext = "mmapstat" }
  if ( (fstat =~ /.pairstat/) ){ ext = "mpairstat" }
  if ( (fstat =~ /.RSstat/) ){ ext = "mRSstat" }
  """
  mkdir -p mstats/${sample}
  merge_statfiles.py -f ${fstat} > mstats/${sample}/${prefix}.${ext}
  """
nservant's avatar
nservant committed
}

process build_contact_maps{
   tag "$sample - $mres"
nservant's avatar
nservant committed
   label 'process_highmem'
nservant's avatar
nservant committed
   publishDir "${params.outdir}/hic_results/matrix/raw", mode: 'copy'
nservant's avatar
nservant committed
   when:
nservant's avatar
nservant committed
   !params.skip_maps
nservant's avatar
nservant committed

nservant's avatar
nservant committed
   set val(sample), file(vpairs), val(mres) from all_valid_pairs.combine(map_res)
   file chrsize from chromosome_size.collect()
nservant's avatar
nservant committed
   file("*.matrix") into raw_maps
   file "*.bed"
   build_matrix --matrix-format upper  --binsize ${mres} --chrsizes ${chrsize} --ifile ${vpairs} --oprefix ${sample}_${mres}
nservant's avatar
nservant committed
process run_ice{
nservant's avatar
nservant committed
   label 'process_highmem'
nservant's avatar
nservant committed
   publishDir "${params.outdir}/hic_results/matrix/iced", mode: 'copy'

nservant's avatar
nservant committed
   when:
nservant's avatar
nservant committed
   !params.skip_maps && !params.skip_ice
nservant's avatar
nservant committed

nservant's avatar
nservant committed
   file(rmaps) from raw_maps
   file "*.biases"
nservant's avatar
nservant committed
   file("*iced.matrix") into iced_maps
   script:
   prefix = rmaps.toString() - ~/(\.matrix)?$/
   """
   ice --filter_low_counts_perc ${params.ice_filer_low_count_perc} \
   --results_filename ${prefix}_iced.matrix \
   --filter_high_counts_perc ${params.ice_filer_high_count_perc} \
   --max_iter ${params.ice_max_iter} --eps ${params.ice_eps} --remove-all-zeros-loci --output-bias 1 --verbose 1 ${rmaps}
/*
 * STEP 5 - COOLER FILE
nservant's avatar
nservant committed
 */
process generate_cool{
   tag "$sample"
nservant's avatar
nservant committed
   label 'process_medium'
nservant's avatar
nservant committed
   publishDir "${params.outdir}/export/cool", mode: 'copy'

nservant's avatar
nservant committed
   when:
nservant's avatar
nservant committed
   !params.skip_cool
nservant's avatar
nservant committed

nservant's avatar
nservant committed
   set val(sample), file(vpairs) from all_valid_pairs_4cool
   file chrsize from chromosome_size_cool.collect()
nservant's avatar
nservant committed
   file("*mcool") into cool_maps
nservant's avatar
nservant committed
   hicpro2higlass.sh -p ${task.cpus} -i $vpairs -r 5000 -c ${chrsize} -n
nservant's avatar
nservant committed

nservant's avatar
nservant committed
 * STEP 6 - MultiQC
nservant's avatar
nservant committed
 */
nservant's avatar
nservant committed
   label 'process_low'
nservant's avatar
nservant committed
   publishDir "${params.outdir}/MultiQC", mode: 'copy'
nservant's avatar
nservant committed
   when:
nservant's avatar
nservant committed
   !params.skip_multiQC
nservant's avatar
nservant committed
   input:
   file multiqc_config from ch_multiqc_config
   file ('input_*/*') from all_mstats.concat(all_mergestat).collect()
   file ('software_versions/*') from software_versions_yaml
   file workflow_summary from create_workflow_summary(summary)
nservant's avatar
nservant committed
   output:
   file "*multiqc_report.html" into multiqc_report
   file "*_data"
nservant's avatar
nservant committed
   script:
   rtitle = custom_runName ? "--title \"$custom_runName\"" : ''
   rfilename = custom_runName ? "--filename " + custom_runName.replaceAll('\\W','_').replaceAll('_+','_') + "_multiqc_report" : ''
   """
   multiqc -f $rtitle $rfilename --config $multiqc_config .
   """
nservant's avatar
nservant committed

nservant's avatar
nservant committed
/*
nservant's avatar
nservant committed
 * STEP 7 - Output Description HTML
nservant's avatar
nservant committed
 */
process output_documentation {
nservant's avatar
nservant committed
   publishDir "${params.outdir}/pipeline_info", mode: 'copy'
nservant's avatar
nservant committed
   input:
   file output_docs from ch_output_docs
nservant's avatar
nservant committed
   output:
   file "results_description.html"
nservant's avatar
nservant committed
   script:
   """
   markdown_to_html.r $output_docs results_description.html
   """
/*
 * Completion e-mail notification
 */
workflow.onComplete {

    // Set up the e-mail variables
    def subject = "[nf-core/hic] Successful: $workflow.runName"
    if (!workflow.success) {
        subject = "[nf-core/hic] FAILED: $workflow.runName"
    }
    def email_fields = [:]
    email_fields['version'] = workflow.manifest.version
    email_fields['runName'] = custom_runName ?: workflow.runName
    email_fields['success'] = workflow.success
    email_fields['dateComplete'] = workflow.complete
    email_fields['duration'] = workflow.duration
    email_fields['exitStatus'] = workflow.exitStatus
    email_fields['errorMessage'] = (workflow.errorMessage ?: 'None')
    email_fields['errorReport'] = (workflow.errorReport ?: 'None')
    email_fields['commandLine'] = workflow.commandLine
    email_fields['projectDir'] = workflow.projectDir
    email_fields['summary'] = summary
    email_fields['summary']['Date Started'] = workflow.start
    email_fields['summary']['Date Completed'] = workflow.complete
    email_fields['summary']['Pipeline script file path'] = workflow.scriptFile
    email_fields['summary']['Pipeline script hash ID'] = workflow.scriptId
    if (workflow.repository) email_fields['summary']['Pipeline repository Git URL'] = workflow.repository
    if (workflow.commitId) email_fields['summary']['Pipeline repository Git Commit'] = workflow.commitId
    if (workflow.revision) email_fields['summary']['Pipeline Git branch/tag'] = workflow.revision
    email_fields['summary']['Nextflow Version'] = workflow.nextflow.version
    email_fields['summary']['Nextflow Build'] = workflow.nextflow.build
    email_fields['summary']['Nextflow Compile Timestamp'] = workflow.nextflow.timestamp

nservant's avatar
nservant committed
    // If not using MultiQC, strip out this code (including params.maxMultiqcEmailFileSize)
nservant's avatar
nservant committed
    // On success try attach the multiqc report
    def mqc_report = null
    try {
        if (workflow.success) {
            mqc_report = ch_multiqc_report.getVal()
            if (mqc_report.getClass() == ArrayList) {
nservant's avatar
nservant committed
                log.warn "[nf-core/hic] Found multiple reports from process 'multiqc', will use only one"
                mqc_report = mqc_report[0]
            }
        }
    } catch (all) {
        log.warn "[nf-core/hic] Could not attach MultiQC report to summary email"
    }

    // Check if we are only sending emails on failure
    email_address = params.email
    if (!params.email && params.email_on_fail && !workflow.success) {
        email_address = params.email_on_fail
    }

    // Render the TXT template
    def engine = new groovy.text.GStringTemplateEngine()
    def tf = new File("$baseDir/assets/email_template.txt")
    def txt_template = engine.createTemplate(tf).make(email_fields)
    def email_txt = txt_template.toString()

    // Render the HTML template
    def hf = new File("$baseDir/assets/email_template.html")
    def html_template = engine.createTemplate(hf).make(email_fields)
    def email_html = html_template.toString()

    // Render the sendmail template
    def smail_fields = [ email: email_address, subject: subject, email_txt: email_txt, email_html: email_html, baseDir: "$baseDir", mqcFile: mqc_report, mqcMaxSize: params.max_multiqc_email_size.toBytes() ]
    def sf = new File("$baseDir/assets/sendmail_template.txt")
    def sendmail_template = engine.createTemplate(sf).make(smail_fields)
    def sendmail_html = sendmail_template.toString()

    // Send the HTML e-mail
    if (email_address) {
            if (params.plaintext_email) { throw GroovyException('Send plaintext e-mail, not HTML') }
            // Try to send HTML e-mail using sendmail
            [ 'sendmail', '-t' ].execute() << sendmail_html
            log.info "[nf-core/hic] Sent summary e-mail to $email_address (sendmail)"
            // Catch failures and try with plaintext
            [ 'mail', '-s', subject, email_address ].execute() << email_txt
            log.info "[nf-core/hic] Sent summary e-mail to $email_address (mail)"
        }
    }

    // Write summary e-mail HTML to a file
    def output_d = new File("${params.outdir}/pipeline_info/")
    if (!output_d.exists()) {
        output_d.mkdirs()
    def output_hf = new File(output_d, "pipeline_report.html")
    output_hf.withWriter { w -> w << email_html }
    def output_tf = new File(output_d, "pipeline_report.txt")
    output_tf.withWriter { w -> w << email_txt }

nservant's avatar
nservant committed
    c_green = params.monochrome_logs ? '' : "\033[0;32m";
    c_purple = params.monochrome_logs ? '' : "\033[0;35m";
nservant's avatar
nservant committed
    c_red = params.monochrome_logs ? '' : "\033[0;31m";
    c_reset = params.monochrome_logs ? '' : "\033[0m";
nservant's avatar
nservant committed

nservant's avatar
nservant committed
    if (workflow.stats.ignoredCount > 0 && workflow.success) {
        log.info "-${c_purple}Warning, pipeline completed, but with errored process(es) ${c_reset}-"
        log.info "-${c_red}Number of ignored errored process(es) : ${workflow.stats.ignoredCount} ${c_reset}-"
        log.info "-${c_green}Number of successfully ran process(es) : ${workflow.stats.succeedCount} ${c_reset}-"
    if (workflow.success) {
        log.info "-${c_purple}[nf-core/hic]${c_green} Pipeline completed successfully${c_reset}-"
nservant's avatar
nservant committed
    } else {
        checkHostname()
        log.info "-${c_purple}[nf-core/hic]${c_red} Pipeline completed with errors${c_reset}-"
def nfcoreHeader() {
nservant's avatar
nservant committed
    // Log colors ANSI codes
    c_black = params.monochrome_logs ? '' : "\033[0;30m";
    c_blue = params.monochrome_logs ? '' : "\033[0;34m";
    c_cyan = params.monochrome_logs ? '' : "\033[0;36m";
    c_dim = params.monochrome_logs ? '' : "\033[2m";
    c_green = params.monochrome_logs ? '' : "\033[0;32m";
    c_purple = params.monochrome_logs ? '' : "\033[0;35m";
    c_reset = params.monochrome_logs ? '' : "\033[0m";
nservant's avatar
nservant committed
    c_white = params.monochrome_logs ? '' : "\033[0;37m";
    c_yellow = params.monochrome_logs ? '' : "\033[0;33m";
nservant's avatar
nservant committed

nservant's avatar
nservant committed
    return """    -${c_dim}--------------------------------------------------${c_reset}-
nservant's avatar
nservant committed
                                            ${c_green},--.${c_black}/${c_green},-.${c_reset}
    ${c_blue}        ___     __   __   __   ___     ${c_green}/,-._.--~\'${c_reset}
    ${c_blue}  |\\ | |__  __ /  ` /  \\ |__) |__         ${c_yellow}}  {${c_reset}
    ${c_blue}  | \\| |       \\__, \\__/ |  \\ |___     ${c_green}\\`-._,-`-,${c_reset}
                                            ${c_green}`._,._,\'${c_reset}
    ${c_purple}  nf-core/hic v${workflow.manifest.version}${c_reset}
nservant's avatar
nservant committed
    -${c_dim}--------------------------------------------------${c_reset}-
nservant's avatar
nservant committed
    """.stripIndent()