Skip to content
Snippets Groups Projects
Select Git revision
  • 705226a9482733c67c18c799cfe394cf7af2ecda
  • master default protected
  • tp_experimental_biologists
3 results

htseq.config

Blame
  • Forked from LBMC / nextflow
    Source project has a limited visibility.
    RNASeq.nf 791 B
    /*                     Cutadapt  Illumina adaptor removal                             */
    
    /*
    * for paired-end data
    */
    
    params.fastq = "$baseDir/data/fastq/*_{1,2}.fastq"
    
    log.info "fastq files : ${params.fastq}"
    
    Channel
      .fromFilePairs( params.fastq )
      .ifEmpty { error "Cannot find any fastq files matching: ${params.fastq}" }
      .set { fastq_files }
    
    process adaptor_removal {
      tag "$pair_id"
      publishDir "results/fastq/adaptor_removal/", mode: 'copy'
    
      input:
      set pair_id, file(reads) from fastq_files
    
      output:
      file "*_cut_R{1,2}.fastq.gz" into fastq_files_cut
    
      script:
      """
      cutadapt -a AGATCGGAAGAG -g CTCTTCCGATCT -A AGATCGGAAGAG -G CTCTTCCGATCT \
      -o ${pair_id}_cut_R1.fastq.gz -p ${pair_id}_cut_R2.fastq.gz \
      ${reads[0]} ${reads[1]} > ${pair_id}_report.txt
      """
    }