Skip to content
Snippets Groups Projects
Unverified Commit ef3ffb37 authored by Björn Langer's avatar Björn Langer Committed by GitHub
Browse files

Merge pull request #297 from JoseEspinosa/updates

Address review comments
parents a05e1aae 4760fc77
No related branches found
No related tags found
No related merge requests found
......@@ -3,5 +3,6 @@ work/
data/
results/
.DS_Store
testing/
testing*
*.pyc
......@@ -26,6 +26,10 @@
> Langmead, B. and Salzberg, S. L. 2012 Fast gapped-read alignment with Bowtie 2. Nature methods, 9(4), p. 357–359. doi: 10.1038/nmeth.1923.
- [Chromap](https://doi.org/10.1038/s41467-021-26865-w)
> Zhang H, Song L, Wang X, Cheng H, Wang C, Meyer CA, Liu T, Tang M, Aluru S, Yue F, Liu XS and Li H. Fast alignment and preprocessing of chromatin profiles with Chromap. Nature communications. 2021, 12(1), 1-6. doi: 10.1038/s41467-021-26865-w
- [deepTools](https://www.ncbi.nlm.nih.gov/pubmed/27079975/)
> Ramírez F, Ryan DP, Grüning B, Bhardwaj V, Kilpert F, Richter AS, Heyne S, Dündar F, Manke T. deepTools2: a next generation web server for deep-sequencing data analysis. Nucleic Acids Res. 2016 Jul 8;44(W1):W160-5. doi: 10.1093/nar/gkw257. Epub 2016 Apr 13. PubMed PMID: 27079975; PubMed Central PMCID: PMC4987876.
......@@ -83,10 +87,6 @@
> Love MI, Huber W, Anders S. Moderated estimation of fold change and dispersion for RNA-seq data with DESeq2. Genome Biol. 2014;15(12):550. PubMed PMID: 25516281; PubMed Central PMCID: PMC4302049.
- [vsn](https://bioconductor.org/packages/release/bioc/html/vsn.html)
> Wolfgang Huber, Anja von Heydebreck, Holger Sueltmann, Annemarie Poustka and Martin Vingron. Variance Stabilization Applied to Microarray Data Calibration and to the Quantification of Differential Expression. Bioinformatics 18, S96-S104 (2002).
- [UpSetR](https://CRAN.R-project.org/package=UpSetR)
> Nils Gehlenborg (2017). UpSetR: A More Scalable Alternative to Venn and Euler Diagrams for Visualizing Intersecting Sets.
......@@ -107,10 +107,6 @@
> Raivo Kolde (2018). pheatmap: Pretty Heatmaps.
- [lattice](https://cran.r-project.org/web/packages/lattice/index.html)
> Sarkar, Deepayan (2008) Lattice: Multivariate Data Visualization with R. Springer, New York. ISBN 978-0-387-75968-5.
- [RColorBrewer](https://CRAN.R-project.org/package=RColorBrewer)
> Erich Neuwirth (2014). RColorBrewer: ColorBrewer Palettes.
......@@ -119,9 +115,6 @@
> Trevor L Davis (2018). optparse: Command Line Option Parser.
- [xfun](https://CRAN.R-project.org/package=xfun)
> Yihui Xie (2018). xfun: Miscellaneous Functions by 'Yihui Xie'.
## Software packaging/containerisation tools
- [Anaconda](https://anaconda.com)
......
sample,fastq_1,fastq_2
SAMPLE_PAIRED_END,/path/to/fastq/files/AEG588A1_S1_L002_R1_001.fastq.gz,/path/to/fastq/files/AEG588A1_S1_L002_R2_001.fastq.gz
SAMPLE_SINGLE_END,/path/to/fastq/files/AEG588A4_S4_L003_R1_001.fastq.gz,
......@@ -510,7 +510,7 @@ if (!params.skip_plot_fingerprint) {
ext.args = { [
'--skipZeros',
"--numberOfSamples $params.fingerprint_bins",
"--labels $meta.ip $meta.control"
"--labels $meta.id $meta.control"
].join(' ').trim() }
ext.prefix = { "${meta.id}.mLb.clN" }
publishDir = [
......
......@@ -44,6 +44,9 @@ process MULTIQC {
path ('featurecounts/*')
path ('deseq2/*')
path ('deseq2/*')
output:
path "*multiqc_report.html", emit: report
path "*_data" , emit: data
......
......@@ -323,25 +323,6 @@
}
}
},
"deseq_qc_options": {
"title": "Differential analysis options",
"type": "object",
"fa_icon": "fas fa-not-equal",
"description": "Options to adjust differential analysis criteria.",
"properties": {
"deseq2_vst": {
"type": "boolean",
"description": "Use vst transformation instead of rlog with DESeq2.",
"help_text": "See [DESeq2 docs](http://bioconductor.org/packages/devel/bioc/vignettes/DESeq2/inst/doc/DESeq2.html#data-transformations-and-visualization).",
"fa_icon": "fas fa-dolly"
},
"skip_deseq2_qc": {
"type": "boolean",
"fa_icon": "fas fa-fast-forward",
"description": "Skip DESeq2 PCA and heatmap plotting."
}
}
},
"process_skipping_options": {
"title": "Process skipping options",
"type": "object",
......@@ -363,6 +344,12 @@
"description": "Skip Preseq.",
"fa_icon": "fas fa-fast-forward"
},
"deseq2_vst": {
"type": "boolean",
"description": "Use vst transformation instead of rlog with DESeq2.",
"help_text": "See [DESeq2 docs](http://bioconductor.org/packages/devel/bioc/vignettes/DESeq2/inst/doc/DESeq2.html#data-transformations-and-visualization).",
"fa_icon": "fas fa-dolly"
},
"skip_plot_profile": {
"type": "boolean",
"description": "Skip deepTools plotProfile.",
......@@ -378,6 +365,11 @@
"description": "Skip Phantompeakqualtools.",
"fa_icon": "fas fa-fast-forward"
},
"skip_deseq2_qc": {
"type": "boolean",
"fa_icon": "fas fa-fast-forward",
"description": "Skip DESeq2 PCA and heatmap plotting."
},
"skip_igv": {
"type": "boolean",
"description": "Skip IGV.",
......@@ -587,9 +579,6 @@
{
"$ref": "#/definitions/peak_calling_options"
},
{
"$ref": "#/definitions/deseq_qc_options"
},
{
"$ref": "#/definitions/process_skipping_options"
},
......
......@@ -507,6 +507,8 @@ workflow CHIPSEQ {
// Consensus peaks analysis
//
ch_macs2_consensus_bed_lib = Channel.empty()
ch_deseq2_pca_multiqc = Channel.empty()
ch_deseq2_clustering_multiqc = Channel.empty()
if (!params.skip_consensus_peaks) {
// Create channel: [ meta , [ peaks ] ]
// Where meta = [ id:antibody, multiple_groups:true/false, replicates_exist:true/false ]
......@@ -582,6 +584,8 @@ workflow CHIPSEQ {
ch_deseq2_pca_header,
ch_deseq2_clustering_header
)
ch_deseq2_pca_multiqc = DESEQ2_QC.out.pca_multiqc
ch_deseq2_clustering_multiqc = DESEQ2_QC.out.dists_multiqc
}
}
......@@ -654,9 +658,10 @@ workflow CHIPSEQ {
ch_custompeaks_frip_multiqc.collect{it[1]}.ifEmpty([]),
ch_custompeaks_count_multiqc.collect{it[1]}.ifEmpty([]),
ch_plothomerannotatepeaks_multiqc.collect{it[1]}.ifEmpty([]),
ch_subreadfeaturecounts_multiqc.collect{it[1]}.ifEmpty([])//,
// path ('macs/consensus/*') from ch_macs_consensus_deseq_mqc.collect().ifEmpty([])
ch_plothomerannotatepeaks_multiqc.collect().ifEmpty([]),
ch_subreadfeaturecounts_multiqc.collect{it[1]}.ifEmpty([]),
ch_deseq2_pca_multiqc.collect().ifEmpty([]),
ch_deseq2_clustering_multiqc.collect().ifEmpty([])
)
multiqc_report = MULTIQC.out.report.toList()
}
......
0% Loading or .
You are about to add 0 people to the discussion. Proceed with caution.
Please register or to comment