# This file contains everything to configure the workflow on a global scale. # The sample based data must be complemented by a samples.tsv file that contains # one row per sample. It can be parsed easily via pandas. samples: "config/samples.tsv" # The source of fastq files for every sequencing unit of all samples has to be provided in the units.tsv file. units: "config/units.tsv" single_end: True resources: ref: # Ensembl species name species: saccharomyces_cerevisiae # Ensembl release release: 101 # Genome build build: R64-1-1 # for testing data a single chromosome can be selected (leave empty for a regular analysis) chromosome: # specify release version number of igenomes list to use (see https://github.com/nf-core/chipseq/releases), e.g. 1.2.2 igenomes_release: 1.2.2 # if igenomes.yaml cannot be used, a value for the mappable or effective genome size can be specified here, e.g. macs-gsize: 2.7e9 macs-gsize: # if igenomes.yaml cannot be used, a path to an own blacklist can be specified here blacklist: trimming: threads: 2 se: "--adapter1 AGATCGGAAGAGCACACGTCTGAACTCCAGTCAC" pe: "--adapter1 AGATCGGAAGAGCACACGTCTGAACTCCAGTCAC --adapter2 AGATCGGAAGAGCGTCGTGTAGGGAAAGAGTGTAGATCTCGGTGGTCGCCGTATCATT" others: "--gzip --trimqualities --trimns --minlength 35" params: # Number of biological replicates required from a given condition for a peak to contribute to a consensus peak min-reps-consensus: 1 callpeak: p-value: 0.5 q-value: deeptools-plots: # when activated the plot profile and heatmap plot are generated, this involves a matrix calculation that requires a lot of working memory. activate: True lc_extrap: activate: False picard_metrics: activate: True peak-annotation-analysis: activate: True peak-qc: activate: True consensus-peak-analysis: # when more than one sample activate: False # samtools view parameter suggestions (for full parameters, see: https://www.htslib.org/doc/samtools-view.html): # if duplicates should be removed in this filtering, add "-F 0x0400" to the params # if for each read, you only want to retain a single (best) mapping, add "-q 1" to params # if you would like to restrict analysis to certain regions (e.g. excluding other "blacklisted" regions), # the -L option is automatically activated if a path to a blacklist of the given genome exists in the # downloaded "resources/ref/igenomes.yaml" or has been provided via the parameter # "config['resources']['ref']['blacklist']" in this configuration file samtools-view-se: "-b -F 0x004" samtools-view-pe: "-b -F 0x004 -G 0x009 -f 0x001" plotfingerprint: # --numberOfSamples parameter of deeptools plotFingerprint, see: https://deeptools.readthedocs.io/en/develop/content/tools/plotFingerprint.html#Optional%20arguments number-of-samples: 500000 # optional parameters for picard's CollectMultipleMetrics from sorted, filtered and merged bam files in post analysis step # see https://gatk.broadinstitute.org/hc/en-us/articles/360037594031-CollectMultipleMetrics-Picard- collect-multiple-metrics: VALIDATION_STRINGENCY=LENIENT bowtie_path: "/usr/local/bin/" db_bowtie_path: "/scratch/users/aginolhac/FastQ_Screen_Genomes/"