diff --git a/CHANGELOG.md b/CHANGELOG.md index a4adf8bdb..2e6ce3867 100644 --- a/CHANGELOG.md +++ b/CHANGELOG.md @@ -45,6 +45,7 @@ and this project adheres to [Semantic Versioning](https://semver.org/spec/v2.0.0 ### Enhancements & fixes - [PR #1374](https://github.com/nf-core/rnaseq/pull/1374) - Bump pipeline version to 3.16.0dev +- [PR #1379](https://github.com/nf-core/rnaseq/pull/1379) - Enhance pipeline level test snapshots - [PR #1380](https://github.com/nf-core/rnaseq/pull/1380) - Fix issues with R modules changing sample names - [PR #1381](https://github.com/nf-core/rnaseq/pull/1381) - Update all modules following massive conda usage update in nf-core modules - [PR #1382](https://github.com/nf-core/rnaseq/pull/1381) - Slight fixes for rnaseq preprocessing diff --git a/nf-test.config b/nf-test.config index 0f4cac519..c843dabec 100644 --- a/nf-test.config +++ b/nf-test.config @@ -13,5 +13,6 @@ config { // load the necessary plugins plugins { load "nft-bam@0.3.0" + load "nft-utils@0.0.2" } } diff --git a/tests/.nftignore b/tests/.nftignore new file mode 100644 index 000000000..dcbd8d8a8 --- /dev/null +++ b/tests/.nftignore @@ -0,0 +1,125 @@ +**/*DupRate_plot.{pdf,r} +**/*Log.out +**/*Log.{final,progress}.out +**/*_fastqc.{html,zip} +**/*_raw.{html,zip} +**/*_{duprateExpBoxplot,duprateExpDens,expressionHist}.{pdf,png,svg} +**/*bam_stat.txt +**/*coverage.gtf +**/*fastq.gz_trimming_report.txt +**/*featureCounts.txt.summary +**/*gene.abundance.txt +**/*hisat2.summary +**/*inner_distance* +**/*junction* +**/*markdup.sorted.MarkDuplicates.metrics.txt +**/*markdup.sorted.{bam,bam.bai} +**/*read_distribution.txt +**/*sorted.bam.{flagstat,idxstats,stats} +**/*sortmerna.log +**/*splice_{events,junction}.{pdf,png,svg} +**/*transcripts.gtf +**/*{cnt,model,theta} +**/*{css,gif,js} +**/*{forward,reverse}.bigWig +**/*{genes,isoforms}.results +**/*{pos,seq}.DupRate.xls +**/*{salmon,star_salmon,star_rsem}_deseq2_clustering-plot*{pdf,png,txt} +**/Junction*.png +**/Reads*.png +**/abundance.{h5,tsv} +**/cutadapt_filtered_reads_plot-{cnt,pct}.{pdf,svg} +**/cutadapt_trimmed_sequences_*{pdf,svg} +**/deseq2* +**/dupradar-section-plot.{pdf,svg} +**/fail_mapped_samples_table* +**/fail_strand_check_table* +**/fastqc-status-check-*{pdf,svg} +**/fastqc_adapter_content_plot.{pdf,png,svg} +**/fastqc_overrepresented_sequences_plot*{pdf,svg} +**/fastqc_per_base_*_plot*{pdf,png,svg} +**/fastqc_per_sequence_*{pdf,svg} +**/fastqc_sequence_length_distribution_plot.{pdf,png,svg} +**/fastqc_sequence_{counts,duplication_levels}_plot*{pdf,svg} +**/fastqc_top_overrepresented_sequences_table*{pdf,png,svg,txt} +**/featurecounts_biotype_plot-{cnt,pct}.{pdf,svg} +**/fld.gz +**/flenDist.txt +**/general_stats_table.{pdf,png,svg} +**/hisat2_pe_plot.txt +**/hisat2_se_plot*{png,svg} +**/hisat2_{pe,se}_plot-{cnt,pct}.{pdf,png,svg} +**/junction_saturation_known.txt +**/junction_saturation_novel.txt +**/kallisto_alignment*{pdf,png,svg} +**/kallisto_alignment.txt +**/kallisto_quant.log +**/meta_info.json +**/multiqc_data.json +**/multiqc_dupradar-section-plot.txt +**/multiqc_fail_strand_check_table.txt +**/multiqc_general_stats.txt +**/multiqc_hisat2.txt +**/multiqc_kallisto.txt +**/multiqc_picard_dups.txt +**/multiqc_plots +**/multiqc_report.html +**/multiqc_rsem.txt +**/multiqc_rseqc_bam_stat.txt +**/multiqc_rseqc_infer_experiment.txt +**/multiqc_rseqc_junction_annotation.txt +**/multiqc_rseqc_read_distribution.txt +**/multiqc_salmon.txt +**/multiqc_samtools_flagstat.txt +**/multiqc_samtools_stats.txt +**/multiqc_software_versions.txt +**/multiqc_sortmerna.txt +**/multiqc_sources.txt +**/multiqc_star.txt +**/multiqc_{salmon,star_salmon}_deseq2_pca-plot*txt +**/picard_deduplication-{cnt,pct}.{pdf,png,svg} +**/picard_deduplication.txt +**/qualimapReport.html +**/qualimap_gene_coverage_profile_Counts.{pdf,svg} +**/qualimap_gene_coverage_profile_Normalised.{pdf,svg} +**/qualimap_genomic_origin-{cnt,pct}.{pdf,png,svg} +**/qualimap_genomic_origin.txt +**/qualimap_rnaseq_genome_results.txt +**/quant.genes.sf +**/quant.sf +**/rnaseq_qc_results.txt +**/rsem_assignment_plot-{cnt,pct}.{pdf,png,svg} +**/rsem_assignment_plot.txt +**/rsem_multimapping_rates.{pdf,svg,txt} +**/rseqc_bam_stat.{pdf,png,svg,txt} +**/rseqc_infer_experiment_plot.{pdf,svg} +**/rseqc_inner_* +**/rseqc_junction_* +**/rseqc_read_distribution_* +**/rseqc_read_dups.txt +**/rseqc_read_dups_plot.txt +**/rseqc_read_dups_plot.{pdf,svg} +**/run_info.json +**/salmon_plot.{pdf,png,svg,txt} +**/salmon_quant.log +**/samtools-flagstat* +**/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.{pdf,svg} +**/samtools-idxstats-mapped-reads-plot_Normalised_Counts-{cnt,pct}.{pdf,svg} +**/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.{pdf,svg} +**/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-{cnt,pct}.{pdf,svg} +**/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.{pdf,svg} +**/samtools-idxstats-mapped-reads-plot_Raw_Counts-{cnt,pct}.{pdf,svg} +**/samtools-stats-dp.{pdf,png,svg,txt} +**/sortmerna-detailed-plot-{cnt,pct}.{pdf,svg} +**/sortmerna-detailed-plot.txt +**/star_summary_table.{pdf,png,svg,txt} +**/t_data.ctab +**/{kallisto,salmon}.merged* +**/{salmon,star_rsem}_deseq2_{clustering,pca}-plot.{pdf,png,svg} +**/{salmon,star_rsem}_deseq2_{pca,pca}-plot.{pdf,png,svg} +**/{samtools,star}_alignment_plot* +**/{star_rsem,star_salmon}_deseq2_{clustering,pca}-plot*{pdf,png,svg} +bbsplit/*.stats.txt +pipeline_info/*.{html,json,txt,yml} +**/deseq2_qc/size_factors/*.txt +star_rsem/log/*.log diff --git a/tests/default.nf.test b/tests/default.nf.test index 069bb846f..80b19646a 100644 --- a/tests/default.nf.test +++ b/tests/default.nf.test @@ -12,908 +12,22 @@ nextflow_pipeline { } then { + // stable_name: All files + folders in ${params.outdir}/ with a stable name + def stable_name = getAllFilesFromDir(params.outdir, true, ['pipeline_info/*.{html,json,txt}'], null) + // stable_path: All files in ${params.outdir}/ with stable content + def stable_path = getAllFilesFromDir(params.outdir, false, null, 'tests/.nftignore') assertAll( - { assert workflow.success }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/bbsplit/RAP1_IAA_30M_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/RAP1_UNINDUCED_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/RAP1_UNINDUCED_REP2.stats.txt").name, - file("${params.outdir}/bbsplit/WT_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/WT_REP2.stats.txt").name - ).match("bbsplit") }, - { assert snapshot( - path("${params.outdir}/custom/out/genome_gfp.fasta"), - path("${params.outdir}/custom/out/genome_gfp.gtf") - ).match("references") }, - { assert snapshot( - // HTMLs and ZIPs are not stable - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_2_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_2_fastqc.zip").name - ).match("fastqc/raw") }, - { assert snapshot( - // HTMLs and ZIPs are not stable - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.zip").name - ).match("fastqc/trim") }, - { assert snapshot( - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/cutadapt_filtered_reads_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc-status-check-heatmap-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc-status-check-heatmap.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_adapter_content_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_overrepresented_sequences_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_overrepresented_sequences_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_base_n_content_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_base_n_content_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_base_sequence_quality_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_base_sequence_quality_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Percentages.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Percentages.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_quality_scores_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_quality_scores_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_counts_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_counts_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_duplication_levels_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_duplication_levels_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_length_distribution_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_citations.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_cutadapt.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_fastqc_fastqc_raw.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_fastqc_fastqc_trimmed.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_featurecounts_biotype_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_samtools_idxstats.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_histogram.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_histogram_1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_histogram_2.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_gene_coverage_profile_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_gene_coverage_profile_Normalised.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_rnaseq_cov_hist.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_infer_experiment_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Raw_Counts.txt"), - // These files are not stable - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_top_overrepresented_sequences_table-1.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_top_overrepresented_sequences_table.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/junction_saturation_known.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/junction_saturation_novel.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_data.json").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_dupradar-section-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_fail_strand_check_table.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_general_stats.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_picard_dups.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_bam_stat.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_infer_experiment.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_junction_annotation.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_read_distribution.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_1.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_2.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_3.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_4.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_pca-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_samtools_flagstat.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_samtools_stats.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_software_versions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_sources.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_1.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_2.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_3.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_4.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_pca-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_deduplication.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_genomic_origin.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_rnaseq_genome_results.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_bam_stat.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance_plot_Counts.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance_plot_Percentages.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Events.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Junctions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_all.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_All_Junctions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_Known_Junctions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_Novel_Junctions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_read_distribution_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_read_dups.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_read_dups_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/salmon_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Percentage_of_total.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Read_counts.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-stats-dp.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools_alignment_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/star_alignment_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/star_summary_table.txt").name - ).match("multiqc_data") }, - { assert snapshot( - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/cutadapt_filtered_reads_plot-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/cutadapt_filtered_reads_plot-pct.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Counts.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Obs_Exp.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/dupradar-section-plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc-status-check-heatmap-1.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc-status-check-heatmap.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot-1.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Counts.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Percentages.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Counts.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Percentages.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot-1.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-pct.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-pct.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot-1.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/featurecounts_biotype_plot-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/featurecounts_biotype_plot-pct.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/qualimap_gene_coverage_profile_Counts.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/qualimap_gene_coverage_profile_Normalised.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_infer_experiment_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_dups_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png"), - // PDFs, SVGs, some PNGs and HTML reports are not stable - file("${params.outdir}/multiqc/star_salmon/multiqc_report.html").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/dupradar-section-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fail_strand_check_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc-status-check-heatmap-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc-status-check-heatmap.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_adapter_content_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Percentages.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Percentages.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_length_distribution_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/featurecounts_biotype_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/featurecounts_biotype_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/general_stats_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Normalised.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_genomic_origin-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_genomic_origin-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_bam_stat.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_infer_experiment_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Percentages.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_All_Junctions.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Known_Junctions.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Novel_Junctions.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_distribution_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_distribution_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_dups_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/salmon_deseq2_clustering-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/salmon_deseq2_pca-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/salmon_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Percentage_of_total.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Read_counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-stats-dp.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_salmon_deseq2_clustering-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_salmon_deseq2_pca-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_summary_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fail_strand_check_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_adapter_content_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_n_content_plot-1.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_n_content_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot-1.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_length_distribution_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table-1.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/general_stats_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/qualimap_genomic_origin-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/qualimap_genomic_origin-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_bam_stat.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_inner_distance_plot_Counts.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_inner_distance_plot_Percentages.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_All_Junctions.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_Known_Junctions.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_Novel_Junctions.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_distribution_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_distribution_plot-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/salmon_deseq2_clustering-plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/salmon_deseq2_pca-plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/salmon_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Percentage_of_total.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Read_counts.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-stats-dp.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_salmon_deseq2_clustering-plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_salmon_deseq2_pca-plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_summary_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/dupradar-section-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fail_strand_check_table.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc-status-check-heatmap-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc-status-check-heatmap.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_adapter_content_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_n_content_plot-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_n_content_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Percentages.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Percentages.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_length_distribution_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/featurecounts_biotype_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/featurecounts_biotype_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/general_stats_table.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Normalised.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/qualimap_genomic_origin-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/qualimap_genomic_origin-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_bam_stat.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_infer_experiment_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_inner_distance_plot_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_inner_distance_plot_Percentages.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_All_Junctions.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Known_Junctions.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Novel_Junctions.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_distribution_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_distribution_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_dups_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/salmon_deseq2_clustering-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/salmon_deseq2_pca-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/salmon_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Percentage_of_total.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Read_counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-stats-dp.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_salmon_deseq2_clustering-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_salmon_deseq2_pca-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_summary_table.svg").name - ).match("multiqc_plots") }, - { assert snapshot( - path("${params.outdir}/salmon/deseq2_qc/R_sessionInfo.log"), - // These files are not stable - file("${params.outdir}/salmon/deseq2_qc/deseq2.dds.RData").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.pca.vals.txt").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.plots.pdf").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.sample.dists.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/WT_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/WT_REP2.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/deseq2.size_factors.RData").name - ).match("salmon/deseq2_qc") }, - { assert snapshot( - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/lib_format_counts.json"), - path("${params.outdir}/salmon/WT_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/WT_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/WT_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/WT_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/WT_REP1/cmd_info.json"), - path("${params.outdir}/salmon/WT_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/WT_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/WT_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/WT_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/WT_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/WT_REP2/cmd_info.json"), - path("${params.outdir}/salmon/WT_REP2/lib_format_counts.json"), - // These files are not stable - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/quant.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/quant.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/quant.sf").name, - file("${params.outdir}/salmon/WT_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/WT_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/WT_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/WT_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/WT_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/WT_REP1/quant.sf").name, - file("${params.outdir}/salmon/WT_REP2/aux_info/fld.gz").name, - file("${params.outdir}/salmon/WT_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/WT_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/WT_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/WT_REP2/quant.genes.sf").name, - file("${params.outdir}/salmon/WT_REP2/quant.sf").name - ).match("salmon_quant") }, - { assert snapshot( - path("${params.outdir}/salmon/tx2gene.tsv"), - // These files are not stable - file("${params.outdir}/salmon/salmon.merged.gene_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_length_scaled.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_scaled.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_lengths.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_tpm.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.transcript_counts.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_lengths.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_tpm.tsv").name - ).match("salmon") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/star_salmon/bigwig/RAP1_IAA_30M_REP1.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_IAA_30M_REP1.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP1.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP1.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP2.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP2.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/WT_REP1.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/WT_REP1.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/WT_REP2.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/WT_REP2.reverse.bigWig").name - ).match("star_salmon/bigwig") }, - { assert snapshot( - path("${params.outdir}/star_salmon/deseq2_qc/R_sessionInfo.log"), - // These files are not stable - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/WT_REP1.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/WT_REP2.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/deseq2.size_factors.RData").name, - file("${params.outdir}/star_salmon/deseq2_qc/deseq2.dds.RData").name, - file("${params.outdir}/star_salmon/deseq2_qc/deseq2.pca.vals.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/deseq2.plots.pdf").name, - file("${params.outdir}/star_salmon/deseq2_qc/deseq2.sample.dists.txt").name - ).match("star_salmon/deseq2_qc") }, - { assert snapshot( - path("${params.outdir}/star_salmon/dupradar/gene_data/RAP1_IAA_30M_REP1_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/gene_data/RAP1_UNINDUCED_REP1_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/gene_data/RAP1_UNINDUCED_REP2_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/gene_data/WT_REP1_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/gene_data/WT_REP2_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/RAP1_IAA_30M_REP1_intercept_slope.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/RAP1_UNINDUCED_REP1_intercept_slope.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/RAP1_UNINDUCED_REP2_intercept_slope.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/WT_REP1_intercept_slope.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/WT_REP2_intercept_slope.txt"), - // PDFs are not stable - file("${params.outdir}/star_salmon/dupradar/box_plot/RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/box_plot/RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/box_plot/RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/box_plot/WT_REP1_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/box_plot/WT_REP2_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/RAP1_IAA_30M_REP1_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/RAP1_UNINDUCED_REP1_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/RAP1_UNINDUCED_REP2_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/WT_REP1_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/WT_REP2_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/RAP1_IAA_30M_REP1_duprateExpDens.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/RAP1_UNINDUCED_REP1_duprateExpDens.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/RAP1_UNINDUCED_REP2_duprateExpDens.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/WT_REP1_duprateExpDens.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/WT_REP2_duprateExpDens.pdf").name - ).match("star_salmon/dupradar") }, - { assert snapshot( - path("${params.outdir}/star_salmon/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt"), - path("${params.outdir}/star_salmon/featurecounts/WT_REP1.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/WT_REP1.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/WT_REP1.featureCounts.txt"), - path("${params.outdir}/star_salmon/featurecounts/WT_REP2.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/WT_REP2.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/WT_REP2.featureCounts.txt"), - // These files are unstable - file("${params.outdir}/star_salmon/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt.summary").name, - file("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt.summary").name, - file("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt.summary").name, - file("${params.outdir}/star_salmon/featurecounts/WT_REP1.featureCounts.txt.summary").name, - file("${params.outdir}/star_salmon/featurecounts/WT_REP2.featureCounts.txt.summary").name - ).match("star_salmon/featurecounts") }, - { assert snapshot( - path("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/WT_REP1.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/WT_REP2.SJ.out.tab"), - // Logs are not stable - file("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.Log.final.out").name, - file("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.Log.out").name, - file("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.Log.final.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.Log.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.Log.final.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.Log.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/WT_REP1.Log.final.out").name, - file("${params.outdir}/star_salmon/log/WT_REP1.Log.out").name, - file("${params.outdir}/star_salmon/log/WT_REP1.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/WT_REP2.Log.final.out").name, - file("${params.outdir}/star_salmon/log/WT_REP2.Log.out").name, - file("${params.outdir}/star_salmon/log/WT_REP2.Log.progress.out").name - ).match("star_salmon/log") }, - { assert snapshot( - // Metrics are not stable - file("${params.outdir}/star_salmon/picard_metrics/RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt").name - ).match("star_salmon/picard_metrics") }, - { assert snapshot( - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - // HTML reports and these files are not stable - file("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP1/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP1/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP2/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP2/rnaseq_qc_results.txt").name - ).match("star_salmon/qualimap") }, - { assert snapshot( - path("${params.outdir}/star_salmon/rseqc/infer_experiment/RAP1_IAA_30M_REP1.infer_experiment.txt"), - path("${params.outdir}/star_salmon/rseqc/infer_experiment/RAP1_UNINDUCED_REP1.infer_experiment.txt"), - path("${params.outdir}/star_salmon/rseqc/infer_experiment/RAP1_UNINDUCED_REP2.infer_experiment.txt"), - path("${params.outdir}/star_salmon/rseqc/infer_experiment/WT_REP1.infer_experiment.txt"), - path("${params.outdir}/star_salmon/rseqc/infer_experiment/WT_REP2.infer_experiment.txt"), - // PDFs, R scripts and all these files are not stable - file("${params.outdir}/star_salmon/rseqc/bam_stat/RAP1_IAA_30M_REP1.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/bam_stat/RAP1_UNINDUCED_REP1.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/bam_stat/RAP1_UNINDUCED_REP2.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/bam_stat/WT_REP1.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/bam_stat/WT_REP2.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/pdf/RAP1_IAA_30M_REP1.inner_distance_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/pdf/WT_REP1.inner_distance_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/pdf/WT_REP2.inner_distance_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/rscript/RAP1_IAA_30M_REP1.inner_distance_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/rscript/WT_REP1.inner_distance_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/rscript/WT_REP2.inner_distance_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_freq.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_mean.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance_freq.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance_mean.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance_freq.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance_mean.txt").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/WT_REP1.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/WT_REP1.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/WT_REP2.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/WT_REP2.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/RAP1_IAA_30M_REP1.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP1.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP2.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/WT_REP1.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/WT_REP2.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/WT_REP1.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/WT_REP1.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/WT_REP2.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/WT_REP2.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/RAP1_IAA_30M_REP1.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP1.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP2.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/WT_REP1.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/WT_REP2.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/RAP1_IAA_30M_REP1.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP1.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP2.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/WT_REP1.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/WT_REP2.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/WT_REP1.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/WT_REP2.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/RAP1_IAA_30M_REP1.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP1.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP2.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/WT_REP1.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/WT_REP2.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/RAP1_IAA_30M_REP1.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/RAP1_UNINDUCED_REP1.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/RAP1_UNINDUCED_REP2.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/WT_REP1.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/WT_REP2.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/RAP1_IAA_30M_REP1.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP1.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP2.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/WT_REP1.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/WT_REP2.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/RAP1_IAA_30M_REP1.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP1.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP2.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/WT_REP1.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/WT_REP2.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.seq.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.seq.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.seq.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/WT_REP1.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/WT_REP1.seq.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/WT_REP2.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/WT_REP2.seq.DupRate.xls").name - ).match("star_salmon/rseqc") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/star_salmon/salmon.merged.gene_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_length_scaled.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_scaled.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_lengths.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_tpm.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_counts.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_lengths.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_tpm.tsv").name - ).match("star_salmon/salmon") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.sorted.bam.stats").name - ).match("star_salmon/samtools_stats") }, - { assert snapshot( - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/i_data.ctab"), - // These files are not stable - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP1.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP1.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP1.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP2.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP2.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP2.transcripts.gtf").name - ).match("star_salmon/stringtie") }, - { assert snapshot( - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/WT_REP1.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/WT_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/WT_REP2.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/WT_REP2.markdup.sorted.bam.bai").name - ).match("star_salmon/markdup") }, - { assert snapshot( - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/cmd_info.json"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/cmd_info.json"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/cmd_info.json"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/WT_REP1/cmd_info.json"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/WT_REP2/cmd_info.json"), - path("${params.outdir}/star_salmon/tx2gene.tsv"), - // These files are not stable - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/quant.genes.sf").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/quant.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/quant.genes.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/quant.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/quant.genes.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/quant.sf").name, - file("${params.outdir}/star_salmon/WT_REP1/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/WT_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/WT_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/WT_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/WT_REP1/quant.genes.sf").name, - file("${params.outdir}/star_salmon/WT_REP1/quant.sf").name, - file("${params.outdir}/star_salmon/WT_REP2/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/WT_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/WT_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/WT_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/WT_REP2/quant.genes.sf").name, - file("${params.outdir}/star_salmon/WT_REP2/quant.sf").name - ).match("star_salmon/salmon_quant") }, - { assert snapshot( - // These reports are not stable - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt").name - ).match("trimgalore") }, - { assert snapshot( - UTILS.removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml") - ).match("versions") } + { assert workflow.success}, + { assert snapshot( + // Number of successful tasks + workflow.trace.succeeded().size(), + // pipeline versions.yml file for multiqc from which Nextflow version is removed because we tests pipelines on multiple Nextflow versions + removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), + // All stable path name, with a relative path + getRelativePath(stable_name, outputDir), + // All files with stable contents + stable_path + ).match() } ) } } @@ -929,31 +43,21 @@ nextflow_pipeline { } then { + // stable_name: All files + folders in ${params.outdir}/ with a stable name + def stable_name = getAllFilesFromDir(params.outdir, true, ['pipeline_info/*.{html,json,txt}'], null) + // stable_path: All files in ${params.outdir}/ with stable content + def stable_path = getAllFilesFromDir(params.outdir, false, null, 'tests/.nftignore') assertAll( - { assert workflow.success }, - { assert snapshot( - UTILS.removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), - file("${params.outdir}/custom/out/genome_transcriptome.fasta").name, - file("${params.outdir}/custom/out/genome_transcriptome.gtf").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw.zip").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report.html").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt").name + { assert workflow.success}, + { assert snapshot( + // Number of successful tasks + workflow.trace.succeeded().size(), + // pipeline versions.yml file for multiqc from which Nextflow version is removed because we tests pipelines on multiple Nextflow versions + removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), + // All stable path name, with a relative path + getRelativePath(stable_name, outputDir), + // All files with stable contents + stable_path ).match() } ) } diff --git a/tests/default.nf.test.snap b/tests/default.nf.test.snap index 79b3ca290..13dccd5f5 100644 --- a/tests/default.nf.test.snap +++ b/tests/default.nf.test.snap @@ -1,1080 +1,1598 @@ { - "star_salmon/log": { - "content": [ - "RAP1_IAA_30M_REP1.SJ.out.tab:md5,ea95e243278af55534f2c52eb5fff7ee", - "RAP1_UNINDUCED_REP1.SJ.out.tab:md5,e548d13942535dc0821f3ec6d9743ec8", - "RAP1_UNINDUCED_REP2.SJ.out.tab:md5,1f294365343a1a5e95682792fdb77033", - "WT_REP1.SJ.out.tab:md5,1350c2fa6a675bf107386c6cd3fc5204", - "WT_REP2.SJ.out.tab:md5,f6cc03643a5e3c1025a5b4754eb1be23", - "RAP1_IAA_30M_REP1.Log.final.out", - "RAP1_IAA_30M_REP1.Log.out", - "RAP1_IAA_30M_REP1.Log.progress.out", - "RAP1_UNINDUCED_REP1.Log.final.out", - "RAP1_UNINDUCED_REP1.Log.out", - "RAP1_UNINDUCED_REP1.Log.progress.out", - "RAP1_UNINDUCED_REP2.Log.final.out", - "RAP1_UNINDUCED_REP2.Log.out", - "RAP1_UNINDUCED_REP2.Log.progress.out", - "WT_REP1.Log.final.out", - "WT_REP1.Log.out", - "WT_REP1.Log.progress.out", - "WT_REP2.Log.final.out", - "WT_REP2.Log.out", - "WT_REP2.Log.progress.out" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T14:57:58.85709" - }, - "star_salmon/salmon_quant": { - "content": [ - "ambig_info.tsv:md5,f9a605d54a0a103566f7a9b8e0867a73", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,4cc2492f557e5e0a2911a0bd83a51020", - "ambig_info.tsv:md5,8f97be8af4e47cc48650c62227a40203", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,dc750c3564c63da54979c852794d58a5", - "ambig_info.tsv:md5,a044fe7a3ad445c9a91a0d54ab5015d1", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,db43ed650e6e7b42cd2c5b8101bb6748", - "ambig_info.tsv:md5,7a8ea02d74058efb801e8c62bca96fd4", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,e418b4e899623449c6babdf53e5aabde", - "ambig_info.tsv:md5,543a047a549437026a1363ea8ddf5b03", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,f234c8d322df3b59d990594c63b24eae", - "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T13:24:55.413942" - }, - "trimgalore": { - "content": [ - "RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T13:59:56.824816" - }, - "star_salmon/rseqc": { - "content": [ - "RAP1_IAA_30M_REP1.infer_experiment.txt:md5,169d25b95c008bebe9ce886fea6a4e33", - "RAP1_UNINDUCED_REP1.infer_experiment.txt:md5,2ca0ce0fd3204bd2cc4812c4655b1f1f", - "RAP1_UNINDUCED_REP2.infer_experiment.txt:md5,7d5705880188f9beab1939e08d6b8f40", - "WT_REP1.infer_experiment.txt:md5,bf0c137f5fca06e7c40e1984a1acb06d", - "WT_REP2.infer_experiment.txt:md5,82e23b329ee60709f343bc2d17d43b14", - "RAP1_IAA_30M_REP1.bam_stat.txt", - "RAP1_UNINDUCED_REP1.bam_stat.txt", - "RAP1_UNINDUCED_REP2.bam_stat.txt", - "WT_REP1.bam_stat.txt", - "WT_REP2.bam_stat.txt", - "RAP1_IAA_30M_REP1.inner_distance_plot.pdf", - "WT_REP1.inner_distance_plot.pdf", - "WT_REP2.inner_distance_plot.pdf", - "RAP1_IAA_30M_REP1.inner_distance_plot.r", - "WT_REP1.inner_distance_plot.r", - "WT_REP2.inner_distance_plot.r", - "RAP1_IAA_30M_REP1.inner_distance.txt", - "RAP1_IAA_30M_REP1.inner_distance_freq.txt", - "RAP1_IAA_30M_REP1.inner_distance_mean.txt", - "WT_REP1.inner_distance.txt", - "WT_REP1.inner_distance_freq.txt", - "WT_REP1.inner_distance_mean.txt", - "WT_REP2.inner_distance.txt", - "WT_REP2.inner_distance_freq.txt", - "WT_REP2.inner_distance_mean.txt", - "RAP1_IAA_30M_REP1.junction.Interact.bed", - "RAP1_IAA_30M_REP1.junction.bed", - "RAP1_UNINDUCED_REP1.junction.Interact.bed", - "RAP1_UNINDUCED_REP1.junction.bed", - "RAP1_UNINDUCED_REP2.junction.Interact.bed", - "RAP1_UNINDUCED_REP2.junction.bed", - "WT_REP1.junction.Interact.bed", - "WT_REP1.junction.bed", - "WT_REP2.junction.Interact.bed", - "WT_REP2.junction.bed", - "RAP1_IAA_30M_REP1.junction_annotation.log", - "RAP1_UNINDUCED_REP1.junction_annotation.log", - "RAP1_UNINDUCED_REP2.junction_annotation.log", - "WT_REP1.junction_annotation.log", - "WT_REP2.junction_annotation.log", - "RAP1_IAA_30M_REP1.splice_events.pdf", - "RAP1_IAA_30M_REP1.splice_junction.pdf", - "RAP1_UNINDUCED_REP1.splice_events.pdf", - "RAP1_UNINDUCED_REP1.splice_junction.pdf", - "RAP1_UNINDUCED_REP2.splice_events.pdf", - "RAP1_UNINDUCED_REP2.splice_junction.pdf", - "WT_REP1.splice_events.pdf", - "WT_REP1.splice_junction.pdf", - "WT_REP2.splice_events.pdf", - "WT_REP2.splice_junction.pdf", - "RAP1_IAA_30M_REP1.junction_plot.r", - "RAP1_UNINDUCED_REP1.junction_plot.r", - "RAP1_UNINDUCED_REP2.junction_plot.r", - "WT_REP1.junction_plot.r", - "WT_REP2.junction_plot.r", - "RAP1_IAA_30M_REP1.junction.xls", - "RAP1_UNINDUCED_REP1.junction.xls", - "RAP1_UNINDUCED_REP2.junction.xls", - "WT_REP1.junction.xls", - "WT_REP2.junction.xls", - "RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf", - "RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf", - "RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf", - "WT_REP1.junctionSaturation_plot.pdf", - "WT_REP2.junctionSaturation_plot.pdf", - "RAP1_IAA_30M_REP1.junctionSaturation_plot.r", - "RAP1_UNINDUCED_REP1.junctionSaturation_plot.r", - "RAP1_UNINDUCED_REP2.junctionSaturation_plot.r", - "WT_REP1.junctionSaturation_plot.r", - "WT_REP2.junctionSaturation_plot.r", - "RAP1_IAA_30M_REP1.read_distribution.txt", - "RAP1_UNINDUCED_REP1.read_distribution.txt", - "RAP1_UNINDUCED_REP2.read_distribution.txt", - "WT_REP1.read_distribution.txt", - "WT_REP2.read_distribution.txt", - "RAP1_IAA_30M_REP1.DupRate_plot.pdf", - "RAP1_UNINDUCED_REP1.DupRate_plot.pdf", - "RAP1_UNINDUCED_REP2.DupRate_plot.pdf", - "WT_REP1.DupRate_plot.pdf", - "WT_REP2.DupRate_plot.pdf", - "RAP1_IAA_30M_REP1.DupRate_plot.r", - "RAP1_UNINDUCED_REP1.DupRate_plot.r", - "RAP1_UNINDUCED_REP2.DupRate_plot.r", - "WT_REP1.DupRate_plot.r", - "WT_REP2.DupRate_plot.r", - "RAP1_IAA_30M_REP1.pos.DupRate.xls", - "RAP1_IAA_30M_REP1.seq.DupRate.xls", - "RAP1_UNINDUCED_REP1.pos.DupRate.xls", - "RAP1_UNINDUCED_REP1.seq.DupRate.xls", - "RAP1_UNINDUCED_REP2.pos.DupRate.xls", - "RAP1_UNINDUCED_REP2.seq.DupRate.xls", - "WT_REP1.pos.DupRate.xls", - "WT_REP1.seq.DupRate.xls", - "WT_REP2.pos.DupRate.xls", - "WT_REP2.seq.DupRate.xls" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T12:44:57.857714" - }, - "references": { - "content": [ - "genome_gfp.fasta:md5,e23e302af63736a199985a169fdac055", - "genome_gfp.gtf:md5,c98b12c302f15731bfc36bcf297cfe28" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T13:59:53.18077" - }, - "star_salmon/samtools_stats": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.stats", - "RAP1_IAA_30M_REP1.sorted.bam.flagstat", - "RAP1_IAA_30M_REP1.sorted.bam.idxstats", - "RAP1_IAA_30M_REP1.sorted.bam.stats", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats", - "RAP1_UNINDUCED_REP1.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP1.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP1.sorted.bam.stats", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats", - "RAP1_UNINDUCED_REP2.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP2.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP2.sorted.bam.stats", - "WT_REP1.markdup.sorted.bam.flagstat", - "WT_REP1.markdup.sorted.bam.idxstats", - "WT_REP1.markdup.sorted.bam.stats", - "WT_REP1.sorted.bam.flagstat", - "WT_REP1.sorted.bam.idxstats", - "WT_REP1.sorted.bam.stats", - "WT_REP2.markdup.sorted.bam.flagstat", - "WT_REP2.markdup.sorted.bam.idxstats", - "WT_REP2.markdup.sorted.bam.stats", - "WT_REP2.sorted.bam.flagstat", - "WT_REP2.sorted.bam.idxstats", - "WT_REP2.sorted.bam.stats" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T18:42:17.143005" - }, "Params: default - stub": { "content": [ - "{BBMAP_BBSPLIT={bbmap=39.01}, CAT_FASTQ={cat=8.3}, CUSTOM_CATADDITIONALFASTA={python=null}, CUSTOM_GETCHROMSIZES={getchromsizes=1.2}, FASTQC={fastqc=0.12.1}, GTF2BED={perl=5.26.2}, GTF_FILTER={python=3.9.5}, GUNZIP_ADDITIONAL_FASTA={gunzip=1.1}, GUNZIP_GTF={gunzip=1.1}, STAR_GENOMEGENERATE={star=2.7.10a, samtools=1.18, gawk=5.1.0}, TRIMGALORE={trimgalore=0.6.7, cutadapt=3.4}, UNTAR_SALMON_INDEX={untar=1.34}, Workflow={nf-core/rnaseq=v3.16.0dev}}", - "genome_transcriptome.fasta", - "genome_transcriptome.gtf", - "RAP1_IAA_30M_REP1_raw.html", - "RAP1_IAA_30M_REP1_raw.zip", - "RAP1_UNINDUCED_REP1_raw.html", - "RAP1_UNINDUCED_REP1_raw.zip", - "RAP1_UNINDUCED_REP2_raw.html", - "RAP1_UNINDUCED_REP2_raw.zip", - "WT_REP1_raw.html", - "WT_REP1_raw.zip", - "WT_REP2_raw.html", - "WT_REP2_raw.zip", - "multiqc_report.html", - "RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T14:00:48.949429" - }, - "multiqc_plots": { - "content": [ - "cutadapt_filtered_reads_plot-cnt.png:md5,704cf0d91bfa3dd658dd8c9590f669a2", - "cutadapt_filtered_reads_plot-pct.png:md5,2684d8b2afca3300e5786486b80237f0", - "cutadapt_trimmed_sequences_plot_3_Counts.png:md5,bef41d894629b0c4dab4478bbf197f50", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.png:md5,1e0d01537d3797623d0b3fd8fbe42787", - "dupradar-section-plot.png:md5,3ae5e5cb161b7abd878d718bc71b41f6", - "fastqc-status-check-heatmap-1.png:md5,2402522f8c02e12aea9af088c6595890", - "fastqc-status-check-heatmap.png:md5,fe8b5b4ab4480d46a12a9005932a9b84", - "fastqc_overrepresented_sequences_plot-1.png:md5,40e450251b80ec0efc9364434234ec7f", - "fastqc_overrepresented_sequences_plot.png:md5,6f5ffbdf1bf61fabe5e028c8bc85de14", - "fastqc_per_sequence_gc_content_plot-1_Counts.png:md5,8a806cec2142f9911502e0a253d83d13", - "fastqc_per_sequence_gc_content_plot-1_Percentages.png:md5,953929d50c8490029880e205e4db7959", - "fastqc_per_sequence_gc_content_plot_Counts.png:md5,01f124545af788fd5cc7bbf41b005e16", - "fastqc_per_sequence_gc_content_plot_Percentages.png:md5,eba3abf8bedb2cb20bad90c54e9c8881", - "fastqc_per_sequence_quality_scores_plot-1.png:md5,d2c29cae169f35744500c751b4a7366e", - "fastqc_per_sequence_quality_scores_plot.png:md5,42fd7369a8aca78f620164a9e887c3cb", - "fastqc_sequence_counts_plot-1-cnt.png:md5,2874fea747c7ff46828bf4f17668caf8", - "fastqc_sequence_counts_plot-1-pct.png:md5,0022d7f5ac78b6eff157de24e37c5ab0", - "fastqc_sequence_counts_plot-cnt.png:md5,3890d5555f2a39b46b9f6efb14cb91f2", - "fastqc_sequence_counts_plot-pct.png:md5,55fa5838c8b2db978fcfa5cb83f6b054", - "fastqc_sequence_duplication_levels_plot-1.png:md5,fcd3b1ec2b95fe4bcd607dc28179a754", - "fastqc_sequence_duplication_levels_plot.png:md5,747431f0f38f8e4c41a11a072fa18780", - "featurecounts_biotype_plot-cnt.png:md5,4c66fce934b018143e7b8f6a1383d3f6", - "featurecounts_biotype_plot-pct.png:md5,9191dc2dd130f22ad404d27e045d2304", - "qualimap_gene_coverage_profile_Counts.png:md5,ac424dc7e5444a32e482bd5048ac4432", - "qualimap_gene_coverage_profile_Normalised.png:md5,62e5a2146daec985b8c2de02e3b57c1e", - "rseqc_infer_experiment_plot.png:md5,60c3cafb671fad2cf5f695615230eb8f", - "rseqc_read_dups_plot.png:md5,958513925fa5494bf499c989842d6928", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png:md5,ce6abb232fd5b5f2e66c0fe9a571d75f", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png:md5,6b44818f886ef020fb3646f152ad4af6", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png:md5,d5d8a85b7ad72a0cb93d9283ea12b23f", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png:md5,19317ad8f1448cd7eb1d319f85cc5c4d", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png:md5,a6849cd92ae738441212b681a411614d", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png:md5,4c06988372df63a1fb5f8be93f73ae8f", - "multiqc_report.html", - "cutadapt_filtered_reads_plot-cnt.pdf", - "cutadapt_filtered_reads_plot-pct.pdf", - "cutadapt_trimmed_sequences_plot_3_Counts.pdf", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf", - "dupradar-section-plot.pdf", - "fail_strand_check_table.pdf", - "fastqc-status-check-heatmap-1.pdf", - "fastqc-status-check-heatmap.pdf", - "fastqc_adapter_content_plot.pdf", - "fastqc_overrepresented_sequences_plot-1.pdf", - "fastqc_overrepresented_sequences_plot.pdf", - "fastqc_per_base_n_content_plot-1.pdf", - "fastqc_per_base_n_content_plot.pdf", - "fastqc_per_base_sequence_quality_plot-1.pdf", - "fastqc_per_base_sequence_quality_plot.pdf", - "fastqc_per_sequence_gc_content_plot-1_Counts.pdf", - "fastqc_per_sequence_gc_content_plot-1_Percentages.pdf", - "fastqc_per_sequence_gc_content_plot_Counts.pdf", - "fastqc_per_sequence_gc_content_plot_Percentages.pdf", - "fastqc_per_sequence_quality_scores_plot-1.pdf", - "fastqc_per_sequence_quality_scores_plot.pdf", - "fastqc_sequence_counts_plot-1-cnt.pdf", - "fastqc_sequence_counts_plot-1-pct.pdf", - "fastqc_sequence_counts_plot-cnt.pdf", - "fastqc_sequence_counts_plot-pct.pdf", - "fastqc_sequence_duplication_levels_plot-1.pdf", - "fastqc_sequence_duplication_levels_plot.pdf", - "fastqc_sequence_length_distribution_plot.pdf", - "fastqc_top_overrepresented_sequences_table-1.pdf", - "fastqc_top_overrepresented_sequences_table.pdf", - "featurecounts_biotype_plot-cnt.pdf", - "featurecounts_biotype_plot-pct.pdf", - "general_stats_table.pdf", - "picard_deduplication-cnt.pdf", - "picard_deduplication-pct.pdf", - "qualimap_gene_coverage_profile_Counts.pdf", - "qualimap_gene_coverage_profile_Normalised.pdf", - "qualimap_genomic_origin-cnt.pdf", - "qualimap_genomic_origin-pct.pdf", - "rseqc_bam_stat.pdf", - "rseqc_infer_experiment_plot.pdf", - "rseqc_inner_distance_plot_Counts.pdf", - "rseqc_inner_distance_plot_Percentages.pdf", - "rseqc_junction_annotation_junctions_plot_Events-cnt.pdf", - "rseqc_junction_annotation_junctions_plot_Events-pct.pdf", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf", - "rseqc_junction_saturation_plot_All_Junctions.pdf", - "rseqc_junction_saturation_plot_Known_Junctions.pdf", - "rseqc_junction_saturation_plot_Novel_Junctions.pdf", - "rseqc_read_distribution_plot-cnt.pdf", - "rseqc_read_distribution_plot-pct.pdf", - "rseqc_read_dups_plot.pdf", - "salmon_deseq2_clustering-plot.pdf", - "salmon_deseq2_pca-plot.pdf", - "salmon_plot.pdf", - "samtools-flagstat-dp_Percentage_of_total.pdf", - "samtools-flagstat-dp_Read_counts.pdf", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf", - "samtools-stats-dp.pdf", - "samtools_alignment_plot-cnt.pdf", - "samtools_alignment_plot-pct.pdf", - "star_alignment_plot-cnt.pdf", - "star_alignment_plot-pct.pdf", - "star_salmon_deseq2_clustering-plot.pdf", - "star_salmon_deseq2_pca-plot.pdf", - "star_summary_table.pdf", - "fail_strand_check_table.png", - "fastqc_adapter_content_plot.png", - "fastqc_per_base_n_content_plot-1.png", - "fastqc_per_base_n_content_plot.png", - "fastqc_per_base_sequence_quality_plot-1.png", - "fastqc_per_base_sequence_quality_plot.png", - "fastqc_sequence_length_distribution_plot.png", - "fastqc_top_overrepresented_sequences_table-1.png", - "fastqc_top_overrepresented_sequences_table.png", - "general_stats_table.png", - "picard_deduplication-cnt.png", - "picard_deduplication-pct.png", - "qualimap_genomic_origin-cnt.png", - "qualimap_genomic_origin-pct.png", - "rseqc_bam_stat.png", - "rseqc_inner_distance_plot_Counts.png", - "rseqc_inner_distance_plot_Percentages.png", - "rseqc_junction_annotation_junctions_plot_Events-cnt.png", - "rseqc_junction_annotation_junctions_plot_Events-pct.png", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.png", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.png", - "rseqc_junction_saturation_plot_All_Junctions.png", - "rseqc_junction_saturation_plot_Known_Junctions.png", - "rseqc_junction_saturation_plot_Novel_Junctions.png", - "rseqc_read_distribution_plot-cnt.png", - "rseqc_read_distribution_plot-pct.png", - "salmon_deseq2_clustering-plot.png", - "salmon_deseq2_pca-plot.png", - "salmon_plot.png", - "samtools-flagstat-dp_Percentage_of_total.png", - "samtools-flagstat-dp_Read_counts.png", - "samtools-stats-dp.png", - "samtools_alignment_plot-cnt.png", - "samtools_alignment_plot-pct.png", - "star_alignment_plot-cnt.png", - "star_alignment_plot-pct.png", - "star_salmon_deseq2_clustering-plot.png", - "star_salmon_deseq2_pca-plot.png", - "star_summary_table.png", - "cutadapt_filtered_reads_plot-cnt.svg", - "cutadapt_filtered_reads_plot-pct.svg", - "cutadapt_trimmed_sequences_plot_3_Counts.svg", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg", - "dupradar-section-plot.svg", - "fail_strand_check_table.svg", - "fastqc-status-check-heatmap-1.svg", - "fastqc-status-check-heatmap.svg", - "fastqc_adapter_content_plot.svg", - "fastqc_overrepresented_sequences_plot-1.svg", - "fastqc_overrepresented_sequences_plot.svg", - "fastqc_per_base_n_content_plot-1.svg", - "fastqc_per_base_n_content_plot.svg", - "fastqc_per_base_sequence_quality_plot-1.svg", - "fastqc_per_base_sequence_quality_plot.svg", - "fastqc_per_sequence_gc_content_plot-1_Counts.svg", - "fastqc_per_sequence_gc_content_plot-1_Percentages.svg", - "fastqc_per_sequence_gc_content_plot_Counts.svg", - "fastqc_per_sequence_gc_content_plot_Percentages.svg", - "fastqc_per_sequence_quality_scores_plot-1.svg", - "fastqc_per_sequence_quality_scores_plot.svg", - "fastqc_sequence_counts_plot-1-cnt.svg", - "fastqc_sequence_counts_plot-1-pct.svg", - "fastqc_sequence_counts_plot-cnt.svg", - "fastqc_sequence_counts_plot-pct.svg", - "fastqc_sequence_duplication_levels_plot-1.svg", - "fastqc_sequence_duplication_levels_plot.svg", - "fastqc_sequence_length_distribution_plot.svg", - "fastqc_top_overrepresented_sequences_table-1.svg", - "fastqc_top_overrepresented_sequences_table.svg", - "featurecounts_biotype_plot-cnt.svg", - "featurecounts_biotype_plot-pct.svg", - "general_stats_table.svg", - "picard_deduplication-cnt.svg", - "picard_deduplication-pct.svg", - "qualimap_gene_coverage_profile_Counts.svg", - "qualimap_gene_coverage_profile_Normalised.svg", - "qualimap_genomic_origin-cnt.svg", - "qualimap_genomic_origin-pct.svg", - "rseqc_bam_stat.svg", - "rseqc_infer_experiment_plot.svg", - "rseqc_inner_distance_plot_Counts.svg", - "rseqc_inner_distance_plot_Percentages.svg", - "rseqc_junction_annotation_junctions_plot_Events-cnt.svg", - "rseqc_junction_annotation_junctions_plot_Events-pct.svg", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.svg", - "rseqc_junction_saturation_plot_All_Junctions.svg", - "rseqc_junction_saturation_plot_Known_Junctions.svg", - "rseqc_junction_saturation_plot_Novel_Junctions.svg", - "rseqc_read_distribution_plot-cnt.svg", - "rseqc_read_distribution_plot-pct.svg", - "rseqc_read_dups_plot.svg", - "salmon_deseq2_clustering-plot.svg", - "salmon_deseq2_pca-plot.svg", - "salmon_plot.svg", - "samtools-flagstat-dp_Percentage_of_total.svg", - "samtools-flagstat-dp_Read_counts.svg", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg", - "samtools-stats-dp.svg", - "samtools_alignment_plot-cnt.svg", - "samtools_alignment_plot-pct.svg", - "star_alignment_plot-cnt.svg", - "star_alignment_plot-pct.svg", - "star_salmon_deseq2_clustering-plot.svg", - "star_salmon_deseq2_pca-plot.svg", - "star_summary_table.svg" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T18:42:16.932219" - }, - "fastqc/raw": { - "content": [ - "RAP1_IAA_30M_REP1_raw_1_fastqc.html", - "RAP1_IAA_30M_REP1_raw_1_fastqc.zip", - "RAP1_IAA_30M_REP1_raw_2_fastqc.html", - "RAP1_IAA_30M_REP1_raw_2_fastqc.zip", - "RAP1_UNINDUCED_REP1_raw_fastqc.html", - "RAP1_UNINDUCED_REP1_raw_fastqc.zip", - "RAP1_UNINDUCED_REP2_raw_fastqc.html", - "RAP1_UNINDUCED_REP2_raw_fastqc.zip", - "WT_REP1_raw_1_fastqc.html", - "WT_REP1_raw_1_fastqc.zip", - "WT_REP1_raw_2_fastqc.html", - "WT_REP1_raw_2_fastqc.zip", - "WT_REP2_raw_1_fastqc.html", - "WT_REP2_raw_1_fastqc.zip", - "WT_REP2_raw_2_fastqc.html", - "WT_REP2_raw_2_fastqc.zip" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T13:59:53.196519" - }, - "star_salmon/stringtie": { - "content": [ - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,3f149502efe2a9d4bac98b1dd18c15e7", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,a052ab04070e72cc318fb7680b0764e3", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,e82329a443b9ff50a86e42aff91bd704", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,d279003d92f7feef9adb31203f84474a", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,10e2d00f93f9e74f224bd3c1bfbeb29b", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,525413b70bcf62c24c8f96182e09883e", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,9aa371befc36478d7720d3ea275e6f4d", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,907ab2e06346df131cbdb929afc005a8", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,b03f3118d1aa58fceadcb3311028e856", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,041edee3193df311f621c09f4991892b", - "t_data.ctab", - "RAP1_IAA_30M_REP1.coverage.gtf", - "RAP1_IAA_30M_REP1.gene.abundance.txt", - "RAP1_IAA_30M_REP1.transcripts.gtf", - "t_data.ctab", - "RAP1_UNINDUCED_REP1.coverage.gtf", - "RAP1_UNINDUCED_REP1.gene.abundance.txt", - "RAP1_UNINDUCED_REP1.transcripts.gtf", - "t_data.ctab", - "RAP1_UNINDUCED_REP2.coverage.gtf", - "RAP1_UNINDUCED_REP2.gene.abundance.txt", - "RAP1_UNINDUCED_REP2.transcripts.gtf", - "t_data.ctab", - "WT_REP1.coverage.gtf", - "WT_REP1.gene.abundance.txt", - "WT_REP1.transcripts.gtf", - "t_data.ctab", - "WT_REP2.coverage.gtf", - "WT_REP2.gene.abundance.txt", - "WT_REP2.transcripts.gtf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T15:35:08.116582" - }, - "salmon_quant": { - "content": [ - "ambig_info.tsv:md5,de973a4b22a4457217ae3dc04caf9401", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,1215f0c20f87d3aef8553ef119e1e74c", - "lib_format_counts.json:md5,c24ffe28d70476b5ccdd8bc2d22c0ac1", - "ambig_info.tsv:md5,45f252b4f0e11e6730cf0c29f800fdbb", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,621c6601aade5b1f2e3d6ca2fc71f636", - "lib_format_counts.json:md5,f6d44c0221f7fd559f11a9afe04c9935", - "ambig_info.tsv:md5,6dcc2891ea572e9b8d1ba52cd434ab84", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,9bed6e4dc5428d6f6297adcea29a6326", - "lib_format_counts.json:md5,7c562bf2f70e42f3a7292687dfd328c3", - "ambig_info.tsv:md5,194f574e0586416155e3f33d42e2b167", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,c7ed0aaa5d6c7934ddbebfd29e4eb86d", - "lib_format_counts.json:md5,d46250bb3677d72feeefc435fe6395a6", - "ambig_info.tsv:md5,a26e3f936e65d7da66392603c2f91f6f", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,69ebfc2c7ca6b221a0a22fa1dc8c20ac", - "lib_format_counts.json:md5,088fd51db07022ffde47033bbd029400", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T13:59:53.950437" - }, - "multiqc_data": { - "content": [ - "cutadapt_filtered_reads_plot.txt:md5,bf033e64e9d23bee85b6277f11c663f1", - "cutadapt_trimmed_sequences_plot_3_Counts.txt:md5,13dfa866fd91dbb072689efe9aa83b1f", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt:md5,07145dd8dd3db654859b18eb0389046c", - "fastqc-status-check-heatmap-1.txt:md5,22a03548736b88b23be6bc0c9ef1b4a6", - "fastqc-status-check-heatmap.txt:md5,5a89b0d8d162f6b1dbdaf39457bbc03b", - "fastqc_adapter_content_plot.txt:md5,da0389be84cfdd189b1d045212eb2974", - "fastqc_overrepresented_sequences_plot-1.txt:md5,4adfeacd3a3a6c7c808f121b24e6b247", - "fastqc_overrepresented_sequences_plot.txt:md5,25d88ea8a72f55e8a374ae802bc7f0b1", - "fastqc_per_base_n_content_plot-1.txt:md5,418610c1ce119cb786ad434db75d366e", - "fastqc_per_base_n_content_plot.txt:md5,d368d7e36ca2f73dcde61f2b486d8213", - "fastqc_per_base_sequence_quality_plot-1.txt:md5,bd22e06e41c096ad4f745d40fe96a1e5", - "fastqc_per_base_sequence_quality_plot.txt:md5,5c3065b549129702b185ea1b817da420", - "fastqc_per_sequence_gc_content_plot-1_Counts.txt:md5,004c60768ceb6197765154e3eaa37b7a", - "fastqc_per_sequence_gc_content_plot-1_Percentages.txt:md5,95d29060b687f745288ad1ec47750037", - "fastqc_per_sequence_gc_content_plot_Counts.txt:md5,9ddaa50167117d3c9188ccf015427704", - "fastqc_per_sequence_gc_content_plot_Percentages.txt:md5,f10ee2881b61308af35f304aa3d810a3", - "fastqc_per_sequence_quality_scores_plot-1.txt:md5,0f9834cc19f76dd5c87cf8cba7435a7c", - "fastqc_per_sequence_quality_scores_plot.txt:md5,b5f9a02933e3065952237afd2ec9ce82", - "fastqc_sequence_counts_plot-1.txt:md5,3861354bbedfbde7ca36a72994f9425c", - "fastqc_sequence_counts_plot.txt:md5,d385a3e2c2573a0902c66e8c93876d3c", - "fastqc_sequence_duplication_levels_plot-1.txt:md5,c73407d55fc532e864fa1dc8dbc12874", - "fastqc_sequence_duplication_levels_plot.txt:md5,8812cee16f6ca65e2c33635754de1772", - "fastqc_sequence_length_distribution_plot.txt:md5,6fe2c985606abad947bcca99b015ae33", - "multiqc_citations.txt:md5,2d2ab6df367e36e98e081c33dec187a0", - "multiqc_cutadapt.txt:md5,aac9581a5670cb55edf564f3d6c1f9a7", - "multiqc_fastqc_fastqc_raw.txt:md5,81c3c1a2575a1891a7f2a9637a0f2cc0", - "multiqc_fastqc_fastqc_trimmed.txt:md5,a3238f515e01d158d875d69968753804", - "multiqc_featurecounts_biotype_plot.txt:md5,56be7f0813c3cbea0f68f61d9b355b71", - "multiqc_samtools_idxstats.txt:md5,fd7d03a91f0b9e01a6939941f7f2243f", - "picard_histogram.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "picard_histogram_1.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "picard_histogram_2.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "qualimap_gene_coverage_profile_Counts.txt:md5,02044ed1bf1eca19a8a87c9971cdc049", - "qualimap_gene_coverage_profile_Normalised.txt:md5,eeeea7f50278b3b335bef545784abbfa", - "qualimap_rnaseq_cov_hist.txt:md5,51407e597076f3a7f98622213bea6bce", - "rseqc_infer_experiment_plot.txt:md5,de5a0bad9cca763928e7c33375eb5218", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt:md5,75acd04232d1804b5f960ee4c5db4722", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt:md5,ae45731d8d4595f77e6b271004f3a070", - "samtools-idxstats-mapped-reads-plot_Raw_Counts.txt:md5,01637c600d3840500851eb4118564cc6", - "fastqc_top_overrepresented_sequences_table-1.txt", - "fastqc_top_overrepresented_sequences_table.txt", - "junction_saturation_known.txt", - "junction_saturation_novel.txt", - "multiqc_data.json", - "multiqc_dupradar-section-plot.txt", - "multiqc_fail_strand_check_table.txt", - "multiqc_general_stats.txt", - "multiqc_picard_dups.txt", - "multiqc_rseqc_bam_stat.txt", - "multiqc_rseqc_infer_experiment.txt", - "multiqc_rseqc_junction_annotation.txt", - "multiqc_rseqc_read_distribution.txt", - "multiqc_salmon.txt", - "multiqc_salmon_deseq2_clustering-plot.txt", - "multiqc_salmon_deseq2_clustering-plot_1.txt", - "multiqc_salmon_deseq2_clustering-plot_2.txt", - "multiqc_salmon_deseq2_clustering-plot_3.txt", - "multiqc_salmon_deseq2_clustering-plot_4.txt", - "multiqc_salmon_deseq2_pca-plot.txt", - "multiqc_samtools_flagstat.txt", - "multiqc_samtools_stats.txt", - "multiqc_software_versions.txt", - "multiqc_sources.txt", - "multiqc_star.txt", - "multiqc_star_salmon_deseq2_clustering-plot.txt", - "multiqc_star_salmon_deseq2_clustering-plot_1.txt", - "multiqc_star_salmon_deseq2_clustering-plot_2.txt", - "multiqc_star_salmon_deseq2_clustering-plot_3.txt", - "multiqc_star_salmon_deseq2_clustering-plot_4.txt", - "multiqc_star_salmon_deseq2_pca-plot.txt", - "picard_deduplication.txt", - "qualimap_genomic_origin.txt", - "qualimap_rnaseq_genome_results.txt", - "rseqc_bam_stat.txt", - "rseqc_inner_distance.txt", - "rseqc_inner_distance_plot_Counts.txt", - "rseqc_inner_distance_plot_Percentages.txt", - "rseqc_junction_annotation_junctions_plot_Events.txt", - "rseqc_junction_annotation_junctions_plot_Junctions.txt", - "rseqc_junction_saturation_all.txt", - "rseqc_junction_saturation_plot_All_Junctions.txt", - "rseqc_junction_saturation_plot_Known_Junctions.txt", - "rseqc_junction_saturation_plot_Novel_Junctions.txt", - "rseqc_read_distribution_plot.txt", - "rseqc_read_dups.txt", - "rseqc_read_dups_plot.txt", - "salmon_plot.txt", - "samtools-flagstat-dp_Percentage_of_total.txt", - "samtools-flagstat-dp_Read_counts.txt", - "samtools-stats-dp.txt", - "samtools_alignment_plot.txt", - "star_alignment_plot.txt", - "star_summary_table.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T18:42:16.785525" - }, - "star_salmon/deseq2_qc": { - "content": [ - "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", - "RAP1_IAA_30M_REP1.txt", - "RAP1_UNINDUCED_REP1.txt", - "RAP1_UNINDUCED_REP2.txt", - "WT_REP1.txt", - "WT_REP2.txt", - "deseq2.size_factors.RData", - "deseq2.dds.RData", - "deseq2.pca.vals.txt", - "deseq2.plots.pdf", - "deseq2.sample.dists.txt" + 22, + { + "BBMAP_BBSPLIT": { + "bbmap": 39.01 + }, + "CAT_FASTQ": { + "cat": 8.3 + }, + "CUSTOM_CATADDITIONALFASTA": { + "python": null + }, + "CUSTOM_GETCHROMSIZES": { + "getchromsizes": 1.2 + }, + "FASTQC": { + "fastqc": "0.12.1" + }, + "GTF2BED": { + "perl": "5.26.2" + }, + "GTF_FILTER": { + "python": "3.9.5" + }, + "GUNZIP_ADDITIONAL_FASTA": { + "gunzip": 1.1 + }, + "GUNZIP_GTF": { + "gunzip": 1.1 + }, + "STAR_GENOMEGENERATE": { + "star": "2.7.10a", + "samtools": 1.18, + "gawk": "5.1.0" + }, + "TRIMGALORE": { + "trimgalore": "0.6.7", + "cutadapt": 3.4 + }, + "UNTAR_SALMON_INDEX": { + "untar": 1.34 + }, + "Workflow": { + "nf-core/rnaseq": "v3.16.0dev" + } + }, + [ + "custom", + "custom/out", + "custom/out/genome_transcriptome.fasta", + "custom/out/genome_transcriptome.gtf", + "fastqc", + "fastqc/raw", + "fastqc/raw/RAP1_IAA_30M_REP1_raw.html", + "fastqc/raw/RAP1_IAA_30M_REP1_raw.zip", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw.html", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw.zip", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw.html", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw.zip", + "fastqc/raw/WT_REP1_raw.html", + "fastqc/raw/WT_REP1_raw.zip", + "fastqc/raw/WT_REP2_raw.html", + "fastqc/raw/WT_REP2_raw.zip", + "fastqc/trim", + "multiqc", + "multiqc/star_salmon", + "multiqc/star_salmon/multiqc_data", + "multiqc/star_salmon/multiqc_plots", + "multiqc/star_salmon/multiqc_report.html", + "pipeline_info", + "pipeline_info/nf_core_rnaseq_software_mqc_versions.yml", + "trimgalore", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" + ], + [ + "genome_transcriptome.fasta:md5,d41d8cd98f00b204e9800998ecf8427e", + "genome_transcriptome.gtf:md5,d41d8cd98f00b204e9800998ecf8427e" + ] ], "meta": { "nf-test": "0.9.0", "nextflow": "24.04.4" }, - "timestamp": "2024-08-23T12:20:39.105655" + "timestamp": "2024-10-02T07:30:25.608093" }, - "star_salmon/markdup": { + "Params: default": { "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.bam", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.bai", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai", - "WT_REP1.markdup.sorted.bam", - "WT_REP1.markdup.sorted.bam.bai", - "WT_REP2.markdup.sorted.bam", - "WT_REP2.markdup.sorted.bam.bai" + 198, + { + "BBMAP_BBSPLIT": { + "bbmap": 39.01 + }, + "BEDTOOLS_GENOMECOV_FW": { + "bedtools": "2.31.1" + }, + "CAT_FASTQ": { + "cat": 8.3 + }, + "CUSTOM_CATADDITIONALFASTA": { + "python": "3.9.5" + }, + "CUSTOM_GETCHROMSIZES": { + "getchromsizes": 1.2 + }, + "CUSTOM_TX2GENE": { + "python": "3.9.5" + }, + "DESEQ2_QC_PSEUDO": { + "r-base": "4.0.3", + "bioconductor-deseq2": "1.28.0" + }, + "DESEQ2_QC_STAR_SALMON": { + "r-base": "4.0.3", + "bioconductor-deseq2": "1.28.0" + }, + "DUPRADAR": { + "bioconductor-dupradar": "1.32.0" + }, + "FASTQC": { + "fastqc": "0.12.1" + }, + "FQ_SUBSAMPLE": { + "fq": "0.9.1 (2022-02-22)" + }, + "GTF2BED": { + "perl": "5.26.2" + }, + "GTF_FILTER": { + "python": "3.9.5" + }, + "GUNZIP_ADDITIONAL_FASTA": { + "gunzip": 1.1 + }, + "GUNZIP_GTF": { + "gunzip": 1.1 + }, + "MULTIQC_CUSTOM_BIOTYPE": { + "python": "3.9.5" + }, + "PICARD_MARKDUPLICATES": { + "picard": "3.1.1" + }, + "QUALIMAP_RNASEQ": { + "qualimap": 2.3 + }, + "RSEQC_BAMSTAT": { + "rseqc": "5.0.2" + }, + "RSEQC_INFEREXPERIMENT": { + "rseqc": "5.0.2" + }, + "RSEQC_INNERDISTANCE": { + "rseqc": "5.0.2" + }, + "RSEQC_JUNCTIONANNOTATION": { + "rseqc": "5.0.2" + }, + "RSEQC_JUNCTIONSATURATION": { + "rseqc": "5.0.2" + }, + "RSEQC_READDISTRIBUTION": { + "rseqc": "5.0.2" + }, + "RSEQC_READDUPLICATION": { + "rseqc": "5.0.2" + }, + "SALMON_QUANT": { + "salmon": "1.10.1" + }, + "SAMTOOLS_FLAGSTAT": { + "samtools": 1.2 + }, + "SAMTOOLS_IDXSTATS": { + "samtools": 1.2 + }, + "SAMTOOLS_INDEX": { + "samtools": 1.2 + }, + "SAMTOOLS_SORT": { + "samtools": 1.2 + }, + "SAMTOOLS_STATS": { + "samtools": 1.2 + }, + "SE_GENE": { + "bioconductor-summarizedexperiment": "1.32.0" + }, + "STAR_ALIGN": { + "star": "2.7.10a", + "samtools": 1.18, + "gawk": "5.1.0" + }, + "STAR_GENOMEGENERATE": { + "star": "2.7.10a", + "samtools": 1.18, + "gawk": "5.1.0" + }, + "STRINGTIE_STRINGTIE": { + "stringtie": "2.2.1" + }, + "SUBREAD_FEATURECOUNTS": { + "subread": "2.0.1" + }, + "TRIMGALORE": { + "trimgalore": "0.6.7", + "cutadapt": 3.4 + }, + "TXIMETA_TXIMPORT": { + "bioconductor-tximeta": "1.20.1" + }, + "UCSC_BEDCLIP": { + "ucsc": 377 + }, + "UCSC_BEDGRAPHTOBIGWIG": { + "ucsc": 445 + }, + "UNTAR_SALMON_INDEX": { + "untar": 1.34 + }, + "Workflow": { + "nf-core/rnaseq": "v3.16.0dev" + } + }, + [ + "bbsplit", + "bbsplit/RAP1_IAA_30M_REP1.stats.txt", + "bbsplit/RAP1_UNINDUCED_REP1.stats.txt", + "bbsplit/RAP1_UNINDUCED_REP2.stats.txt", + "bbsplit/WT_REP1.stats.txt", + "bbsplit/WT_REP2.stats.txt", + "custom", + "custom/out", + "custom/out/genome_gfp.fasta", + "custom/out/genome_gfp.gtf", + "fastqc", + "fastqc/raw", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.html", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.zip", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.html", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.zip", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.html", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.zip", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.html", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.zip", + "fastqc/raw/WT_REP1_raw_1_fastqc.html", + "fastqc/raw/WT_REP1_raw_1_fastqc.zip", + "fastqc/raw/WT_REP1_raw_2_fastqc.html", + "fastqc/raw/WT_REP1_raw_2_fastqc.zip", + "fastqc/raw/WT_REP2_raw_1_fastqc.html", + "fastqc/raw/WT_REP2_raw_1_fastqc.zip", + "fastqc/raw/WT_REP2_raw_2_fastqc.html", + "fastqc/raw/WT_REP2_raw_2_fastqc.zip", + "fastqc/trim", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip", + "fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html", + "fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip", + "fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html", + "fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip", + "fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.html", + "fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.html", + "fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.zip", + "fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.html", + "fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.html", + "fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.zip", + "multiqc", + "multiqc/star_salmon", + "multiqc/star_salmon/multiqc_report.html", + "multiqc/star_salmon/multiqc_report_data", + "multiqc/star_salmon/multiqc_report_data/cutadapt_filtered_reads_plot.txt", + "multiqc/star_salmon/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc-status-check-heatmap-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc-status-check-heatmap.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_adapter_content_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_overrepresented_sequences_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_overrepresented_sequences_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_base_n_content_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_base_n_content_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_base_sequence_quality_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_base_sequence_quality_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Percentages.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Percentages.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_quality_scores_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_quality_scores_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_counts_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_counts_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_duplication_levels_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_duplication_levels_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_length_distribution_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_top_overrepresented_sequences_table-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_top_overrepresented_sequences_table.txt", + "multiqc/star_salmon/multiqc_report_data/junction_saturation_known.txt", + "multiqc/star_salmon/multiqc_report_data/junction_saturation_novel.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_citations.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_cutadapt.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_data.json", + "multiqc/star_salmon/multiqc_report_data/multiqc_dupradar-section-plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_fail_strand_check_table.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_fastqc_fastqc_raw.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_fastqc_fastqc_trimmed.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_featurecounts_biotype_plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_general_stats.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_picard_dups.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_bam_stat.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_infer_experiment.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_junction_annotation.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_read_distribution.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_1.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_2.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_3.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_4.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_pca-plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_samtools_flagstat.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_samtools_idxstats.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_samtools_stats.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_software_versions.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_sources.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_1.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_2.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_3.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_4.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_pca-plot.txt", + "multiqc/star_salmon/multiqc_report_data/picard_deduplication.txt", + "multiqc/star_salmon/multiqc_report_data/picard_histogram.txt", + "multiqc/star_salmon/multiqc_report_data/picard_histogram_1.txt", + "multiqc/star_salmon/multiqc_report_data/picard_histogram_2.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_gene_coverage_profile_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_gene_coverage_profile_Normalised.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_genomic_origin.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_rnaseq_cov_hist.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_rnaseq_genome_results.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_bam_stat.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_infer_experiment_plot.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance_plot_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance_plot_Percentages.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Events.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Junctions.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_all.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_All_Junctions.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_Known_Junctions.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_Novel_Junctions.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_read_distribution_plot.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_read_dups.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_read_dups_plot.txt", + "multiqc/star_salmon/multiqc_report_data/salmon_plot.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Percentage_of_total.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Read_counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Raw_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-stats-dp.txt", + "multiqc/star_salmon/multiqc_report_data/samtools_alignment_plot.txt", + "multiqc/star_salmon/multiqc_report_data/star_alignment_plot.txt", + "multiqc/star_salmon/multiqc_report_data/star_summary_table.txt", + "multiqc/star_salmon/multiqc_report_plots", + "multiqc/star_salmon/multiqc_report_plots/pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/dupradar-section-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fail_strand_check_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc-status-check-heatmap-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc-status-check-heatmap.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_adapter_content_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Percentages.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Percentages.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_length_distribution_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/featurecounts_biotype_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/featurecounts_biotype_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/general_stats_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Normalised.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_genomic_origin-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_genomic_origin-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_bam_stat.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_infer_experiment_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Percentages.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_All_Junctions.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Known_Junctions.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Novel_Junctions.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_distribution_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_distribution_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_dups_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/salmon_deseq2_clustering-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/salmon_deseq2_pca-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/salmon_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Percentage_of_total.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Read_counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-stats-dp.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_salmon_deseq2_clustering-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_salmon_deseq2_pca-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_summary_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/png", + "multiqc/star_salmon/multiqc_report_plots/png/cutadapt_filtered_reads_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/cutadapt_filtered_reads_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Obs_Exp.png", + "multiqc/star_salmon/multiqc_report_plots/png/dupradar-section-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fail_strand_check_table.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc-status-check-heatmap-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc-status-check-heatmap.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_adapter_content_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_n_content_plot-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_n_content_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Percentages.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Percentages.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_length_distribution_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table.png", + "multiqc/star_salmon/multiqc_report_plots/png/featurecounts_biotype_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/featurecounts_biotype_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/general_stats_table.png", + "multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/qualimap_gene_coverage_profile_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/qualimap_gene_coverage_profile_Normalised.png", + "multiqc/star_salmon/multiqc_report_plots/png/qualimap_genomic_origin-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/qualimap_genomic_origin-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_bam_stat.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_infer_experiment_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_inner_distance_plot_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_inner_distance_plot_Percentages.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_All_Junctions.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_Known_Junctions.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_Novel_Junctions.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_distribution_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_distribution_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_dups_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/salmon_deseq2_clustering-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/salmon_deseq2_pca-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/salmon_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Percentage_of_total.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Read_counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-stats-dp.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_salmon_deseq2_clustering-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_salmon_deseq2_pca-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_summary_table.png", + "multiqc/star_salmon/multiqc_report_plots/svg", + "multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/dupradar-section-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fail_strand_check_table.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc-status-check-heatmap-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc-status-check-heatmap.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_adapter_content_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_n_content_plot-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_n_content_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Percentages.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Percentages.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_length_distribution_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/featurecounts_biotype_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/featurecounts_biotype_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/general_stats_table.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Normalised.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/qualimap_genomic_origin-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/qualimap_genomic_origin-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_bam_stat.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_infer_experiment_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_inner_distance_plot_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_inner_distance_plot_Percentages.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_All_Junctions.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Known_Junctions.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Novel_Junctions.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_distribution_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_distribution_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_dups_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/salmon_deseq2_clustering-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/salmon_deseq2_pca-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/salmon_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Percentage_of_total.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Read_counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-stats-dp.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_salmon_deseq2_clustering-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_salmon_deseq2_pca-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_summary_table.svg", + "pipeline_info", + "pipeline_info/nf_core_rnaseq_software_mqc_versions.yml", + "salmon", + "salmon/RAP1_IAA_30M_REP1", + "salmon/RAP1_IAA_30M_REP1/aux_info", + "salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv", + "salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json", + "salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz", + "salmon/RAP1_IAA_30M_REP1/cmd_info.json", + "salmon/RAP1_IAA_30M_REP1/libParams", + "salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt", + "salmon/RAP1_IAA_30M_REP1/lib_format_counts.json", + "salmon/RAP1_IAA_30M_REP1/logs", + "salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log", + "salmon/RAP1_IAA_30M_REP1/quant.genes.sf", + "salmon/RAP1_IAA_30M_REP1/quant.sf", + "salmon/RAP1_UNINDUCED_REP1", + "salmon/RAP1_UNINDUCED_REP1/aux_info", + "salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv", + "salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json", + "salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz", + "salmon/RAP1_UNINDUCED_REP1/cmd_info.json", + "salmon/RAP1_UNINDUCED_REP1/libParams", + "salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt", + "salmon/RAP1_UNINDUCED_REP1/lib_format_counts.json", + "salmon/RAP1_UNINDUCED_REP1/logs", + "salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log", + "salmon/RAP1_UNINDUCED_REP1/quant.genes.sf", + "salmon/RAP1_UNINDUCED_REP1/quant.sf", + "salmon/RAP1_UNINDUCED_REP2", + "salmon/RAP1_UNINDUCED_REP2/aux_info", + "salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv", + "salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json", + "salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz", + "salmon/RAP1_UNINDUCED_REP2/cmd_info.json", + "salmon/RAP1_UNINDUCED_REP2/libParams", + "salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt", + "salmon/RAP1_UNINDUCED_REP2/lib_format_counts.json", + "salmon/RAP1_UNINDUCED_REP2/logs", + "salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log", + "salmon/RAP1_UNINDUCED_REP2/quant.genes.sf", + "salmon/RAP1_UNINDUCED_REP2/quant.sf", + "salmon/WT_REP1", + "salmon/WT_REP1/aux_info", + "salmon/WT_REP1/aux_info/ambig_info.tsv", + "salmon/WT_REP1/aux_info/expected_bias.gz", + "salmon/WT_REP1/aux_info/fld.gz", + "salmon/WT_REP1/aux_info/meta_info.json", + "salmon/WT_REP1/aux_info/observed_bias.gz", + "salmon/WT_REP1/aux_info/observed_bias_3p.gz", + "salmon/WT_REP1/cmd_info.json", + "salmon/WT_REP1/libParams", + "salmon/WT_REP1/libParams/flenDist.txt", + "salmon/WT_REP1/lib_format_counts.json", + "salmon/WT_REP1/logs", + "salmon/WT_REP1/logs/salmon_quant.log", + "salmon/WT_REP1/quant.genes.sf", + "salmon/WT_REP1/quant.sf", + "salmon/WT_REP2", + "salmon/WT_REP2/aux_info", + "salmon/WT_REP2/aux_info/ambig_info.tsv", + "salmon/WT_REP2/aux_info/expected_bias.gz", + "salmon/WT_REP2/aux_info/fld.gz", + "salmon/WT_REP2/aux_info/meta_info.json", + "salmon/WT_REP2/aux_info/observed_bias.gz", + "salmon/WT_REP2/aux_info/observed_bias_3p.gz", + "salmon/WT_REP2/cmd_info.json", + "salmon/WT_REP2/libParams", + "salmon/WT_REP2/libParams/flenDist.txt", + "salmon/WT_REP2/lib_format_counts.json", + "salmon/WT_REP2/logs", + "salmon/WT_REP2/logs/salmon_quant.log", + "salmon/WT_REP2/quant.genes.sf", + "salmon/WT_REP2/quant.sf", + "salmon/deseq2_qc", + "salmon/deseq2_qc/R_sessionInfo.log", + "salmon/deseq2_qc/deseq2.dds.RData", + "salmon/deseq2_qc/deseq2.pca.vals.txt", + "salmon/deseq2_qc/deseq2.plots.pdf", + "salmon/deseq2_qc/deseq2.sample.dists.txt", + "salmon/deseq2_qc/size_factors", + "salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt", + "salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt", + "salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt", + "salmon/deseq2_qc/size_factors/WT_REP1.txt", + "salmon/deseq2_qc/size_factors/WT_REP2.txt", + "salmon/deseq2_qc/size_factors/deseq2.size_factors.RData", + "salmon/salmon.merged.gene_counts.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts.tsv", + "salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts_length_scaled.tsv", + "salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts_scaled.tsv", + "salmon/salmon.merged.gene_lengths.tsv", + "salmon/salmon.merged.gene_tpm.tsv", + "salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds", + "salmon/salmon.merged.transcript_counts.tsv", + "salmon/salmon.merged.transcript_lengths.tsv", + "salmon/salmon.merged.transcript_tpm.tsv", + "salmon/tx2gene.tsv", + "star_salmon", + "star_salmon/RAP1_IAA_30M_REP1", + "star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam", + "star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam.bai", + "star_salmon/RAP1_IAA_30M_REP1/aux_info", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz", + "star_salmon/RAP1_IAA_30M_REP1/cmd_info.json", + "star_salmon/RAP1_IAA_30M_REP1/libParams", + "star_salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt", + "star_salmon/RAP1_IAA_30M_REP1/logs", + "star_salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log", + "star_salmon/RAP1_IAA_30M_REP1/quant.genes.sf", + "star_salmon/RAP1_IAA_30M_REP1/quant.sf", + "star_salmon/RAP1_UNINDUCED_REP1", + "star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam", + "star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz", + "star_salmon/RAP1_UNINDUCED_REP1/cmd_info.json", + "star_salmon/RAP1_UNINDUCED_REP1/libParams", + "star_salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt", + "star_salmon/RAP1_UNINDUCED_REP1/logs", + "star_salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log", + "star_salmon/RAP1_UNINDUCED_REP1/quant.genes.sf", + "star_salmon/RAP1_UNINDUCED_REP1/quant.sf", + "star_salmon/RAP1_UNINDUCED_REP2", + "star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam", + "star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz", + "star_salmon/RAP1_UNINDUCED_REP2/cmd_info.json", + "star_salmon/RAP1_UNINDUCED_REP2/libParams", + "star_salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt", + "star_salmon/RAP1_UNINDUCED_REP2/logs", + "star_salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log", + "star_salmon/RAP1_UNINDUCED_REP2/quant.genes.sf", + "star_salmon/RAP1_UNINDUCED_REP2/quant.sf", + "star_salmon/WT_REP1", + "star_salmon/WT_REP1.markdup.sorted.bam", + "star_salmon/WT_REP1.markdup.sorted.bam.bai", + "star_salmon/WT_REP1/aux_info", + "star_salmon/WT_REP1/aux_info/ambig_info.tsv", + "star_salmon/WT_REP1/aux_info/expected_bias.gz", + "star_salmon/WT_REP1/aux_info/fld.gz", + "star_salmon/WT_REP1/aux_info/meta_info.json", + "star_salmon/WT_REP1/aux_info/observed_bias.gz", + "star_salmon/WT_REP1/aux_info/observed_bias_3p.gz", + "star_salmon/WT_REP1/cmd_info.json", + "star_salmon/WT_REP1/libParams", + "star_salmon/WT_REP1/libParams/flenDist.txt", + "star_salmon/WT_REP1/logs", + "star_salmon/WT_REP1/logs/salmon_quant.log", + "star_salmon/WT_REP1/quant.genes.sf", + "star_salmon/WT_REP1/quant.sf", + "star_salmon/WT_REP2", + "star_salmon/WT_REP2.markdup.sorted.bam", + "star_salmon/WT_REP2.markdup.sorted.bam.bai", + "star_salmon/WT_REP2/aux_info", + "star_salmon/WT_REP2/aux_info/ambig_info.tsv", + "star_salmon/WT_REP2/aux_info/expected_bias.gz", + "star_salmon/WT_REP2/aux_info/fld.gz", + "star_salmon/WT_REP2/aux_info/meta_info.json", + "star_salmon/WT_REP2/aux_info/observed_bias.gz", + "star_salmon/WT_REP2/aux_info/observed_bias_3p.gz", + "star_salmon/WT_REP2/cmd_info.json", + "star_salmon/WT_REP2/libParams", + "star_salmon/WT_REP2/libParams/flenDist.txt", + "star_salmon/WT_REP2/logs", + "star_salmon/WT_REP2/logs/salmon_quant.log", + "star_salmon/WT_REP2/quant.genes.sf", + "star_salmon/WT_REP2/quant.sf", + "star_salmon/bigwig", + "star_salmon/bigwig/RAP1_IAA_30M_REP1.forward.bigWig", + "star_salmon/bigwig/RAP1_IAA_30M_REP1.reverse.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP1.forward.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP1.reverse.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP2.forward.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP2.reverse.bigWig", + "star_salmon/bigwig/WT_REP1.forward.bigWig", + "star_salmon/bigwig/WT_REP1.reverse.bigWig", + "star_salmon/bigwig/WT_REP2.forward.bigWig", + "star_salmon/bigwig/WT_REP2.reverse.bigWig", + "star_salmon/deseq2_qc", + "star_salmon/deseq2_qc/R_sessionInfo.log", + "star_salmon/deseq2_qc/deseq2.dds.RData", + "star_salmon/deseq2_qc/deseq2.pca.vals.txt", + "star_salmon/deseq2_qc/deseq2.plots.pdf", + "star_salmon/deseq2_qc/deseq2.sample.dists.txt", + "star_salmon/deseq2_qc/size_factors", + "star_salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt", + "star_salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt", + "star_salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt", + "star_salmon/deseq2_qc/size_factors/WT_REP1.txt", + "star_salmon/deseq2_qc/size_factors/WT_REP2.txt", + "star_salmon/deseq2_qc/size_factors/deseq2.size_factors.RData", + "star_salmon/dupradar", + "star_salmon/dupradar/box_plot", + "star_salmon/dupradar/box_plot/RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf", + "star_salmon/dupradar/box_plot/RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf", + "star_salmon/dupradar/box_plot/RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf", + "star_salmon/dupradar/box_plot/WT_REP1_duprateExpBoxplot.pdf", + "star_salmon/dupradar/box_plot/WT_REP2_duprateExpBoxplot.pdf", + "star_salmon/dupradar/gene_data", + "star_salmon/dupradar/gene_data/RAP1_IAA_30M_REP1_dupMatrix.txt", + "star_salmon/dupradar/gene_data/RAP1_UNINDUCED_REP1_dupMatrix.txt", + "star_salmon/dupradar/gene_data/RAP1_UNINDUCED_REP2_dupMatrix.txt", + "star_salmon/dupradar/gene_data/WT_REP1_dupMatrix.txt", + "star_salmon/dupradar/gene_data/WT_REP2_dupMatrix.txt", + "star_salmon/dupradar/histogram", + "star_salmon/dupradar/histogram/RAP1_IAA_30M_REP1_expressionHist.pdf", + "star_salmon/dupradar/histogram/RAP1_UNINDUCED_REP1_expressionHist.pdf", + "star_salmon/dupradar/histogram/RAP1_UNINDUCED_REP2_expressionHist.pdf", + "star_salmon/dupradar/histogram/WT_REP1_expressionHist.pdf", + "star_salmon/dupradar/histogram/WT_REP2_expressionHist.pdf", + "star_salmon/dupradar/intercepts_slope", + "star_salmon/dupradar/intercepts_slope/RAP1_IAA_30M_REP1_intercept_slope.txt", + "star_salmon/dupradar/intercepts_slope/RAP1_UNINDUCED_REP1_intercept_slope.txt", + "star_salmon/dupradar/intercepts_slope/RAP1_UNINDUCED_REP2_intercept_slope.txt", + "star_salmon/dupradar/intercepts_slope/WT_REP1_intercept_slope.txt", + "star_salmon/dupradar/intercepts_slope/WT_REP2_intercept_slope.txt", + "star_salmon/dupradar/scatter_plot", + "star_salmon/dupradar/scatter_plot/RAP1_IAA_30M_REP1_duprateExpDens.pdf", + "star_salmon/dupradar/scatter_plot/RAP1_UNINDUCED_REP1_duprateExpDens.pdf", + "star_salmon/dupradar/scatter_plot/RAP1_UNINDUCED_REP2_duprateExpDens.pdf", + "star_salmon/dupradar/scatter_plot/WT_REP1_duprateExpDens.pdf", + "star_salmon/dupradar/scatter_plot/WT_REP2_duprateExpDens.pdf", + "star_salmon/featurecounts", + "star_salmon/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv", + "star_salmon/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv", + "star_salmon/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt", + "star_salmon/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt.summary", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt.summary", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt.summary", + "star_salmon/featurecounts/WT_REP1.biotype_counts_mqc.tsv", + "star_salmon/featurecounts/WT_REP1.biotype_counts_rrna_mqc.tsv", + "star_salmon/featurecounts/WT_REP1.featureCounts.txt", + "star_salmon/featurecounts/WT_REP1.featureCounts.txt.summary", + "star_salmon/featurecounts/WT_REP2.biotype_counts_mqc.tsv", + "star_salmon/featurecounts/WT_REP2.biotype_counts_rrna_mqc.tsv", + "star_salmon/featurecounts/WT_REP2.featureCounts.txt", + "star_salmon/featurecounts/WT_REP2.featureCounts.txt.summary", + "star_salmon/log", + "star_salmon/log/RAP1_IAA_30M_REP1.Log.final.out", + "star_salmon/log/RAP1_IAA_30M_REP1.Log.out", + "star_salmon/log/RAP1_IAA_30M_REP1.Log.progress.out", + "star_salmon/log/RAP1_IAA_30M_REP1.SJ.out.tab", + "star_salmon/log/RAP1_UNINDUCED_REP1.Log.final.out", + "star_salmon/log/RAP1_UNINDUCED_REP1.Log.out", + "star_salmon/log/RAP1_UNINDUCED_REP1.Log.progress.out", + "star_salmon/log/RAP1_UNINDUCED_REP1.SJ.out.tab", + "star_salmon/log/RAP1_UNINDUCED_REP2.Log.final.out", + "star_salmon/log/RAP1_UNINDUCED_REP2.Log.out", + "star_salmon/log/RAP1_UNINDUCED_REP2.Log.progress.out", + "star_salmon/log/RAP1_UNINDUCED_REP2.SJ.out.tab", + "star_salmon/log/WT_REP1.Log.final.out", + "star_salmon/log/WT_REP1.Log.out", + "star_salmon/log/WT_REP1.Log.progress.out", + "star_salmon/log/WT_REP1.SJ.out.tab", + "star_salmon/log/WT_REP2.Log.final.out", + "star_salmon/log/WT_REP2.Log.out", + "star_salmon/log/WT_REP2.Log.progress.out", + "star_salmon/log/WT_REP2.SJ.out.tab", + "star_salmon/picard_metrics", + "star_salmon/picard_metrics/RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/qualimap", + "star_salmon/qualimap/RAP1_IAA_30M_REP1", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/agogo.css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/ajax-loader.gif", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/basic.css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/bgfooter.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/bgtop.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/comment-bright.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/comment-close.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/comment.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/doctools.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/down-pressed.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/down.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/file.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/jquery.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/minus.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/plus.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/pygments.css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/qualimap_logo_small.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/report.css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/searchtools.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/underscore.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/up-pressed.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/up.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/websupport.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/qualimapReport.html", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/rnaseq_qc_results.txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/agogo.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/ajax-loader.gif", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/basic.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/bgfooter.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/bgtop.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/comment-bright.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/comment-close.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/comment.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/doctools.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/down-pressed.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/down.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/file.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/jquery.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/minus.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/plus.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/pygments.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/qualimap_logo_small.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/report.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/searchtools.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/underscore.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/up-pressed.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/up.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/websupport.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/qualimapReport.html", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/rnaseq_qc_results.txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/agogo.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/ajax-loader.gif", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/basic.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/bgfooter.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/bgtop.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/comment-bright.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/comment-close.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/comment.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/doctools.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/down-pressed.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/down.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/file.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/jquery.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/minus.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/plus.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/pygments.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/qualimap_logo_small.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/report.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/searchtools.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/underscore.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/up-pressed.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/up.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/websupport.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/qualimapReport.html", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/rnaseq_qc_results.txt", + "star_salmon/qualimap/WT_REP1", + "star_salmon/qualimap/WT_REP1/css", + "star_salmon/qualimap/WT_REP1/css/agogo.css", + "star_salmon/qualimap/WT_REP1/css/ajax-loader.gif", + "star_salmon/qualimap/WT_REP1/css/basic.css", + "star_salmon/qualimap/WT_REP1/css/bgfooter.png", + "star_salmon/qualimap/WT_REP1/css/bgtop.png", + "star_salmon/qualimap/WT_REP1/css/comment-bright.png", + "star_salmon/qualimap/WT_REP1/css/comment-close.png", + "star_salmon/qualimap/WT_REP1/css/comment.png", + "star_salmon/qualimap/WT_REP1/css/doctools.js", + "star_salmon/qualimap/WT_REP1/css/down-pressed.png", + "star_salmon/qualimap/WT_REP1/css/down.png", + "star_salmon/qualimap/WT_REP1/css/file.png", + "star_salmon/qualimap/WT_REP1/css/jquery.js", + "star_salmon/qualimap/WT_REP1/css/minus.png", + "star_salmon/qualimap/WT_REP1/css/plus.png", + "star_salmon/qualimap/WT_REP1/css/pygments.css", + "star_salmon/qualimap/WT_REP1/css/qualimap_logo_small.png", + "star_salmon/qualimap/WT_REP1/css/report.css", + "star_salmon/qualimap/WT_REP1/css/searchtools.js", + "star_salmon/qualimap/WT_REP1/css/underscore.js", + "star_salmon/qualimap/WT_REP1/css/up-pressed.png", + "star_salmon/qualimap/WT_REP1/css/up.png", + "star_salmon/qualimap/WT_REP1/css/websupport.js", + "star_salmon/qualimap/WT_REP1/images_qualimapReport", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/WT_REP1/qualimapReport.html", + "star_salmon/qualimap/WT_REP1/raw_data_qualimapReport", + "star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/WT_REP1/rnaseq_qc_results.txt", + "star_salmon/qualimap/WT_REP2", + "star_salmon/qualimap/WT_REP2/css", + "star_salmon/qualimap/WT_REP2/css/agogo.css", + "star_salmon/qualimap/WT_REP2/css/ajax-loader.gif", + "star_salmon/qualimap/WT_REP2/css/basic.css", + "star_salmon/qualimap/WT_REP2/css/bgfooter.png", + "star_salmon/qualimap/WT_REP2/css/bgtop.png", + "star_salmon/qualimap/WT_REP2/css/comment-bright.png", + "star_salmon/qualimap/WT_REP2/css/comment-close.png", + "star_salmon/qualimap/WT_REP2/css/comment.png", + "star_salmon/qualimap/WT_REP2/css/doctools.js", + "star_salmon/qualimap/WT_REP2/css/down-pressed.png", + "star_salmon/qualimap/WT_REP2/css/down.png", + "star_salmon/qualimap/WT_REP2/css/file.png", + "star_salmon/qualimap/WT_REP2/css/jquery.js", + "star_salmon/qualimap/WT_REP2/css/minus.png", + "star_salmon/qualimap/WT_REP2/css/plus.png", + "star_salmon/qualimap/WT_REP2/css/pygments.css", + "star_salmon/qualimap/WT_REP2/css/qualimap_logo_small.png", + "star_salmon/qualimap/WT_REP2/css/report.css", + "star_salmon/qualimap/WT_REP2/css/searchtools.js", + "star_salmon/qualimap/WT_REP2/css/underscore.js", + "star_salmon/qualimap/WT_REP2/css/up-pressed.png", + "star_salmon/qualimap/WT_REP2/css/up.png", + "star_salmon/qualimap/WT_REP2/css/websupport.js", + "star_salmon/qualimap/WT_REP2/images_qualimapReport", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/WT_REP2/qualimapReport.html", + "star_salmon/qualimap/WT_REP2/raw_data_qualimapReport", + "star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/WT_REP2/rnaseq_qc_results.txt", + "star_salmon/rseqc", + "star_salmon/rseqc/bam_stat", + "star_salmon/rseqc/bam_stat/RAP1_IAA_30M_REP1.bam_stat.txt", + "star_salmon/rseqc/bam_stat/RAP1_UNINDUCED_REP1.bam_stat.txt", + "star_salmon/rseqc/bam_stat/RAP1_UNINDUCED_REP2.bam_stat.txt", + "star_salmon/rseqc/bam_stat/WT_REP1.bam_stat.txt", + "star_salmon/rseqc/bam_stat/WT_REP2.bam_stat.txt", + "star_salmon/rseqc/infer_experiment", + "star_salmon/rseqc/infer_experiment/RAP1_IAA_30M_REP1.infer_experiment.txt", + "star_salmon/rseqc/infer_experiment/RAP1_UNINDUCED_REP1.infer_experiment.txt", + "star_salmon/rseqc/infer_experiment/RAP1_UNINDUCED_REP2.infer_experiment.txt", + "star_salmon/rseqc/infer_experiment/WT_REP1.infer_experiment.txt", + "star_salmon/rseqc/infer_experiment/WT_REP2.infer_experiment.txt", + "star_salmon/rseqc/inner_distance", + "star_salmon/rseqc/inner_distance/pdf", + "star_salmon/rseqc/inner_distance/pdf/RAP1_IAA_30M_REP1.inner_distance_plot.pdf", + "star_salmon/rseqc/inner_distance/pdf/WT_REP1.inner_distance_plot.pdf", + "star_salmon/rseqc/inner_distance/pdf/WT_REP2.inner_distance_plot.pdf", + "star_salmon/rseqc/inner_distance/rscript", + "star_salmon/rseqc/inner_distance/rscript/RAP1_IAA_30M_REP1.inner_distance_plot.r", + "star_salmon/rseqc/inner_distance/rscript/WT_REP1.inner_distance_plot.r", + "star_salmon/rseqc/inner_distance/rscript/WT_REP2.inner_distance_plot.r", + "star_salmon/rseqc/inner_distance/txt", + "star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance.txt", + "star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_freq.txt", + "star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_mean.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance_freq.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance_mean.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance_freq.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance_mean.txt", + "star_salmon/rseqc/junction_annotation", + "star_salmon/rseqc/junction_annotation/bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.bed", + "star_salmon/rseqc/junction_annotation/bed/WT_REP1.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/WT_REP1.junction.bed", + "star_salmon/rseqc/junction_annotation/bed/WT_REP2.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/WT_REP2.junction.bed", + "star_salmon/rseqc/junction_annotation/log", + "star_salmon/rseqc/junction_annotation/log/RAP1_IAA_30M_REP1.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP1.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP2.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/log/WT_REP1.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/log/WT_REP2.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/pdf/WT_REP1.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/WT_REP1.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/pdf/WT_REP2.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/WT_REP2.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/rscript", + "star_salmon/rseqc/junction_annotation/rscript/RAP1_IAA_30M_REP1.junction_plot.r", + "star_salmon/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP1.junction_plot.r", + "star_salmon/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP2.junction_plot.r", + "star_salmon/rseqc/junction_annotation/rscript/WT_REP1.junction_plot.r", + "star_salmon/rseqc/junction_annotation/rscript/WT_REP2.junction_plot.r", + "star_salmon/rseqc/junction_annotation/xls", + "star_salmon/rseqc/junction_annotation/xls/RAP1_IAA_30M_REP1.junction.xls", + "star_salmon/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP1.junction.xls", + "star_salmon/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP2.junction.xls", + "star_salmon/rseqc/junction_annotation/xls/WT_REP1.junction.xls", + "star_salmon/rseqc/junction_annotation/xls/WT_REP2.junction.xls", + "star_salmon/rseqc/junction_saturation", + "star_salmon/rseqc/junction_saturation/pdf", + "star_salmon/rseqc/junction_saturation/pdf/RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/pdf/WT_REP1.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/pdf/WT_REP2.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/rscript", + "star_salmon/rseqc/junction_saturation/rscript/RAP1_IAA_30M_REP1.junctionSaturation_plot.r", + "star_salmon/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP1.junctionSaturation_plot.r", + "star_salmon/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP2.junctionSaturation_plot.r", + "star_salmon/rseqc/junction_saturation/rscript/WT_REP1.junctionSaturation_plot.r", + "star_salmon/rseqc/junction_saturation/rscript/WT_REP2.junctionSaturation_plot.r", + "star_salmon/rseqc/read_distribution", + "star_salmon/rseqc/read_distribution/RAP1_IAA_30M_REP1.read_distribution.txt", + "star_salmon/rseqc/read_distribution/RAP1_UNINDUCED_REP1.read_distribution.txt", + "star_salmon/rseqc/read_distribution/RAP1_UNINDUCED_REP2.read_distribution.txt", + "star_salmon/rseqc/read_distribution/WT_REP1.read_distribution.txt", + "star_salmon/rseqc/read_distribution/WT_REP2.read_distribution.txt", + "star_salmon/rseqc/read_duplication", + "star_salmon/rseqc/read_duplication/pdf", + "star_salmon/rseqc/read_duplication/pdf/RAP1_IAA_30M_REP1.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP1.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP2.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/pdf/WT_REP1.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/pdf/WT_REP2.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/rscript", + "star_salmon/rseqc/read_duplication/rscript/RAP1_IAA_30M_REP1.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP1.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP2.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/rscript/WT_REP1.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/rscript/WT_REP2.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.seq.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.seq.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.seq.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/WT_REP1.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/WT_REP1.seq.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/WT_REP2.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/WT_REP2.seq.DupRate.xls", + "star_salmon/salmon.merged.gene_counts.SummarizedExperiment.rds", + "star_salmon/salmon.merged.gene_counts.tsv", + "star_salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", + "star_salmon/salmon.merged.gene_counts_length_scaled.tsv", + "star_salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", + "star_salmon/salmon.merged.gene_counts_scaled.tsv", + "star_salmon/salmon.merged.gene_lengths.tsv", + "star_salmon/salmon.merged.gene_tpm.tsv", + "star_salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds", + "star_salmon/salmon.merged.transcript_counts.tsv", + "star_salmon/salmon.merged.transcript_lengths.tsv", + "star_salmon/salmon.merged.transcript_tpm.tsv", + "star_salmon/samtools_stats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP1.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP1.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP1.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP2.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP2.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP2.sorted.bam.stats", + "star_salmon/stringtie", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e2t.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e_data.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i2t.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i_data.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/t_data.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.coverage.gtf", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.gene.abundance.txt", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.transcripts.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/t_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.coverage.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.gene.abundance.txt", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.transcripts.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/t_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.coverage.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.gene.abundance.txt", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.transcripts.gtf", + "star_salmon/stringtie/WT_REP1.ballgown", + "star_salmon/stringtie/WT_REP1.ballgown/e2t.ctab", + "star_salmon/stringtie/WT_REP1.ballgown/e_data.ctab", + "star_salmon/stringtie/WT_REP1.ballgown/i2t.ctab", + "star_salmon/stringtie/WT_REP1.ballgown/i_data.ctab", + "star_salmon/stringtie/WT_REP1.ballgown/t_data.ctab", + "star_salmon/stringtie/WT_REP1.coverage.gtf", + "star_salmon/stringtie/WT_REP1.gene.abundance.txt", + "star_salmon/stringtie/WT_REP1.transcripts.gtf", + "star_salmon/stringtie/WT_REP2.ballgown", + "star_salmon/stringtie/WT_REP2.ballgown/e2t.ctab", + "star_salmon/stringtie/WT_REP2.ballgown/e_data.ctab", + "star_salmon/stringtie/WT_REP2.ballgown/i2t.ctab", + "star_salmon/stringtie/WT_REP2.ballgown/i_data.ctab", + "star_salmon/stringtie/WT_REP2.ballgown/t_data.ctab", + "star_salmon/stringtie/WT_REP2.coverage.gtf", + "star_salmon/stringtie/WT_REP2.gene.abundance.txt", + "star_salmon/stringtie/WT_REP2.transcripts.gtf", + "star_salmon/tx2gene.tsv", + "trimgalore", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" + ], + [ + "genome_gfp.fasta:md5,e23e302af63736a199985a169fdac055", + "genome_gfp.gtf:md5,c98b12c302f15731bfc36bcf297cfe28", + "cutadapt_filtered_reads_plot.txt:md5,bf033e64e9d23bee85b6277f11c663f1", + "cutadapt_trimmed_sequences_plot_3_Counts.txt:md5,13dfa866fd91dbb072689efe9aa83b1f", + "cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt:md5,07145dd8dd3db654859b18eb0389046c", + "fastqc-status-check-heatmap-1.txt:md5,22a03548736b88b23be6bc0c9ef1b4a6", + "fastqc-status-check-heatmap.txt:md5,5a89b0d8d162f6b1dbdaf39457bbc03b", + "fastqc_adapter_content_plot.txt:md5,da0389be84cfdd189b1d045212eb2974", + "fastqc_overrepresented_sequences_plot-1.txt:md5,4adfeacd3a3a6c7c808f121b24e6b247", + "fastqc_overrepresented_sequences_plot.txt:md5,25d88ea8a72f55e8a374ae802bc7f0b1", + "fastqc_per_base_n_content_plot-1.txt:md5,418610c1ce119cb786ad434db75d366e", + "fastqc_per_base_n_content_plot.txt:md5,d368d7e36ca2f73dcde61f2b486d8213", + "fastqc_per_base_sequence_quality_plot-1.txt:md5,bd22e06e41c096ad4f745d40fe96a1e5", + "fastqc_per_base_sequence_quality_plot.txt:md5,5c3065b549129702b185ea1b817da420", + "fastqc_per_sequence_gc_content_plot-1_Counts.txt:md5,004c60768ceb6197765154e3eaa37b7a", + "fastqc_per_sequence_gc_content_plot-1_Percentages.txt:md5,95d29060b687f745288ad1ec47750037", + "fastqc_per_sequence_gc_content_plot_Counts.txt:md5,9ddaa50167117d3c9188ccf015427704", + "fastqc_per_sequence_gc_content_plot_Percentages.txt:md5,f10ee2881b61308af35f304aa3d810a3", + "fastqc_per_sequence_quality_scores_plot-1.txt:md5,0f9834cc19f76dd5c87cf8cba7435a7c", + "fastqc_per_sequence_quality_scores_plot.txt:md5,b5f9a02933e3065952237afd2ec9ce82", + "fastqc_sequence_counts_plot-1.txt:md5,3861354bbedfbde7ca36a72994f9425c", + "fastqc_sequence_counts_plot.txt:md5,d385a3e2c2573a0902c66e8c93876d3c", + "fastqc_sequence_duplication_levels_plot-1.txt:md5,c73407d55fc532e864fa1dc8dbc12874", + "fastqc_sequence_duplication_levels_plot.txt:md5,8812cee16f6ca65e2c33635754de1772", + "fastqc_sequence_length_distribution_plot.txt:md5,6fe2c985606abad947bcca99b015ae33", + "multiqc_citations.txt:md5,2d2ab6df367e36e98e081c33dec187a0", + "multiqc_cutadapt.txt:md5,aac9581a5670cb55edf564f3d6c1f9a7", + "multiqc_fastqc_fastqc_raw.txt:md5,81c3c1a2575a1891a7f2a9637a0f2cc0", + "multiqc_fastqc_fastqc_trimmed.txt:md5,a3238f515e01d158d875d69968753804", + "multiqc_featurecounts_biotype_plot.txt:md5,56be7f0813c3cbea0f68f61d9b355b71", + "multiqc_samtools_idxstats.txt:md5,fd7d03a91f0b9e01a6939941f7f2243f", + "picard_histogram.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "picard_histogram_1.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "picard_histogram_2.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "qualimap_gene_coverage_profile_Counts.txt:md5,02044ed1bf1eca19a8a87c9971cdc049", + "qualimap_gene_coverage_profile_Normalised.txt:md5,eeeea7f50278b3b335bef545784abbfa", + "qualimap_rnaseq_cov_hist.txt:md5,51407e597076f3a7f98622213bea6bce", + "rseqc_infer_experiment_plot.txt:md5,de5a0bad9cca763928e7c33375eb5218", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt:md5,75acd04232d1804b5f960ee4c5db4722", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt:md5,ae45731d8d4595f77e6b271004f3a070", + "samtools-idxstats-mapped-reads-plot_Raw_Counts.txt:md5,01637c600d3840500851eb4118564cc6", + "cutadapt_filtered_reads_plot-cnt.png:md5,704cf0d91bfa3dd658dd8c9590f669a2", + "cutadapt_filtered_reads_plot-pct.png:md5,2684d8b2afca3300e5786486b80237f0", + "cutadapt_trimmed_sequences_plot_3_Counts.png:md5,bef41d894629b0c4dab4478bbf197f50", + "cutadapt_trimmed_sequences_plot_3_Obs_Exp.png:md5,1e0d01537d3797623d0b3fd8fbe42787", + "dupradar-section-plot.png:md5,3ae5e5cb161b7abd878d718bc71b41f6", + "fastqc-status-check-heatmap-1.png:md5,2402522f8c02e12aea9af088c6595890", + "fastqc-status-check-heatmap.png:md5,fe8b5b4ab4480d46a12a9005932a9b84", + "fastqc_overrepresented_sequences_plot-1.png:md5,40e450251b80ec0efc9364434234ec7f", + "fastqc_overrepresented_sequences_plot.png:md5,6f5ffbdf1bf61fabe5e028c8bc85de14", + "fastqc_per_sequence_gc_content_plot-1_Counts.png:md5,8a806cec2142f9911502e0a253d83d13", + "fastqc_per_sequence_gc_content_plot-1_Percentages.png:md5,953929d50c8490029880e205e4db7959", + "fastqc_per_sequence_gc_content_plot_Counts.png:md5,01f124545af788fd5cc7bbf41b005e16", + "fastqc_per_sequence_gc_content_plot_Percentages.png:md5,eba3abf8bedb2cb20bad90c54e9c8881", + "fastqc_per_sequence_quality_scores_plot-1.png:md5,d2c29cae169f35744500c751b4a7366e", + "fastqc_per_sequence_quality_scores_plot.png:md5,42fd7369a8aca78f620164a9e887c3cb", + "fastqc_sequence_counts_plot-1-cnt.png:md5,2874fea747c7ff46828bf4f17668caf8", + "fastqc_sequence_counts_plot-1-pct.png:md5,0022d7f5ac78b6eff157de24e37c5ab0", + "fastqc_sequence_counts_plot-cnt.png:md5,3890d5555f2a39b46b9f6efb14cb91f2", + "fastqc_sequence_counts_plot-pct.png:md5,55fa5838c8b2db978fcfa5cb83f6b054", + "fastqc_sequence_duplication_levels_plot-1.png:md5,fcd3b1ec2b95fe4bcd607dc28179a754", + "fastqc_sequence_duplication_levels_plot.png:md5,747431f0f38f8e4c41a11a072fa18780", + "featurecounts_biotype_plot-cnt.png:md5,4c66fce934b018143e7b8f6a1383d3f6", + "featurecounts_biotype_plot-pct.png:md5,9191dc2dd130f22ad404d27e045d2304", + "qualimap_gene_coverage_profile_Counts.png:md5,ac424dc7e5444a32e482bd5048ac4432", + "qualimap_gene_coverage_profile_Normalised.png:md5,62e5a2146daec985b8c2de02e3b57c1e", + "rseqc_infer_experiment_plot.png:md5,60c3cafb671fad2cf5f695615230eb8f", + "rseqc_read_dups_plot.png:md5,958513925fa5494bf499c989842d6928", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png:md5,ce6abb232fd5b5f2e66c0fe9a571d75f", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png:md5,6b44818f886ef020fb3646f152ad4af6", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png:md5,d5d8a85b7ad72a0cb93d9283ea12b23f", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png:md5,19317ad8f1448cd7eb1d319f85cc5c4d", + "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png:md5,a6849cd92ae738441212b681a411614d", + "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png:md5,4c06988372df63a1fb5f8be93f73ae8f", + "ambig_info.tsv:md5,de973a4b22a4457217ae3dc04caf9401", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,1215f0c20f87d3aef8553ef119e1e74c", + "lib_format_counts.json:md5,c24ffe28d70476b5ccdd8bc2d22c0ac1", + "ambig_info.tsv:md5,45f252b4f0e11e6730cf0c29f800fdbb", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,621c6601aade5b1f2e3d6ca2fc71f636", + "lib_format_counts.json:md5,f6d44c0221f7fd559f11a9afe04c9935", + "ambig_info.tsv:md5,6dcc2891ea572e9b8d1ba52cd434ab84", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,9bed6e4dc5428d6f6297adcea29a6326", + "lib_format_counts.json:md5,7c562bf2f70e42f3a7292687dfd328c3", + "ambig_info.tsv:md5,194f574e0586416155e3f33d42e2b167", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,c7ed0aaa5d6c7934ddbebfd29e4eb86d", + "lib_format_counts.json:md5,d46250bb3677d72feeefc435fe6395a6", + "ambig_info.tsv:md5,a26e3f936e65d7da66392603c2f91f6f", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,69ebfc2c7ca6b221a0a22fa1dc8c20ac", + "lib_format_counts.json:md5,088fd51db07022ffde47033bbd029400", + "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", + "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", + "ambig_info.tsv:md5,f9a605d54a0a103566f7a9b8e0867a73", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,4cc2492f557e5e0a2911a0bd83a51020", + "ambig_info.tsv:md5,8f97be8af4e47cc48650c62227a40203", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,dc750c3564c63da54979c852794d58a5", + "ambig_info.tsv:md5,a044fe7a3ad445c9a91a0d54ab5015d1", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,db43ed650e6e7b42cd2c5b8101bb6748", + "ambig_info.tsv:md5,7a8ea02d74058efb801e8c62bca96fd4", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,e418b4e899623449c6babdf53e5aabde", + "ambig_info.tsv:md5,543a047a549437026a1363ea8ddf5b03", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,f234c8d322df3b59d990594c63b24eae", + "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", + "RAP1_IAA_30M_REP1_dupMatrix.txt:md5,2e0d518a450bb57801cdd075d4e9c217", + "RAP1_UNINDUCED_REP1_dupMatrix.txt:md5,96e2f9e1fc5a22a7d468e6fb4a613370", + "RAP1_UNINDUCED_REP2_dupMatrix.txt:md5,28c30ce734d78d53b1c47c3f87414e4b", + "WT_REP1_dupMatrix.txt:md5,b6aa1b99d91f5fa7a94efeed1c496c00", + "WT_REP2_dupMatrix.txt:md5,02236769150436cf31b7339f612119a5", + "RAP1_IAA_30M_REP1_intercept_slope.txt:md5,c677048855caf5190f29fa5f7137cd79", + "RAP1_UNINDUCED_REP1_intercept_slope.txt:md5,ea1b4323d3bc83759e8a026416bca32b", + "RAP1_UNINDUCED_REP2_intercept_slope.txt:md5,b062f49a5223a3452075062cdd308043", + "WT_REP1_intercept_slope.txt:md5,e7fcac6d125a7ba746a5cba4a1e66aef", + "WT_REP2_intercept_slope.txt:md5,5af16b07a734b73a2c1103b535f9e26e", + "RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv:md5,f3688a214d33a43ad79abe4b31df0c4b", + "RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv:md5,dde2de0cb90e10d0195c726f768e9941", + "RAP1_IAA_30M_REP1.featureCounts.txt:md5,b38da3230d4d29ebc8d4af36852d7212", + "RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv:md5,d241d50e582ceb97e6f16b3556f5f5a9", + "RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv:md5,845ff9059c72bc6722a8de69776e22bb", + "RAP1_UNINDUCED_REP1.featureCounts.txt:md5,2ab175746532de1c54020c1eabc27bb5", + "RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv:md5,b621ce1e803d8670ece6c66391c33ba4", + "RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv:md5,6d3fa4c88c7fe61f638e4624ad5e22f0", + "RAP1_UNINDUCED_REP2.featureCounts.txt:md5,480b2586a878bc22f5b73f94051b41d8", + "WT_REP1.biotype_counts_mqc.tsv:md5,cac41767a8cc2e5fee58637971ec89d1", + "WT_REP1.biotype_counts_rrna_mqc.tsv:md5,8ef76d717492ca23764938aee8ea33a9", + "WT_REP1.featureCounts.txt:md5,112001ddbe917d935ee276d1685840bd", + "WT_REP2.biotype_counts_mqc.tsv:md5,e61b72317ac3c4d4ac64b663145e6262", + "WT_REP2.biotype_counts_rrna_mqc.tsv:md5,12294618fe44df1e7f39348372dcb481", + "WT_REP2.featureCounts.txt:md5,59e23ae18cfe6aa2e5a884bc03cbff15", + "RAP1_IAA_30M_REP1.SJ.out.tab:md5,ea95e243278af55534f2c52eb5fff7ee", + "RAP1_UNINDUCED_REP1.SJ.out.tab:md5,e548d13942535dc0821f3ec6d9743ec8", + "RAP1_UNINDUCED_REP2.SJ.out.tab:md5,1f294365343a1a5e95682792fdb77033", + "WT_REP1.SJ.out.tab:md5,1350c2fa6a675bf107386c6cd3fc5204", + "WT_REP2.SJ.out.tab:md5,f6cc03643a5e3c1025a5b4754eb1be23", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,876c1b88f33bd3e5fe1a41679729573d", + "Coverage Profile Along Genes (Low).png:md5,ee1f2c9cc4dd4867811eda1e68864ab4", + "Coverage Profile Along Genes (Total).png:md5,53747a8f9813744902756ad60638380a", + "Transcript coverage histogram.png:md5,4f9072d4b11216373b59396293803a37", + "coverage_profile_along_genes_(high).txt:md5,fcb06d460810c0555de5396b9dae05e8", + "coverage_profile_along_genes_(low).txt:md5,e3c9a1ddfdb89f8534ff7548b70fce32", + "coverage_profile_along_genes_(total).txt:md5,e3c9a1ddfdb89f8534ff7548b70fce32", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,bbf0531018e7fccfc1dfdd1c05715518", + "Coverage Profile Along Genes (Low).png:md5,3c147d9c831d4be98615a22a72fad05d", + "Coverage Profile Along Genes (Total).png:md5,5a8a6db3a8d19a2dcb8f715b11e67c50", + "Transcript coverage histogram.png:md5,488440d7b6d73bcd4567316712e281fe", + "coverage_profile_along_genes_(high).txt:md5,9f1e29a4d6eec52e8796b080daaedca3", + "coverage_profile_along_genes_(low).txt:md5,353f42a84ff34167646fc83909eac2ff", + "coverage_profile_along_genes_(total).txt:md5,353f42a84ff34167646fc83909eac2ff", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,5a5d99cc7a1dba3762d67f4aa4adad58", + "Coverage Profile Along Genes (Low).png:md5,b6adc296e9a732aa0495a6da8fa4ed90", + "Coverage Profile Along Genes (Total).png:md5,fcb94fb9c1a51c1db32f884d05929cc8", + "Transcript coverage histogram.png:md5,3aeb52ff3e3752727a370b0d7ceb0518", + "coverage_profile_along_genes_(high).txt:md5,3b20a736708df02ea8c86dc5829ae67e", + "coverage_profile_along_genes_(low).txt:md5,02b314b76ef1317f20e129412340755d", + "coverage_profile_along_genes_(total).txt:md5,02b314b76ef1317f20e129412340755d", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,c974d47996bcc57b99dfaf6903f61f41", + "Coverage Profile Along Genes (Low).png:md5,c8fe631f0580c93adb5be107c6a7a1a3", + "Coverage Profile Along Genes (Total).png:md5,424d245e9f3e626d9e79f51d1b93e946", + "Transcript coverage histogram.png:md5,17404146ad5e0a9bce97ce622e00975e", + "coverage_profile_along_genes_(high).txt:md5,8bf366c7dbc6170035ee64a057c581f1", + "coverage_profile_along_genes_(low).txt:md5,a9102de3ff9679d1f7a86afa85997211", + "coverage_profile_along_genes_(total).txt:md5,a9102de3ff9679d1f7a86afa85997211", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,40edd79c21f3e8d8bbac384156c472d6", + "Coverage Profile Along Genes (Low).png:md5,935c0372259a953a4c99569e9b236ae5", + "Coverage Profile Along Genes (Total).png:md5,34f7a4307be1ea674b7b98eee564d96b", + "Transcript coverage histogram.png:md5,e2abf8a9c62fef57f0be1ca0e01e502d", + "coverage_profile_along_genes_(high).txt:md5,3f13eb908d6e97e6831306e9527cc2e3", + "coverage_profile_along_genes_(low).txt:md5,24df553662d0cedaa74cf06a8fead40b", + "coverage_profile_along_genes_(total).txt:md5,24df553662d0cedaa74cf06a8fead40b", + "RAP1_IAA_30M_REP1.infer_experiment.txt:md5,169d25b95c008bebe9ce886fea6a4e33", + "RAP1_UNINDUCED_REP1.infer_experiment.txt:md5,2ca0ce0fd3204bd2cc4812c4655b1f1f", + "RAP1_UNINDUCED_REP2.infer_experiment.txt:md5,7d5705880188f9beab1939e08d6b8f40", + "WT_REP1.infer_experiment.txt:md5,bf0c137f5fca06e7c40e1984a1acb06d", + "WT_REP2.infer_experiment.txt:md5,82e23b329ee60709f343bc2d17d43b14", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,3f149502efe2a9d4bac98b1dd18c15e7", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,a052ab04070e72cc318fb7680b0764e3", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,e82329a443b9ff50a86e42aff91bd704", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,d279003d92f7feef9adb31203f84474a", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,10e2d00f93f9e74f224bd3c1bfbeb29b", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,525413b70bcf62c24c8f96182e09883e", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,9aa371befc36478d7720d3ea275e6f4d", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,907ab2e06346df131cbdb929afc005a8", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,b03f3118d1aa58fceadcb3311028e856", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,041edee3193df311f621c09f4991892b", + "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe" + ] ], "meta": { "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T13:24:55.331523" - }, - "star_salmon/featurecounts": { - "content": [ - "RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv:md5,f3688a214d33a43ad79abe4b31df0c4b", - "RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv:md5,dde2de0cb90e10d0195c726f768e9941", - "RAP1_IAA_30M_REP1.featureCounts.txt:md5,b38da3230d4d29ebc8d4af36852d7212", - "RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv:md5,d241d50e582ceb97e6f16b3556f5f5a9", - "RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv:md5,845ff9059c72bc6722a8de69776e22bb", - "RAP1_UNINDUCED_REP1.featureCounts.txt:md5,2ab175746532de1c54020c1eabc27bb5", - "RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv:md5,b621ce1e803d8670ece6c66391c33ba4", - "RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv:md5,6d3fa4c88c7fe61f638e4624ad5e22f0", - "RAP1_UNINDUCED_REP2.featureCounts.txt:md5,480b2586a878bc22f5b73f94051b41d8", - "WT_REP1.biotype_counts_mqc.tsv:md5,cac41767a8cc2e5fee58637971ec89d1", - "WT_REP1.biotype_counts_rrna_mqc.tsv:md5,8ef76d717492ca23764938aee8ea33a9", - "WT_REP1.featureCounts.txt:md5,112001ddbe917d935ee276d1685840bd", - "WT_REP2.biotype_counts_mqc.tsv:md5,e61b72317ac3c4d4ac64b663145e6262", - "WT_REP2.biotype_counts_rrna_mqc.tsv:md5,12294618fe44df1e7f39348372dcb481", - "WT_REP2.featureCounts.txt:md5,59e23ae18cfe6aa2e5a884bc03cbff15", - "RAP1_IAA_30M_REP1.featureCounts.txt.summary", - "RAP1_UNINDUCED_REP1.featureCounts.txt.summary", - "RAP1_UNINDUCED_REP2.featureCounts.txt.summary", - "WT_REP1.featureCounts.txt.summary", - "WT_REP2.featureCounts.txt.summary" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T12:44:57.630756" - }, - "salmon/deseq2_qc": { - "content": [ - "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", - "deseq2.dds.RData", - "deseq2.pca.vals.txt", - "deseq2.plots.pdf", - "deseq2.sample.dists.txt", - "RAP1_IAA_30M_REP1.txt", - "RAP1_UNINDUCED_REP1.txt", - "RAP1_UNINDUCED_REP2.txt", - "WT_REP1.txt", - "WT_REP2.txt", - "deseq2.size_factors.RData" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T15:35:07.630987" - }, - "salmon": { - "content": [ - "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", - "salmon.merged.gene_counts.SummarizedExperiment.rds", - "salmon.merged.gene_counts.tsv", - "salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_length_scaled.tsv", - "salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_scaled.tsv", - "salmon.merged.gene_lengths.tsv", - "salmon.merged.gene_tpm.tsv", - "salmon.merged.transcript_counts.SummarizedExperiment.rds", - "salmon.merged.transcript_counts.tsv", - "salmon.merged.transcript_lengths.tsv", - "salmon.merged.transcript_tpm.tsv" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T13:59:54.169289" - }, - "star_salmon/picard_metrics": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt", - "WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T13:59:55.48375" - }, - "star_salmon/salmon": { - "content": [ - "salmon.merged.gene_counts.SummarizedExperiment.rds", - "salmon.merged.gene_counts.tsv", - "salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_length_scaled.tsv", - "salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_scaled.tsv", - "salmon.merged.gene_lengths.tsv", - "salmon.merged.gene_tpm.tsv", - "salmon.merged.transcript_counts.SummarizedExperiment.rds", - "salmon.merged.transcript_counts.tsv", - "salmon.merged.transcript_lengths.tsv", - "salmon.merged.transcript_tpm.tsv" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T14:57:59.602274" - }, - "star_salmon/bigwig": { - "content": [ - "RAP1_IAA_30M_REP1.forward.bigWig", - "RAP1_IAA_30M_REP1.reverse.bigWig", - "RAP1_UNINDUCED_REP1.forward.bigWig", - "RAP1_UNINDUCED_REP1.reverse.bigWig", - "RAP1_UNINDUCED_REP2.forward.bigWig", - "RAP1_UNINDUCED_REP2.reverse.bigWig", - "WT_REP1.forward.bigWig", - "WT_REP1.reverse.bigWig", - "WT_REP2.forward.bigWig", - "WT_REP2.reverse.bigWig" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T13:59:54.39954" - }, - "versions": { - "content": [ - "{BBMAP_BBSPLIT={bbmap=39.01}, BEDTOOLS_GENOMECOV_FW={bedtools=2.31.1}, CAT_FASTQ={cat=8.3}, CUSTOM_CATADDITIONALFASTA={python=3.9.5}, CUSTOM_GETCHROMSIZES={getchromsizes=1.2}, CUSTOM_TX2GENE={python=3.9.5}, DESEQ2_QC_PSEUDO={r-base=4.0.3, bioconductor-deseq2=1.28.0}, DESEQ2_QC_STAR_SALMON={r-base=4.0.3, bioconductor-deseq2=1.28.0}, DUPRADAR={bioconductor-dupradar=1.32.0}, FASTQC={fastqc=0.12.1}, FQ_SUBSAMPLE={fq=0.9.1 (2022-02-22)}, GTF2BED={perl=5.26.2}, GTF_FILTER={python=3.9.5}, GUNZIP_ADDITIONAL_FASTA={gunzip=1.1}, GUNZIP_GTF={gunzip=1.1}, MULTIQC_CUSTOM_BIOTYPE={python=3.9.5}, PICARD_MARKDUPLICATES={picard=3.1.1}, QUALIMAP_RNASEQ={qualimap=2.3}, RSEQC_BAMSTAT={rseqc=5.0.2}, RSEQC_INFEREXPERIMENT={rseqc=5.0.2}, RSEQC_INNERDISTANCE={rseqc=5.0.2}, RSEQC_JUNCTIONANNOTATION={rseqc=5.0.2}, RSEQC_JUNCTIONSATURATION={rseqc=5.0.2}, RSEQC_READDISTRIBUTION={rseqc=5.0.2}, RSEQC_READDUPLICATION={rseqc=5.0.2}, SALMON_QUANT={salmon=1.10.1}, SAMTOOLS_FLAGSTAT={samtools=1.2}, SAMTOOLS_IDXSTATS={samtools=1.2}, SAMTOOLS_INDEX={samtools=1.2}, SAMTOOLS_SORT={samtools=1.2}, SAMTOOLS_STATS={samtools=1.2}, SE_GENE={bioconductor-summarizedexperiment=1.32.0}, STAR_ALIGN={star=2.7.10a, samtools=1.18, gawk=5.1.0}, STAR_GENOMEGENERATE={star=2.7.10a, samtools=1.18, gawk=5.1.0}, STRINGTIE_STRINGTIE={stringtie=2.2.1}, SUBREAD_FEATURECOUNTS={subread=2.0.1}, TRIMGALORE={trimgalore=0.6.7, cutadapt=3.4}, TXIMETA_TXIMPORT={bioconductor-tximeta=1.20.1}, UCSC_BEDCLIP={ucsc=377}, UCSC_BEDGRAPHTOBIGWIG={ucsc=445}, UNTAR_SALMON_INDEX={untar=1.34}, Workflow={nf-core/rnaseq=v3.16.0dev}}" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T13:59:57.208071" - }, - "fastqc/trim": { - "content": [ - "RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html", - "RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip", - "RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html", - "RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip", - "RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html", - "RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip", - "RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html", - "RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip", - "WT_REP1_trimmed_1_val_1_fastqc.html", - "WT_REP1_trimmed_1_val_1_fastqc.zip", - "WT_REP1_trimmed_2_val_2_fastqc.html", - "WT_REP1_trimmed_2_val_2_fastqc.zip", - "WT_REP2_trimmed_1_val_1_fastqc.html", - "WT_REP2_trimmed_1_val_1_fastqc.zip", - "WT_REP2_trimmed_2_val_2_fastqc.html", - "WT_REP2_trimmed_2_val_2_fastqc.zip" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T13:59:53.266348" - }, - "star_salmon/dupradar": { - "content": [ - "RAP1_IAA_30M_REP1_dupMatrix.txt:md5,2e0d518a450bb57801cdd075d4e9c217", - "RAP1_UNINDUCED_REP1_dupMatrix.txt:md5,96e2f9e1fc5a22a7d468e6fb4a613370", - "RAP1_UNINDUCED_REP2_dupMatrix.txt:md5,28c30ce734d78d53b1c47c3f87414e4b", - "WT_REP1_dupMatrix.txt:md5,b6aa1b99d91f5fa7a94efeed1c496c00", - "WT_REP2_dupMatrix.txt:md5,02236769150436cf31b7339f612119a5", - "RAP1_IAA_30M_REP1_intercept_slope.txt:md5,c677048855caf5190f29fa5f7137cd79", - "RAP1_UNINDUCED_REP1_intercept_slope.txt:md5,ea1b4323d3bc83759e8a026416bca32b", - "RAP1_UNINDUCED_REP2_intercept_slope.txt:md5,b062f49a5223a3452075062cdd308043", - "WT_REP1_intercept_slope.txt:md5,e7fcac6d125a7ba746a5cba4a1e66aef", - "WT_REP2_intercept_slope.txt:md5,5af16b07a734b73a2c1103b535f9e26e", - "RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf", - "RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf", - "RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf", - "WT_REP1_duprateExpBoxplot.pdf", - "WT_REP2_duprateExpBoxplot.pdf", - "RAP1_IAA_30M_REP1_expressionHist.pdf", - "RAP1_UNINDUCED_REP1_expressionHist.pdf", - "RAP1_UNINDUCED_REP2_expressionHist.pdf", - "WT_REP1_expressionHist.pdf", - "WT_REP2_expressionHist.pdf", - "RAP1_IAA_30M_REP1_duprateExpDens.pdf", - "RAP1_UNINDUCED_REP1_duprateExpDens.pdf", - "RAP1_UNINDUCED_REP2_duprateExpDens.pdf", - "WT_REP1_duprateExpDens.pdf", - "WT_REP2_duprateExpDens.pdf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T13:59:54.879476" - }, - "bbsplit": { - "content": [ - "RAP1_IAA_30M_REP1.stats.txt", - "RAP1_UNINDUCED_REP1.stats.txt", - "RAP1_UNINDUCED_REP2.stats.txt", - "WT_REP1.stats.txt", - "WT_REP2.stats.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T16:18:49.803978" - }, - "star_salmon/qualimap": { - "content": [ - "Coverage Profile Along Genes (High).png:md5,876c1b88f33bd3e5fe1a41679729573d", - "Coverage Profile Along Genes (Low).png:md5,ee1f2c9cc4dd4867811eda1e68864ab4", - "Coverage Profile Along Genes (Total).png:md5,53747a8f9813744902756ad60638380a", - "Transcript coverage histogram.png:md5,4f9072d4b11216373b59396293803a37", - "coverage_profile_along_genes_(high).txt:md5,fcb06d460810c0555de5396b9dae05e8", - "coverage_profile_along_genes_(low).txt:md5,e3c9a1ddfdb89f8534ff7548b70fce32", - "coverage_profile_along_genes_(total).txt:md5,e3c9a1ddfdb89f8534ff7548b70fce32", - "Coverage Profile Along Genes (High).png:md5,bbf0531018e7fccfc1dfdd1c05715518", - "Coverage Profile Along Genes (Low).png:md5,3c147d9c831d4be98615a22a72fad05d", - "Coverage Profile Along Genes (Total).png:md5,5a8a6db3a8d19a2dcb8f715b11e67c50", - "Transcript coverage histogram.png:md5,488440d7b6d73bcd4567316712e281fe", - "coverage_profile_along_genes_(high).txt:md5,9f1e29a4d6eec52e8796b080daaedca3", - "coverage_profile_along_genes_(low).txt:md5,353f42a84ff34167646fc83909eac2ff", - "coverage_profile_along_genes_(total).txt:md5,353f42a84ff34167646fc83909eac2ff", - "Coverage Profile Along Genes (High).png:md5,5a5d99cc7a1dba3762d67f4aa4adad58", - "Coverage Profile Along Genes (Low).png:md5,b6adc296e9a732aa0495a6da8fa4ed90", - "Coverage Profile Along Genes (Total).png:md5,fcb94fb9c1a51c1db32f884d05929cc8", - "Transcript coverage histogram.png:md5,3aeb52ff3e3752727a370b0d7ceb0518", - "coverage_profile_along_genes_(high).txt:md5,3b20a736708df02ea8c86dc5829ae67e", - "coverage_profile_along_genes_(low).txt:md5,02b314b76ef1317f20e129412340755d", - "coverage_profile_along_genes_(total).txt:md5,02b314b76ef1317f20e129412340755d", - "Coverage Profile Along Genes (High).png:md5,c974d47996bcc57b99dfaf6903f61f41", - "Coverage Profile Along Genes (Low).png:md5,c8fe631f0580c93adb5be107c6a7a1a3", - "Coverage Profile Along Genes (Total).png:md5,424d245e9f3e626d9e79f51d1b93e946", - "Transcript coverage histogram.png:md5,17404146ad5e0a9bce97ce622e00975e", - "coverage_profile_along_genes_(high).txt:md5,8bf366c7dbc6170035ee64a057c581f1", - "coverage_profile_along_genes_(low).txt:md5,a9102de3ff9679d1f7a86afa85997211", - "coverage_profile_along_genes_(total).txt:md5,a9102de3ff9679d1f7a86afa85997211", - "Coverage Profile Along Genes (High).png:md5,40edd79c21f3e8d8bbac384156c472d6", - "Coverage Profile Along Genes (Low).png:md5,935c0372259a953a4c99569e9b236ae5", - "Coverage Profile Along Genes (Total).png:md5,34f7a4307be1ea674b7b98eee564d96b", - "Transcript coverage histogram.png:md5,e2abf8a9c62fef57f0be1ca0e01e502d", - "coverage_profile_along_genes_(high).txt:md5,3f13eb908d6e97e6831306e9527cc2e3", - "coverage_profile_along_genes_(low).txt:md5,24df553662d0cedaa74cf06a8fead40b", - "coverage_profile_along_genes_(total).txt:md5,24df553662d0cedaa74cf06a8fead40b", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" + "nextflow": "24.08.0" }, - "timestamp": "2024-08-26T12:44:57.740534" + "timestamp": "2024-10-02T08:39:09.000328" } } \ No newline at end of file diff --git a/tests/featurecounts_group_type.nf.test b/tests/featurecounts_group_type.nf.test index 16794293b..fcd11c1da 100644 --- a/tests/featurecounts_group_type.nf.test +++ b/tests/featurecounts_group_type.nf.test @@ -13,878 +13,22 @@ nextflow_pipeline { } then { + // stable_name: All files + folders in ${params.outdir}/ with a stable name + def stable_name = getAllFilesFromDir(params.outdir, true, ['pipeline_info/*.{html,json,txt}'], null) + // stable_path: All files in ${params.outdir}/ with stable content + def stable_path = getAllFilesFromDir(params.outdir, false, null, 'tests/.nftignore') assertAll( - { assert workflow.success }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/bbsplit/RAP1_IAA_30M_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/RAP1_UNINDUCED_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/RAP1_UNINDUCED_REP2.stats.txt").name, - file("${params.outdir}/bbsplit/WT_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/WT_REP2.stats.txt").name - ).match("bbsplit") }, - { assert snapshot( - path("${params.outdir}/custom/out/genome_gfp.fasta"), - path("${params.outdir}/custom/out/genome_gfp.gtf") - ).match("references") }, - { assert snapshot( - // HTMLs and ZIPs are not stable - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_2_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_2_fastqc.zip").name - ).match("fastqc/raw") }, - { assert snapshot( - // HTMLs and ZIPs are not stable - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.zip").name - ).match("fastqc/trim") }, - { assert snapshot( - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/cutadapt_filtered_reads_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc-status-check-heatmap-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc-status-check-heatmap.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_adapter_content_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_overrepresented_sequences_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_overrepresented_sequences_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_base_n_content_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_base_n_content_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_base_sequence_quality_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_base_sequence_quality_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Percentages.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Percentages.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_quality_scores_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_quality_scores_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_counts_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_counts_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_duplication_levels_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_duplication_levels_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_length_distribution_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_citations.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_cutadapt.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_fastqc_fastqc_raw.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_fastqc_fastqc_trimmed.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_samtools_idxstats.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_histogram.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_histogram_1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_histogram_2.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_gene_coverage_profile_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_gene_coverage_profile_Normalised.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_rnaseq_cov_hist.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_infer_experiment_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Raw_Counts.txt"), - // These files are not stable - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_top_overrepresented_sequences_table-1.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_top_overrepresented_sequences_table.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/junction_saturation_known.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/junction_saturation_novel.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_data.json").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_dupradar-section-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_fail_strand_check_table.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_general_stats.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_picard_dups.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_bam_stat.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_infer_experiment.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_junction_annotation.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_read_distribution.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_1.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_2.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_3.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_4.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_pca-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_samtools_flagstat.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_samtools_stats.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_software_versions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_sources.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_1.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_2.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_3.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_4.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_pca-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_deduplication.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_genomic_origin.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_rnaseq_genome_results.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_bam_stat.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance_plot_Counts.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance_plot_Percentages.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Events.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Junctions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_all.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_All_Junctions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_Known_Junctions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_Novel_Junctions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_read_distribution_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_read_dups.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_read_dups_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/salmon_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Percentage_of_total.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Read_counts.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-stats-dp.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools_alignment_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/star_alignment_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/star_summary_table.txt").name - ).match("multiqc_data") }, - { assert snapshot( - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/cutadapt_filtered_reads_plot-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/cutadapt_filtered_reads_plot-pct.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Counts.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Obs_Exp.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/dupradar-section-plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc-status-check-heatmap-1.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc-status-check-heatmap.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot-1.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Counts.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Percentages.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Counts.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Percentages.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot-1.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-pct.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-pct.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot-1.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/qualimap_gene_coverage_profile_Counts.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/qualimap_gene_coverage_profile_Normalised.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_infer_experiment_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_dups_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png"), - // PDFs, SVGs, some PNGs and HTML reports are not stable - file("${params.outdir}/multiqc/star_salmon/multiqc_report.html").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/dupradar-section-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fail_strand_check_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc-status-check-heatmap-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc-status-check-heatmap.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_adapter_content_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Percentages.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Percentages.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_length_distribution_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/general_stats_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Normalised.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_genomic_origin-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_genomic_origin-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_bam_stat.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_infer_experiment_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Percentages.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_All_Junctions.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Known_Junctions.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Novel_Junctions.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_distribution_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_distribution_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_dups_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/salmon_deseq2_clustering-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/salmon_deseq2_pca-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/salmon_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Percentage_of_total.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Read_counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-stats-dp.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_salmon_deseq2_clustering-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_salmon_deseq2_pca-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_summary_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fail_strand_check_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_adapter_content_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_n_content_plot-1.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_n_content_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot-1.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_length_distribution_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table-1.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/general_stats_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/qualimap_genomic_origin-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/qualimap_genomic_origin-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_bam_stat.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_inner_distance_plot_Counts.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_inner_distance_plot_Percentages.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_All_Junctions.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_Known_Junctions.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_Novel_Junctions.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_distribution_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_distribution_plot-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/salmon_deseq2_clustering-plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/salmon_deseq2_pca-plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/salmon_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Percentage_of_total.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Read_counts.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-stats-dp.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_salmon_deseq2_clustering-plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_salmon_deseq2_pca-plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_summary_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/dupradar-section-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fail_strand_check_table.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc-status-check-heatmap-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc-status-check-heatmap.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_adapter_content_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_n_content_plot-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_n_content_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Percentages.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Percentages.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_length_distribution_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/general_stats_table.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Normalised.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/qualimap_genomic_origin-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/qualimap_genomic_origin-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_bam_stat.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_infer_experiment_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_inner_distance_plot_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_inner_distance_plot_Percentages.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_All_Junctions.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Known_Junctions.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Novel_Junctions.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_distribution_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_distribution_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_dups_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/salmon_deseq2_clustering-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/salmon_deseq2_pca-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/salmon_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Percentage_of_total.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Read_counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-stats-dp.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_salmon_deseq2_clustering-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_salmon_deseq2_pca-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_summary_table.svg").name - ).match("multiqc_plots") }, - { assert snapshot( - path("${params.outdir}/salmon/deseq2_qc/R_sessionInfo.log"), - // These files are not stable - file("${params.outdir}/salmon/deseq2_qc/deseq2.dds.RData").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.pca.vals.txt").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.plots.pdf").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.sample.dists.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/WT_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/WT_REP2.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/deseq2.size_factors.RData").name - ).match("salmon/deseq2_qc") }, - { assert snapshot( - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/lib_format_counts.json"), - path("${params.outdir}/salmon/WT_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/WT_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/WT_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/WT_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/WT_REP1/cmd_info.json"), - path("${params.outdir}/salmon/WT_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/WT_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/WT_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/WT_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/WT_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/WT_REP2/cmd_info.json"), - path("${params.outdir}/salmon/WT_REP2/lib_format_counts.json"), - // These files are not stable - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/quant.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/quant.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/quant.sf").name, - file("${params.outdir}/salmon/WT_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/WT_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/WT_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/WT_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/WT_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/WT_REP1/quant.sf").name, - file("${params.outdir}/salmon/WT_REP2/aux_info/fld.gz").name, - file("${params.outdir}/salmon/WT_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/WT_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/WT_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/WT_REP2/quant.genes.sf").name, - file("${params.outdir}/salmon/WT_REP2/quant.sf").name - ).match("salmon_quant") }, - { assert snapshot( - path("${params.outdir}/salmon/tx2gene.tsv"), - // These files are not stable - file("${params.outdir}/salmon/salmon.merged.gene_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_length_scaled.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_scaled.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_lengths.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_tpm.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.transcript_counts.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_lengths.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_tpm.tsv").name - ).match("salmon") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/star_salmon/bigwig/RAP1_IAA_30M_REP1.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_IAA_30M_REP1.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP1.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP1.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP2.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP2.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/WT_REP1.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/WT_REP1.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/WT_REP2.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/WT_REP2.reverse.bigWig").name - ).match("star_salmon/bigwig") }, - { assert snapshot( - path("${params.outdir}/star_salmon/deseq2_qc/R_sessionInfo.log"), - // These files are not stable - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/WT_REP1.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/WT_REP2.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/deseq2.size_factors.RData").name, - file("${params.outdir}/star_salmon/deseq2_qc/deseq2.dds.RData").name, - file("${params.outdir}/star_salmon/deseq2_qc/deseq2.pca.vals.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/deseq2.plots.pdf").name, - file("${params.outdir}/star_salmon/deseq2_qc/deseq2.sample.dists.txt").name - ).match("star_salmon/deseq2_qc") }, - { assert snapshot( - path("${params.outdir}/star_salmon/dupradar/gene_data/RAP1_IAA_30M_REP1_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/gene_data/RAP1_UNINDUCED_REP1_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/gene_data/RAP1_UNINDUCED_REP2_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/gene_data/WT_REP1_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/gene_data/WT_REP2_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/RAP1_IAA_30M_REP1_intercept_slope.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/RAP1_UNINDUCED_REP1_intercept_slope.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/RAP1_UNINDUCED_REP2_intercept_slope.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/WT_REP1_intercept_slope.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/WT_REP2_intercept_slope.txt"), - // PDFs are not stable - file("${params.outdir}/star_salmon/dupradar/box_plot/RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/box_plot/RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/box_plot/RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/box_plot/WT_REP1_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/box_plot/WT_REP2_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/RAP1_IAA_30M_REP1_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/RAP1_UNINDUCED_REP1_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/RAP1_UNINDUCED_REP2_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/WT_REP1_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/WT_REP2_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/RAP1_IAA_30M_REP1_duprateExpDens.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/RAP1_UNINDUCED_REP1_duprateExpDens.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/RAP1_UNINDUCED_REP2_duprateExpDens.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/WT_REP1_duprateExpDens.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/WT_REP2_duprateExpDens.pdf").name - ).match("star_salmon/dupradar") }, - { assert snapshot( - path("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/WT_REP1.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/WT_REP2.SJ.out.tab"), - // Logs are not stable - file("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.Log.final.out").name, - file("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.Log.out").name, - file("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.Log.final.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.Log.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.Log.final.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.Log.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/WT_REP1.Log.final.out").name, - file("${params.outdir}/star_salmon/log/WT_REP1.Log.out").name, - file("${params.outdir}/star_salmon/log/WT_REP1.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/WT_REP2.Log.final.out").name, - file("${params.outdir}/star_salmon/log/WT_REP2.Log.out").name, - file("${params.outdir}/star_salmon/log/WT_REP2.Log.progress.out").name - ).match("star_salmon/log") }, - { assert snapshot( - // Metrics are not stable - file("${params.outdir}/star_salmon/picard_metrics/RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt").name - ).match("star_salmon/picard_metrics") }, - { assert snapshot( - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - // HTML reports and these files are not stable - file("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP1/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP1/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP2/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP2/rnaseq_qc_results.txt").name - ).match("star_salmon/qualimap") }, - { assert snapshot( - path("${params.outdir}/star_salmon/rseqc/infer_experiment/RAP1_IAA_30M_REP1.infer_experiment.txt"), - path("${params.outdir}/star_salmon/rseqc/infer_experiment/RAP1_UNINDUCED_REP1.infer_experiment.txt"), - path("${params.outdir}/star_salmon/rseqc/infer_experiment/RAP1_UNINDUCED_REP2.infer_experiment.txt"), - path("${params.outdir}/star_salmon/rseqc/infer_experiment/WT_REP1.infer_experiment.txt"), - path("${params.outdir}/star_salmon/rseqc/infer_experiment/WT_REP2.infer_experiment.txt"), - // PDFs, R scripts and all these files are not stable - file("${params.outdir}/star_salmon/rseqc/bam_stat/RAP1_IAA_30M_REP1.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/bam_stat/RAP1_UNINDUCED_REP1.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/bam_stat/RAP1_UNINDUCED_REP2.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/bam_stat/WT_REP1.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/bam_stat/WT_REP2.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/pdf/RAP1_IAA_30M_REP1.inner_distance_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/pdf/WT_REP1.inner_distance_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/pdf/WT_REP2.inner_distance_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/rscript/RAP1_IAA_30M_REP1.inner_distance_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/rscript/WT_REP1.inner_distance_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/rscript/WT_REP2.inner_distance_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_freq.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_mean.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance_freq.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance_mean.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance_freq.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance_mean.txt").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/WT_REP1.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/WT_REP1.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/WT_REP2.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/WT_REP2.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/RAP1_IAA_30M_REP1.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP1.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP2.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/WT_REP1.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/WT_REP2.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/WT_REP1.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/WT_REP1.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/WT_REP2.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/WT_REP2.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/RAP1_IAA_30M_REP1.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP1.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP2.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/WT_REP1.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/WT_REP2.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/RAP1_IAA_30M_REP1.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP1.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP2.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/WT_REP1.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/WT_REP2.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/WT_REP1.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/WT_REP2.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/RAP1_IAA_30M_REP1.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP1.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP2.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/WT_REP1.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/WT_REP2.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/RAP1_IAA_30M_REP1.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/RAP1_UNINDUCED_REP1.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/RAP1_UNINDUCED_REP2.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/WT_REP1.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/WT_REP2.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/RAP1_IAA_30M_REP1.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP1.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP2.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/WT_REP1.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/WT_REP2.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/RAP1_IAA_30M_REP1.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP1.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP2.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/WT_REP1.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/WT_REP2.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.seq.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.seq.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.seq.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/WT_REP1.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/WT_REP1.seq.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/WT_REP2.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/WT_REP2.seq.DupRate.xls").name - ).match("star_salmon/rseqc") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/star_salmon/salmon.merged.gene_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_length_scaled.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_scaled.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_lengths.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_tpm.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_counts.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_lengths.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_tpm.tsv").name - ).match("star_salmon/salmon") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.sorted.bam.stats").name - ).match("star_salmon/samtools_stats") }, - { assert snapshot( - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/i_data.ctab"), - // These files are not stable - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP1.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP1.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP1.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP2.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP2.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP2.transcripts.gtf").name - ).match("star_salmon/stringtie") }, - { assert snapshot( - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/WT_REP1.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/WT_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/WT_REP2.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/WT_REP2.markdup.sorted.bam.bai").name - ).match("star_salmon/markdup") }, - { assert snapshot( - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/cmd_info.json"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/cmd_info.json"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/cmd_info.json"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/WT_REP1/cmd_info.json"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/WT_REP2/cmd_info.json"), - path("${params.outdir}/star_salmon/tx2gene.tsv"), - // These files are not stable - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/quant.genes.sf").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/quant.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/quant.genes.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/quant.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/quant.genes.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/quant.sf").name, - file("${params.outdir}/star_salmon/WT_REP1/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/WT_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/WT_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/WT_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/WT_REP1/quant.genes.sf").name, - file("${params.outdir}/star_salmon/WT_REP1/quant.sf").name, - file("${params.outdir}/star_salmon/WT_REP2/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/WT_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/WT_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/WT_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/WT_REP2/quant.genes.sf").name, - file("${params.outdir}/star_salmon/WT_REP2/quant.sf").name - ).match("star_salmon/salmon_quant") }, - { assert snapshot( - // These reports are not stable - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt").name - ).match("trimgalore") }, - { assert snapshot( - UTILS.removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml") - ).match("versions") } + { assert workflow.success}, + { assert snapshot( + // Number of successful tasks + workflow.trace.succeeded().size(), + // pipeline versions.yml file for multiqc from which Nextflow version is removed because we tests pipelines on multiple Nextflow versions + removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), + // All stable path name, with a relative path + getRelativePath(stable_name, outputDir), + // All files with stable contents + stable_path + ).match() } ) } } @@ -901,31 +45,21 @@ nextflow_pipeline { } then { + // stable_name: All files + folders in ${params.outdir}/ with a stable name + def stable_name = getAllFilesFromDir(params.outdir, true, ['pipeline_info/*.{html,json,txt}'], null) + // stable_path: All files in ${params.outdir}/ with stable content + def stable_path = getAllFilesFromDir(params.outdir, false, null, 'tests/.nftignore') assertAll( - { assert workflow.success }, - { assert snapshot( - UTILS.removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), - file("${params.outdir}/custom/out/genome_transcriptome.fasta").name, - file("${params.outdir}/custom/out/genome_transcriptome.gtf").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw.zip").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report.html").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt").name + { assert workflow.success}, + { assert snapshot( + // Number of successful tasks + workflow.trace.succeeded().size(), + // pipeline versions.yml file for multiqc from which Nextflow version is removed because we tests pipelines on multiple Nextflow versions + removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), + // All stable path name, with a relative path + getRelativePath(stable_name, outputDir), + // All files with stable contents + stable_path ).match() } ) } diff --git a/tests/featurecounts_group_type.nf.test.snap b/tests/featurecounts_group_type.nf.test.snap index 3a08ab907..a74557fc7 100644 --- a/tests/featurecounts_group_type.nf.test.snap +++ b/tests/featurecounts_group_type.nf.test.snap @@ -1,1044 +1,1546 @@ { - "star_salmon/log": { - "content": [ - "RAP1_IAA_30M_REP1.SJ.out.tab:md5,ea95e243278af55534f2c52eb5fff7ee", - "RAP1_UNINDUCED_REP1.SJ.out.tab:md5,e548d13942535dc0821f3ec6d9743ec8", - "RAP1_UNINDUCED_REP2.SJ.out.tab:md5,1f294365343a1a5e95682792fdb77033", - "WT_REP1.SJ.out.tab:md5,1350c2fa6a675bf107386c6cd3fc5204", - "WT_REP2.SJ.out.tab:md5,f6cc03643a5e3c1025a5b4754eb1be23", - "RAP1_IAA_30M_REP1.Log.final.out", - "RAP1_IAA_30M_REP1.Log.out", - "RAP1_IAA_30M_REP1.Log.progress.out", - "RAP1_UNINDUCED_REP1.Log.final.out", - "RAP1_UNINDUCED_REP1.Log.out", - "RAP1_UNINDUCED_REP1.Log.progress.out", - "RAP1_UNINDUCED_REP2.Log.final.out", - "RAP1_UNINDUCED_REP2.Log.out", - "RAP1_UNINDUCED_REP2.Log.progress.out", - "WT_REP1.Log.final.out", - "WT_REP1.Log.out", - "WT_REP1.Log.progress.out", - "WT_REP2.Log.final.out", - "WT_REP2.Log.out", - "WT_REP2.Log.progress.out" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T17:43:26.652121" - }, - "star_salmon/salmon_quant": { - "content": [ - "ambig_info.tsv:md5,f9a605d54a0a103566f7a9b8e0867a73", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,4cc2492f557e5e0a2911a0bd83a51020", - "ambig_info.tsv:md5,8f97be8af4e47cc48650c62227a40203", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,dc750c3564c63da54979c852794d58a5", - "ambig_info.tsv:md5,a044fe7a3ad445c9a91a0d54ab5015d1", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,db43ed650e6e7b42cd2c5b8101bb6748", - "ambig_info.tsv:md5,7a8ea02d74058efb801e8c62bca96fd4", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,e418b4e899623449c6babdf53e5aabde", - "ambig_info.tsv:md5,543a047a549437026a1363ea8ddf5b03", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,f234c8d322df3b59d990594c63b24eae", - "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T13:34:18.439694" - }, - "multiqc_data": { - "content": [ - "cutadapt_filtered_reads_plot.txt:md5,bf033e64e9d23bee85b6277f11c663f1", - "cutadapt_trimmed_sequences_plot_3_Counts.txt:md5,13dfa866fd91dbb072689efe9aa83b1f", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt:md5,07145dd8dd3db654859b18eb0389046c", - "fastqc-status-check-heatmap-1.txt:md5,22a03548736b88b23be6bc0c9ef1b4a6", - "fastqc-status-check-heatmap.txt:md5,5a89b0d8d162f6b1dbdaf39457bbc03b", - "fastqc_adapter_content_plot.txt:md5,da0389be84cfdd189b1d045212eb2974", - "fastqc_overrepresented_sequences_plot-1.txt:md5,4adfeacd3a3a6c7c808f121b24e6b247", - "fastqc_overrepresented_sequences_plot.txt:md5,25d88ea8a72f55e8a374ae802bc7f0b1", - "fastqc_per_base_n_content_plot-1.txt:md5,418610c1ce119cb786ad434db75d366e", - "fastqc_per_base_n_content_plot.txt:md5,d368d7e36ca2f73dcde61f2b486d8213", - "fastqc_per_base_sequence_quality_plot-1.txt:md5,bd22e06e41c096ad4f745d40fe96a1e5", - "fastqc_per_base_sequence_quality_plot.txt:md5,5c3065b549129702b185ea1b817da420", - "fastqc_per_sequence_gc_content_plot-1_Counts.txt:md5,004c60768ceb6197765154e3eaa37b7a", - "fastqc_per_sequence_gc_content_plot-1_Percentages.txt:md5,95d29060b687f745288ad1ec47750037", - "fastqc_per_sequence_gc_content_plot_Counts.txt:md5,9ddaa50167117d3c9188ccf015427704", - "fastqc_per_sequence_gc_content_plot_Percentages.txt:md5,f10ee2881b61308af35f304aa3d810a3", - "fastqc_per_sequence_quality_scores_plot-1.txt:md5,0f9834cc19f76dd5c87cf8cba7435a7c", - "fastqc_per_sequence_quality_scores_plot.txt:md5,b5f9a02933e3065952237afd2ec9ce82", - "fastqc_sequence_counts_plot-1.txt:md5,3861354bbedfbde7ca36a72994f9425c", - "fastqc_sequence_counts_plot.txt:md5,d385a3e2c2573a0902c66e8c93876d3c", - "fastqc_sequence_duplication_levels_plot-1.txt:md5,c73407d55fc532e864fa1dc8dbc12874", - "fastqc_sequence_duplication_levels_plot.txt:md5,8812cee16f6ca65e2c33635754de1772", - "fastqc_sequence_length_distribution_plot.txt:md5,6fe2c985606abad947bcca99b015ae33", - "multiqc_citations.txt:md5,2d2ab6df367e36e98e081c33dec187a0", - "multiqc_cutadapt.txt:md5,aac9581a5670cb55edf564f3d6c1f9a7", - "multiqc_fastqc_fastqc_raw.txt:md5,81c3c1a2575a1891a7f2a9637a0f2cc0", - "multiqc_fastqc_fastqc_trimmed.txt:md5,a3238f515e01d158d875d69968753804", - "multiqc_samtools_idxstats.txt:md5,fd7d03a91f0b9e01a6939941f7f2243f", - "picard_histogram.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "picard_histogram_1.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "picard_histogram_2.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "qualimap_gene_coverage_profile_Counts.txt:md5,02044ed1bf1eca19a8a87c9971cdc049", - "qualimap_gene_coverage_profile_Normalised.txt:md5,eeeea7f50278b3b335bef545784abbfa", - "qualimap_rnaseq_cov_hist.txt:md5,51407e597076f3a7f98622213bea6bce", - "rseqc_infer_experiment_plot.txt:md5,de5a0bad9cca763928e7c33375eb5218", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt:md5,75acd04232d1804b5f960ee4c5db4722", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt:md5,ae45731d8d4595f77e6b271004f3a070", - "samtools-idxstats-mapped-reads-plot_Raw_Counts.txt:md5,01637c600d3840500851eb4118564cc6", - "fastqc_top_overrepresented_sequences_table-1.txt", - "fastqc_top_overrepresented_sequences_table.txt", - "junction_saturation_known.txt", - "junction_saturation_novel.txt", - "multiqc_data.json", - "multiqc_dupradar-section-plot.txt", - "multiqc_fail_strand_check_table.txt", - "multiqc_general_stats.txt", - "multiqc_picard_dups.txt", - "multiqc_rseqc_bam_stat.txt", - "multiqc_rseqc_infer_experiment.txt", - "multiqc_rseqc_junction_annotation.txt", - "multiqc_rseqc_read_distribution.txt", - "multiqc_salmon.txt", - "multiqc_salmon_deseq2_clustering-plot.txt", - "multiqc_salmon_deseq2_clustering-plot_1.txt", - "multiqc_salmon_deseq2_clustering-plot_2.txt", - "multiqc_salmon_deseq2_clustering-plot_3.txt", - "multiqc_salmon_deseq2_clustering-plot_4.txt", - "multiqc_salmon_deseq2_pca-plot.txt", - "multiqc_samtools_flagstat.txt", - "multiqc_samtools_stats.txt", - "multiqc_software_versions.txt", - "multiqc_sources.txt", - "multiqc_star.txt", - "multiqc_star_salmon_deseq2_clustering-plot.txt", - "multiqc_star_salmon_deseq2_clustering-plot_1.txt", - "multiqc_star_salmon_deseq2_clustering-plot_2.txt", - "multiqc_star_salmon_deseq2_clustering-plot_3.txt", - "multiqc_star_salmon_deseq2_clustering-plot_4.txt", - "multiqc_star_salmon_deseq2_pca-plot.txt", - "picard_deduplication.txt", - "qualimap_genomic_origin.txt", - "qualimap_rnaseq_genome_results.txt", - "rseqc_bam_stat.txt", - "rseqc_inner_distance.txt", - "rseqc_inner_distance_plot_Counts.txt", - "rseqc_inner_distance_plot_Percentages.txt", - "rseqc_junction_annotation_junctions_plot_Events.txt", - "rseqc_junction_annotation_junctions_plot_Junctions.txt", - "rseqc_junction_saturation_all.txt", - "rseqc_junction_saturation_plot_All_Junctions.txt", - "rseqc_junction_saturation_plot_Known_Junctions.txt", - "rseqc_junction_saturation_plot_Novel_Junctions.txt", - "rseqc_read_distribution_plot.txt", - "rseqc_read_dups.txt", - "rseqc_read_dups_plot.txt", - "salmon_plot.txt", - "samtools-flagstat-dp_Percentage_of_total.txt", - "samtools-flagstat-dp_Read_counts.txt", - "samtools-stats-dp.txt", - "samtools_alignment_plot.txt", - "star_alignment_plot.txt", - "star_summary_table.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T18:50:10.937365" - }, - "trimgalore": { - "content": [ - "RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T17:43:26.995324" - }, - "star_salmon/rseqc": { - "content": [ - "RAP1_IAA_30M_REP1.infer_experiment.txt:md5,169d25b95c008bebe9ce886fea6a4e33", - "RAP1_UNINDUCED_REP1.infer_experiment.txt:md5,2ca0ce0fd3204bd2cc4812c4655b1f1f", - "RAP1_UNINDUCED_REP2.infer_experiment.txt:md5,7d5705880188f9beab1939e08d6b8f40", - "WT_REP1.infer_experiment.txt:md5,bf0c137f5fca06e7c40e1984a1acb06d", - "WT_REP2.infer_experiment.txt:md5,82e23b329ee60709f343bc2d17d43b14", - "RAP1_IAA_30M_REP1.bam_stat.txt", - "RAP1_UNINDUCED_REP1.bam_stat.txt", - "RAP1_UNINDUCED_REP2.bam_stat.txt", - "WT_REP1.bam_stat.txt", - "WT_REP2.bam_stat.txt", - "RAP1_IAA_30M_REP1.inner_distance_plot.pdf", - "WT_REP1.inner_distance_plot.pdf", - "WT_REP2.inner_distance_plot.pdf", - "RAP1_IAA_30M_REP1.inner_distance_plot.r", - "WT_REP1.inner_distance_plot.r", - "WT_REP2.inner_distance_plot.r", - "RAP1_IAA_30M_REP1.inner_distance.txt", - "RAP1_IAA_30M_REP1.inner_distance_freq.txt", - "RAP1_IAA_30M_REP1.inner_distance_mean.txt", - "WT_REP1.inner_distance.txt", - "WT_REP1.inner_distance_freq.txt", - "WT_REP1.inner_distance_mean.txt", - "WT_REP2.inner_distance.txt", - "WT_REP2.inner_distance_freq.txt", - "WT_REP2.inner_distance_mean.txt", - "RAP1_IAA_30M_REP1.junction.Interact.bed", - "RAP1_IAA_30M_REP1.junction.bed", - "RAP1_UNINDUCED_REP1.junction.Interact.bed", - "RAP1_UNINDUCED_REP1.junction.bed", - "RAP1_UNINDUCED_REP2.junction.Interact.bed", - "RAP1_UNINDUCED_REP2.junction.bed", - "WT_REP1.junction.Interact.bed", - "WT_REP1.junction.bed", - "WT_REP2.junction.Interact.bed", - "WT_REP2.junction.bed", - "RAP1_IAA_30M_REP1.junction_annotation.log", - "RAP1_UNINDUCED_REP1.junction_annotation.log", - "RAP1_UNINDUCED_REP2.junction_annotation.log", - "WT_REP1.junction_annotation.log", - "WT_REP2.junction_annotation.log", - "RAP1_IAA_30M_REP1.splice_events.pdf", - "RAP1_IAA_30M_REP1.splice_junction.pdf", - "RAP1_UNINDUCED_REP1.splice_events.pdf", - "RAP1_UNINDUCED_REP1.splice_junction.pdf", - "RAP1_UNINDUCED_REP2.splice_events.pdf", - "RAP1_UNINDUCED_REP2.splice_junction.pdf", - "WT_REP1.splice_events.pdf", - "WT_REP1.splice_junction.pdf", - "WT_REP2.splice_events.pdf", - "WT_REP2.splice_junction.pdf", - "RAP1_IAA_30M_REP1.junction_plot.r", - "RAP1_UNINDUCED_REP1.junction_plot.r", - "RAP1_UNINDUCED_REP2.junction_plot.r", - "WT_REP1.junction_plot.r", - "WT_REP2.junction_plot.r", - "RAP1_IAA_30M_REP1.junction.xls", - "RAP1_UNINDUCED_REP1.junction.xls", - "RAP1_UNINDUCED_REP2.junction.xls", - "WT_REP1.junction.xls", - "WT_REP2.junction.xls", - "RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf", - "RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf", - "RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf", - "WT_REP1.junctionSaturation_plot.pdf", - "WT_REP2.junctionSaturation_plot.pdf", - "RAP1_IAA_30M_REP1.junctionSaturation_plot.r", - "RAP1_UNINDUCED_REP1.junctionSaturation_plot.r", - "RAP1_UNINDUCED_REP2.junctionSaturation_plot.r", - "WT_REP1.junctionSaturation_plot.r", - "WT_REP2.junctionSaturation_plot.r", - "RAP1_IAA_30M_REP1.read_distribution.txt", - "RAP1_UNINDUCED_REP1.read_distribution.txt", - "RAP1_UNINDUCED_REP2.read_distribution.txt", - "WT_REP1.read_distribution.txt", - "WT_REP2.read_distribution.txt", - "RAP1_IAA_30M_REP1.DupRate_plot.pdf", - "RAP1_UNINDUCED_REP1.DupRate_plot.pdf", - "RAP1_UNINDUCED_REP2.DupRate_plot.pdf", - "WT_REP1.DupRate_plot.pdf", - "WT_REP2.DupRate_plot.pdf", - "RAP1_IAA_30M_REP1.DupRate_plot.r", - "RAP1_UNINDUCED_REP1.DupRate_plot.r", - "RAP1_UNINDUCED_REP2.DupRate_plot.r", - "WT_REP1.DupRate_plot.r", - "WT_REP2.DupRate_plot.r", - "RAP1_IAA_30M_REP1.pos.DupRate.xls", - "RAP1_IAA_30M_REP1.seq.DupRate.xls", - "RAP1_UNINDUCED_REP1.pos.DupRate.xls", - "RAP1_UNINDUCED_REP1.seq.DupRate.xls", - "RAP1_UNINDUCED_REP2.pos.DupRate.xls", - "RAP1_UNINDUCED_REP2.seq.DupRate.xls", - "WT_REP1.pos.DupRate.xls", - "WT_REP1.seq.DupRate.xls", - "WT_REP2.pos.DupRate.xls", - "WT_REP2.seq.DupRate.xls" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T14:18:39.109008" - }, - "references": { - "content": [ - "genome_gfp.fasta:md5,e23e302af63736a199985a169fdac055", - "genome_gfp.gtf:md5,b4776accd1bf7206c7ab0f1d84e4721e" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T15:44:10.068551" - }, - "star_salmon/deseq2_qc": { - "content": [ - "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", - "RAP1_IAA_30M_REP1.txt", - "RAP1_UNINDUCED_REP1.txt", - "RAP1_UNINDUCED_REP2.txt", - "WT_REP1.txt", - "WT_REP2.txt", - "deseq2.size_factors.RData", - "deseq2.dds.RData", - "deseq2.pca.vals.txt", - "deseq2.plots.pdf", - "deseq2.sample.dists.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T12:28:48.071152" - }, - "star_salmon/markdup": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.bam", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.bai", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai", - "WT_REP1.markdup.sorted.bam", - "WT_REP1.markdup.sorted.bam.bai", - "WT_REP2.markdup.sorted.bam", - "WT_REP2.markdup.sorted.bam.bai" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T13:34:18.361387" - }, - "star_salmon/samtools_stats": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.stats", - "RAP1_IAA_30M_REP1.sorted.bam.flagstat", - "RAP1_IAA_30M_REP1.sorted.bam.idxstats", - "RAP1_IAA_30M_REP1.sorted.bam.stats", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats", - "RAP1_UNINDUCED_REP1.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP1.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP1.sorted.bam.stats", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats", - "RAP1_UNINDUCED_REP2.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP2.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP2.sorted.bam.stats", - "WT_REP1.markdup.sorted.bam.flagstat", - "WT_REP1.markdup.sorted.bam.idxstats", - "WT_REP1.markdup.sorted.bam.stats", - "WT_REP1.sorted.bam.flagstat", - "WT_REP1.sorted.bam.idxstats", - "WT_REP1.sorted.bam.stats", - "WT_REP2.markdup.sorted.bam.flagstat", - "WT_REP2.markdup.sorted.bam.idxstats", - "WT_REP2.markdup.sorted.bam.stats", - "WT_REP2.sorted.bam.flagstat", - "WT_REP2.sorted.bam.idxstats", - "WT_REP2.sorted.bam.stats" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T18:50:11.105038" - }, - "salmon/deseq2_qc": { - "content": [ - "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", - "deseq2.dds.RData", - "deseq2.pca.vals.txt", - "deseq2.plots.pdf", - "deseq2.sample.dists.txt", - "RAP1_IAA_30M_REP1.txt", - "RAP1_UNINDUCED_REP1.txt", - "RAP1_UNINDUCED_REP2.txt", - "WT_REP1.txt", - "WT_REP2.txt", - "deseq2.size_factors.RData" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T17:34:58.241817" - }, - "salmon": { - "content": [ - "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", - "salmon.merged.gene_counts.SummarizedExperiment.rds", - "salmon.merged.gene_counts.tsv", - "salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_length_scaled.tsv", - "salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_scaled.tsv", - "salmon.merged.gene_lengths.tsv", - "salmon.merged.gene_tpm.tsv", - "salmon.merged.transcript_counts.SummarizedExperiment.rds", - "salmon.merged.transcript_counts.tsv", - "salmon.merged.transcript_lengths.tsv", - "salmon.merged.transcript_tpm.tsv" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T17:34:58.361409" - }, - "multiqc_plots": { - "content": [ - "cutadapt_filtered_reads_plot-cnt.png:md5,704cf0d91bfa3dd658dd8c9590f669a2", - "cutadapt_filtered_reads_plot-pct.png:md5,2684d8b2afca3300e5786486b80237f0", - "cutadapt_trimmed_sequences_plot_3_Counts.png:md5,bef41d894629b0c4dab4478bbf197f50", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.png:md5,1e0d01537d3797623d0b3fd8fbe42787", - "dupradar-section-plot.png:md5,3ae5e5cb161b7abd878d718bc71b41f6", - "fastqc-status-check-heatmap-1.png:md5,2402522f8c02e12aea9af088c6595890", - "fastqc-status-check-heatmap.png:md5,fe8b5b4ab4480d46a12a9005932a9b84", - "fastqc_overrepresented_sequences_plot-1.png:md5,40e450251b80ec0efc9364434234ec7f", - "fastqc_overrepresented_sequences_plot.png:md5,6f5ffbdf1bf61fabe5e028c8bc85de14", - "fastqc_per_sequence_gc_content_plot-1_Counts.png:md5,8a806cec2142f9911502e0a253d83d13", - "fastqc_per_sequence_gc_content_plot-1_Percentages.png:md5,953929d50c8490029880e205e4db7959", - "fastqc_per_sequence_gc_content_plot_Counts.png:md5,01f124545af788fd5cc7bbf41b005e16", - "fastqc_per_sequence_gc_content_plot_Percentages.png:md5,eba3abf8bedb2cb20bad90c54e9c8881", - "fastqc_per_sequence_quality_scores_plot-1.png:md5,d2c29cae169f35744500c751b4a7366e", - "fastqc_per_sequence_quality_scores_plot.png:md5,42fd7369a8aca78f620164a9e887c3cb", - "fastqc_sequence_counts_plot-1-cnt.png:md5,2874fea747c7ff46828bf4f17668caf8", - "fastqc_sequence_counts_plot-1-pct.png:md5,0022d7f5ac78b6eff157de24e37c5ab0", - "fastqc_sequence_counts_plot-cnt.png:md5,3890d5555f2a39b46b9f6efb14cb91f2", - "fastqc_sequence_counts_plot-pct.png:md5,55fa5838c8b2db978fcfa5cb83f6b054", - "fastqc_sequence_duplication_levels_plot-1.png:md5,fcd3b1ec2b95fe4bcd607dc28179a754", - "fastqc_sequence_duplication_levels_plot.png:md5,747431f0f38f8e4c41a11a072fa18780", - "qualimap_gene_coverage_profile_Counts.png:md5,ac424dc7e5444a32e482bd5048ac4432", - "qualimap_gene_coverage_profile_Normalised.png:md5,62e5a2146daec985b8c2de02e3b57c1e", - "rseqc_infer_experiment_plot.png:md5,60c3cafb671fad2cf5f695615230eb8f", - "rseqc_read_dups_plot.png:md5,958513925fa5494bf499c989842d6928", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png:md5,ce6abb232fd5b5f2e66c0fe9a571d75f", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png:md5,6b44818f886ef020fb3646f152ad4af6", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png:md5,d5d8a85b7ad72a0cb93d9283ea12b23f", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png:md5,19317ad8f1448cd7eb1d319f85cc5c4d", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png:md5,a6849cd92ae738441212b681a411614d", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png:md5,4c06988372df63a1fb5f8be93f73ae8f", - "multiqc_report.html", - "cutadapt_filtered_reads_plot-cnt.pdf", - "cutadapt_filtered_reads_plot-pct.pdf", - "cutadapt_trimmed_sequences_plot_3_Counts.pdf", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf", - "dupradar-section-plot.pdf", - "fail_strand_check_table.pdf", - "fastqc-status-check-heatmap-1.pdf", - "fastqc-status-check-heatmap.pdf", - "fastqc_adapter_content_plot.pdf", - "fastqc_overrepresented_sequences_plot-1.pdf", - "fastqc_overrepresented_sequences_plot.pdf", - "fastqc_per_base_n_content_plot-1.pdf", - "fastqc_per_base_n_content_plot.pdf", - "fastqc_per_base_sequence_quality_plot-1.pdf", - "fastqc_per_base_sequence_quality_plot.pdf", - "fastqc_per_sequence_gc_content_plot-1_Counts.pdf", - "fastqc_per_sequence_gc_content_plot-1_Percentages.pdf", - "fastqc_per_sequence_gc_content_plot_Counts.pdf", - "fastqc_per_sequence_gc_content_plot_Percentages.pdf", - "fastqc_per_sequence_quality_scores_plot-1.pdf", - "fastqc_per_sequence_quality_scores_plot.pdf", - "fastqc_sequence_counts_plot-1-cnt.pdf", - "fastqc_sequence_counts_plot-1-pct.pdf", - "fastqc_sequence_counts_plot-cnt.pdf", - "fastqc_sequence_counts_plot-pct.pdf", - "fastqc_sequence_duplication_levels_plot-1.pdf", - "fastqc_sequence_duplication_levels_plot.pdf", - "fastqc_sequence_length_distribution_plot.pdf", - "fastqc_top_overrepresented_sequences_table-1.pdf", - "fastqc_top_overrepresented_sequences_table.pdf", - "general_stats_table.pdf", - "picard_deduplication-cnt.pdf", - "picard_deduplication-pct.pdf", - "qualimap_gene_coverage_profile_Counts.pdf", - "qualimap_gene_coverage_profile_Normalised.pdf", - "qualimap_genomic_origin-cnt.pdf", - "qualimap_genomic_origin-pct.pdf", - "rseqc_bam_stat.pdf", - "rseqc_infer_experiment_plot.pdf", - "rseqc_inner_distance_plot_Counts.pdf", - "rseqc_inner_distance_plot_Percentages.pdf", - "rseqc_junction_annotation_junctions_plot_Events-cnt.pdf", - "rseqc_junction_annotation_junctions_plot_Events-pct.pdf", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf", - "rseqc_junction_saturation_plot_All_Junctions.pdf", - "rseqc_junction_saturation_plot_Known_Junctions.pdf", - "rseqc_junction_saturation_plot_Novel_Junctions.pdf", - "rseqc_read_distribution_plot-cnt.pdf", - "rseqc_read_distribution_plot-pct.pdf", - "rseqc_read_dups_plot.pdf", - "salmon_deseq2_clustering-plot.pdf", - "salmon_deseq2_pca-plot.pdf", - "salmon_plot.pdf", - "samtools-flagstat-dp_Percentage_of_total.pdf", - "samtools-flagstat-dp_Read_counts.pdf", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf", - "samtools-stats-dp.pdf", - "samtools_alignment_plot-cnt.pdf", - "samtools_alignment_plot-pct.pdf", - "star_alignment_plot-cnt.pdf", - "star_alignment_plot-pct.pdf", - "star_salmon_deseq2_clustering-plot.pdf", - "star_salmon_deseq2_pca-plot.pdf", - "star_summary_table.pdf", - "fail_strand_check_table.png", - "fastqc_adapter_content_plot.png", - "fastqc_per_base_n_content_plot-1.png", - "fastqc_per_base_n_content_plot.png", - "fastqc_per_base_sequence_quality_plot-1.png", - "fastqc_per_base_sequence_quality_plot.png", - "fastqc_sequence_length_distribution_plot.png", - "fastqc_top_overrepresented_sequences_table-1.png", - "fastqc_top_overrepresented_sequences_table.png", - "general_stats_table.png", - "picard_deduplication-cnt.png", - "picard_deduplication-pct.png", - "qualimap_genomic_origin-cnt.png", - "qualimap_genomic_origin-pct.png", - "rseqc_bam_stat.png", - "rseqc_inner_distance_plot_Counts.png", - "rseqc_inner_distance_plot_Percentages.png", - "rseqc_junction_annotation_junctions_plot_Events-cnt.png", - "rseqc_junction_annotation_junctions_plot_Events-pct.png", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.png", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.png", - "rseqc_junction_saturation_plot_All_Junctions.png", - "rseqc_junction_saturation_plot_Known_Junctions.png", - "rseqc_junction_saturation_plot_Novel_Junctions.png", - "rseqc_read_distribution_plot-cnt.png", - "rseqc_read_distribution_plot-pct.png", - "salmon_deseq2_clustering-plot.png", - "salmon_deseq2_pca-plot.png", - "salmon_plot.png", - "samtools-flagstat-dp_Percentage_of_total.png", - "samtools-flagstat-dp_Read_counts.png", - "samtools-stats-dp.png", - "samtools_alignment_plot-cnt.png", - "samtools_alignment_plot-pct.png", - "star_alignment_plot-cnt.png", - "star_alignment_plot-pct.png", - "star_salmon_deseq2_clustering-plot.png", - "star_salmon_deseq2_pca-plot.png", - "star_summary_table.png", - "cutadapt_filtered_reads_plot-cnt.svg", - "cutadapt_filtered_reads_plot-pct.svg", - "cutadapt_trimmed_sequences_plot_3_Counts.svg", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg", - "dupradar-section-plot.svg", - "fail_strand_check_table.svg", - "fastqc-status-check-heatmap-1.svg", - "fastqc-status-check-heatmap.svg", - "fastqc_adapter_content_plot.svg", - "fastqc_overrepresented_sequences_plot-1.svg", - "fastqc_overrepresented_sequences_plot.svg", - "fastqc_per_base_n_content_plot-1.svg", - "fastqc_per_base_n_content_plot.svg", - "fastqc_per_base_sequence_quality_plot-1.svg", - "fastqc_per_base_sequence_quality_plot.svg", - "fastqc_per_sequence_gc_content_plot-1_Counts.svg", - "fastqc_per_sequence_gc_content_plot-1_Percentages.svg", - "fastqc_per_sequence_gc_content_plot_Counts.svg", - "fastqc_per_sequence_gc_content_plot_Percentages.svg", - "fastqc_per_sequence_quality_scores_plot-1.svg", - "fastqc_per_sequence_quality_scores_plot.svg", - "fastqc_sequence_counts_plot-1-cnt.svg", - "fastqc_sequence_counts_plot-1-pct.svg", - "fastqc_sequence_counts_plot-cnt.svg", - "fastqc_sequence_counts_plot-pct.svg", - "fastqc_sequence_duplication_levels_plot-1.svg", - "fastqc_sequence_duplication_levels_plot.svg", - "fastqc_sequence_length_distribution_plot.svg", - "fastqc_top_overrepresented_sequences_table-1.svg", - "fastqc_top_overrepresented_sequences_table.svg", - "general_stats_table.svg", - "picard_deduplication-cnt.svg", - "picard_deduplication-pct.svg", - "qualimap_gene_coverage_profile_Counts.svg", - "qualimap_gene_coverage_profile_Normalised.svg", - "qualimap_genomic_origin-cnt.svg", - "qualimap_genomic_origin-pct.svg", - "rseqc_bam_stat.svg", - "rseqc_infer_experiment_plot.svg", - "rseqc_inner_distance_plot_Counts.svg", - "rseqc_inner_distance_plot_Percentages.svg", - "rseqc_junction_annotation_junctions_plot_Events-cnt.svg", - "rseqc_junction_annotation_junctions_plot_Events-pct.svg", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.svg", - "rseqc_junction_saturation_plot_All_Junctions.svg", - "rseqc_junction_saturation_plot_Known_Junctions.svg", - "rseqc_junction_saturation_plot_Novel_Junctions.svg", - "rseqc_read_distribution_plot-cnt.svg", - "rseqc_read_distribution_plot-pct.svg", - "rseqc_read_dups_plot.svg", - "salmon_deseq2_clustering-plot.svg", - "salmon_deseq2_pca-plot.svg", - "salmon_plot.svg", - "samtools-flagstat-dp_Percentage_of_total.svg", - "samtools-flagstat-dp_Read_counts.svg", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg", - "samtools-stats-dp.svg", - "samtools_alignment_plot-cnt.svg", - "samtools_alignment_plot-pct.svg", - "star_alignment_plot-cnt.svg", - "star_alignment_plot-pct.svg", - "star_salmon_deseq2_clustering-plot.svg", - "star_salmon_deseq2_pca-plot.svg", - "star_summary_table.svg" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T18:50:11.011282" - }, - "star_salmon/picard_metrics": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt", - "WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T17:43:26.670351" - }, - "star_salmon/salmon": { - "content": [ - "salmon.merged.gene_counts.SummarizedExperiment.rds", - "salmon.merged.gene_counts.tsv", - "salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_length_scaled.tsv", - "salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_scaled.tsv", - "salmon.merged.gene_lengths.tsv", - "salmon.merged.gene_tpm.tsv", - "salmon.merged.transcript_counts.SummarizedExperiment.rds", - "salmon.merged.transcript_counts.tsv", - "salmon.merged.transcript_lengths.tsv", - "salmon.merged.transcript_tpm.tsv" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T17:43:26.774813" - }, - "fastqc/raw": { - "content": [ - "RAP1_IAA_30M_REP1_raw_1_fastqc.html", - "RAP1_IAA_30M_REP1_raw_1_fastqc.zip", - "RAP1_IAA_30M_REP1_raw_2_fastqc.html", - "RAP1_IAA_30M_REP1_raw_2_fastqc.zip", - "RAP1_UNINDUCED_REP1_raw_fastqc.html", - "RAP1_UNINDUCED_REP1_raw_fastqc.zip", - "RAP1_UNINDUCED_REP2_raw_fastqc.html", - "RAP1_UNINDUCED_REP2_raw_fastqc.zip", - "WT_REP1_raw_1_fastqc.html", - "WT_REP1_raw_1_fastqc.zip", - "WT_REP1_raw_2_fastqc.html", - "WT_REP1_raw_2_fastqc.zip", - "WT_REP2_raw_1_fastqc.html", - "WT_REP2_raw_1_fastqc.zip", - "WT_REP2_raw_2_fastqc.html", - "WT_REP2_raw_2_fastqc.zip" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T15:44:10.08366" - }, - "star_salmon/bigwig": { - "content": [ - "RAP1_IAA_30M_REP1.forward.bigWig", - "RAP1_IAA_30M_REP1.reverse.bigWig", - "RAP1_UNINDUCED_REP1.forward.bigWig", - "RAP1_UNINDUCED_REP1.reverse.bigWig", - "RAP1_UNINDUCED_REP2.forward.bigWig", - "RAP1_UNINDUCED_REP2.reverse.bigWig", - "WT_REP1.forward.bigWig", - "WT_REP1.reverse.bigWig", - "WT_REP2.forward.bigWig", - "WT_REP2.reverse.bigWig" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T17:34:58.428703" - }, - "versions": { - "content": [ - "{BBMAP_BBSPLIT={bbmap=39.01}, BEDTOOLS_GENOMECOV_FW={bedtools=2.31.1}, CAT_FASTQ={cat=8.3}, CUSTOM_CATADDITIONALFASTA={python=3.9.5}, CUSTOM_GETCHROMSIZES={getchromsizes=1.2}, CUSTOM_TX2GENE={python=3.9.5}, DESEQ2_QC_PSEUDO={r-base=4.0.3, bioconductor-deseq2=1.28.0}, DESEQ2_QC_STAR_SALMON={r-base=4.0.3, bioconductor-deseq2=1.28.0}, DUPRADAR={bioconductor-dupradar=1.32.0}, FASTQC={fastqc=0.12.1}, FQ_SUBSAMPLE={fq=0.9.1 (2022-02-22)}, GTF2BED={perl=5.26.2}, GTF_FILTER={python=3.9.5}, GUNZIP_ADDITIONAL_FASTA={gunzip=1.1}, GUNZIP_GTF={gunzip=1.1}, PICARD_MARKDUPLICATES={picard=3.1.1}, QUALIMAP_RNASEQ={qualimap=2.3}, RSEQC_BAMSTAT={rseqc=5.0.2}, RSEQC_INFEREXPERIMENT={rseqc=5.0.2}, RSEQC_INNERDISTANCE={rseqc=5.0.2}, RSEQC_JUNCTIONANNOTATION={rseqc=5.0.2}, RSEQC_JUNCTIONSATURATION={rseqc=5.0.2}, RSEQC_READDISTRIBUTION={rseqc=5.0.2}, RSEQC_READDUPLICATION={rseqc=5.0.2}, SALMON_QUANT={salmon=1.10.1}, SAMTOOLS_FLAGSTAT={samtools=1.2}, SAMTOOLS_IDXSTATS={samtools=1.2}, SAMTOOLS_INDEX={samtools=1.2}, SAMTOOLS_SORT={samtools=1.2}, SAMTOOLS_STATS={samtools=1.2}, SE_GENE={bioconductor-summarizedexperiment=1.32.0}, STAR_ALIGN={star=2.7.10a, samtools=1.18, gawk=5.1.0}, STAR_GENOMEGENERATE={star=2.7.10a, samtools=1.18, gawk=5.1.0}, STRINGTIE_STRINGTIE={stringtie=2.2.1}, TRIMGALORE={trimgalore=0.6.7, cutadapt=3.4}, TXIMETA_TXIMPORT={bioconductor-tximeta=1.20.1}, UCSC_BEDCLIP={ucsc=377}, UCSC_BEDGRAPHTOBIGWIG={ucsc=445}, UNTAR_SALMON_INDEX={untar=1.34}, Workflow={nf-core/rnaseq=v3.16.0dev}}" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T16:30:35.233269" - }, "Params: --featurecounts_group_type false - stub": { "content": [ - "{BBMAP_BBSPLIT={bbmap=39.01}, CAT_FASTQ={cat=8.3}, CUSTOM_CATADDITIONALFASTA={python=null}, CUSTOM_GETCHROMSIZES={getchromsizes=1.2}, FASTQC={fastqc=0.12.1}, GTF2BED={perl=5.26.2}, GTF_FILTER={python=3.9.5}, GUNZIP_ADDITIONAL_FASTA={gunzip=1.1}, GUNZIP_GTF={gunzip=1.1}, STAR_GENOMEGENERATE={star=2.7.10a, samtools=1.18, gawk=5.1.0}, TRIMGALORE={trimgalore=0.6.7, cutadapt=3.4}, UNTAR_SALMON_INDEX={untar=1.34}, Workflow={nf-core/rnaseq=v3.16.0dev}}", - "genome_transcriptome.fasta", - "genome_transcriptome.gtf", - "RAP1_IAA_30M_REP1_raw.html", - "RAP1_IAA_30M_REP1_raw.zip", - "RAP1_UNINDUCED_REP1_raw.html", - "RAP1_UNINDUCED_REP1_raw.zip", - "RAP1_UNINDUCED_REP2_raw.html", - "RAP1_UNINDUCED_REP2_raw.zip", - "WT_REP1_raw.html", - "WT_REP1_raw.zip", - "WT_REP2_raw.html", - "WT_REP2_raw.zip", - "multiqc_report.html", - "RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T16:31:29.50571" - }, - "star_salmon/stringtie": { - "content": [ - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,3f149502efe2a9d4bac98b1dd18c15e7", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,a052ab04070e72cc318fb7680b0764e3", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,e82329a443b9ff50a86e42aff91bd704", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,d279003d92f7feef9adb31203f84474a", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,10e2d00f93f9e74f224bd3c1bfbeb29b", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,525413b70bcf62c24c8f96182e09883e", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,9aa371befc36478d7720d3ea275e6f4d", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,907ab2e06346df131cbdb929afc005a8", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,b03f3118d1aa58fceadcb3311028e856", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,041edee3193df311f621c09f4991892b", - "t_data.ctab", - "RAP1_IAA_30M_REP1.coverage.gtf", - "RAP1_IAA_30M_REP1.gene.abundance.txt", - "RAP1_IAA_30M_REP1.transcripts.gtf", - "t_data.ctab", - "RAP1_UNINDUCED_REP1.coverage.gtf", - "RAP1_UNINDUCED_REP1.gene.abundance.txt", - "RAP1_UNINDUCED_REP1.transcripts.gtf", - "t_data.ctab", - "RAP1_UNINDUCED_REP2.coverage.gtf", - "RAP1_UNINDUCED_REP2.gene.abundance.txt", - "RAP1_UNINDUCED_REP2.transcripts.gtf", - "t_data.ctab", - "WT_REP1.coverage.gtf", - "WT_REP1.gene.abundance.txt", - "WT_REP1.transcripts.gtf", - "t_data.ctab", - "WT_REP2.coverage.gtf", - "WT_REP2.gene.abundance.txt", - "WT_REP2.transcripts.gtf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T17:43:26.873868" - }, - "fastqc/trim": { - "content": [ - "RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html", - "RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip", - "RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html", - "RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip", - "RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html", - "RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip", - "RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html", - "RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip", - "WT_REP1_trimmed_1_val_1_fastqc.html", - "WT_REP1_trimmed_1_val_1_fastqc.zip", - "WT_REP1_trimmed_2_val_2_fastqc.html", - "WT_REP1_trimmed_2_val_2_fastqc.zip", - "WT_REP2_trimmed_1_val_1_fastqc.html", - "WT_REP2_trimmed_1_val_1_fastqc.zip", - "WT_REP2_trimmed_2_val_2_fastqc.html", - "WT_REP2_trimmed_2_val_2_fastqc.zip" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T15:44:10.142955" - }, - "star_salmon/dupradar": { - "content": [ - "RAP1_IAA_30M_REP1_dupMatrix.txt:md5,2e0d518a450bb57801cdd075d4e9c217", - "RAP1_UNINDUCED_REP1_dupMatrix.txt:md5,96e2f9e1fc5a22a7d468e6fb4a613370", - "RAP1_UNINDUCED_REP2_dupMatrix.txt:md5,28c30ce734d78d53b1c47c3f87414e4b", - "WT_REP1_dupMatrix.txt:md5,b6aa1b99d91f5fa7a94efeed1c496c00", - "WT_REP2_dupMatrix.txt:md5,02236769150436cf31b7339f612119a5", - "RAP1_IAA_30M_REP1_intercept_slope.txt:md5,c677048855caf5190f29fa5f7137cd79", - "RAP1_UNINDUCED_REP1_intercept_slope.txt:md5,ea1b4323d3bc83759e8a026416bca32b", - "RAP1_UNINDUCED_REP2_intercept_slope.txt:md5,b062f49a5223a3452075062cdd308043", - "WT_REP1_intercept_slope.txt:md5,e7fcac6d125a7ba746a5cba4a1e66aef", - "WT_REP2_intercept_slope.txt:md5,5af16b07a734b73a2c1103b535f9e26e", - "RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf", - "RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf", - "RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf", - "WT_REP1_duprateExpBoxplot.pdf", - "WT_REP2_duprateExpBoxplot.pdf", - "RAP1_IAA_30M_REP1_expressionHist.pdf", - "RAP1_UNINDUCED_REP1_expressionHist.pdf", - "RAP1_UNINDUCED_REP2_expressionHist.pdf", - "WT_REP1_expressionHist.pdf", - "WT_REP2_expressionHist.pdf", - "RAP1_IAA_30M_REP1_duprateExpDens.pdf", - "RAP1_UNINDUCED_REP1_duprateExpDens.pdf", - "RAP1_UNINDUCED_REP2_duprateExpDens.pdf", - "WT_REP1_duprateExpDens.pdf", - "WT_REP2_duprateExpDens.pdf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T17:34:58.606096" - }, - "bbsplit": { - "content": [ - "RAP1_IAA_30M_REP1.stats.txt", - "RAP1_UNINDUCED_REP1.stats.txt", - "RAP1_UNINDUCED_REP2.stats.txt", - "WT_REP1.stats.txt", - "WT_REP2.stats.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-22T16:30:34.908301" - }, - "salmon_quant": { - "content": [ - "ambig_info.tsv:md5,de973a4b22a4457217ae3dc04caf9401", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,1215f0c20f87d3aef8553ef119e1e74c", - "lib_format_counts.json:md5,c24ffe28d70476b5ccdd8bc2d22c0ac1", - "ambig_info.tsv:md5,45f252b4f0e11e6730cf0c29f800fdbb", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,621c6601aade5b1f2e3d6ca2fc71f636", - "lib_format_counts.json:md5,f6d44c0221f7fd559f11a9afe04c9935", - "ambig_info.tsv:md5,6dcc2891ea572e9b8d1ba52cd434ab84", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,9bed6e4dc5428d6f6297adcea29a6326", - "lib_format_counts.json:md5,7c562bf2f70e42f3a7292687dfd328c3", - "ambig_info.tsv:md5,194f574e0586416155e3f33d42e2b167", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,c7ed0aaa5d6c7934ddbebfd29e4eb86d", - "lib_format_counts.json:md5,d46250bb3677d72feeefc435fe6395a6", - "ambig_info.tsv:md5,a26e3f936e65d7da66392603c2f91f6f", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,69ebfc2c7ca6b221a0a22fa1dc8c20ac", - "lib_format_counts.json:md5,088fd51db07022ffde47033bbd029400", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf" + 22, + { + "BBMAP_BBSPLIT": { + "bbmap": 39.01 + }, + "CAT_FASTQ": { + "cat": 8.3 + }, + "CUSTOM_CATADDITIONALFASTA": { + "python": null + }, + "CUSTOM_GETCHROMSIZES": { + "getchromsizes": 1.2 + }, + "FASTQC": { + "fastqc": "0.12.1" + }, + "GTF2BED": { + "perl": "5.26.2" + }, + "GTF_FILTER": { + "python": "3.9.5" + }, + "GUNZIP_ADDITIONAL_FASTA": { + "gunzip": 1.1 + }, + "GUNZIP_GTF": { + "gunzip": 1.1 + }, + "STAR_GENOMEGENERATE": { + "star": "2.7.10a", + "samtools": 1.18, + "gawk": "5.1.0" + }, + "TRIMGALORE": { + "trimgalore": "0.6.7", + "cutadapt": 3.4 + }, + "UNTAR_SALMON_INDEX": { + "untar": 1.34 + }, + "Workflow": { + "nf-core/rnaseq": "v3.16.0dev" + } + }, + [ + "custom", + "custom/out", + "custom/out/genome_transcriptome.fasta", + "custom/out/genome_transcriptome.gtf", + "fastqc", + "fastqc/raw", + "fastqc/raw/RAP1_IAA_30M_REP1_raw.html", + "fastqc/raw/RAP1_IAA_30M_REP1_raw.zip", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw.html", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw.zip", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw.html", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw.zip", + "fastqc/raw/WT_REP1_raw.html", + "fastqc/raw/WT_REP1_raw.zip", + "fastqc/raw/WT_REP2_raw.html", + "fastqc/raw/WT_REP2_raw.zip", + "fastqc/trim", + "multiqc", + "multiqc/star_salmon", + "multiqc/star_salmon/multiqc_data", + "multiqc/star_salmon/multiqc_plots", + "multiqc/star_salmon/multiqc_report.html", + "pipeline_info", + "pipeline_info/nf_core_rnaseq_software_mqc_versions.yml", + "trimgalore", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" + ], + [ + "genome_transcriptome.fasta:md5,d41d8cd98f00b204e9800998ecf8427e", + "genome_transcriptome.gtf:md5,d41d8cd98f00b204e9800998ecf8427e" + ] ], "meta": { "nf-test": "0.9.0", "nextflow": "24.04.4" }, - "timestamp": "2024-08-22T17:34:58.29814" + "timestamp": "2024-10-02T07:38:08.811967" }, - "star_salmon/qualimap": { + "Params: --featurecounts_group_type false": { "content": [ - "Coverage Profile Along Genes (High).png:md5,876c1b88f33bd3e5fe1a41679729573d", - "Coverage Profile Along Genes (Low).png:md5,ee1f2c9cc4dd4867811eda1e68864ab4", - "Coverage Profile Along Genes (Total).png:md5,53747a8f9813744902756ad60638380a", - "Transcript coverage histogram.png:md5,4f9072d4b11216373b59396293803a37", - "coverage_profile_along_genes_(high).txt:md5,fcb06d460810c0555de5396b9dae05e8", - "coverage_profile_along_genes_(low).txt:md5,e3c9a1ddfdb89f8534ff7548b70fce32", - "coverage_profile_along_genes_(total).txt:md5,e3c9a1ddfdb89f8534ff7548b70fce32", - "Coverage Profile Along Genes (High).png:md5,bbf0531018e7fccfc1dfdd1c05715518", - "Coverage Profile Along Genes (Low).png:md5,3c147d9c831d4be98615a22a72fad05d", - "Coverage Profile Along Genes (Total).png:md5,5a8a6db3a8d19a2dcb8f715b11e67c50", - "Transcript coverage histogram.png:md5,488440d7b6d73bcd4567316712e281fe", - "coverage_profile_along_genes_(high).txt:md5,9f1e29a4d6eec52e8796b080daaedca3", - "coverage_profile_along_genes_(low).txt:md5,353f42a84ff34167646fc83909eac2ff", - "coverage_profile_along_genes_(total).txt:md5,353f42a84ff34167646fc83909eac2ff", - "Coverage Profile Along Genes (High).png:md5,5a5d99cc7a1dba3762d67f4aa4adad58", - "Coverage Profile Along Genes (Low).png:md5,b6adc296e9a732aa0495a6da8fa4ed90", - "Coverage Profile Along Genes (Total).png:md5,fcb94fb9c1a51c1db32f884d05929cc8", - "Transcript coverage histogram.png:md5,3aeb52ff3e3752727a370b0d7ceb0518", - "coverage_profile_along_genes_(high).txt:md5,3b20a736708df02ea8c86dc5829ae67e", - "coverage_profile_along_genes_(low).txt:md5,02b314b76ef1317f20e129412340755d", - "coverage_profile_along_genes_(total).txt:md5,02b314b76ef1317f20e129412340755d", - "Coverage Profile Along Genes (High).png:md5,c974d47996bcc57b99dfaf6903f61f41", - "Coverage Profile Along Genes (Low).png:md5,c8fe631f0580c93adb5be107c6a7a1a3", - "Coverage Profile Along Genes (Total).png:md5,424d245e9f3e626d9e79f51d1b93e946", - "Transcript coverage histogram.png:md5,17404146ad5e0a9bce97ce622e00975e", - "coverage_profile_along_genes_(high).txt:md5,8bf366c7dbc6170035ee64a057c581f1", - "coverage_profile_along_genes_(low).txt:md5,a9102de3ff9679d1f7a86afa85997211", - "coverage_profile_along_genes_(total).txt:md5,a9102de3ff9679d1f7a86afa85997211", - "Coverage Profile Along Genes (High).png:md5,40edd79c21f3e8d8bbac384156c472d6", - "Coverage Profile Along Genes (Low).png:md5,935c0372259a953a4c99569e9b236ae5", - "Coverage Profile Along Genes (Total).png:md5,34f7a4307be1ea674b7b98eee564d96b", - "Transcript coverage histogram.png:md5,e2abf8a9c62fef57f0be1ca0e01e502d", - "coverage_profile_along_genes_(high).txt:md5,3f13eb908d6e97e6831306e9527cc2e3", - "coverage_profile_along_genes_(low).txt:md5,24df553662d0cedaa74cf06a8fead40b", - "coverage_profile_along_genes_(total).txt:md5,24df553662d0cedaa74cf06a8fead40b", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt" + 188, + { + "BBMAP_BBSPLIT": { + "bbmap": 39.01 + }, + "BEDTOOLS_GENOMECOV_FW": { + "bedtools": "2.31.1" + }, + "CAT_FASTQ": { + "cat": 8.3 + }, + "CUSTOM_CATADDITIONALFASTA": { + "python": "3.9.5" + }, + "CUSTOM_GETCHROMSIZES": { + "getchromsizes": 1.2 + }, + "CUSTOM_TX2GENE": { + "python": "3.9.5" + }, + "DESEQ2_QC_PSEUDO": { + "r-base": "4.0.3", + "bioconductor-deseq2": "1.28.0" + }, + "DESEQ2_QC_STAR_SALMON": { + "r-base": "4.0.3", + "bioconductor-deseq2": "1.28.0" + }, + "DUPRADAR": { + "bioconductor-dupradar": "1.32.0" + }, + "FASTQC": { + "fastqc": "0.12.1" + }, + "FQ_SUBSAMPLE": { + "fq": "0.9.1 (2022-02-22)" + }, + "GTF2BED": { + "perl": "5.26.2" + }, + "GTF_FILTER": { + "python": "3.9.5" + }, + "GUNZIP_ADDITIONAL_FASTA": { + "gunzip": 1.1 + }, + "GUNZIP_GTF": { + "gunzip": 1.1 + }, + "PICARD_MARKDUPLICATES": { + "picard": "3.1.1" + }, + "QUALIMAP_RNASEQ": { + "qualimap": 2.3 + }, + "RSEQC_BAMSTAT": { + "rseqc": "5.0.2" + }, + "RSEQC_INFEREXPERIMENT": { + "rseqc": "5.0.2" + }, + "RSEQC_INNERDISTANCE": { + "rseqc": "5.0.2" + }, + "RSEQC_JUNCTIONANNOTATION": { + "rseqc": "5.0.2" + }, + "RSEQC_JUNCTIONSATURATION": { + "rseqc": "5.0.2" + }, + "RSEQC_READDISTRIBUTION": { + "rseqc": "5.0.2" + }, + "RSEQC_READDUPLICATION": { + "rseqc": "5.0.2" + }, + "SALMON_QUANT": { + "salmon": "1.10.1" + }, + "SAMTOOLS_FLAGSTAT": { + "samtools": 1.2 + }, + "SAMTOOLS_IDXSTATS": { + "samtools": 1.2 + }, + "SAMTOOLS_INDEX": { + "samtools": 1.2 + }, + "SAMTOOLS_SORT": { + "samtools": 1.2 + }, + "SAMTOOLS_STATS": { + "samtools": 1.2 + }, + "SE_GENE": { + "bioconductor-summarizedexperiment": "1.32.0" + }, + "STAR_ALIGN": { + "star": "2.7.10a", + "samtools": 1.18, + "gawk": "5.1.0" + }, + "STAR_GENOMEGENERATE": { + "star": "2.7.10a", + "samtools": 1.18, + "gawk": "5.1.0" + }, + "STRINGTIE_STRINGTIE": { + "stringtie": "2.2.1" + }, + "TRIMGALORE": { + "trimgalore": "0.6.7", + "cutadapt": 3.4 + }, + "TXIMETA_TXIMPORT": { + "bioconductor-tximeta": "1.20.1" + }, + "UCSC_BEDCLIP": { + "ucsc": 377 + }, + "UCSC_BEDGRAPHTOBIGWIG": { + "ucsc": 445 + }, + "UNTAR_SALMON_INDEX": { + "untar": 1.34 + }, + "Workflow": { + "nf-core/rnaseq": "v3.16.0dev" + } + }, + [ + "bbsplit", + "bbsplit/RAP1_IAA_30M_REP1.stats.txt", + "bbsplit/RAP1_UNINDUCED_REP1.stats.txt", + "bbsplit/RAP1_UNINDUCED_REP2.stats.txt", + "bbsplit/WT_REP1.stats.txt", + "bbsplit/WT_REP2.stats.txt", + "custom", + "custom/out", + "custom/out/genome_gfp.fasta", + "custom/out/genome_gfp.gtf", + "fastqc", + "fastqc/raw", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.html", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.zip", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.html", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.zip", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.html", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.zip", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.html", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.zip", + "fastqc/raw/WT_REP1_raw_1_fastqc.html", + "fastqc/raw/WT_REP1_raw_1_fastqc.zip", + "fastqc/raw/WT_REP1_raw_2_fastqc.html", + "fastqc/raw/WT_REP1_raw_2_fastqc.zip", + "fastqc/raw/WT_REP2_raw_1_fastqc.html", + "fastqc/raw/WT_REP2_raw_1_fastqc.zip", + "fastqc/raw/WT_REP2_raw_2_fastqc.html", + "fastqc/raw/WT_REP2_raw_2_fastqc.zip", + "fastqc/trim", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip", + "fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html", + "fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip", + "fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html", + "fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip", + "fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.html", + "fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.html", + "fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.zip", + "fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.html", + "fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.html", + "fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.zip", + "multiqc", + "multiqc/star_salmon", + "multiqc/star_salmon/multiqc_report.html", + "multiqc/star_salmon/multiqc_report_data", + "multiqc/star_salmon/multiqc_report_data/cutadapt_filtered_reads_plot.txt", + "multiqc/star_salmon/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc-status-check-heatmap-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc-status-check-heatmap.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_adapter_content_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_overrepresented_sequences_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_overrepresented_sequences_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_base_n_content_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_base_n_content_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_base_sequence_quality_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_base_sequence_quality_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Percentages.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Percentages.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_quality_scores_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_quality_scores_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_counts_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_counts_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_duplication_levels_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_duplication_levels_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_length_distribution_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_top_overrepresented_sequences_table-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_top_overrepresented_sequences_table.txt", + "multiqc/star_salmon/multiqc_report_data/junction_saturation_known.txt", + "multiqc/star_salmon/multiqc_report_data/junction_saturation_novel.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_citations.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_cutadapt.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_data.json", + "multiqc/star_salmon/multiqc_report_data/multiqc_dupradar-section-plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_fail_strand_check_table.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_fastqc_fastqc_raw.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_fastqc_fastqc_trimmed.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_general_stats.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_picard_dups.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_bam_stat.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_infer_experiment.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_junction_annotation.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_read_distribution.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_1.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_2.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_3.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_4.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_pca-plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_samtools_flagstat.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_samtools_idxstats.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_samtools_stats.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_software_versions.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_sources.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_1.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_2.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_3.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_4.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_pca-plot.txt", + "multiqc/star_salmon/multiqc_report_data/picard_deduplication.txt", + "multiqc/star_salmon/multiqc_report_data/picard_histogram.txt", + "multiqc/star_salmon/multiqc_report_data/picard_histogram_1.txt", + "multiqc/star_salmon/multiqc_report_data/picard_histogram_2.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_gene_coverage_profile_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_gene_coverage_profile_Normalised.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_genomic_origin.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_rnaseq_cov_hist.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_rnaseq_genome_results.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_bam_stat.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_infer_experiment_plot.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance_plot_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance_plot_Percentages.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Events.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Junctions.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_all.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_All_Junctions.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_Known_Junctions.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_Novel_Junctions.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_read_distribution_plot.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_read_dups.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_read_dups_plot.txt", + "multiqc/star_salmon/multiqc_report_data/salmon_plot.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Percentage_of_total.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Read_counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Raw_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-stats-dp.txt", + "multiqc/star_salmon/multiqc_report_data/samtools_alignment_plot.txt", + "multiqc/star_salmon/multiqc_report_data/star_alignment_plot.txt", + "multiqc/star_salmon/multiqc_report_data/star_summary_table.txt", + "multiqc/star_salmon/multiqc_report_plots", + "multiqc/star_salmon/multiqc_report_plots/pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/dupradar-section-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fail_strand_check_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc-status-check-heatmap-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc-status-check-heatmap.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_adapter_content_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Percentages.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Percentages.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_length_distribution_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/general_stats_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Normalised.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_genomic_origin-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_genomic_origin-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_bam_stat.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_infer_experiment_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Percentages.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_All_Junctions.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Known_Junctions.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Novel_Junctions.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_distribution_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_distribution_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_dups_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/salmon_deseq2_clustering-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/salmon_deseq2_pca-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/salmon_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Percentage_of_total.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Read_counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-stats-dp.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_salmon_deseq2_clustering-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_salmon_deseq2_pca-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_summary_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/png", + "multiqc/star_salmon/multiqc_report_plots/png/cutadapt_filtered_reads_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/cutadapt_filtered_reads_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Obs_Exp.png", + "multiqc/star_salmon/multiqc_report_plots/png/dupradar-section-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fail_strand_check_table.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc-status-check-heatmap-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc-status-check-heatmap.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_adapter_content_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_n_content_plot-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_n_content_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Percentages.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Percentages.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_length_distribution_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table.png", + "multiqc/star_salmon/multiqc_report_plots/png/general_stats_table.png", + "multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/qualimap_gene_coverage_profile_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/qualimap_gene_coverage_profile_Normalised.png", + "multiqc/star_salmon/multiqc_report_plots/png/qualimap_genomic_origin-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/qualimap_genomic_origin-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_bam_stat.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_infer_experiment_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_inner_distance_plot_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_inner_distance_plot_Percentages.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_All_Junctions.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_Known_Junctions.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_Novel_Junctions.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_distribution_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_distribution_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_dups_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/salmon_deseq2_clustering-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/salmon_deseq2_pca-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/salmon_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Percentage_of_total.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Read_counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-stats-dp.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_salmon_deseq2_clustering-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_salmon_deseq2_pca-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_summary_table.png", + "multiqc/star_salmon/multiqc_report_plots/svg", + "multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/dupradar-section-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fail_strand_check_table.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc-status-check-heatmap-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc-status-check-heatmap.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_adapter_content_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_n_content_plot-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_n_content_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Percentages.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Percentages.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_length_distribution_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/general_stats_table.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Normalised.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/qualimap_genomic_origin-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/qualimap_genomic_origin-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_bam_stat.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_infer_experiment_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_inner_distance_plot_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_inner_distance_plot_Percentages.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_All_Junctions.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Known_Junctions.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Novel_Junctions.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_distribution_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_distribution_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_dups_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/salmon_deseq2_clustering-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/salmon_deseq2_pca-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/salmon_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Percentage_of_total.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Read_counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-stats-dp.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_salmon_deseq2_clustering-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_salmon_deseq2_pca-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_summary_table.svg", + "pipeline_info", + "pipeline_info/nf_core_rnaseq_software_mqc_versions.yml", + "salmon", + "salmon/RAP1_IAA_30M_REP1", + "salmon/RAP1_IAA_30M_REP1/aux_info", + "salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv", + "salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json", + "salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz", + "salmon/RAP1_IAA_30M_REP1/cmd_info.json", + "salmon/RAP1_IAA_30M_REP1/libParams", + "salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt", + "salmon/RAP1_IAA_30M_REP1/lib_format_counts.json", + "salmon/RAP1_IAA_30M_REP1/logs", + "salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log", + "salmon/RAP1_IAA_30M_REP1/quant.genes.sf", + "salmon/RAP1_IAA_30M_REP1/quant.sf", + "salmon/RAP1_UNINDUCED_REP1", + "salmon/RAP1_UNINDUCED_REP1/aux_info", + "salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv", + "salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json", + "salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz", + "salmon/RAP1_UNINDUCED_REP1/cmd_info.json", + "salmon/RAP1_UNINDUCED_REP1/libParams", + "salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt", + "salmon/RAP1_UNINDUCED_REP1/lib_format_counts.json", + "salmon/RAP1_UNINDUCED_REP1/logs", + "salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log", + "salmon/RAP1_UNINDUCED_REP1/quant.genes.sf", + "salmon/RAP1_UNINDUCED_REP1/quant.sf", + "salmon/RAP1_UNINDUCED_REP2", + "salmon/RAP1_UNINDUCED_REP2/aux_info", + "salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv", + "salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json", + "salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz", + "salmon/RAP1_UNINDUCED_REP2/cmd_info.json", + "salmon/RAP1_UNINDUCED_REP2/libParams", + "salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt", + "salmon/RAP1_UNINDUCED_REP2/lib_format_counts.json", + "salmon/RAP1_UNINDUCED_REP2/logs", + "salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log", + "salmon/RAP1_UNINDUCED_REP2/quant.genes.sf", + "salmon/RAP1_UNINDUCED_REP2/quant.sf", + "salmon/WT_REP1", + "salmon/WT_REP1/aux_info", + "salmon/WT_REP1/aux_info/ambig_info.tsv", + "salmon/WT_REP1/aux_info/expected_bias.gz", + "salmon/WT_REP1/aux_info/fld.gz", + "salmon/WT_REP1/aux_info/meta_info.json", + "salmon/WT_REP1/aux_info/observed_bias.gz", + "salmon/WT_REP1/aux_info/observed_bias_3p.gz", + "salmon/WT_REP1/cmd_info.json", + "salmon/WT_REP1/libParams", + "salmon/WT_REP1/libParams/flenDist.txt", + "salmon/WT_REP1/lib_format_counts.json", + "salmon/WT_REP1/logs", + "salmon/WT_REP1/logs/salmon_quant.log", + "salmon/WT_REP1/quant.genes.sf", + "salmon/WT_REP1/quant.sf", + "salmon/WT_REP2", + "salmon/WT_REP2/aux_info", + "salmon/WT_REP2/aux_info/ambig_info.tsv", + "salmon/WT_REP2/aux_info/expected_bias.gz", + "salmon/WT_REP2/aux_info/fld.gz", + "salmon/WT_REP2/aux_info/meta_info.json", + "salmon/WT_REP2/aux_info/observed_bias.gz", + "salmon/WT_REP2/aux_info/observed_bias_3p.gz", + "salmon/WT_REP2/cmd_info.json", + "salmon/WT_REP2/libParams", + "salmon/WT_REP2/libParams/flenDist.txt", + "salmon/WT_REP2/lib_format_counts.json", + "salmon/WT_REP2/logs", + "salmon/WT_REP2/logs/salmon_quant.log", + "salmon/WT_REP2/quant.genes.sf", + "salmon/WT_REP2/quant.sf", + "salmon/deseq2_qc", + "salmon/deseq2_qc/R_sessionInfo.log", + "salmon/deseq2_qc/deseq2.dds.RData", + "salmon/deseq2_qc/deseq2.pca.vals.txt", + "salmon/deseq2_qc/deseq2.plots.pdf", + "salmon/deseq2_qc/deseq2.sample.dists.txt", + "salmon/deseq2_qc/size_factors", + "salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt", + "salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt", + "salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt", + "salmon/deseq2_qc/size_factors/WT_REP1.txt", + "salmon/deseq2_qc/size_factors/WT_REP2.txt", + "salmon/deseq2_qc/size_factors/deseq2.size_factors.RData", + "salmon/salmon.merged.gene_counts.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts.tsv", + "salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts_length_scaled.tsv", + "salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts_scaled.tsv", + "salmon/salmon.merged.gene_lengths.tsv", + "salmon/salmon.merged.gene_tpm.tsv", + "salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds", + "salmon/salmon.merged.transcript_counts.tsv", + "salmon/salmon.merged.transcript_lengths.tsv", + "salmon/salmon.merged.transcript_tpm.tsv", + "salmon/tx2gene.tsv", + "star_salmon", + "star_salmon/RAP1_IAA_30M_REP1", + "star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam", + "star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam.bai", + "star_salmon/RAP1_IAA_30M_REP1/aux_info", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz", + "star_salmon/RAP1_IAA_30M_REP1/cmd_info.json", + "star_salmon/RAP1_IAA_30M_REP1/libParams", + "star_salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt", + "star_salmon/RAP1_IAA_30M_REP1/logs", + "star_salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log", + "star_salmon/RAP1_IAA_30M_REP1/quant.genes.sf", + "star_salmon/RAP1_IAA_30M_REP1/quant.sf", + "star_salmon/RAP1_UNINDUCED_REP1", + "star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam", + "star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz", + "star_salmon/RAP1_UNINDUCED_REP1/cmd_info.json", + "star_salmon/RAP1_UNINDUCED_REP1/libParams", + "star_salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt", + "star_salmon/RAP1_UNINDUCED_REP1/logs", + "star_salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log", + "star_salmon/RAP1_UNINDUCED_REP1/quant.genes.sf", + "star_salmon/RAP1_UNINDUCED_REP1/quant.sf", + "star_salmon/RAP1_UNINDUCED_REP2", + "star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam", + "star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz", + "star_salmon/RAP1_UNINDUCED_REP2/cmd_info.json", + "star_salmon/RAP1_UNINDUCED_REP2/libParams", + "star_salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt", + "star_salmon/RAP1_UNINDUCED_REP2/logs", + "star_salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log", + "star_salmon/RAP1_UNINDUCED_REP2/quant.genes.sf", + "star_salmon/RAP1_UNINDUCED_REP2/quant.sf", + "star_salmon/WT_REP1", + "star_salmon/WT_REP1.markdup.sorted.bam", + "star_salmon/WT_REP1.markdup.sorted.bam.bai", + "star_salmon/WT_REP1/aux_info", + "star_salmon/WT_REP1/aux_info/ambig_info.tsv", + "star_salmon/WT_REP1/aux_info/expected_bias.gz", + "star_salmon/WT_REP1/aux_info/fld.gz", + "star_salmon/WT_REP1/aux_info/meta_info.json", + "star_salmon/WT_REP1/aux_info/observed_bias.gz", + "star_salmon/WT_REP1/aux_info/observed_bias_3p.gz", + "star_salmon/WT_REP1/cmd_info.json", + "star_salmon/WT_REP1/libParams", + "star_salmon/WT_REP1/libParams/flenDist.txt", + "star_salmon/WT_REP1/logs", + "star_salmon/WT_REP1/logs/salmon_quant.log", + "star_salmon/WT_REP1/quant.genes.sf", + "star_salmon/WT_REP1/quant.sf", + "star_salmon/WT_REP2", + "star_salmon/WT_REP2.markdup.sorted.bam", + "star_salmon/WT_REP2.markdup.sorted.bam.bai", + "star_salmon/WT_REP2/aux_info", + "star_salmon/WT_REP2/aux_info/ambig_info.tsv", + "star_salmon/WT_REP2/aux_info/expected_bias.gz", + "star_salmon/WT_REP2/aux_info/fld.gz", + "star_salmon/WT_REP2/aux_info/meta_info.json", + "star_salmon/WT_REP2/aux_info/observed_bias.gz", + "star_salmon/WT_REP2/aux_info/observed_bias_3p.gz", + "star_salmon/WT_REP2/cmd_info.json", + "star_salmon/WT_REP2/libParams", + "star_salmon/WT_REP2/libParams/flenDist.txt", + "star_salmon/WT_REP2/logs", + "star_salmon/WT_REP2/logs/salmon_quant.log", + "star_salmon/WT_REP2/quant.genes.sf", + "star_salmon/WT_REP2/quant.sf", + "star_salmon/bigwig", + "star_salmon/bigwig/RAP1_IAA_30M_REP1.forward.bigWig", + "star_salmon/bigwig/RAP1_IAA_30M_REP1.reverse.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP1.forward.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP1.reverse.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP2.forward.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP2.reverse.bigWig", + "star_salmon/bigwig/WT_REP1.forward.bigWig", + "star_salmon/bigwig/WT_REP1.reverse.bigWig", + "star_salmon/bigwig/WT_REP2.forward.bigWig", + "star_salmon/bigwig/WT_REP2.reverse.bigWig", + "star_salmon/deseq2_qc", + "star_salmon/deseq2_qc/R_sessionInfo.log", + "star_salmon/deseq2_qc/deseq2.dds.RData", + "star_salmon/deseq2_qc/deseq2.pca.vals.txt", + "star_salmon/deseq2_qc/deseq2.plots.pdf", + "star_salmon/deseq2_qc/deseq2.sample.dists.txt", + "star_salmon/deseq2_qc/size_factors", + "star_salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt", + "star_salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt", + "star_salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt", + "star_salmon/deseq2_qc/size_factors/WT_REP1.txt", + "star_salmon/deseq2_qc/size_factors/WT_REP2.txt", + "star_salmon/deseq2_qc/size_factors/deseq2.size_factors.RData", + "star_salmon/dupradar", + "star_salmon/dupradar/box_plot", + "star_salmon/dupradar/box_plot/RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf", + "star_salmon/dupradar/box_plot/RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf", + "star_salmon/dupradar/box_plot/RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf", + "star_salmon/dupradar/box_plot/WT_REP1_duprateExpBoxplot.pdf", + "star_salmon/dupradar/box_plot/WT_REP2_duprateExpBoxplot.pdf", + "star_salmon/dupradar/gene_data", + "star_salmon/dupradar/gene_data/RAP1_IAA_30M_REP1_dupMatrix.txt", + "star_salmon/dupradar/gene_data/RAP1_UNINDUCED_REP1_dupMatrix.txt", + "star_salmon/dupradar/gene_data/RAP1_UNINDUCED_REP2_dupMatrix.txt", + "star_salmon/dupradar/gene_data/WT_REP1_dupMatrix.txt", + "star_salmon/dupradar/gene_data/WT_REP2_dupMatrix.txt", + "star_salmon/dupradar/histogram", + "star_salmon/dupradar/histogram/RAP1_IAA_30M_REP1_expressionHist.pdf", + "star_salmon/dupradar/histogram/RAP1_UNINDUCED_REP1_expressionHist.pdf", + "star_salmon/dupradar/histogram/RAP1_UNINDUCED_REP2_expressionHist.pdf", + "star_salmon/dupradar/histogram/WT_REP1_expressionHist.pdf", + "star_salmon/dupradar/histogram/WT_REP2_expressionHist.pdf", + "star_salmon/dupradar/intercepts_slope", + "star_salmon/dupradar/intercepts_slope/RAP1_IAA_30M_REP1_intercept_slope.txt", + "star_salmon/dupradar/intercepts_slope/RAP1_UNINDUCED_REP1_intercept_slope.txt", + "star_salmon/dupradar/intercepts_slope/RAP1_UNINDUCED_REP2_intercept_slope.txt", + "star_salmon/dupradar/intercepts_slope/WT_REP1_intercept_slope.txt", + "star_salmon/dupradar/intercepts_slope/WT_REP2_intercept_slope.txt", + "star_salmon/dupradar/scatter_plot", + "star_salmon/dupradar/scatter_plot/RAP1_IAA_30M_REP1_duprateExpDens.pdf", + "star_salmon/dupradar/scatter_plot/RAP1_UNINDUCED_REP1_duprateExpDens.pdf", + "star_salmon/dupradar/scatter_plot/RAP1_UNINDUCED_REP2_duprateExpDens.pdf", + "star_salmon/dupradar/scatter_plot/WT_REP1_duprateExpDens.pdf", + "star_salmon/dupradar/scatter_plot/WT_REP2_duprateExpDens.pdf", + "star_salmon/log", + "star_salmon/log/RAP1_IAA_30M_REP1.Log.final.out", + "star_salmon/log/RAP1_IAA_30M_REP1.Log.out", + "star_salmon/log/RAP1_IAA_30M_REP1.Log.progress.out", + "star_salmon/log/RAP1_IAA_30M_REP1.SJ.out.tab", + "star_salmon/log/RAP1_UNINDUCED_REP1.Log.final.out", + "star_salmon/log/RAP1_UNINDUCED_REP1.Log.out", + "star_salmon/log/RAP1_UNINDUCED_REP1.Log.progress.out", + "star_salmon/log/RAP1_UNINDUCED_REP1.SJ.out.tab", + "star_salmon/log/RAP1_UNINDUCED_REP2.Log.final.out", + "star_salmon/log/RAP1_UNINDUCED_REP2.Log.out", + "star_salmon/log/RAP1_UNINDUCED_REP2.Log.progress.out", + "star_salmon/log/RAP1_UNINDUCED_REP2.SJ.out.tab", + "star_salmon/log/WT_REP1.Log.final.out", + "star_salmon/log/WT_REP1.Log.out", + "star_salmon/log/WT_REP1.Log.progress.out", + "star_salmon/log/WT_REP1.SJ.out.tab", + "star_salmon/log/WT_REP2.Log.final.out", + "star_salmon/log/WT_REP2.Log.out", + "star_salmon/log/WT_REP2.Log.progress.out", + "star_salmon/log/WT_REP2.SJ.out.tab", + "star_salmon/picard_metrics", + "star_salmon/picard_metrics/RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/qualimap", + "star_salmon/qualimap/RAP1_IAA_30M_REP1", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/agogo.css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/ajax-loader.gif", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/basic.css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/bgfooter.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/bgtop.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/comment-bright.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/comment-close.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/comment.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/doctools.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/down-pressed.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/down.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/file.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/jquery.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/minus.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/plus.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/pygments.css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/qualimap_logo_small.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/report.css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/searchtools.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/underscore.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/up-pressed.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/up.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/websupport.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/qualimapReport.html", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/rnaseq_qc_results.txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/agogo.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/ajax-loader.gif", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/basic.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/bgfooter.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/bgtop.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/comment-bright.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/comment-close.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/comment.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/doctools.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/down-pressed.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/down.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/file.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/jquery.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/minus.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/plus.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/pygments.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/qualimap_logo_small.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/report.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/searchtools.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/underscore.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/up-pressed.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/up.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/websupport.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/qualimapReport.html", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/rnaseq_qc_results.txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/agogo.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/ajax-loader.gif", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/basic.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/bgfooter.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/bgtop.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/comment-bright.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/comment-close.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/comment.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/doctools.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/down-pressed.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/down.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/file.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/jquery.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/minus.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/plus.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/pygments.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/qualimap_logo_small.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/report.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/searchtools.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/underscore.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/up-pressed.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/up.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/websupport.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/qualimapReport.html", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/rnaseq_qc_results.txt", + "star_salmon/qualimap/WT_REP1", + "star_salmon/qualimap/WT_REP1/css", + "star_salmon/qualimap/WT_REP1/css/agogo.css", + "star_salmon/qualimap/WT_REP1/css/ajax-loader.gif", + "star_salmon/qualimap/WT_REP1/css/basic.css", + "star_salmon/qualimap/WT_REP1/css/bgfooter.png", + "star_salmon/qualimap/WT_REP1/css/bgtop.png", + "star_salmon/qualimap/WT_REP1/css/comment-bright.png", + "star_salmon/qualimap/WT_REP1/css/comment-close.png", + "star_salmon/qualimap/WT_REP1/css/comment.png", + "star_salmon/qualimap/WT_REP1/css/doctools.js", + "star_salmon/qualimap/WT_REP1/css/down-pressed.png", + "star_salmon/qualimap/WT_REP1/css/down.png", + "star_salmon/qualimap/WT_REP1/css/file.png", + "star_salmon/qualimap/WT_REP1/css/jquery.js", + "star_salmon/qualimap/WT_REP1/css/minus.png", + "star_salmon/qualimap/WT_REP1/css/plus.png", + "star_salmon/qualimap/WT_REP1/css/pygments.css", + "star_salmon/qualimap/WT_REP1/css/qualimap_logo_small.png", + "star_salmon/qualimap/WT_REP1/css/report.css", + "star_salmon/qualimap/WT_REP1/css/searchtools.js", + "star_salmon/qualimap/WT_REP1/css/underscore.js", + "star_salmon/qualimap/WT_REP1/css/up-pressed.png", + "star_salmon/qualimap/WT_REP1/css/up.png", + "star_salmon/qualimap/WT_REP1/css/websupport.js", + "star_salmon/qualimap/WT_REP1/images_qualimapReport", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/WT_REP1/qualimapReport.html", + "star_salmon/qualimap/WT_REP1/raw_data_qualimapReport", + "star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/WT_REP1/rnaseq_qc_results.txt", + "star_salmon/qualimap/WT_REP2", + "star_salmon/qualimap/WT_REP2/css", + "star_salmon/qualimap/WT_REP2/css/agogo.css", + "star_salmon/qualimap/WT_REP2/css/ajax-loader.gif", + "star_salmon/qualimap/WT_REP2/css/basic.css", + "star_salmon/qualimap/WT_REP2/css/bgfooter.png", + "star_salmon/qualimap/WT_REP2/css/bgtop.png", + "star_salmon/qualimap/WT_REP2/css/comment-bright.png", + "star_salmon/qualimap/WT_REP2/css/comment-close.png", + "star_salmon/qualimap/WT_REP2/css/comment.png", + "star_salmon/qualimap/WT_REP2/css/doctools.js", + "star_salmon/qualimap/WT_REP2/css/down-pressed.png", + "star_salmon/qualimap/WT_REP2/css/down.png", + "star_salmon/qualimap/WT_REP2/css/file.png", + "star_salmon/qualimap/WT_REP2/css/jquery.js", + "star_salmon/qualimap/WT_REP2/css/minus.png", + "star_salmon/qualimap/WT_REP2/css/plus.png", + "star_salmon/qualimap/WT_REP2/css/pygments.css", + "star_salmon/qualimap/WT_REP2/css/qualimap_logo_small.png", + "star_salmon/qualimap/WT_REP2/css/report.css", + "star_salmon/qualimap/WT_REP2/css/searchtools.js", + "star_salmon/qualimap/WT_REP2/css/underscore.js", + "star_salmon/qualimap/WT_REP2/css/up-pressed.png", + "star_salmon/qualimap/WT_REP2/css/up.png", + "star_salmon/qualimap/WT_REP2/css/websupport.js", + "star_salmon/qualimap/WT_REP2/images_qualimapReport", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/WT_REP2/qualimapReport.html", + "star_salmon/qualimap/WT_REP2/raw_data_qualimapReport", + "star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/WT_REP2/rnaseq_qc_results.txt", + "star_salmon/rseqc", + "star_salmon/rseqc/bam_stat", + "star_salmon/rseqc/bam_stat/RAP1_IAA_30M_REP1.bam_stat.txt", + "star_salmon/rseqc/bam_stat/RAP1_UNINDUCED_REP1.bam_stat.txt", + "star_salmon/rseqc/bam_stat/RAP1_UNINDUCED_REP2.bam_stat.txt", + "star_salmon/rseqc/bam_stat/WT_REP1.bam_stat.txt", + "star_salmon/rseqc/bam_stat/WT_REP2.bam_stat.txt", + "star_salmon/rseqc/infer_experiment", + "star_salmon/rseqc/infer_experiment/RAP1_IAA_30M_REP1.infer_experiment.txt", + "star_salmon/rseqc/infer_experiment/RAP1_UNINDUCED_REP1.infer_experiment.txt", + "star_salmon/rseqc/infer_experiment/RAP1_UNINDUCED_REP2.infer_experiment.txt", + "star_salmon/rseqc/infer_experiment/WT_REP1.infer_experiment.txt", + "star_salmon/rseqc/infer_experiment/WT_REP2.infer_experiment.txt", + "star_salmon/rseqc/inner_distance", + "star_salmon/rseqc/inner_distance/pdf", + "star_salmon/rseqc/inner_distance/pdf/RAP1_IAA_30M_REP1.inner_distance_plot.pdf", + "star_salmon/rseqc/inner_distance/pdf/WT_REP1.inner_distance_plot.pdf", + "star_salmon/rseqc/inner_distance/pdf/WT_REP2.inner_distance_plot.pdf", + "star_salmon/rseqc/inner_distance/rscript", + "star_salmon/rseqc/inner_distance/rscript/RAP1_IAA_30M_REP1.inner_distance_plot.r", + "star_salmon/rseqc/inner_distance/rscript/WT_REP1.inner_distance_plot.r", + "star_salmon/rseqc/inner_distance/rscript/WT_REP2.inner_distance_plot.r", + "star_salmon/rseqc/inner_distance/txt", + "star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance.txt", + "star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_freq.txt", + "star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_mean.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance_freq.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance_mean.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance_freq.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance_mean.txt", + "star_salmon/rseqc/junction_annotation", + "star_salmon/rseqc/junction_annotation/bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.bed", + "star_salmon/rseqc/junction_annotation/bed/WT_REP1.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/WT_REP1.junction.bed", + "star_salmon/rseqc/junction_annotation/bed/WT_REP2.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/WT_REP2.junction.bed", + "star_salmon/rseqc/junction_annotation/log", + "star_salmon/rseqc/junction_annotation/log/RAP1_IAA_30M_REP1.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP1.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP2.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/log/WT_REP1.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/log/WT_REP2.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/pdf/WT_REP1.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/WT_REP1.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/pdf/WT_REP2.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/WT_REP2.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/rscript", + "star_salmon/rseqc/junction_annotation/rscript/RAP1_IAA_30M_REP1.junction_plot.r", + "star_salmon/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP1.junction_plot.r", + "star_salmon/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP2.junction_plot.r", + "star_salmon/rseqc/junction_annotation/rscript/WT_REP1.junction_plot.r", + "star_salmon/rseqc/junction_annotation/rscript/WT_REP2.junction_plot.r", + "star_salmon/rseqc/junction_annotation/xls", + "star_salmon/rseqc/junction_annotation/xls/RAP1_IAA_30M_REP1.junction.xls", + "star_salmon/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP1.junction.xls", + "star_salmon/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP2.junction.xls", + "star_salmon/rseqc/junction_annotation/xls/WT_REP1.junction.xls", + "star_salmon/rseqc/junction_annotation/xls/WT_REP2.junction.xls", + "star_salmon/rseqc/junction_saturation", + "star_salmon/rseqc/junction_saturation/pdf", + "star_salmon/rseqc/junction_saturation/pdf/RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/pdf/WT_REP1.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/pdf/WT_REP2.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/rscript", + "star_salmon/rseqc/junction_saturation/rscript/RAP1_IAA_30M_REP1.junctionSaturation_plot.r", + "star_salmon/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP1.junctionSaturation_plot.r", + "star_salmon/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP2.junctionSaturation_plot.r", + "star_salmon/rseqc/junction_saturation/rscript/WT_REP1.junctionSaturation_plot.r", + "star_salmon/rseqc/junction_saturation/rscript/WT_REP2.junctionSaturation_plot.r", + "star_salmon/rseqc/read_distribution", + "star_salmon/rseqc/read_distribution/RAP1_IAA_30M_REP1.read_distribution.txt", + "star_salmon/rseqc/read_distribution/RAP1_UNINDUCED_REP1.read_distribution.txt", + "star_salmon/rseqc/read_distribution/RAP1_UNINDUCED_REP2.read_distribution.txt", + "star_salmon/rseqc/read_distribution/WT_REP1.read_distribution.txt", + "star_salmon/rseqc/read_distribution/WT_REP2.read_distribution.txt", + "star_salmon/rseqc/read_duplication", + "star_salmon/rseqc/read_duplication/pdf", + "star_salmon/rseqc/read_duplication/pdf/RAP1_IAA_30M_REP1.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP1.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP2.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/pdf/WT_REP1.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/pdf/WT_REP2.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/rscript", + "star_salmon/rseqc/read_duplication/rscript/RAP1_IAA_30M_REP1.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP1.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP2.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/rscript/WT_REP1.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/rscript/WT_REP2.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.seq.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.seq.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.seq.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/WT_REP1.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/WT_REP1.seq.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/WT_REP2.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/WT_REP2.seq.DupRate.xls", + "star_salmon/salmon.merged.gene_counts.SummarizedExperiment.rds", + "star_salmon/salmon.merged.gene_counts.tsv", + "star_salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", + "star_salmon/salmon.merged.gene_counts_length_scaled.tsv", + "star_salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", + "star_salmon/salmon.merged.gene_counts_scaled.tsv", + "star_salmon/salmon.merged.gene_lengths.tsv", + "star_salmon/salmon.merged.gene_tpm.tsv", + "star_salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds", + "star_salmon/salmon.merged.transcript_counts.tsv", + "star_salmon/salmon.merged.transcript_lengths.tsv", + "star_salmon/salmon.merged.transcript_tpm.tsv", + "star_salmon/samtools_stats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP1.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP1.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP1.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP2.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP2.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP2.sorted.bam.stats", + "star_salmon/stringtie", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e2t.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e_data.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i2t.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i_data.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/t_data.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.coverage.gtf", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.gene.abundance.txt", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.transcripts.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/t_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.coverage.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.gene.abundance.txt", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.transcripts.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/t_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.coverage.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.gene.abundance.txt", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.transcripts.gtf", + "star_salmon/stringtie/WT_REP1.ballgown", + "star_salmon/stringtie/WT_REP1.ballgown/e2t.ctab", + "star_salmon/stringtie/WT_REP1.ballgown/e_data.ctab", + "star_salmon/stringtie/WT_REP1.ballgown/i2t.ctab", + "star_salmon/stringtie/WT_REP1.ballgown/i_data.ctab", + "star_salmon/stringtie/WT_REP1.ballgown/t_data.ctab", + "star_salmon/stringtie/WT_REP1.coverage.gtf", + "star_salmon/stringtie/WT_REP1.gene.abundance.txt", + "star_salmon/stringtie/WT_REP1.transcripts.gtf", + "star_salmon/stringtie/WT_REP2.ballgown", + "star_salmon/stringtie/WT_REP2.ballgown/e2t.ctab", + "star_salmon/stringtie/WT_REP2.ballgown/e_data.ctab", + "star_salmon/stringtie/WT_REP2.ballgown/i2t.ctab", + "star_salmon/stringtie/WT_REP2.ballgown/i_data.ctab", + "star_salmon/stringtie/WT_REP2.ballgown/t_data.ctab", + "star_salmon/stringtie/WT_REP2.coverage.gtf", + "star_salmon/stringtie/WT_REP2.gene.abundance.txt", + "star_salmon/stringtie/WT_REP2.transcripts.gtf", + "star_salmon/tx2gene.tsv", + "trimgalore", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" + ], + [ + "genome_gfp.fasta:md5,e23e302af63736a199985a169fdac055", + "genome_gfp.gtf:md5,b4776accd1bf7206c7ab0f1d84e4721e", + "cutadapt_filtered_reads_plot.txt:md5,bf033e64e9d23bee85b6277f11c663f1", + "cutadapt_trimmed_sequences_plot_3_Counts.txt:md5,13dfa866fd91dbb072689efe9aa83b1f", + "cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt:md5,07145dd8dd3db654859b18eb0389046c", + "fastqc-status-check-heatmap-1.txt:md5,22a03548736b88b23be6bc0c9ef1b4a6", + "fastqc-status-check-heatmap.txt:md5,5a89b0d8d162f6b1dbdaf39457bbc03b", + "fastqc_adapter_content_plot.txt:md5,da0389be84cfdd189b1d045212eb2974", + "fastqc_overrepresented_sequences_plot-1.txt:md5,4adfeacd3a3a6c7c808f121b24e6b247", + "fastqc_overrepresented_sequences_plot.txt:md5,25d88ea8a72f55e8a374ae802bc7f0b1", + "fastqc_per_base_n_content_plot-1.txt:md5,418610c1ce119cb786ad434db75d366e", + "fastqc_per_base_n_content_plot.txt:md5,d368d7e36ca2f73dcde61f2b486d8213", + "fastqc_per_base_sequence_quality_plot-1.txt:md5,bd22e06e41c096ad4f745d40fe96a1e5", + "fastqc_per_base_sequence_quality_plot.txt:md5,5c3065b549129702b185ea1b817da420", + "fastqc_per_sequence_gc_content_plot-1_Counts.txt:md5,004c60768ceb6197765154e3eaa37b7a", + "fastqc_per_sequence_gc_content_plot-1_Percentages.txt:md5,95d29060b687f745288ad1ec47750037", + "fastqc_per_sequence_gc_content_plot_Counts.txt:md5,9ddaa50167117d3c9188ccf015427704", + "fastqc_per_sequence_gc_content_plot_Percentages.txt:md5,f10ee2881b61308af35f304aa3d810a3", + "fastqc_per_sequence_quality_scores_plot-1.txt:md5,0f9834cc19f76dd5c87cf8cba7435a7c", + "fastqc_per_sequence_quality_scores_plot.txt:md5,b5f9a02933e3065952237afd2ec9ce82", + "fastqc_sequence_counts_plot-1.txt:md5,3861354bbedfbde7ca36a72994f9425c", + "fastqc_sequence_counts_plot.txt:md5,d385a3e2c2573a0902c66e8c93876d3c", + "fastqc_sequence_duplication_levels_plot-1.txt:md5,c73407d55fc532e864fa1dc8dbc12874", + "fastqc_sequence_duplication_levels_plot.txt:md5,8812cee16f6ca65e2c33635754de1772", + "fastqc_sequence_length_distribution_plot.txt:md5,6fe2c985606abad947bcca99b015ae33", + "multiqc_citations.txt:md5,2d2ab6df367e36e98e081c33dec187a0", + "multiqc_cutadapt.txt:md5,aac9581a5670cb55edf564f3d6c1f9a7", + "multiqc_fastqc_fastqc_raw.txt:md5,81c3c1a2575a1891a7f2a9637a0f2cc0", + "multiqc_fastqc_fastqc_trimmed.txt:md5,a3238f515e01d158d875d69968753804", + "multiqc_samtools_idxstats.txt:md5,fd7d03a91f0b9e01a6939941f7f2243f", + "picard_histogram.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "picard_histogram_1.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "picard_histogram_2.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "qualimap_gene_coverage_profile_Counts.txt:md5,02044ed1bf1eca19a8a87c9971cdc049", + "qualimap_gene_coverage_profile_Normalised.txt:md5,eeeea7f50278b3b335bef545784abbfa", + "qualimap_rnaseq_cov_hist.txt:md5,51407e597076f3a7f98622213bea6bce", + "rseqc_infer_experiment_plot.txt:md5,de5a0bad9cca763928e7c33375eb5218", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt:md5,75acd04232d1804b5f960ee4c5db4722", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt:md5,ae45731d8d4595f77e6b271004f3a070", + "samtools-idxstats-mapped-reads-plot_Raw_Counts.txt:md5,01637c600d3840500851eb4118564cc6", + "cutadapt_filtered_reads_plot-cnt.png:md5,704cf0d91bfa3dd658dd8c9590f669a2", + "cutadapt_filtered_reads_plot-pct.png:md5,2684d8b2afca3300e5786486b80237f0", + "cutadapt_trimmed_sequences_plot_3_Counts.png:md5,bef41d894629b0c4dab4478bbf197f50", + "cutadapt_trimmed_sequences_plot_3_Obs_Exp.png:md5,1e0d01537d3797623d0b3fd8fbe42787", + "dupradar-section-plot.png:md5,3ae5e5cb161b7abd878d718bc71b41f6", + "fastqc-status-check-heatmap-1.png:md5,2402522f8c02e12aea9af088c6595890", + "fastqc-status-check-heatmap.png:md5,fe8b5b4ab4480d46a12a9005932a9b84", + "fastqc_overrepresented_sequences_plot-1.png:md5,40e450251b80ec0efc9364434234ec7f", + "fastqc_overrepresented_sequences_plot.png:md5,6f5ffbdf1bf61fabe5e028c8bc85de14", + "fastqc_per_sequence_gc_content_plot-1_Counts.png:md5,8a806cec2142f9911502e0a253d83d13", + "fastqc_per_sequence_gc_content_plot-1_Percentages.png:md5,953929d50c8490029880e205e4db7959", + "fastqc_per_sequence_gc_content_plot_Counts.png:md5,01f124545af788fd5cc7bbf41b005e16", + "fastqc_per_sequence_gc_content_plot_Percentages.png:md5,eba3abf8bedb2cb20bad90c54e9c8881", + "fastqc_per_sequence_quality_scores_plot-1.png:md5,d2c29cae169f35744500c751b4a7366e", + "fastqc_per_sequence_quality_scores_plot.png:md5,42fd7369a8aca78f620164a9e887c3cb", + "fastqc_sequence_counts_plot-1-cnt.png:md5,2874fea747c7ff46828bf4f17668caf8", + "fastqc_sequence_counts_plot-1-pct.png:md5,0022d7f5ac78b6eff157de24e37c5ab0", + "fastqc_sequence_counts_plot-cnt.png:md5,3890d5555f2a39b46b9f6efb14cb91f2", + "fastqc_sequence_counts_plot-pct.png:md5,55fa5838c8b2db978fcfa5cb83f6b054", + "fastqc_sequence_duplication_levels_plot-1.png:md5,fcd3b1ec2b95fe4bcd607dc28179a754", + "fastqc_sequence_duplication_levels_plot.png:md5,747431f0f38f8e4c41a11a072fa18780", + "qualimap_gene_coverage_profile_Counts.png:md5,ac424dc7e5444a32e482bd5048ac4432", + "qualimap_gene_coverage_profile_Normalised.png:md5,62e5a2146daec985b8c2de02e3b57c1e", + "rseqc_infer_experiment_plot.png:md5,60c3cafb671fad2cf5f695615230eb8f", + "rseqc_read_dups_plot.png:md5,958513925fa5494bf499c989842d6928", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png:md5,ce6abb232fd5b5f2e66c0fe9a571d75f", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png:md5,6b44818f886ef020fb3646f152ad4af6", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png:md5,d5d8a85b7ad72a0cb93d9283ea12b23f", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png:md5,19317ad8f1448cd7eb1d319f85cc5c4d", + "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png:md5,a6849cd92ae738441212b681a411614d", + "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png:md5,4c06988372df63a1fb5f8be93f73ae8f", + "ambig_info.tsv:md5,de973a4b22a4457217ae3dc04caf9401", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,1215f0c20f87d3aef8553ef119e1e74c", + "lib_format_counts.json:md5,c24ffe28d70476b5ccdd8bc2d22c0ac1", + "ambig_info.tsv:md5,45f252b4f0e11e6730cf0c29f800fdbb", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,621c6601aade5b1f2e3d6ca2fc71f636", + "lib_format_counts.json:md5,f6d44c0221f7fd559f11a9afe04c9935", + "ambig_info.tsv:md5,6dcc2891ea572e9b8d1ba52cd434ab84", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,9bed6e4dc5428d6f6297adcea29a6326", + "lib_format_counts.json:md5,7c562bf2f70e42f3a7292687dfd328c3", + "ambig_info.tsv:md5,194f574e0586416155e3f33d42e2b167", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,c7ed0aaa5d6c7934ddbebfd29e4eb86d", + "lib_format_counts.json:md5,d46250bb3677d72feeefc435fe6395a6", + "ambig_info.tsv:md5,a26e3f936e65d7da66392603c2f91f6f", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,69ebfc2c7ca6b221a0a22fa1dc8c20ac", + "lib_format_counts.json:md5,088fd51db07022ffde47033bbd029400", + "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", + "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", + "ambig_info.tsv:md5,f9a605d54a0a103566f7a9b8e0867a73", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,4cc2492f557e5e0a2911a0bd83a51020", + "ambig_info.tsv:md5,8f97be8af4e47cc48650c62227a40203", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,dc750c3564c63da54979c852794d58a5", + "ambig_info.tsv:md5,a044fe7a3ad445c9a91a0d54ab5015d1", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,db43ed650e6e7b42cd2c5b8101bb6748", + "ambig_info.tsv:md5,7a8ea02d74058efb801e8c62bca96fd4", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,e418b4e899623449c6babdf53e5aabde", + "ambig_info.tsv:md5,543a047a549437026a1363ea8ddf5b03", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,f234c8d322df3b59d990594c63b24eae", + "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", + "RAP1_IAA_30M_REP1_dupMatrix.txt:md5,2e0d518a450bb57801cdd075d4e9c217", + "RAP1_UNINDUCED_REP1_dupMatrix.txt:md5,96e2f9e1fc5a22a7d468e6fb4a613370", + "RAP1_UNINDUCED_REP2_dupMatrix.txt:md5,28c30ce734d78d53b1c47c3f87414e4b", + "WT_REP1_dupMatrix.txt:md5,b6aa1b99d91f5fa7a94efeed1c496c00", + "WT_REP2_dupMatrix.txt:md5,02236769150436cf31b7339f612119a5", + "RAP1_IAA_30M_REP1_intercept_slope.txt:md5,c677048855caf5190f29fa5f7137cd79", + "RAP1_UNINDUCED_REP1_intercept_slope.txt:md5,ea1b4323d3bc83759e8a026416bca32b", + "RAP1_UNINDUCED_REP2_intercept_slope.txt:md5,b062f49a5223a3452075062cdd308043", + "WT_REP1_intercept_slope.txt:md5,e7fcac6d125a7ba746a5cba4a1e66aef", + "WT_REP2_intercept_slope.txt:md5,5af16b07a734b73a2c1103b535f9e26e", + "RAP1_IAA_30M_REP1.SJ.out.tab:md5,ea95e243278af55534f2c52eb5fff7ee", + "RAP1_UNINDUCED_REP1.SJ.out.tab:md5,e548d13942535dc0821f3ec6d9743ec8", + "RAP1_UNINDUCED_REP2.SJ.out.tab:md5,1f294365343a1a5e95682792fdb77033", + "WT_REP1.SJ.out.tab:md5,1350c2fa6a675bf107386c6cd3fc5204", + "WT_REP2.SJ.out.tab:md5,f6cc03643a5e3c1025a5b4754eb1be23", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,876c1b88f33bd3e5fe1a41679729573d", + "Coverage Profile Along Genes (Low).png:md5,ee1f2c9cc4dd4867811eda1e68864ab4", + "Coverage Profile Along Genes (Total).png:md5,53747a8f9813744902756ad60638380a", + "Transcript coverage histogram.png:md5,4f9072d4b11216373b59396293803a37", + "coverage_profile_along_genes_(high).txt:md5,fcb06d460810c0555de5396b9dae05e8", + "coverage_profile_along_genes_(low).txt:md5,e3c9a1ddfdb89f8534ff7548b70fce32", + "coverage_profile_along_genes_(total).txt:md5,e3c9a1ddfdb89f8534ff7548b70fce32", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,bbf0531018e7fccfc1dfdd1c05715518", + "Coverage Profile Along Genes (Low).png:md5,3c147d9c831d4be98615a22a72fad05d", + "Coverage Profile Along Genes (Total).png:md5,5a8a6db3a8d19a2dcb8f715b11e67c50", + "Transcript coverage histogram.png:md5,488440d7b6d73bcd4567316712e281fe", + "coverage_profile_along_genes_(high).txt:md5,9f1e29a4d6eec52e8796b080daaedca3", + "coverage_profile_along_genes_(low).txt:md5,353f42a84ff34167646fc83909eac2ff", + "coverage_profile_along_genes_(total).txt:md5,353f42a84ff34167646fc83909eac2ff", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,5a5d99cc7a1dba3762d67f4aa4adad58", + "Coverage Profile Along Genes (Low).png:md5,b6adc296e9a732aa0495a6da8fa4ed90", + "Coverage Profile Along Genes (Total).png:md5,fcb94fb9c1a51c1db32f884d05929cc8", + "Transcript coverage histogram.png:md5,3aeb52ff3e3752727a370b0d7ceb0518", + "coverage_profile_along_genes_(high).txt:md5,3b20a736708df02ea8c86dc5829ae67e", + "coverage_profile_along_genes_(low).txt:md5,02b314b76ef1317f20e129412340755d", + "coverage_profile_along_genes_(total).txt:md5,02b314b76ef1317f20e129412340755d", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,c974d47996bcc57b99dfaf6903f61f41", + "Coverage Profile Along Genes (Low).png:md5,c8fe631f0580c93adb5be107c6a7a1a3", + "Coverage Profile Along Genes (Total).png:md5,424d245e9f3e626d9e79f51d1b93e946", + "Transcript coverage histogram.png:md5,17404146ad5e0a9bce97ce622e00975e", + "coverage_profile_along_genes_(high).txt:md5,8bf366c7dbc6170035ee64a057c581f1", + "coverage_profile_along_genes_(low).txt:md5,a9102de3ff9679d1f7a86afa85997211", + "coverage_profile_along_genes_(total).txt:md5,a9102de3ff9679d1f7a86afa85997211", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,40edd79c21f3e8d8bbac384156c472d6", + "Coverage Profile Along Genes (Low).png:md5,935c0372259a953a4c99569e9b236ae5", + "Coverage Profile Along Genes (Total).png:md5,34f7a4307be1ea674b7b98eee564d96b", + "Transcript coverage histogram.png:md5,e2abf8a9c62fef57f0be1ca0e01e502d", + "coverage_profile_along_genes_(high).txt:md5,3f13eb908d6e97e6831306e9527cc2e3", + "coverage_profile_along_genes_(low).txt:md5,24df553662d0cedaa74cf06a8fead40b", + "coverage_profile_along_genes_(total).txt:md5,24df553662d0cedaa74cf06a8fead40b", + "RAP1_IAA_30M_REP1.infer_experiment.txt:md5,169d25b95c008bebe9ce886fea6a4e33", + "RAP1_UNINDUCED_REP1.infer_experiment.txt:md5,2ca0ce0fd3204bd2cc4812c4655b1f1f", + "RAP1_UNINDUCED_REP2.infer_experiment.txt:md5,7d5705880188f9beab1939e08d6b8f40", + "WT_REP1.infer_experiment.txt:md5,bf0c137f5fca06e7c40e1984a1acb06d", + "WT_REP2.infer_experiment.txt:md5,82e23b329ee60709f343bc2d17d43b14", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,3f149502efe2a9d4bac98b1dd18c15e7", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,a052ab04070e72cc318fb7680b0764e3", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,e82329a443b9ff50a86e42aff91bd704", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,d279003d92f7feef9adb31203f84474a", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,10e2d00f93f9e74f224bd3c1bfbeb29b", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,525413b70bcf62c24c8f96182e09883e", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,9aa371befc36478d7720d3ea275e6f4d", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,907ab2e06346df131cbdb929afc005a8", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,b03f3118d1aa58fceadcb3311028e856", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,041edee3193df311f621c09f4991892b", + "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe" + ] ], "meta": { "nf-test": "0.9.0", "nextflow": "24.04.4" }, - "timestamp": "2024-08-26T14:18:38.410297" + "timestamp": "2024-10-02T07:37:24.538529" } } \ No newline at end of file diff --git a/tests/hisat2.nf.test b/tests/hisat2.nf.test index 9577086ea..e743a37d4 100644 --- a/tests/hisat2.nf.test +++ b/tests/hisat2.nf.test @@ -13,806 +13,22 @@ nextflow_pipeline { } then { + // stable_name: All files + folders in ${params.outdir}/ with a stable name + def stable_name = getAllFilesFromDir(params.outdir, true, ['pipeline_info/*.{html,json,txt}'], null) + // stable_path: All files in ${params.outdir}/ with stable content + def stable_path = getAllFilesFromDir(params.outdir, false, null, 'tests/.nftignore') assertAll( - { assert workflow.success }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/bbsplit/RAP1_IAA_30M_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/RAP1_UNINDUCED_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/RAP1_UNINDUCED_REP2.stats.txt").name, - file("${params.outdir}/bbsplit/WT_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/WT_REP2.stats.txt").name - ).match("bbsplit") }, - { assert snapshot( - path("${params.outdir}/custom/out/genome_gfp.fasta"), - path("${params.outdir}/custom/out/genome_gfp.gtf") - ).match("references") }, - { assert snapshot( - // HTMLs and ZIPs are not stable - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_2_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_2_fastqc.zip").name - ).match("fastqc/raw") }, - { assert snapshot( - // HTMLs and ZIPs are not stable - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.zip").name - ).match("fastqc/trim") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/hisat2/bigwig/RAP1_IAA_30M_REP1.forward.bigWig").name, - file("${params.outdir}/hisat2/bigwig/RAP1_IAA_30M_REP1.reverse.bigWig").name, - file("${params.outdir}/hisat2/bigwig/RAP1_UNINDUCED_REP1.forward.bigWig").name, - file("${params.outdir}/hisat2/bigwig/RAP1_UNINDUCED_REP1.reverse.bigWig").name, - file("${params.outdir}/hisat2/bigwig/RAP1_UNINDUCED_REP2.forward.bigWig").name, - file("${params.outdir}/hisat2/bigwig/RAP1_UNINDUCED_REP2.reverse.bigWig").name, - file("${params.outdir}/hisat2/bigwig/WT_REP1.forward.bigWig").name, - file("${params.outdir}/hisat2/bigwig/WT_REP1.reverse.bigWig").name, - file("${params.outdir}/hisat2/bigwig/WT_REP2.forward.bigWig").name, - file("${params.outdir}/hisat2/bigwig/WT_REP2.reverse.bigWig").name - ).match("hisat2/bigwig") }, - { assert snapshot( - path("${params.outdir}/hisat2/dupradar/gene_data/RAP1_IAA_30M_REP1_dupMatrix.txt"), - path("${params.outdir}/hisat2/dupradar/gene_data/RAP1_UNINDUCED_REP1_dupMatrix.txt"), - path("${params.outdir}/hisat2/dupradar/gene_data/RAP1_UNINDUCED_REP2_dupMatrix.txt"), - path("${params.outdir}/hisat2/dupradar/gene_data/WT_REP1_dupMatrix.txt"), - path("${params.outdir}/hisat2/dupradar/gene_data/WT_REP2_dupMatrix.txt"), - path("${params.outdir}/hisat2/dupradar/intercepts_slope/RAP1_IAA_30M_REP1_intercept_slope.txt"), - path("${params.outdir}/hisat2/dupradar/intercepts_slope/RAP1_UNINDUCED_REP1_intercept_slope.txt"), - path("${params.outdir}/hisat2/dupradar/intercepts_slope/RAP1_UNINDUCED_REP2_intercept_slope.txt"), - path("${params.outdir}/hisat2/dupradar/intercepts_slope/WT_REP1_intercept_slope.txt"), - path("${params.outdir}/hisat2/dupradar/intercepts_slope/WT_REP2_intercept_slope.txt"), - // PDFs are not stable - file("${params.outdir}/hisat2/dupradar/box_plot/RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf").name, - file("${params.outdir}/hisat2/dupradar/box_plot/RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf").name, - file("${params.outdir}/hisat2/dupradar/box_plot/RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf").name, - file("${params.outdir}/hisat2/dupradar/box_plot/WT_REP1_duprateExpBoxplot.pdf").name, - file("${params.outdir}/hisat2/dupradar/box_plot/WT_REP2_duprateExpBoxplot.pdf").name, - file("${params.outdir}/hisat2/dupradar/histogram/RAP1_IAA_30M_REP1_expressionHist.pdf").name, - file("${params.outdir}/hisat2/dupradar/histogram/RAP1_UNINDUCED_REP1_expressionHist.pdf").name, - file("${params.outdir}/hisat2/dupradar/histogram/RAP1_UNINDUCED_REP2_expressionHist.pdf").name, - file("${params.outdir}/hisat2/dupradar/histogram/WT_REP1_expressionHist.pdf").name, - file("${params.outdir}/hisat2/dupradar/histogram/WT_REP2_expressionHist.pdf").name, - file("${params.outdir}/hisat2/dupradar/scatter_plot/RAP1_IAA_30M_REP1_duprateExpDens.pdf").name, - file("${params.outdir}/hisat2/dupradar/scatter_plot/RAP1_UNINDUCED_REP1_duprateExpDens.pdf").name, - file("${params.outdir}/hisat2/dupradar/scatter_plot/RAP1_UNINDUCED_REP2_duprateExpDens.pdf").name, - file("${params.outdir}/hisat2/dupradar/scatter_plot/WT_REP1_duprateExpDens.pdf").name, - file("${params.outdir}/hisat2/dupradar/scatter_plot/WT_REP2_duprateExpDens.pdf").name - ).match("hisat2/dupradar") }, - { assert snapshot( - path("${params.outdir}/hisat2/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv"), - path("${params.outdir}/hisat2/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/hisat2/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt"), - path("${params.outdir}/hisat2/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv"), - path("${params.outdir}/hisat2/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/hisat2/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt"), - path("${params.outdir}/hisat2/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv"), - path("${params.outdir}/hisat2/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/hisat2/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt"), - path("${params.outdir}/hisat2/featurecounts/WT_REP1.biotype_counts_mqc.tsv"), - path("${params.outdir}/hisat2/featurecounts/WT_REP1.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/hisat2/featurecounts/WT_REP1.featureCounts.txt"), - path("${params.outdir}/hisat2/featurecounts/WT_REP2.biotype_counts_mqc.tsv"), - path("${params.outdir}/hisat2/featurecounts/WT_REP2.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/hisat2/featurecounts/WT_REP2.featureCounts.txt"), - file("${params.outdir}/hisat2/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt.summary").name, - file("${params.outdir}/hisat2/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt.summary").name, - file("${params.outdir}/hisat2/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt.summary").name, - file("${params.outdir}/hisat2/featurecounts/WT_REP1.featureCounts.txt.summary").name, - file("${params.outdir}/hisat2/featurecounts/WT_REP2.featureCounts.txt.summary").name - ).match("hisat2/featurecounts") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/hisat2/RAP1_IAA_30M_REP1.markdup.sorted.bam").name, - file("${params.outdir}/hisat2/RAP1_IAA_30M_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/hisat2/RAP1_UNINDUCED_REP1.markdup.sorted.bam").name, - file("${params.outdir}/hisat2/RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/hisat2/RAP1_UNINDUCED_REP2.markdup.sorted.bam").name, - file("${params.outdir}/hisat2/RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai").name, - file("${params.outdir}/hisat2/WT_REP1.markdup.sorted.bam").name, - file("${params.outdir}/hisat2/WT_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/hisat2/WT_REP2.markdup.sorted.bam").name, - file("${params.outdir}/hisat2/WT_REP2.markdup.sorted.bam.bai").name - ).match("hisat2/markdup") }, - { assert snapshot( - file("${params.outdir}/hisat2/log/RAP1_IAA_30M_REP1.hisat2.summary.log").name, - file("${params.outdir}/hisat2/log/RAP1_UNINDUCED_REP1.hisat2.summary.log").name, - file("${params.outdir}/hisat2/log/RAP1_UNINDUCED_REP2.hisat2.summary.log").name, - file("${params.outdir}/hisat2/log/WT_REP1.hisat2.summary.log").name, - file("${params.outdir}/hisat2/log/WT_REP2.hisat2.summary.log").name - ).match("hisat2") }, - { assert snapshot( - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/cutadapt_filtered_reads_plot.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Counts.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc-status-check-heatmap-1.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc-status-check-heatmap.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc_adapter_content_plot.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc_overrepresented_sequences_plot-1.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc_overrepresented_sequences_plot.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc_per_base_n_content_plot-1.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc_per_base_n_content_plot.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc_per_base_sequence_quality_plot-1.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc_per_base_sequence_quality_plot.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Counts.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Percentages.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Counts.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Percentages.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc_per_sequence_quality_scores_plot-1.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc_per_sequence_quality_scores_plot.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc_sequence_counts_plot-1.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc_sequence_counts_plot.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc_sequence_duplication_levels_plot-1.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc_sequence_duplication_levels_plot.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc_sequence_length_distribution_plot.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_citations.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_cutadapt.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_fastqc_fastqc_raw.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_fastqc_fastqc_trimmed.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_featurecounts_biotype_plot.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_samtools_idxstats.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/picard_histogram.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/picard_histogram_1.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/picard_histogram_2.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/qualimap_gene_coverage_profile_Counts.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/qualimap_gene_coverage_profile_Normalised.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/qualimap_rnaseq_cov_hist.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/rseqc_infer_experiment_plot.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Raw_Counts.txt"), - // These files are not stable - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc_top_overrepresented_sequences_table-1.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/fastqc_top_overrepresented_sequences_table.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/hisat2_pe_plot.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/hisat2_se_plot.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/junction_saturation_known.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/junction_saturation_novel.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_data.json").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_dupradar-section-plot.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_fail_strand_check_table.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_general_stats.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_hisat2.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_hisat2_deseq2_clustering-plot.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_hisat2_deseq2_clustering-plot_1.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_hisat2_deseq2_clustering-plot_2.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_hisat2_deseq2_clustering-plot_3.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_hisat2_deseq2_clustering-plot_4.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_hisat2_deseq2_pca-plot.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_picard_dups.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_rseqc_bam_stat.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_rseqc_infer_experiment.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_rseqc_junction_annotation.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_rseqc_read_distribution.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_salmon.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_1.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_2.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_3.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_4.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_salmon_deseq2_pca-plot.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_samtools_flagstat.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_samtools_stats.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_software_versions.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/multiqc_sources.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/picard_deduplication.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/qualimap_genomic_origin.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/rseqc_bam_stat.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/rseqc_inner_distance.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/rseqc_inner_distance_plot_Counts.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/rseqc_inner_distance_plot_Percentages.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Events.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Junctions.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/rseqc_junction_saturation_all.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/rseqc_junction_saturation_plot_All_Junctions.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/rseqc_junction_saturation_plot_Known_Junctions.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/rseqc_junction_saturation_plot_Novel_Junctions.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/rseqc_read_distribution_plot.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/rseqc_read_dups.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/rseqc_read_dups_plot.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/salmon_plot.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/samtools-flagstat-dp_Percentage_of_total.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/samtools-flagstat-dp_Read_counts.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/samtools-stats-dp.txt").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_data/samtools_alignment_plot.txt").name - ).match("multiqc_data") }, - { assert snapshot( - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/cutadapt_filtered_reads_plot-cnt.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/cutadapt_filtered_reads_plot-pct.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Counts.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Obs_Exp.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/dupradar-section-plot.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc-status-check-heatmap-1.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc-status-check-heatmap.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot-1.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Counts.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Percentages.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Counts.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Percentages.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot-1.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-cnt.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-pct.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_sequence_counts_plot-cnt.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_sequence_counts_plot-pct.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot-1.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/featurecounts_biotype_plot-cnt.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/featurecounts_biotype_plot-pct.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/qualimap_gene_coverage_profile_Counts.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/qualimap_gene_coverage_profile_Normalised.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/rseqc_infer_experiment_plot.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/rseqc_read_dups_plot.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png"), - path("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png"), - // PDFs, SVGs, some PNGs and HTML reports are not stable - file("${params.outdir}/multiqc/hisat2/multiqc_report.html").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-pct.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Counts.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/dupradar-section-plot.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fail_strand_check_table.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc-status-check-heatmap-1.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc-status-check-heatmap.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_adapter_content_plot.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot-1.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot-1.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot-1.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Counts.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Percentages.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Counts.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Percentages.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot-1.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-cnt.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-pct.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-pct.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot-1.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_sequence_length_distribution_plot.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table-1.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/featurecounts_biotype_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/featurecounts_biotype_plot-pct.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/general_stats_table.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/hisat2_deseq2_clustering-plot.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/hisat2_deseq2_pca-plot.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/hisat2_pe_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/hisat2_pe_plot-pct.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/hisat2_se_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/hisat2_se_plot-pct.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/picard_deduplication-cnt.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/picard_deduplication-pct.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Counts.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Normalised.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/qualimap_genomic_origin-cnt.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/qualimap_genomic_origin-pct.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/rseqc_bam_stat.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/rseqc_infer_experiment_plot.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Counts.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Percentages.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-cnt.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-pct.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_All_Junctions.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Known_Junctions.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Novel_Junctions.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/rseqc_read_distribution_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/rseqc_read_distribution_plot-pct.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/rseqc_read_dups_plot.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/salmon_deseq2_clustering-plot.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/salmon_deseq2_pca-plot.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/salmon_plot.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/samtools-flagstat-dp_Percentage_of_total.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/samtools-flagstat-dp_Read_counts.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/samtools-stats-dp.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/samtools_alignment_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/pdf/samtools_alignment_plot-pct.pdf").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fail_strand_check_table.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_adapter_content_plot.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_per_base_n_content_plot-1.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_per_base_n_content_plot.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot-1.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_sequence_length_distribution_plot.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table-1.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/general_stats_table.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/hisat2_deseq2_clustering-plot.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/hisat2_deseq2_pca-plot.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/hisat2_pe_plot-cnt.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/hisat2_pe_plot-pct.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/hisat2_se_plot-cnt.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/hisat2_se_plot-pct.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/picard_deduplication-cnt.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/picard_deduplication-pct.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/qualimap_genomic_origin-cnt.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/qualimap_genomic_origin-pct.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/rseqc_bam_stat.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/rseqc_inner_distance_plot_Counts.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/rseqc_inner_distance_plot_Percentages.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-cnt.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-pct.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-cnt.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-pct.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/rseqc_junction_saturation_plot_All_Junctions.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/rseqc_junction_saturation_plot_Known_Junctions.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/rseqc_junction_saturation_plot_Novel_Junctions.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/rseqc_read_distribution_plot-cnt.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/rseqc_read_distribution_plot-pct.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/salmon_deseq2_clustering-plot.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/salmon_deseq2_pca-plot.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/salmon_plot.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/samtools-flagstat-dp_Percentage_of_total.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/samtools-flagstat-dp_Read_counts.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/samtools-stats-dp.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/samtools_alignment_plot-cnt.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/png/samtools_alignment_plot-pct.png").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-cnt.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-pct.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Counts.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/dupradar-section-plot.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fail_strand_check_table.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc-status-check-heatmap-1.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc-status-check-heatmap.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_adapter_content_plot.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot-1.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_per_base_n_content_plot-1.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_per_base_n_content_plot.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot-1.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Counts.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Percentages.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Counts.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Percentages.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot-1.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-cnt.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-pct.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_sequence_counts_plot-cnt.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_sequence_counts_plot-pct.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot-1.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_sequence_length_distribution_plot.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table-1.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/featurecounts_biotype_plot-cnt.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/featurecounts_biotype_plot-pct.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/general_stats_table.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/hisat2_deseq2_clustering-plot.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/hisat2_deseq2_pca-plot.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/hisat2_pe_plot-cnt.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/hisat2_pe_plot-pct.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/hisat2_se_plot-cnt.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/hisat2_se_plot-pct.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/picard_deduplication-cnt.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/picard_deduplication-pct.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Counts.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Normalised.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/qualimap_genomic_origin-cnt.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/qualimap_genomic_origin-pct.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/rseqc_bam_stat.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/rseqc_infer_experiment_plot.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/rseqc_inner_distance_plot_Counts.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/rseqc_inner_distance_plot_Percentages.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-cnt.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-pct.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-pct.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/rseqc_junction_saturation_plot_All_Junctions.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Known_Junctions.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Novel_Junctions.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/rseqc_read_distribution_plot-cnt.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/rseqc_read_distribution_plot-pct.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/rseqc_read_dups_plot.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/salmon_deseq2_clustering-plot.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/salmon_deseq2_pca-plot.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/salmon_plot.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/samtools-flagstat-dp_Percentage_of_total.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/samtools-flagstat-dp_Read_counts.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/samtools-stats-dp.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/samtools_alignment_plot-cnt.svg").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report_plots/svg/samtools_alignment_plot-pct.svg").name - ).match("multiqc_plots") }, - { assert snapshot( - // Metrics are not stable - file("${params.outdir}/hisat2/picard_metrics/RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/hisat2/picard_metrics/RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/hisat2/picard_metrics/RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/hisat2/picard_metrics/WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/hisat2/picard_metrics/WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt").name - ).match("hisat2/picard_metrics") }, - { assert snapshot( - path("${params.outdir}/hisat2/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/hisat2/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/hisat2/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/hisat2/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/hisat2/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/hisat2/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/hisat2/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/hisat2/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/hisat2/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/hisat2/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/hisat2/qualimap/WT_REP1/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/hisat2/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/hisat2/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/hisat2/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/hisat2/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/hisat2/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/hisat2/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/hisat2/qualimap/WT_REP2/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/hisat2/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/hisat2/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/hisat2/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - // HTML reports and these files are not stable - file("${params.outdir}/hisat2/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/hisat2/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/hisat2/qualimap/RAP1_IAA_30M_REP1/qualimapReport.html").name, - file("${params.outdir}/hisat2/qualimap/RAP1_IAA_30M_REP1/rnaseq_qc_results.txt").name, - file("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP1/qualimapReport.html").name, - file("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP1/rnaseq_qc_results.txt").name, - file("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP2/qualimapReport.html").name, - file("${params.outdir}/hisat2/qualimap/RAP1_UNINDUCED_REP2/rnaseq_qc_results.txt").name, - file("${params.outdir}/hisat2/qualimap/WT_REP1/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/hisat2/qualimap/WT_REP1/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/hisat2/qualimap/WT_REP1/qualimapReport.html").name, - file("${params.outdir}/hisat2/qualimap/WT_REP1/rnaseq_qc_results.txt").name, - file("${params.outdir}/hisat2/qualimap/WT_REP2/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/hisat2/qualimap/WT_REP2/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/hisat2/qualimap/WT_REP2/qualimapReport.html").name, - file("${params.outdir}/hisat2/qualimap/WT_REP2/rnaseq_qc_results.txt").name - ).match("hisat2/qualimap") }, - { assert snapshot( - path("${params.outdir}/hisat2/rseqc/infer_experiment/RAP1_IAA_30M_REP1.infer_experiment.txt"), - path("${params.outdir}/hisat2/rseqc/infer_experiment/RAP1_UNINDUCED_REP1.infer_experiment.txt"), - path("${params.outdir}/hisat2/rseqc/infer_experiment/RAP1_UNINDUCED_REP2.infer_experiment.txt"), - path("${params.outdir}/hisat2/rseqc/infer_experiment/WT_REP1.infer_experiment.txt"), - path("${params.outdir}/hisat2/rseqc/infer_experiment/WT_REP2.infer_experiment.txt"), - // PDFs, R scripts and all these files are not stable - file("${params.outdir}/hisat2/rseqc/bam_stat/RAP1_IAA_30M_REP1.bam_stat.txt").name, - file("${params.outdir}/hisat2/rseqc/bam_stat/RAP1_UNINDUCED_REP1.bam_stat.txt").name, - file("${params.outdir}/hisat2/rseqc/bam_stat/RAP1_UNINDUCED_REP2.bam_stat.txt").name, - file("${params.outdir}/hisat2/rseqc/bam_stat/WT_REP1.bam_stat.txt").name, - file("${params.outdir}/hisat2/rseqc/bam_stat/WT_REP2.bam_stat.txt").name, - file("${params.outdir}/hisat2/rseqc/inner_distance/pdf/RAP1_IAA_30M_REP1.inner_distance_plot.pdf").name, - file("${params.outdir}/hisat2/rseqc/inner_distance/pdf/WT_REP1.inner_distance_plot.pdf").name, - file("${params.outdir}/hisat2/rseqc/inner_distance/pdf/WT_REP2.inner_distance_plot.pdf").name, - file("${params.outdir}/hisat2/rseqc/inner_distance/rscript/RAP1_IAA_30M_REP1.inner_distance_plot.r").name, - file("${params.outdir}/hisat2/rseqc/inner_distance/rscript/WT_REP1.inner_distance_plot.r").name, - file("${params.outdir}/hisat2/rseqc/inner_distance/rscript/WT_REP2.inner_distance_plot.r").name, - file("${params.outdir}/hisat2/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance.txt").name, - file("${params.outdir}/hisat2/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_freq.txt").name, - file("${params.outdir}/hisat2/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_mean.txt").name, - file("${params.outdir}/hisat2/rseqc/inner_distance/txt/WT_REP1.inner_distance.txt").name, - file("${params.outdir}/hisat2/rseqc/inner_distance/txt/WT_REP1.inner_distance_freq.txt").name, - file("${params.outdir}/hisat2/rseqc/inner_distance/txt/WT_REP1.inner_distance_mean.txt").name, - file("${params.outdir}/hisat2/rseqc/inner_distance/txt/WT_REP2.inner_distance.txt").name, - file("${params.outdir}/hisat2/rseqc/inner_distance/txt/WT_REP2.inner_distance_freq.txt").name, - file("${params.outdir}/hisat2/rseqc/inner_distance/txt/WT_REP2.inner_distance_mean.txt").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.Interact.bed").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.bed").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.Interact.bed").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.bed").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.Interact.bed").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.bed").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/bed/WT_REP1.junction.Interact.bed").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/bed/WT_REP1.junction.bed").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/bed/WT_REP2.junction.Interact.bed").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/bed/WT_REP2.junction.bed").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/log/RAP1_IAA_30M_REP1.junction_annotation.log").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP1.junction_annotation.log").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP2.junction_annotation.log").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/log/WT_REP1.junction_annotation.log").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/log/WT_REP2.junction_annotation.log").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_events.pdf").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_junction.pdf").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_events.pdf").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_junction.pdf").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_events.pdf").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_junction.pdf").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/pdf/WT_REP1.splice_events.pdf").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/pdf/WT_REP1.splice_junction.pdf").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/pdf/WT_REP2.splice_events.pdf").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/pdf/WT_REP2.splice_junction.pdf").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/rscript/RAP1_IAA_30M_REP1.junction_plot.r").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP1.junction_plot.r").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP2.junction_plot.r").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/rscript/WT_REP1.junction_plot.r").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/rscript/WT_REP2.junction_plot.r").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/xls/RAP1_IAA_30M_REP1.junction.xls").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP1.junction.xls").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP2.junction.xls").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/xls/WT_REP1.junction.xls").name, - file("${params.outdir}/hisat2/rseqc/junction_annotation/xls/WT_REP2.junction.xls").name, - file("${params.outdir}/hisat2/rseqc/junction_saturation/pdf/RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf").name, - file("${params.outdir}/hisat2/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf").name, - file("${params.outdir}/hisat2/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf").name, - file("${params.outdir}/hisat2/rseqc/junction_saturation/pdf/WT_REP1.junctionSaturation_plot.pdf").name, - file("${params.outdir}/hisat2/rseqc/junction_saturation/pdf/WT_REP2.junctionSaturation_plot.pdf").name, - file("${params.outdir}/hisat2/rseqc/junction_saturation/rscript/RAP1_IAA_30M_REP1.junctionSaturation_plot.r").name, - file("${params.outdir}/hisat2/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP1.junctionSaturation_plot.r").name, - file("${params.outdir}/hisat2/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP2.junctionSaturation_plot.r").name, - file("${params.outdir}/hisat2/rseqc/junction_saturation/rscript/WT_REP1.junctionSaturation_plot.r").name, - file("${params.outdir}/hisat2/rseqc/junction_saturation/rscript/WT_REP2.junctionSaturation_plot.r").name, - file("${params.outdir}/hisat2/rseqc/read_distribution/RAP1_IAA_30M_REP1.read_distribution.txt").name, - file("${params.outdir}/hisat2/rseqc/read_distribution/RAP1_UNINDUCED_REP1.read_distribution.txt").name, - file("${params.outdir}/hisat2/rseqc/read_distribution/RAP1_UNINDUCED_REP2.read_distribution.txt").name, - file("${params.outdir}/hisat2/rseqc/read_distribution/WT_REP1.read_distribution.txt").name, - file("${params.outdir}/hisat2/rseqc/read_distribution/WT_REP2.read_distribution.txt").name, - file("${params.outdir}/hisat2/rseqc/read_duplication/pdf/RAP1_IAA_30M_REP1.DupRate_plot.pdf").name, - file("${params.outdir}/hisat2/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP1.DupRate_plot.pdf").name, - file("${params.outdir}/hisat2/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP2.DupRate_plot.pdf").name, - file("${params.outdir}/hisat2/rseqc/read_duplication/pdf/WT_REP1.DupRate_plot.pdf").name, - file("${params.outdir}/hisat2/rseqc/read_duplication/pdf/WT_REP2.DupRate_plot.pdf").name, - file("${params.outdir}/hisat2/rseqc/read_duplication/rscript/RAP1_IAA_30M_REP1.DupRate_plot.r").name, - file("${params.outdir}/hisat2/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP1.DupRate_plot.r").name, - file("${params.outdir}/hisat2/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP2.DupRate_plot.r").name, - file("${params.outdir}/hisat2/rseqc/read_duplication/rscript/WT_REP1.DupRate_plot.r").name, - file("${params.outdir}/hisat2/rseqc/read_duplication/rscript/WT_REP2.DupRate_plot.r").name, - file("${params.outdir}/hisat2/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.pos.DupRate.xls").name, - file("${params.outdir}/hisat2/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.seq.DupRate.xls").name, - file("${params.outdir}/hisat2/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.pos.DupRate.xls").name, - file("${params.outdir}/hisat2/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.seq.DupRate.xls").name, - file("${params.outdir}/hisat2/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.pos.DupRate.xls").name, - file("${params.outdir}/hisat2/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.seq.DupRate.xls").name, - file("${params.outdir}/hisat2/rseqc/read_duplication/xls/WT_REP1.pos.DupRate.xls").name, - file("${params.outdir}/hisat2/rseqc/read_duplication/xls/WT_REP1.seq.DupRate.xls").name, - file("${params.outdir}/hisat2/rseqc/read_duplication/xls/WT_REP2.pos.DupRate.xls").name, - file("${params.outdir}/hisat2/rseqc/read_duplication/xls/WT_REP2.seq.DupRate.xls").name - ).match("hisat2/rseqc") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/hisat2/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/hisat2/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/hisat2/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/hisat2/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/hisat2/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/hisat2/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.stats").name, - file("${params.outdir}/hisat2/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/hisat2/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/hisat2/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/hisat2/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/hisat2/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/hisat2/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.stats").name, - file("${params.outdir}/hisat2/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/hisat2/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/hisat2/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats").name, - file("${params.outdir}/hisat2/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.flagstat").name, - file("${params.outdir}/hisat2/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.idxstats").name, - file("${params.outdir}/hisat2/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.stats").name, - file("${params.outdir}/hisat2/samtools_stats/WT_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/hisat2/samtools_stats/WT_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/hisat2/samtools_stats/WT_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/hisat2/samtools_stats/WT_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/hisat2/samtools_stats/WT_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/hisat2/samtools_stats/WT_REP1.sorted.bam.stats").name, - file("${params.outdir}/hisat2/samtools_stats/WT_REP2.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/hisat2/samtools_stats/WT_REP2.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/hisat2/samtools_stats/WT_REP2.markdup.sorted.bam.stats").name, - file("${params.outdir}/hisat2/samtools_stats/WT_REP2.sorted.bam.flagstat").name, - file("${params.outdir}/hisat2/samtools_stats/WT_REP2.sorted.bam.idxstats").name, - file("${params.outdir}/hisat2/samtools_stats/WT_REP2.sorted.bam.stats").name - ).match("hisat2/samtools_stats") }, - { assert snapshot( - path("${params.outdir}/hisat2/stringtie/RAP1_IAA_30M_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/hisat2/stringtie/RAP1_IAA_30M_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/hisat2/stringtie/RAP1_IAA_30M_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/hisat2/stringtie/RAP1_IAA_30M_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/hisat2/stringtie/RAP1_UNINDUCED_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/hisat2/stringtie/RAP1_UNINDUCED_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/hisat2/stringtie/RAP1_UNINDUCED_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/hisat2/stringtie/RAP1_UNINDUCED_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/hisat2/stringtie/RAP1_UNINDUCED_REP2.ballgown/e2t.ctab"), - path("${params.outdir}/hisat2/stringtie/RAP1_UNINDUCED_REP2.ballgown/e_data.ctab"), - path("${params.outdir}/hisat2/stringtie/RAP1_UNINDUCED_REP2.ballgown/i2t.ctab"), - path("${params.outdir}/hisat2/stringtie/RAP1_UNINDUCED_REP2.ballgown/i_data.ctab"), - path("${params.outdir}/hisat2/stringtie/WT_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/hisat2/stringtie/WT_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/hisat2/stringtie/WT_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/hisat2/stringtie/WT_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/hisat2/stringtie/WT_REP2.ballgown/e2t.ctab"), - path("${params.outdir}/hisat2/stringtie/WT_REP2.ballgown/e_data.ctab"), - path("${params.outdir}/hisat2/stringtie/WT_REP2.ballgown/i2t.ctab"), - path("${params.outdir}/hisat2/stringtie/WT_REP2.ballgown/i_data.ctab"), - // These files are not stable - file("${params.outdir}/hisat2/stringtie/RAP1_IAA_30M_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/hisat2/stringtie/RAP1_IAA_30M_REP1.coverage.gtf").name, - file("${params.outdir}/hisat2/stringtie/RAP1_IAA_30M_REP1.gene.abundance.txt").name, - file("${params.outdir}/hisat2/stringtie/RAP1_IAA_30M_REP1.transcripts.gtf").name, - file("${params.outdir}/hisat2/stringtie/RAP1_UNINDUCED_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/hisat2/stringtie/RAP1_UNINDUCED_REP1.coverage.gtf").name, - file("${params.outdir}/hisat2/stringtie/RAP1_UNINDUCED_REP1.gene.abundance.txt").name, - file("${params.outdir}/hisat2/stringtie/RAP1_UNINDUCED_REP1.transcripts.gtf").name, - file("${params.outdir}/hisat2/stringtie/RAP1_UNINDUCED_REP2.ballgown/t_data.ctab").name, - file("${params.outdir}/hisat2/stringtie/RAP1_UNINDUCED_REP2.coverage.gtf").name, - file("${params.outdir}/hisat2/stringtie/RAP1_UNINDUCED_REP2.gene.abundance.txt").name, - file("${params.outdir}/hisat2/stringtie/RAP1_UNINDUCED_REP2.transcripts.gtf").name, - file("${params.outdir}/hisat2/stringtie/WT_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/hisat2/stringtie/WT_REP1.coverage.gtf").name, - file("${params.outdir}/hisat2/stringtie/WT_REP1.gene.abundance.txt").name, - file("${params.outdir}/hisat2/stringtie/WT_REP1.transcripts.gtf").name, - file("${params.outdir}/hisat2/stringtie/WT_REP2.ballgown/t_data.ctab").name, - file("${params.outdir}/hisat2/stringtie/WT_REP2.coverage.gtf").name, - file("${params.outdir}/hisat2/stringtie/WT_REP2.gene.abundance.txt").name, - file("${params.outdir}/hisat2/stringtie/WT_REP2.transcripts.gtf").name - ).match("hisat2/stringtie") }, - { assert snapshot( - path("${params.outdir}/salmon/deseq2_qc/R_sessionInfo.log"), - // These files are not stable - file("${params.outdir}/salmon/deseq2_qc/deseq2.dds.RData").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.pca.vals.txt").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.plots.pdf").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.sample.dists.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/WT_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/WT_REP2.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/deseq2.size_factors.RData").name - ).match("salmon/deseq2_qc") }, - { assert snapshot( - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/lib_format_counts.json"), - path("${params.outdir}/salmon/WT_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/WT_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/WT_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/WT_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/WT_REP1/cmd_info.json"), - path("${params.outdir}/salmon/WT_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/WT_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/WT_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/WT_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/WT_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/WT_REP2/cmd_info.json"), - path("${params.outdir}/salmon/WT_REP2/lib_format_counts.json"), - // These files are not stable - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/quant.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/quant.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/quant.sf").name, - file("${params.outdir}/salmon/WT_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/WT_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/WT_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/WT_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/WT_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/WT_REP1/quant.sf").name, - file("${params.outdir}/salmon/WT_REP2/aux_info/fld.gz").name, - file("${params.outdir}/salmon/WT_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/WT_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/WT_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/WT_REP2/quant.genes.sf").name, - file("${params.outdir}/salmon/WT_REP2/quant.sf").name - ).match("salmon_quant") }, - { assert snapshot( - path("${params.outdir}/salmon/tx2gene.tsv"), - // These files are not stable - file("${params.outdir}/salmon/salmon.merged.gene_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_length_scaled.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_scaled.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_lengths.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_tpm.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.transcript_counts.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_lengths.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_tpm.tsv").name - ).match("salmon") }, - { assert snapshot( - // These reports are not stable - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt").name - ).match("trimgalore") }, - { assert snapshot( - UTILS.removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml") - ).match("versions") } + { assert workflow.success}, + { assert snapshot( + // Number of successful tasks + workflow.trace.succeeded().size(), + // pipeline versions.yml file for multiqc from which Nextflow version is removed because we tests pipelines on multiple Nextflow versions + removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), + // All stable path name, with a relative path + getRelativePath(stable_name, outputDir), + // All files with stable contents + stable_path + ).match() } ) } } @@ -829,31 +45,21 @@ nextflow_pipeline { } then { + // stable_name: All files + folders in ${params.outdir}/ with a stable name + def stable_name = getAllFilesFromDir(params.outdir, true, ['pipeline_info/*.{html,json,txt}'], null) + // stable_path: All files in ${params.outdir}/ with stable content + def stable_path = getAllFilesFromDir(params.outdir, false, null, 'tests/.nftignore') assertAll( - { assert workflow.success }, - { assert snapshot( - UTILS.removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), - file("${params.outdir}/custom/out/genome_transcriptome.fasta").name, - file("${params.outdir}/custom/out/genome_transcriptome.gtf").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw.zip").name, - file("${params.outdir}/multiqc/hisat2/multiqc_report.html").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt").name + { assert workflow.success}, + { assert snapshot( + // Number of successful tasks + workflow.trace.succeeded().size(), + // pipeline versions.yml file for multiqc from which Nextflow version is removed because we tests pipelines on multiple Nextflow versions + removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), + // All stable path name, with a relative path + getRelativePath(stable_name, outputDir), + // All files with stable contents + stable_path ).match() } ) } diff --git a/tests/hisat2.nf.test.snap b/tests/hisat2.nf.test.snap index 1a15dd9a4..99ddfa937 100644 --- a/tests/hisat2.nf.test.snap +++ b/tests/hisat2.nf.test.snap @@ -1,961 +1,1444 @@ { - "hisat2/rseqc": { - "content": [ - "RAP1_IAA_30M_REP1.infer_experiment.txt:md5,1d4348685fa61819ff8076213d0873b3", - "RAP1_UNINDUCED_REP1.infer_experiment.txt:md5,3ee0f64e82f0b1ac16b5f3e2b30b024c", - "RAP1_UNINDUCED_REP2.infer_experiment.txt:md5,3d17628d178e5a3cc9dc03f32614bff7", - "WT_REP1.infer_experiment.txt:md5,13e3c748f5b968455a39eb9fefd87053", - "WT_REP2.infer_experiment.txt:md5,230910b354a5531d1c4bf711ccd6e493", - "RAP1_IAA_30M_REP1.bam_stat.txt", - "RAP1_UNINDUCED_REP1.bam_stat.txt", - "RAP1_UNINDUCED_REP2.bam_stat.txt", - "WT_REP1.bam_stat.txt", - "WT_REP2.bam_stat.txt", - "RAP1_IAA_30M_REP1.inner_distance_plot.pdf", - "WT_REP1.inner_distance_plot.pdf", - "WT_REP2.inner_distance_plot.pdf", - "RAP1_IAA_30M_REP1.inner_distance_plot.r", - "WT_REP1.inner_distance_plot.r", - "WT_REP2.inner_distance_plot.r", - "RAP1_IAA_30M_REP1.inner_distance.txt", - "RAP1_IAA_30M_REP1.inner_distance_freq.txt", - "RAP1_IAA_30M_REP1.inner_distance_mean.txt", - "WT_REP1.inner_distance.txt", - "WT_REP1.inner_distance_freq.txt", - "WT_REP1.inner_distance_mean.txt", - "WT_REP2.inner_distance.txt", - "WT_REP2.inner_distance_freq.txt", - "WT_REP2.inner_distance_mean.txt", - "RAP1_IAA_30M_REP1.junction.Interact.bed", - "RAP1_IAA_30M_REP1.junction.bed", - "RAP1_UNINDUCED_REP1.junction.Interact.bed", - "RAP1_UNINDUCED_REP1.junction.bed", - "RAP1_UNINDUCED_REP2.junction.Interact.bed", - "RAP1_UNINDUCED_REP2.junction.bed", - "WT_REP1.junction.Interact.bed", - "WT_REP1.junction.bed", - "WT_REP2.junction.Interact.bed", - "WT_REP2.junction.bed", - "RAP1_IAA_30M_REP1.junction_annotation.log", - "RAP1_UNINDUCED_REP1.junction_annotation.log", - "RAP1_UNINDUCED_REP2.junction_annotation.log", - "WT_REP1.junction_annotation.log", - "WT_REP2.junction_annotation.log", - "RAP1_IAA_30M_REP1.splice_events.pdf", - "RAP1_IAA_30M_REP1.splice_junction.pdf", - "RAP1_UNINDUCED_REP1.splice_events.pdf", - "RAP1_UNINDUCED_REP1.splice_junction.pdf", - "RAP1_UNINDUCED_REP2.splice_events.pdf", - "RAP1_UNINDUCED_REP2.splice_junction.pdf", - "WT_REP1.splice_events.pdf", - "WT_REP1.splice_junction.pdf", - "WT_REP2.splice_events.pdf", - "WT_REP2.splice_junction.pdf", - "RAP1_IAA_30M_REP1.junction_plot.r", - "RAP1_UNINDUCED_REP1.junction_plot.r", - "RAP1_UNINDUCED_REP2.junction_plot.r", - "WT_REP1.junction_plot.r", - "WT_REP2.junction_plot.r", - "RAP1_IAA_30M_REP1.junction.xls", - "RAP1_UNINDUCED_REP1.junction.xls", - "RAP1_UNINDUCED_REP2.junction.xls", - "WT_REP1.junction.xls", - "WT_REP2.junction.xls", - "RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf", - "RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf", - "RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf", - "WT_REP1.junctionSaturation_plot.pdf", - "WT_REP2.junctionSaturation_plot.pdf", - "RAP1_IAA_30M_REP1.junctionSaturation_plot.r", - "RAP1_UNINDUCED_REP1.junctionSaturation_plot.r", - "RAP1_UNINDUCED_REP2.junctionSaturation_plot.r", - "WT_REP1.junctionSaturation_plot.r", - "WT_REP2.junctionSaturation_plot.r", - "RAP1_IAA_30M_REP1.read_distribution.txt", - "RAP1_UNINDUCED_REP1.read_distribution.txt", - "RAP1_UNINDUCED_REP2.read_distribution.txt", - "WT_REP1.read_distribution.txt", - "WT_REP2.read_distribution.txt", - "RAP1_IAA_30M_REP1.DupRate_plot.pdf", - "RAP1_UNINDUCED_REP1.DupRate_plot.pdf", - "RAP1_UNINDUCED_REP2.DupRate_plot.pdf", - "WT_REP1.DupRate_plot.pdf", - "WT_REP2.DupRate_plot.pdf", - "RAP1_IAA_30M_REP1.DupRate_plot.r", - "RAP1_UNINDUCED_REP1.DupRate_plot.r", - "RAP1_UNINDUCED_REP2.DupRate_plot.r", - "WT_REP1.DupRate_plot.r", - "WT_REP2.DupRate_plot.r", - "RAP1_IAA_30M_REP1.pos.DupRate.xls", - "RAP1_IAA_30M_REP1.seq.DupRate.xls", - "RAP1_UNINDUCED_REP1.pos.DupRate.xls", - "RAP1_UNINDUCED_REP1.seq.DupRate.xls", - "RAP1_UNINDUCED_REP2.pos.DupRate.xls", - "RAP1_UNINDUCED_REP2.seq.DupRate.xls", - "WT_REP1.pos.DupRate.xls", - "WT_REP1.seq.DupRate.xls", - "WT_REP2.pos.DupRate.xls", - "WT_REP2.seq.DupRate.xls" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T13:55:07.472724" - }, - "trimgalore": { - "content": [ - "RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T10:32:15.607595" - }, - "multiqc_data": { - "content": [ - "cutadapt_filtered_reads_plot.txt:md5,bf033e64e9d23bee85b6277f11c663f1", - "cutadapt_trimmed_sequences_plot_3_Counts.txt:md5,13dfa866fd91dbb072689efe9aa83b1f", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt:md5,07145dd8dd3db654859b18eb0389046c", - "fastqc-status-check-heatmap-1.txt:md5,22a03548736b88b23be6bc0c9ef1b4a6", - "fastqc-status-check-heatmap.txt:md5,5a89b0d8d162f6b1dbdaf39457bbc03b", - "fastqc_adapter_content_plot.txt:md5,da0389be84cfdd189b1d045212eb2974", - "fastqc_overrepresented_sequences_plot-1.txt:md5,4adfeacd3a3a6c7c808f121b24e6b247", - "fastqc_overrepresented_sequences_plot.txt:md5,25d88ea8a72f55e8a374ae802bc7f0b1", - "fastqc_per_base_n_content_plot-1.txt:md5,418610c1ce119cb786ad434db75d366e", - "fastqc_per_base_n_content_plot.txt:md5,d368d7e36ca2f73dcde61f2b486d8213", - "fastqc_per_base_sequence_quality_plot-1.txt:md5,bd22e06e41c096ad4f745d40fe96a1e5", - "fastqc_per_base_sequence_quality_plot.txt:md5,5c3065b549129702b185ea1b817da420", - "fastqc_per_sequence_gc_content_plot-1_Counts.txt:md5,004c60768ceb6197765154e3eaa37b7a", - "fastqc_per_sequence_gc_content_plot-1_Percentages.txt:md5,95d29060b687f745288ad1ec47750037", - "fastqc_per_sequence_gc_content_plot_Counts.txt:md5,9ddaa50167117d3c9188ccf015427704", - "fastqc_per_sequence_gc_content_plot_Percentages.txt:md5,f10ee2881b61308af35f304aa3d810a3", - "fastqc_per_sequence_quality_scores_plot-1.txt:md5,0f9834cc19f76dd5c87cf8cba7435a7c", - "fastqc_per_sequence_quality_scores_plot.txt:md5,b5f9a02933e3065952237afd2ec9ce82", - "fastqc_sequence_counts_plot-1.txt:md5,3861354bbedfbde7ca36a72994f9425c", - "fastqc_sequence_counts_plot.txt:md5,d385a3e2c2573a0902c66e8c93876d3c", - "fastqc_sequence_duplication_levels_plot-1.txt:md5,c73407d55fc532e864fa1dc8dbc12874", - "fastqc_sequence_duplication_levels_plot.txt:md5,8812cee16f6ca65e2c33635754de1772", - "fastqc_sequence_length_distribution_plot.txt:md5,6fe2c985606abad947bcca99b015ae33", - "multiqc_citations.txt:md5,da5043f8ab9b5bd51d91ccf3111c655e", - "multiqc_cutadapt.txt:md5,aac9581a5670cb55edf564f3d6c1f9a7", - "multiqc_fastqc_fastqc_raw.txt:md5,81c3c1a2575a1891a7f2a9637a0f2cc0", - "multiqc_fastqc_fastqc_trimmed.txt:md5,a3238f515e01d158d875d69968753804", - "multiqc_featurecounts_biotype_plot.txt:md5,d35ad008181f0f7be84d5770d17a3a65", - "multiqc_samtools_idxstats.txt:md5,66a8e8aecb6233f5a3521151b1ce8d49", - "picard_histogram.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "picard_histogram_1.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "picard_histogram_2.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "qualimap_gene_coverage_profile_Counts.txt:md5,f3b9bb1902af4c7b5e04c0830ded2c02", - "qualimap_gene_coverage_profile_Normalised.txt:md5,ebcedec8e5c959414a4e89ccae3fc07e", - "qualimap_rnaseq_cov_hist.txt:md5,b78ff616f267f9b061b3297b767e88fb", - "rseqc_infer_experiment_plot.txt:md5,0556a013129be7d78fac4345fddbe8c5", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt:md5,75acd04232d1804b5f960ee4c5db4722", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt:md5,3625f666cc09d0f07990716aeccd869f", - "samtools-idxstats-mapped-reads-plot_Raw_Counts.txt:md5,6c323b383a6506d124506405b9463d93", - "fastqc_top_overrepresented_sequences_table-1.txt", - "fastqc_top_overrepresented_sequences_table.txt", - "hisat2_pe_plot.txt", - "hisat2_se_plot.txt", - "junction_saturation_known.txt", - "junction_saturation_novel.txt", - "multiqc_data.json", - "multiqc_dupradar-section-plot.txt", - "multiqc_fail_strand_check_table.txt", - "multiqc_general_stats.txt", - "multiqc_hisat2.txt", - "multiqc_hisat2_deseq2_clustering-plot.txt", - "multiqc_hisat2_deseq2_clustering-plot_1.txt", - "multiqc_hisat2_deseq2_clustering-plot_2.txt", - "multiqc_hisat2_deseq2_clustering-plot_3.txt", - "multiqc_hisat2_deseq2_clustering-plot_4.txt", - "multiqc_hisat2_deseq2_pca-plot.txt", - "multiqc_picard_dups.txt", - "multiqc_rseqc_bam_stat.txt", - "multiqc_rseqc_infer_experiment.txt", - "multiqc_rseqc_junction_annotation.txt", - "multiqc_rseqc_read_distribution.txt", - "multiqc_salmon.txt", - "multiqc_salmon_deseq2_clustering-plot.txt", - "multiqc_salmon_deseq2_clustering-plot_1.txt", - "multiqc_salmon_deseq2_clustering-plot_2.txt", - "multiqc_salmon_deseq2_clustering-plot_3.txt", - "multiqc_salmon_deseq2_clustering-plot_4.txt", - "multiqc_salmon_deseq2_pca-plot.txt", - "multiqc_samtools_flagstat.txt", - "multiqc_samtools_stats.txt", - "multiqc_software_versions.txt", - "multiqc_sources.txt", - "picard_deduplication.txt", - "qualimap_genomic_origin.txt", - "rseqc_bam_stat.txt", - "rseqc_inner_distance.txt", - "rseqc_inner_distance_plot_Counts.txt", - "rseqc_inner_distance_plot_Percentages.txt", - "rseqc_junction_annotation_junctions_plot_Events.txt", - "rseqc_junction_annotation_junctions_plot_Junctions.txt", - "rseqc_junction_saturation_all.txt", - "rseqc_junction_saturation_plot_All_Junctions.txt", - "rseqc_junction_saturation_plot_Known_Junctions.txt", - "rseqc_junction_saturation_plot_Novel_Junctions.txt", - "rseqc_read_distribution_plot.txt", - "rseqc_read_dups.txt", - "rseqc_read_dups_plot.txt", - "salmon_plot.txt", - "samtools-flagstat-dp_Percentage_of_total.txt", - "samtools-flagstat-dp_Read_counts.txt", - "samtools-stats-dp.txt", - "samtools_alignment_plot.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T19:01:52.559836" - }, - "hisat2/picard_metrics": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt", - "WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T12:35:11.735947" - }, - "references": { - "content": [ - "genome_gfp.fasta:md5,e23e302af63736a199985a169fdac055", - "genome_gfp.gtf:md5,c98b12c302f15731bfc36bcf297cfe28" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T10:32:15.597034" - }, - "hisat2/featurecounts": { - "content": [ - "RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv:md5,079b099e5c5e9fe5e2559dfc938aa48b", - "RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv:md5,dde2de0cb90e10d0195c726f768e9941", - "RAP1_IAA_30M_REP1.featureCounts.txt:md5,eedff929765dbc950528ee499e6d63ba", - "RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv:md5,4d1820a35481f454f17a14326356253d", - "RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv:md5,845ff9059c72bc6722a8de69776e22bb", - "RAP1_UNINDUCED_REP1.featureCounts.txt:md5,b007abbc78b08d8d2bb37a267665947d", - "RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv:md5,3632da2126cb33391428ba0d6d10787f", - "RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv:md5,6d3fa4c88c7fe61f638e4624ad5e22f0", - "RAP1_UNINDUCED_REP2.featureCounts.txt:md5,ea897231d1c447d8e395716741b876ab", - "WT_REP1.biotype_counts_mqc.tsv:md5,abc303e93390bb5bd8f916f8f5978de3", - "WT_REP1.biotype_counts_rrna_mqc.tsv:md5,8ef76d717492ca23764938aee8ea33a9", - "WT_REP1.featureCounts.txt:md5,39721c0d981304996438bc2f505bf98c", - "WT_REP2.biotype_counts_mqc.tsv:md5,74a5436a716a7d99f425f73914cb2794", - "WT_REP2.biotype_counts_rrna_mqc.tsv:md5,12294618fe44df1e7f39348372dcb481", - "WT_REP2.featureCounts.txt:md5,702446d50a5019c84fcef85d1cfef78c", - "RAP1_IAA_30M_REP1.featureCounts.txt.summary", - "RAP1_UNINDUCED_REP1.featureCounts.txt.summary", - "RAP1_UNINDUCED_REP2.featureCounts.txt.summary", - "WT_REP1.featureCounts.txt.summary", - "WT_REP2.featureCounts.txt.summary" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T12:58:36.389406" - }, - "hisat2/samtools_stats": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.stats", - "RAP1_IAA_30M_REP1.sorted.bam.flagstat", - "RAP1_IAA_30M_REP1.sorted.bam.idxstats", - "RAP1_IAA_30M_REP1.sorted.bam.stats", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats", - "RAP1_UNINDUCED_REP1.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP1.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP1.sorted.bam.stats", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats", - "RAP1_UNINDUCED_REP2.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP2.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP2.sorted.bam.stats", - "WT_REP1.markdup.sorted.bam.flagstat", - "WT_REP1.markdup.sorted.bam.idxstats", - "WT_REP1.markdup.sorted.bam.stats", - "WT_REP1.sorted.bam.flagstat", - "WT_REP1.sorted.bam.idxstats", - "WT_REP1.sorted.bam.stats", - "WT_REP2.markdup.sorted.bam.flagstat", - "WT_REP2.markdup.sorted.bam.idxstats", - "WT_REP2.markdup.sorted.bam.stats", - "WT_REP2.sorted.bam.flagstat", - "WT_REP2.sorted.bam.idxstats", - "WT_REP2.sorted.bam.stats" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T19:01:52.753084" - }, - "salmon/deseq2_qc": { - "content": [ - "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", - "deseq2.dds.RData", - "deseq2.pca.vals.txt", - "deseq2.plots.pdf", - "deseq2.sample.dists.txt", - "RAP1_IAA_30M_REP1.txt", - "RAP1_UNINDUCED_REP1.txt", - "RAP1_UNINDUCED_REP2.txt", - "WT_REP1.txt", - "WT_REP2.txt", - "deseq2.size_factors.RData" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T12:35:11.9096" - }, - "salmon": { - "content": [ - "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", - "salmon.merged.gene_counts.SummarizedExperiment.rds", - "salmon.merged.gene_counts.tsv", - "salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_length_scaled.tsv", - "salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_scaled.tsv", - "salmon.merged.gene_lengths.tsv", - "salmon.merged.gene_tpm.tsv", - "salmon.merged.transcript_counts.SummarizedExperiment.rds", - "salmon.merged.transcript_counts.tsv", - "salmon.merged.transcript_lengths.tsv", - "salmon.merged.transcript_tpm.tsv" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T12:35:12.005199" - }, - "hisat2/bigwig": { - "content": [ - "RAP1_IAA_30M_REP1.forward.bigWig", - "RAP1_IAA_30M_REP1.reverse.bigWig", - "RAP1_UNINDUCED_REP1.forward.bigWig", - "RAP1_UNINDUCED_REP1.reverse.bigWig", - "RAP1_UNINDUCED_REP2.forward.bigWig", - "RAP1_UNINDUCED_REP2.reverse.bigWig", - "WT_REP1.forward.bigWig", - "WT_REP1.reverse.bigWig", - "WT_REP2.forward.bigWig", - "WT_REP2.reverse.bigWig" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T12:35:11.683972" - }, - "multiqc_plots": { - "content": [ - "cutadapt_filtered_reads_plot-cnt.png:md5,704cf0d91bfa3dd658dd8c9590f669a2", - "cutadapt_filtered_reads_plot-pct.png:md5,2684d8b2afca3300e5786486b80237f0", - "cutadapt_trimmed_sequences_plot_3_Counts.png:md5,bef41d894629b0c4dab4478bbf197f50", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.png:md5,1e0d01537d3797623d0b3fd8fbe42787", - "dupradar-section-plot.png:md5,6074ea2315d296094bd10fad3dcc475b", - "fastqc-status-check-heatmap-1.png:md5,2402522f8c02e12aea9af088c6595890", - "fastqc-status-check-heatmap.png:md5,fe8b5b4ab4480d46a12a9005932a9b84", - "fastqc_overrepresented_sequences_plot-1.png:md5,40e450251b80ec0efc9364434234ec7f", - "fastqc_overrepresented_sequences_plot.png:md5,6f5ffbdf1bf61fabe5e028c8bc85de14", - "fastqc_per_sequence_gc_content_plot-1_Counts.png:md5,8a806cec2142f9911502e0a253d83d13", - "fastqc_per_sequence_gc_content_plot-1_Percentages.png:md5,953929d50c8490029880e205e4db7959", - "fastqc_per_sequence_gc_content_plot_Counts.png:md5,01f124545af788fd5cc7bbf41b005e16", - "fastqc_per_sequence_gc_content_plot_Percentages.png:md5,eba3abf8bedb2cb20bad90c54e9c8881", - "fastqc_per_sequence_quality_scores_plot-1.png:md5,d2c29cae169f35744500c751b4a7366e", - "fastqc_per_sequence_quality_scores_plot.png:md5,42fd7369a8aca78f620164a9e887c3cb", - "fastqc_sequence_counts_plot-1-cnt.png:md5,2874fea747c7ff46828bf4f17668caf8", - "fastqc_sequence_counts_plot-1-pct.png:md5,0022d7f5ac78b6eff157de24e37c5ab0", - "fastqc_sequence_counts_plot-cnt.png:md5,3890d5555f2a39b46b9f6efb14cb91f2", - "fastqc_sequence_counts_plot-pct.png:md5,55fa5838c8b2db978fcfa5cb83f6b054", - "fastqc_sequence_duplication_levels_plot-1.png:md5,fcd3b1ec2b95fe4bcd607dc28179a754", - "fastqc_sequence_duplication_levels_plot.png:md5,747431f0f38f8e4c41a11a072fa18780", - "featurecounts_biotype_plot-cnt.png:md5,138e00d2fe0af27f2979cf7bdff83b46", - "featurecounts_biotype_plot-pct.png:md5,3b7550efe9068f3ada2cc64e311f3338", - "qualimap_gene_coverage_profile_Counts.png:md5,1aa39028b017760d0b09f1b6f8c1fa3a", - "qualimap_gene_coverage_profile_Normalised.png:md5,1cd382a79b89564a006afe431aa3916d", - "rseqc_infer_experiment_plot.png:md5,73f5b860029912da9c3f6a887238d251", - "rseqc_read_dups_plot.png:md5,fbb8a2268f0468be5a94c960bd2ebd2a", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png:md5,ce6abb232fd5b5f2e66c0fe9a571d75f", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png:md5,6b44818f886ef020fb3646f152ad4af6", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png:md5,a56226e705754ce81c7709d40794dd92", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png:md5,3bb99f72a15a4159860008beea8c802b", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png:md5,25015f9be4710c4eccc50f30db3bf521", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png:md5,baa90f5ad4d999fc60db30840b72d8c6", - "multiqc_report.html", - "cutadapt_filtered_reads_plot-cnt.pdf", - "cutadapt_filtered_reads_plot-pct.pdf", - "cutadapt_trimmed_sequences_plot_3_Counts.pdf", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf", - "dupradar-section-plot.pdf", - "fail_strand_check_table.pdf", - "fastqc-status-check-heatmap-1.pdf", - "fastqc-status-check-heatmap.pdf", - "fastqc_adapter_content_plot.pdf", - "fastqc_overrepresented_sequences_plot-1.pdf", - "fastqc_overrepresented_sequences_plot.pdf", - "fastqc_per_base_n_content_plot-1.pdf", - "fastqc_per_base_n_content_plot.pdf", - "fastqc_per_base_sequence_quality_plot-1.pdf", - "fastqc_per_base_sequence_quality_plot.pdf", - "fastqc_per_sequence_gc_content_plot-1_Counts.pdf", - "fastqc_per_sequence_gc_content_plot-1_Percentages.pdf", - "fastqc_per_sequence_gc_content_plot_Counts.pdf", - "fastqc_per_sequence_gc_content_plot_Percentages.pdf", - "fastqc_per_sequence_quality_scores_plot-1.pdf", - "fastqc_per_sequence_quality_scores_plot.pdf", - "fastqc_sequence_counts_plot-1-cnt.pdf", - "fastqc_sequence_counts_plot-1-pct.pdf", - "fastqc_sequence_counts_plot-cnt.pdf", - "fastqc_sequence_counts_plot-pct.pdf", - "fastqc_sequence_duplication_levels_plot-1.pdf", - "fastqc_sequence_duplication_levels_plot.pdf", - "fastqc_sequence_length_distribution_plot.pdf", - "fastqc_top_overrepresented_sequences_table-1.pdf", - "fastqc_top_overrepresented_sequences_table.pdf", - "featurecounts_biotype_plot-cnt.pdf", - "featurecounts_biotype_plot-pct.pdf", - "general_stats_table.pdf", - "hisat2_deseq2_clustering-plot.pdf", - "hisat2_deseq2_pca-plot.pdf", - "hisat2_pe_plot-cnt.pdf", - "hisat2_pe_plot-pct.pdf", - "hisat2_se_plot-cnt.pdf", - "hisat2_se_plot-pct.pdf", - "picard_deduplication-cnt.pdf", - "picard_deduplication-pct.pdf", - "qualimap_gene_coverage_profile_Counts.pdf", - "qualimap_gene_coverage_profile_Normalised.pdf", - "qualimap_genomic_origin-cnt.pdf", - "qualimap_genomic_origin-pct.pdf", - "rseqc_bam_stat.pdf", - "rseqc_infer_experiment_plot.pdf", - "rseqc_inner_distance_plot_Counts.pdf", - "rseqc_inner_distance_plot_Percentages.pdf", - "rseqc_junction_annotation_junctions_plot_Events-cnt.pdf", - "rseqc_junction_annotation_junctions_plot_Events-pct.pdf", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf", - "rseqc_junction_saturation_plot_All_Junctions.pdf", - "rseqc_junction_saturation_plot_Known_Junctions.pdf", - "rseqc_junction_saturation_plot_Novel_Junctions.pdf", - "rseqc_read_distribution_plot-cnt.pdf", - "rseqc_read_distribution_plot-pct.pdf", - "rseqc_read_dups_plot.pdf", - "salmon_deseq2_clustering-plot.pdf", - "salmon_deseq2_pca-plot.pdf", - "salmon_plot.pdf", - "samtools-flagstat-dp_Percentage_of_total.pdf", - "samtools-flagstat-dp_Read_counts.pdf", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf", - "samtools-stats-dp.pdf", - "samtools_alignment_plot-cnt.pdf", - "samtools_alignment_plot-pct.pdf", - "fail_strand_check_table.png", - "fastqc_adapter_content_plot.png", - "fastqc_per_base_n_content_plot-1.png", - "fastqc_per_base_n_content_plot.png", - "fastqc_per_base_sequence_quality_plot-1.png", - "fastqc_per_base_sequence_quality_plot.png", - "fastqc_sequence_length_distribution_plot.png", - "fastqc_top_overrepresented_sequences_table-1.png", - "fastqc_top_overrepresented_sequences_table.png", - "general_stats_table.png", - "hisat2_deseq2_clustering-plot.png", - "hisat2_deseq2_pca-plot.png", - "hisat2_pe_plot-cnt.png", - "hisat2_pe_plot-pct.png", - "hisat2_se_plot-cnt.png", - "hisat2_se_plot-pct.png", - "picard_deduplication-cnt.png", - "picard_deduplication-pct.png", - "qualimap_genomic_origin-cnt.png", - "qualimap_genomic_origin-pct.png", - "rseqc_bam_stat.png", - "rseqc_inner_distance_plot_Counts.png", - "rseqc_inner_distance_plot_Percentages.png", - "rseqc_junction_annotation_junctions_plot_Events-cnt.png", - "rseqc_junction_annotation_junctions_plot_Events-pct.png", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.png", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.png", - "rseqc_junction_saturation_plot_All_Junctions.png", - "rseqc_junction_saturation_plot_Known_Junctions.png", - "rseqc_junction_saturation_plot_Novel_Junctions.png", - "rseqc_read_distribution_plot-cnt.png", - "rseqc_read_distribution_plot-pct.png", - "salmon_deseq2_clustering-plot.png", - "salmon_deseq2_pca-plot.png", - "salmon_plot.png", - "samtools-flagstat-dp_Percentage_of_total.png", - "samtools-flagstat-dp_Read_counts.png", - "samtools-stats-dp.png", - "samtools_alignment_plot-cnt.png", - "samtools_alignment_plot-pct.png", - "cutadapt_filtered_reads_plot-cnt.svg", - "cutadapt_filtered_reads_plot-pct.svg", - "cutadapt_trimmed_sequences_plot_3_Counts.svg", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg", - "dupradar-section-plot.svg", - "fail_strand_check_table.svg", - "fastqc-status-check-heatmap-1.svg", - "fastqc-status-check-heatmap.svg", - "fastqc_adapter_content_plot.svg", - "fastqc_overrepresented_sequences_plot-1.svg", - "fastqc_overrepresented_sequences_plot.svg", - "fastqc_per_base_n_content_plot-1.svg", - "fastqc_per_base_n_content_plot.svg", - "fastqc_per_base_sequence_quality_plot-1.svg", - "fastqc_per_base_sequence_quality_plot.svg", - "fastqc_per_sequence_gc_content_plot-1_Counts.svg", - "fastqc_per_sequence_gc_content_plot-1_Percentages.svg", - "fastqc_per_sequence_gc_content_plot_Counts.svg", - "fastqc_per_sequence_gc_content_plot_Percentages.svg", - "fastqc_per_sequence_quality_scores_plot-1.svg", - "fastqc_per_sequence_quality_scores_plot.svg", - "fastqc_sequence_counts_plot-1-cnt.svg", - "fastqc_sequence_counts_plot-1-pct.svg", - "fastqc_sequence_counts_plot-cnt.svg", - "fastqc_sequence_counts_plot-pct.svg", - "fastqc_sequence_duplication_levels_plot-1.svg", - "fastqc_sequence_duplication_levels_plot.svg", - "fastqc_sequence_length_distribution_plot.svg", - "fastqc_top_overrepresented_sequences_table-1.svg", - "fastqc_top_overrepresented_sequences_table.svg", - "featurecounts_biotype_plot-cnt.svg", - "featurecounts_biotype_plot-pct.svg", - "general_stats_table.svg", - "hisat2_deseq2_clustering-plot.svg", - "hisat2_deseq2_pca-plot.svg", - "hisat2_pe_plot-cnt.svg", - "hisat2_pe_plot-pct.svg", - "hisat2_se_plot-cnt.svg", - "hisat2_se_plot-pct.svg", - "picard_deduplication-cnt.svg", - "picard_deduplication-pct.svg", - "qualimap_gene_coverage_profile_Counts.svg", - "qualimap_gene_coverage_profile_Normalised.svg", - "qualimap_genomic_origin-cnt.svg", - "qualimap_genomic_origin-pct.svg", - "rseqc_bam_stat.svg", - "rseqc_infer_experiment_plot.svg", - "rseqc_inner_distance_plot_Counts.svg", - "rseqc_inner_distance_plot_Percentages.svg", - "rseqc_junction_annotation_junctions_plot_Events-cnt.svg", - "rseqc_junction_annotation_junctions_plot_Events-pct.svg", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.svg", - "rseqc_junction_saturation_plot_All_Junctions.svg", - "rseqc_junction_saturation_plot_Known_Junctions.svg", - "rseqc_junction_saturation_plot_Novel_Junctions.svg", - "rseqc_read_distribution_plot-cnt.svg", - "rseqc_read_distribution_plot-pct.svg", - "rseqc_read_dups_plot.svg", - "salmon_deseq2_clustering-plot.svg", - "salmon_deseq2_pca-plot.svg", - "salmon_plot.svg", - "samtools-flagstat-dp_Percentage_of_total.svg", - "samtools-flagstat-dp_Read_counts.svg", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg", - "samtools-stats-dp.svg", - "samtools_alignment_plot-cnt.svg", - "samtools_alignment_plot-pct.svg" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T19:01:52.649421" - }, - "fastqc/raw": { - "content": [ - "RAP1_IAA_30M_REP1_raw_1_fastqc.html", - "RAP1_IAA_30M_REP1_raw_1_fastqc.zip", - "RAP1_IAA_30M_REP1_raw_2_fastqc.html", - "RAP1_IAA_30M_REP1_raw_2_fastqc.zip", - "RAP1_UNINDUCED_REP1_raw_fastqc.html", - "RAP1_UNINDUCED_REP1_raw_fastqc.zip", - "RAP1_UNINDUCED_REP2_raw_fastqc.html", - "RAP1_UNINDUCED_REP2_raw_fastqc.zip", - "WT_REP1_raw_1_fastqc.html", - "WT_REP1_raw_1_fastqc.zip", - "WT_REP1_raw_2_fastqc.html", - "WT_REP1_raw_2_fastqc.zip", - "WT_REP2_raw_1_fastqc.html", - "WT_REP2_raw_1_fastqc.zip", - "WT_REP2_raw_2_fastqc.html", - "WT_REP2_raw_2_fastqc.zip" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T12:35:11.678184" - }, "Params: --aligner hisat2 - stub": { "content": [ - "{BBMAP_BBSPLIT={bbmap=39.01}, CAT_FASTQ={cat=8.3}, CUSTOM_CATADDITIONALFASTA={python=null}, CUSTOM_GETCHROMSIZES={getchromsizes=1.2}, FASTQC={fastqc=0.12.1}, GTF2BED={perl=5.26.2}, GTF_FILTER={python=3.9.5}, GUNZIP_ADDITIONAL_FASTA={gunzip=1.1}, GUNZIP_GTF={gunzip=1.1}, HISAT2_EXTRACTSPLICESITES={hisat2=2.2.1}, TRIMGALORE={trimgalore=0.6.7, cutadapt=3.4}, UNTAR_HISAT2_INDEX={untar=1.34}, UNTAR_SALMON_INDEX={untar=1.34}, Workflow={nf-core/rnaseq=v3.16.0dev}}", - "genome_transcriptome.fasta", - "genome_transcriptome.gtf", - "RAP1_IAA_30M_REP1_raw.html", - "RAP1_IAA_30M_REP1_raw.zip", - "RAP1_UNINDUCED_REP1_raw.html", - "RAP1_UNINDUCED_REP1_raw.zip", - "RAP1_UNINDUCED_REP2_raw.html", - "RAP1_UNINDUCED_REP2_raw.zip", - "WT_REP1_raw.html", - "WT_REP1_raw.zip", - "WT_REP2_raw.html", - "WT_REP2_raw.zip", - "multiqc_report.html", - "RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T10:32:59.957379" - }, - "hisat2/qualimap": { - "content": [ - "Coverage Profile Along Genes (High).png:md5,99a8749fb819be0f1bde152e2246d964", - "Coverage Profile Along Genes (Low).png:md5,31bed1d299f6e763c61a2866abc847c9", - "Coverage Profile Along Genes (Total).png:md5,97d15c2ffd8163b800b1ca6378ae0ce9", - "Transcript coverage histogram.png:md5,a0cd920b7f67ee02deb4fd5ee5a5b0fc", - "coverage_profile_along_genes_(high).txt:md5,b56043c3546cac003461c57abad93536", - "coverage_profile_along_genes_(low).txt:md5,1b55d86defcc541643137497c4c6bb06", - "coverage_profile_along_genes_(total).txt:md5,1b55d86defcc541643137497c4c6bb06", - "Coverage Profile Along Genes (High).png:md5,0c9e9983e2bb5688bca25d1697bcde9c", - "Coverage Profile Along Genes (Low).png:md5,07df4715abe4e9c49265b7cecec79fe6", - "Coverage Profile Along Genes (Total).png:md5,a4ed549db9b210e43955386957fdcd49", - "Transcript coverage histogram.png:md5,1ee5a0ec7f0eec36dd51e312d303ea55", - "coverage_profile_along_genes_(high).txt:md5,9ffadadb953cc9ea1b1c01ac92fcdf61", - "coverage_profile_along_genes_(low).txt:md5,fb281c857a2c4e093b0d8e1f756abf81", - "coverage_profile_along_genes_(total).txt:md5,fb281c857a2c4e093b0d8e1f756abf81", - "Coverage Profile Along Genes (High).png:md5,9e530e83b3ab308ece285c115b7bde7d", - "Coverage Profile Along Genes (Low).png:md5,b4181c86e9764bf7f543b24232ffea77", - "Coverage Profile Along Genes (Total).png:md5,ec77f7b0919d8537f31ecf3a6dd245b0", - "Transcript coverage histogram.png:md5,4017dc4254884805a327a6fd45e06562", - "coverage_profile_along_genes_(high).txt:md5,a31cb4ba804080544072cd57fc1bdf1c", - "coverage_profile_along_genes_(low).txt:md5,f744e295c3d034b1a86e1dde8bb18eff", - "coverage_profile_along_genes_(total).txt:md5,f744e295c3d034b1a86e1dde8bb18eff", - "Coverage Profile Along Genes (High).png:md5,9e4a7aa85ae86a7ab5b1c949ed10d913", - "Coverage Profile Along Genes (Low).png:md5,3f9d7d3842d827bb5a7a46a80e88e14b", - "Coverage Profile Along Genes (Total).png:md5,44826c2d3263ff4aaedfa3b4d0c068db", - "Transcript coverage histogram.png:md5,51e934c908640c9dda94d3de8c4dd81f", - "coverage_profile_along_genes_(high).txt:md5,be72a2c9023f6eb81bd5816af33abb65", - "coverage_profile_along_genes_(low).txt:md5,9fce120533ff57f8bc2a2f44f1b6decb", - "coverage_profile_along_genes_(total).txt:md5,9fce120533ff57f8bc2a2f44f1b6decb", - "Coverage Profile Along Genes (High).png:md5,f63458b8564de80c90c992926ea273ed", - "Coverage Profile Along Genes (Low).png:md5,44f0dd7c647a2ce2c1f06e3920266e95", - "Coverage Profile Along Genes (Total).png:md5,12780d9ad7b76dbdd39736099c45cf07", - "Transcript coverage histogram.png:md5,fcc848c9d318a28c7dff00cb2960e038", - "coverage_profile_along_genes_(high).txt:md5,83d436e0ddb7435bb343db5e4dfb744a", - "coverage_profile_along_genes_(low).txt:md5,58021e91f3595a0d6dc74abc41690638", - "coverage_profile_along_genes_(total).txt:md5,58021e91f3595a0d6dc74abc41690638", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T13:55:07.345475" - }, - "versions": { - "content": [ - "{BBMAP_BBSPLIT={bbmap=39.01}, BEDTOOLS_GENOMECOV_FW={bedtools=2.31.1}, CAT_FASTQ={cat=8.3}, CUSTOM_CATADDITIONALFASTA={python=3.9.5}, CUSTOM_GETCHROMSIZES={getchromsizes=1.2}, CUSTOM_TX2GENE={python=3.9.5}, DESEQ2_QC_PSEUDO={r-base=4.0.3, bioconductor-deseq2=1.28.0}, DUPRADAR={bioconductor-dupradar=1.32.0}, FASTQC={fastqc=0.12.1}, FQ_SUBSAMPLE={fq=0.9.1 (2022-02-22)}, GTF2BED={perl=5.26.2}, GTF_FILTER={python=3.9.5}, GUNZIP_ADDITIONAL_FASTA={gunzip=1.1}, GUNZIP_GTF={gunzip=1.1}, HISAT2_ALIGN={hisat2=2.2.1, samtools=1.16.1}, HISAT2_EXTRACTSPLICESITES={hisat2=2.2.1}, MULTIQC_CUSTOM_BIOTYPE={python=3.9.5}, PICARD_MARKDUPLICATES={picard=3.1.1}, QUALIMAP_RNASEQ={qualimap=2.3}, RSEQC_BAMSTAT={rseqc=5.0.2}, RSEQC_INFEREXPERIMENT={rseqc=5.0.2}, RSEQC_INNERDISTANCE={rseqc=5.0.2}, RSEQC_JUNCTIONANNOTATION={rseqc=5.0.2}, RSEQC_JUNCTIONSATURATION={rseqc=5.0.2}, RSEQC_READDISTRIBUTION={rseqc=5.0.2}, RSEQC_READDUPLICATION={rseqc=5.0.2}, SALMON_QUANT={salmon=1.10.1}, SAMTOOLS_FLAGSTAT={samtools=1.2}, SAMTOOLS_IDXSTATS={samtools=1.2}, SAMTOOLS_INDEX={samtools=1.2}, SAMTOOLS_SORT={samtools=1.2}, SAMTOOLS_STATS={samtools=1.2}, SE_GENE={bioconductor-summarizedexperiment=1.32.0}, STRINGTIE_STRINGTIE={stringtie=2.2.1}, SUBREAD_FEATURECOUNTS={subread=2.0.1}, TRIMGALORE={trimgalore=0.6.7, cutadapt=3.4}, TXIMETA_TXIMPORT={bioconductor-tximeta=1.20.1}, UCSC_BEDCLIP={ucsc=377}, UCSC_BEDGRAPHTOBIGWIG={ucsc=445}, UNTAR_HISAT2_INDEX={untar=1.34}, UNTAR_SALMON_INDEX={untar=1.34}, Workflow={nf-core/rnaseq=v3.16.0dev}}" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T10:32:15.832405" - }, - "fastqc/trim": { - "content": [ - "RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html", - "RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip", - "RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html", - "RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip", - "RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html", - "RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip", - "RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html", - "RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip", - "WT_REP1_trimmed_1_val_1_fastqc.html", - "WT_REP1_trimmed_1_val_1_fastqc.zip", - "WT_REP1_trimmed_2_val_2_fastqc.html", - "WT_REP1_trimmed_2_val_2_fastqc.zip", - "WT_REP2_trimmed_1_val_1_fastqc.html", - "WT_REP2_trimmed_1_val_1_fastqc.zip", - "WT_REP2_trimmed_2_val_2_fastqc.html", - "WT_REP2_trimmed_2_val_2_fastqc.zip" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T12:35:11.679664" - }, - "hisat2/dupradar": { - "content": [ - "RAP1_IAA_30M_REP1_dupMatrix.txt:md5,8a6bf324a928534cb7ed7a5522aff7d0", - "RAP1_UNINDUCED_REP1_dupMatrix.txt:md5,ae3e70edc98ec8117608f8f608effab9", - "RAP1_UNINDUCED_REP2_dupMatrix.txt:md5,9a5c2672c5817e930c7b884ada8fd92c", - "WT_REP1_dupMatrix.txt:md5,11371da7a087879340c2e7e6842a5d89", - "WT_REP2_dupMatrix.txt:md5,5176c7447c4295f94e2683dd9995cea0", - "RAP1_IAA_30M_REP1_intercept_slope.txt:md5,1285c70833b46849b726412858736ed7", - "RAP1_UNINDUCED_REP1_intercept_slope.txt:md5,a2efe7c3cad6f910d5dc208c2825a245", - "RAP1_UNINDUCED_REP2_intercept_slope.txt:md5,117712525fcbd396f77710f4f4b605d9", - "WT_REP1_intercept_slope.txt:md5,df33cbc6c3cb1c85c0c06cdba7df3873", - "WT_REP2_intercept_slope.txt:md5,38fbb93a419e666bc81020602852b1e2", - "RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf", - "RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf", - "RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf", - "WT_REP1_duprateExpBoxplot.pdf", - "WT_REP2_duprateExpBoxplot.pdf", - "RAP1_IAA_30M_REP1_expressionHist.pdf", - "RAP1_UNINDUCED_REP1_expressionHist.pdf", - "RAP1_UNINDUCED_REP2_expressionHist.pdf", - "WT_REP1_expressionHist.pdf", - "WT_REP2_expressionHist.pdf", - "RAP1_IAA_30M_REP1_duprateExpDens.pdf", - "RAP1_UNINDUCED_REP1_duprateExpDens.pdf", - "RAP1_UNINDUCED_REP2_duprateExpDens.pdf", - "WT_REP1_duprateExpDens.pdf", - "WT_REP2_duprateExpDens.pdf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T12:35:11.695025" - }, - "hisat2": { - "content": [ - "RAP1_IAA_30M_REP1.hisat2.summary.log", - "RAP1_UNINDUCED_REP1.hisat2.summary.log", - "RAP1_UNINDUCED_REP2.hisat2.summary.log", - "WT_REP1.hisat2.summary.log", - "WT_REP2.hisat2.summary.log" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T13:40:29.865928" - }, - "hisat2/stringtie": { - "content": [ - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,c93ce5b90352398208e3d88c68df45c6", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,fe9d92d1d28e1bc1b223e2ce22b4ef05", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,293d64f70bd8353b822e4fa8a6f082a3", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,d279003d92f7feef9adb31203f84474a", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,ed48a29b77c315cb61a6bf09e68c877d", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,cf2506824949c02e0bfde17a9ed86e61", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,a17c7749a005a89875876eb2d90721d4", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,2e2d760739539fba09cbb666ab95afa1", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,22bdc84c1c4acce9798868e8c7b56004", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,80fe14762a8f7230d516bba37b7275d1", - "t_data.ctab", - "RAP1_IAA_30M_REP1.coverage.gtf", - "RAP1_IAA_30M_REP1.gene.abundance.txt", - "RAP1_IAA_30M_REP1.transcripts.gtf", - "t_data.ctab", - "RAP1_UNINDUCED_REP1.coverage.gtf", - "RAP1_UNINDUCED_REP1.gene.abundance.txt", - "RAP1_UNINDUCED_REP1.transcripts.gtf", - "t_data.ctab", - "RAP1_UNINDUCED_REP2.coverage.gtf", - "RAP1_UNINDUCED_REP2.gene.abundance.txt", - "RAP1_UNINDUCED_REP2.transcripts.gtf", - "t_data.ctab", - "WT_REP1.coverage.gtf", - "WT_REP1.gene.abundance.txt", - "WT_REP1.transcripts.gtf", - "t_data.ctab", - "WT_REP2.coverage.gtf", - "WT_REP2.gene.abundance.txt", - "WT_REP2.transcripts.gtf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T12:35:11.865423" - }, - "bbsplit": { - "content": [ - "RAP1_IAA_30M_REP1.stats.txt", - "RAP1_UNINDUCED_REP1.stats.txt", - "RAP1_UNINDUCED_REP2.stats.txt", - "WT_REP1.stats.txt", - "WT_REP2.stats.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T10:32:15.589105" - }, - "salmon_quant": { - "content": [ - "ambig_info.tsv:md5,de973a4b22a4457217ae3dc04caf9401", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,1215f0c20f87d3aef8553ef119e1e74c", - "lib_format_counts.json:md5,c24ffe28d70476b5ccdd8bc2d22c0ac1", - "ambig_info.tsv:md5,45f252b4f0e11e6730cf0c29f800fdbb", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,621c6601aade5b1f2e3d6ca2fc71f636", - "lib_format_counts.json:md5,f6d44c0221f7fd559f11a9afe04c9935", - "ambig_info.tsv:md5,6dcc2891ea572e9b8d1ba52cd434ab84", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,9bed6e4dc5428d6f6297adcea29a6326", - "lib_format_counts.json:md5,7c562bf2f70e42f3a7292687dfd328c3", - "ambig_info.tsv:md5,194f574e0586416155e3f33d42e2b167", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,c7ed0aaa5d6c7934ddbebfd29e4eb86d", - "lib_format_counts.json:md5,d46250bb3677d72feeefc435fe6395a6", - "ambig_info.tsv:md5,a26e3f936e65d7da66392603c2f91f6f", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,69ebfc2c7ca6b221a0a22fa1dc8c20ac", - "lib_format_counts.json:md5,088fd51db07022ffde47033bbd029400", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf" + 23, + { + "BBMAP_BBSPLIT": { + "bbmap": 39.01 + }, + "CAT_FASTQ": { + "cat": 8.3 + }, + "CUSTOM_CATADDITIONALFASTA": { + "python": null + }, + "CUSTOM_GETCHROMSIZES": { + "getchromsizes": 1.2 + }, + "FASTQC": { + "fastqc": "0.12.1" + }, + "GTF2BED": { + "perl": "5.26.2" + }, + "GTF_FILTER": { + "python": "3.9.5" + }, + "GUNZIP_ADDITIONAL_FASTA": { + "gunzip": 1.1 + }, + "GUNZIP_GTF": { + "gunzip": 1.1 + }, + "HISAT2_EXTRACTSPLICESITES": { + "hisat2": "2.2.1" + }, + "TRIMGALORE": { + "trimgalore": "0.6.7", + "cutadapt": 3.4 + }, + "UNTAR_HISAT2_INDEX": { + "untar": 1.34 + }, + "UNTAR_SALMON_INDEX": { + "untar": 1.34 + }, + "Workflow": { + "nf-core/rnaseq": "v3.16.0dev" + } + }, + [ + "custom", + "custom/out", + "custom/out/genome_transcriptome.fasta", + "custom/out/genome_transcriptome.gtf", + "fastqc", + "fastqc/raw", + "fastqc/raw/RAP1_IAA_30M_REP1_raw.html", + "fastqc/raw/RAP1_IAA_30M_REP1_raw.zip", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw.html", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw.zip", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw.html", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw.zip", + "fastqc/raw/WT_REP1_raw.html", + "fastqc/raw/WT_REP1_raw.zip", + "fastqc/raw/WT_REP2_raw.html", + "fastqc/raw/WT_REP2_raw.zip", + "fastqc/trim", + "multiqc", + "multiqc/hisat2", + "multiqc/hisat2/multiqc_data", + "multiqc/hisat2/multiqc_plots", + "multiqc/hisat2/multiqc_report.html", + "pipeline_info", + "pipeline_info/nf_core_rnaseq_software_mqc_versions.yml", + "trimgalore", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" + ], + [ + "genome_transcriptome.fasta:md5,d41d8cd98f00b204e9800998ecf8427e", + "genome_transcriptome.gtf:md5,d41d8cd98f00b204e9800998ecf8427e" + ] ], "meta": { "nf-test": "0.9.0", "nextflow": "24.04.4" }, - "timestamp": "2024-08-23T12:35:11.954394" + "timestamp": "2024-10-02T07:43:50.371605" }, - "hisat2/markdup": { + "Params: --aligner hisat2": { "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.bam", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.bai", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai", - "WT_REP1.markdup.sorted.bam", - "WT_REP1.markdup.sorted.bam.bai", - "WT_REP2.markdup.sorted.bam", - "WT_REP2.markdup.sorted.bam.bai" + 187, + { + "BBMAP_BBSPLIT": { + "bbmap": 39.01 + }, + "BEDTOOLS_GENOMECOV_FW": { + "bedtools": "2.31.1" + }, + "CAT_FASTQ": { + "cat": 8.3 + }, + "CUSTOM_CATADDITIONALFASTA": { + "python": "3.9.5" + }, + "CUSTOM_GETCHROMSIZES": { + "getchromsizes": 1.2 + }, + "CUSTOM_TX2GENE": { + "python": "3.9.5" + }, + "DESEQ2_QC_PSEUDO": { + "r-base": "4.0.3", + "bioconductor-deseq2": "1.28.0" + }, + "DUPRADAR": { + "bioconductor-dupradar": "1.32.0" + }, + "FASTQC": { + "fastqc": "0.12.1" + }, + "FQ_SUBSAMPLE": { + "fq": "0.9.1 (2022-02-22)" + }, + "GTF2BED": { + "perl": "5.26.2" + }, + "GTF_FILTER": { + "python": "3.9.5" + }, + "GUNZIP_ADDITIONAL_FASTA": { + "gunzip": 1.1 + }, + "GUNZIP_GTF": { + "gunzip": 1.1 + }, + "HISAT2_ALIGN": { + "hisat2": "2.2.1", + "samtools": "1.16.1" + }, + "HISAT2_EXTRACTSPLICESITES": { + "hisat2": "2.2.1" + }, + "MULTIQC_CUSTOM_BIOTYPE": { + "python": "3.9.5" + }, + "PICARD_MARKDUPLICATES": { + "picard": "3.1.1" + }, + "QUALIMAP_RNASEQ": { + "qualimap": 2.3 + }, + "RSEQC_BAMSTAT": { + "rseqc": "5.0.2" + }, + "RSEQC_INFEREXPERIMENT": { + "rseqc": "5.0.2" + }, + "RSEQC_INNERDISTANCE": { + "rseqc": "5.0.2" + }, + "RSEQC_JUNCTIONANNOTATION": { + "rseqc": "5.0.2" + }, + "RSEQC_JUNCTIONSATURATION": { + "rseqc": "5.0.2" + }, + "RSEQC_READDISTRIBUTION": { + "rseqc": "5.0.2" + }, + "RSEQC_READDUPLICATION": { + "rseqc": "5.0.2" + }, + "SALMON_QUANT": { + "salmon": "1.10.1" + }, + "SAMTOOLS_FLAGSTAT": { + "samtools": 1.2 + }, + "SAMTOOLS_IDXSTATS": { + "samtools": 1.2 + }, + "SAMTOOLS_INDEX": { + "samtools": 1.2 + }, + "SAMTOOLS_SORT": { + "samtools": 1.2 + }, + "SAMTOOLS_STATS": { + "samtools": 1.2 + }, + "SE_GENE": { + "bioconductor-summarizedexperiment": "1.32.0" + }, + "STRINGTIE_STRINGTIE": { + "stringtie": "2.2.1" + }, + "SUBREAD_FEATURECOUNTS": { + "subread": "2.0.1" + }, + "TRIMGALORE": { + "trimgalore": "0.6.7", + "cutadapt": 3.4 + }, + "TXIMETA_TXIMPORT": { + "bioconductor-tximeta": "1.20.1" + }, + "UCSC_BEDCLIP": { + "ucsc": 377 + }, + "UCSC_BEDGRAPHTOBIGWIG": { + "ucsc": 445 + }, + "UNTAR_HISAT2_INDEX": { + "untar": 1.34 + }, + "UNTAR_SALMON_INDEX": { + "untar": 1.34 + }, + "Workflow": { + "nf-core/rnaseq": "v3.16.0dev" + } + }, + [ + "bbsplit", + "bbsplit/RAP1_IAA_30M_REP1.stats.txt", + "bbsplit/RAP1_UNINDUCED_REP1.stats.txt", + "bbsplit/RAP1_UNINDUCED_REP2.stats.txt", + "bbsplit/WT_REP1.stats.txt", + "bbsplit/WT_REP2.stats.txt", + "custom", + "custom/out", + "custom/out/genome_gfp.fasta", + "custom/out/genome_gfp.gtf", + "fastqc", + "fastqc/raw", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.html", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.zip", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.html", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.zip", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.html", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.zip", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.html", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.zip", + "fastqc/raw/WT_REP1_raw_1_fastqc.html", + "fastqc/raw/WT_REP1_raw_1_fastqc.zip", + "fastqc/raw/WT_REP1_raw_2_fastqc.html", + "fastqc/raw/WT_REP1_raw_2_fastqc.zip", + "fastqc/raw/WT_REP2_raw_1_fastqc.html", + "fastqc/raw/WT_REP2_raw_1_fastqc.zip", + "fastqc/raw/WT_REP2_raw_2_fastqc.html", + "fastqc/raw/WT_REP2_raw_2_fastqc.zip", + "fastqc/trim", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip", + "fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html", + "fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip", + "fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html", + "fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip", + "fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.html", + "fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.html", + "fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.zip", + "fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.html", + "fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.html", + "fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.zip", + "hisat2", + "hisat2/RAP1_IAA_30M_REP1.markdup.sorted.bam", + "hisat2/RAP1_IAA_30M_REP1.markdup.sorted.bam.bai", + "hisat2/RAP1_UNINDUCED_REP1.markdup.sorted.bam", + "hisat2/RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai", + "hisat2/RAP1_UNINDUCED_REP2.markdup.sorted.bam", + "hisat2/RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai", + "hisat2/WT_REP1.markdup.sorted.bam", + "hisat2/WT_REP1.markdup.sorted.bam.bai", + "hisat2/WT_REP2.markdup.sorted.bam", + "hisat2/WT_REP2.markdup.sorted.bam.bai", + "hisat2/bigwig", + "hisat2/bigwig/RAP1_IAA_30M_REP1.forward.bigWig", + "hisat2/bigwig/RAP1_IAA_30M_REP1.reverse.bigWig", + "hisat2/bigwig/RAP1_UNINDUCED_REP1.forward.bigWig", + "hisat2/bigwig/RAP1_UNINDUCED_REP1.reverse.bigWig", + "hisat2/bigwig/RAP1_UNINDUCED_REP2.forward.bigWig", + "hisat2/bigwig/RAP1_UNINDUCED_REP2.reverse.bigWig", + "hisat2/bigwig/WT_REP1.forward.bigWig", + "hisat2/bigwig/WT_REP1.reverse.bigWig", + "hisat2/bigwig/WT_REP2.forward.bigWig", + "hisat2/bigwig/WT_REP2.reverse.bigWig", + "hisat2/dupradar", + "hisat2/dupradar/box_plot", + "hisat2/dupradar/box_plot/RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf", + "hisat2/dupradar/box_plot/RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf", + "hisat2/dupradar/box_plot/RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf", + "hisat2/dupradar/box_plot/WT_REP1_duprateExpBoxplot.pdf", + "hisat2/dupradar/box_plot/WT_REP2_duprateExpBoxplot.pdf", + "hisat2/dupradar/gene_data", + "hisat2/dupradar/gene_data/RAP1_IAA_30M_REP1_dupMatrix.txt", + "hisat2/dupradar/gene_data/RAP1_UNINDUCED_REP1_dupMatrix.txt", + "hisat2/dupradar/gene_data/RAP1_UNINDUCED_REP2_dupMatrix.txt", + "hisat2/dupradar/gene_data/WT_REP1_dupMatrix.txt", + "hisat2/dupradar/gene_data/WT_REP2_dupMatrix.txt", + "hisat2/dupradar/histogram", + "hisat2/dupradar/histogram/RAP1_IAA_30M_REP1_expressionHist.pdf", + "hisat2/dupradar/histogram/RAP1_UNINDUCED_REP1_expressionHist.pdf", + "hisat2/dupradar/histogram/RAP1_UNINDUCED_REP2_expressionHist.pdf", + "hisat2/dupradar/histogram/WT_REP1_expressionHist.pdf", + "hisat2/dupradar/histogram/WT_REP2_expressionHist.pdf", + "hisat2/dupradar/intercepts_slope", + "hisat2/dupradar/intercepts_slope/RAP1_IAA_30M_REP1_intercept_slope.txt", + "hisat2/dupradar/intercepts_slope/RAP1_UNINDUCED_REP1_intercept_slope.txt", + "hisat2/dupradar/intercepts_slope/RAP1_UNINDUCED_REP2_intercept_slope.txt", + "hisat2/dupradar/intercepts_slope/WT_REP1_intercept_slope.txt", + "hisat2/dupradar/intercepts_slope/WT_REP2_intercept_slope.txt", + "hisat2/dupradar/scatter_plot", + "hisat2/dupradar/scatter_plot/RAP1_IAA_30M_REP1_duprateExpDens.pdf", + "hisat2/dupradar/scatter_plot/RAP1_UNINDUCED_REP1_duprateExpDens.pdf", + "hisat2/dupradar/scatter_plot/RAP1_UNINDUCED_REP2_duprateExpDens.pdf", + "hisat2/dupradar/scatter_plot/WT_REP1_duprateExpDens.pdf", + "hisat2/dupradar/scatter_plot/WT_REP2_duprateExpDens.pdf", + "hisat2/featurecounts", + "hisat2/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv", + "hisat2/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv", + "hisat2/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt", + "hisat2/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt.summary", + "hisat2/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv", + "hisat2/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv", + "hisat2/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt", + "hisat2/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt.summary", + "hisat2/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv", + "hisat2/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv", + "hisat2/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt", + "hisat2/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt.summary", + "hisat2/featurecounts/WT_REP1.biotype_counts_mqc.tsv", + "hisat2/featurecounts/WT_REP1.biotype_counts_rrna_mqc.tsv", + "hisat2/featurecounts/WT_REP1.featureCounts.txt", + "hisat2/featurecounts/WT_REP1.featureCounts.txt.summary", + "hisat2/featurecounts/WT_REP2.biotype_counts_mqc.tsv", + "hisat2/featurecounts/WT_REP2.biotype_counts_rrna_mqc.tsv", + "hisat2/featurecounts/WT_REP2.featureCounts.txt", + "hisat2/featurecounts/WT_REP2.featureCounts.txt.summary", + "hisat2/log", + "hisat2/log/RAP1_IAA_30M_REP1.hisat2.summary.log", + "hisat2/log/RAP1_UNINDUCED_REP1.hisat2.summary.log", + "hisat2/log/RAP1_UNINDUCED_REP2.hisat2.summary.log", + "hisat2/log/WT_REP1.hisat2.summary.log", + "hisat2/log/WT_REP2.hisat2.summary.log", + "hisat2/picard_metrics", + "hisat2/picard_metrics/RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "hisat2/picard_metrics/RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "hisat2/picard_metrics/RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt", + "hisat2/picard_metrics/WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "hisat2/picard_metrics/WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt", + "hisat2/qualimap", + "hisat2/qualimap/RAP1_IAA_30M_REP1", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/agogo.css", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/ajax-loader.gif", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/basic.css", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/bgfooter.png", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/bgtop.png", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/comment-bright.png", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/comment-close.png", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/comment.png", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/doctools.js", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/down-pressed.png", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/down.png", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/file.png", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/jquery.js", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/minus.png", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/plus.png", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/pygments.css", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/qualimap_logo_small.png", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/report.css", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/searchtools.js", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/underscore.js", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/up-pressed.png", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/up.png", + "hisat2/qualimap/RAP1_IAA_30M_REP1/css/websupport.js", + "hisat2/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport", + "hisat2/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png", + "hisat2/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "hisat2/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "hisat2/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Junction Analysis.png", + "hisat2/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Reads Genomic Origin.png", + "hisat2/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Transcript coverage histogram.png", + "hisat2/qualimap/RAP1_IAA_30M_REP1/qualimapReport.html", + "hisat2/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport", + "hisat2/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "hisat2/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "hisat2/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "hisat2/qualimap/RAP1_IAA_30M_REP1/rnaseq_qc_results.txt", + "hisat2/qualimap/RAP1_UNINDUCED_REP1", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/agogo.css", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/ajax-loader.gif", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/basic.css", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/bgfooter.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/bgtop.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/comment-bright.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/comment-close.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/comment.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/doctools.js", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/down-pressed.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/down.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/file.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/jquery.js", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/minus.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/plus.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/pygments.css", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/qualimap_logo_small.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/report.css", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/searchtools.js", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/underscore.js", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/up-pressed.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/up.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/css/websupport.js", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Junction Analysis.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Reads Genomic Origin.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Transcript coverage histogram.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/qualimapReport.html", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "hisat2/qualimap/RAP1_UNINDUCED_REP1/rnaseq_qc_results.txt", + "hisat2/qualimap/RAP1_UNINDUCED_REP2", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/agogo.css", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/ajax-loader.gif", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/basic.css", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/bgfooter.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/bgtop.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/comment-bright.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/comment-close.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/comment.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/doctools.js", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/down-pressed.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/down.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/file.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/jquery.js", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/minus.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/plus.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/pygments.css", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/qualimap_logo_small.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/report.css", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/searchtools.js", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/underscore.js", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/up-pressed.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/up.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/css/websupport.js", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Junction Analysis.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Reads Genomic Origin.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Transcript coverage histogram.png", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/qualimapReport.html", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "hisat2/qualimap/RAP1_UNINDUCED_REP2/rnaseq_qc_results.txt", + "hisat2/qualimap/WT_REP1", + "hisat2/qualimap/WT_REP1/css", + "hisat2/qualimap/WT_REP1/css/agogo.css", + "hisat2/qualimap/WT_REP1/css/ajax-loader.gif", + "hisat2/qualimap/WT_REP1/css/basic.css", + "hisat2/qualimap/WT_REP1/css/bgfooter.png", + "hisat2/qualimap/WT_REP1/css/bgtop.png", + "hisat2/qualimap/WT_REP1/css/comment-bright.png", + "hisat2/qualimap/WT_REP1/css/comment-close.png", + "hisat2/qualimap/WT_REP1/css/comment.png", + "hisat2/qualimap/WT_REP1/css/doctools.js", + "hisat2/qualimap/WT_REP1/css/down-pressed.png", + "hisat2/qualimap/WT_REP1/css/down.png", + "hisat2/qualimap/WT_REP1/css/file.png", + "hisat2/qualimap/WT_REP1/css/jquery.js", + "hisat2/qualimap/WT_REP1/css/minus.png", + "hisat2/qualimap/WT_REP1/css/plus.png", + "hisat2/qualimap/WT_REP1/css/pygments.css", + "hisat2/qualimap/WT_REP1/css/qualimap_logo_small.png", + "hisat2/qualimap/WT_REP1/css/report.css", + "hisat2/qualimap/WT_REP1/css/searchtools.js", + "hisat2/qualimap/WT_REP1/css/underscore.js", + "hisat2/qualimap/WT_REP1/css/up-pressed.png", + "hisat2/qualimap/WT_REP1/css/up.png", + "hisat2/qualimap/WT_REP1/css/websupport.js", + "hisat2/qualimap/WT_REP1/images_qualimapReport", + "hisat2/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png", + "hisat2/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "hisat2/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "hisat2/qualimap/WT_REP1/images_qualimapReport/Junction Analysis.png", + "hisat2/qualimap/WT_REP1/images_qualimapReport/Reads Genomic Origin.png", + "hisat2/qualimap/WT_REP1/images_qualimapReport/Transcript coverage histogram.png", + "hisat2/qualimap/WT_REP1/qualimapReport.html", + "hisat2/qualimap/WT_REP1/raw_data_qualimapReport", + "hisat2/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "hisat2/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "hisat2/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "hisat2/qualimap/WT_REP1/rnaseq_qc_results.txt", + "hisat2/qualimap/WT_REP2", + "hisat2/qualimap/WT_REP2/css", + "hisat2/qualimap/WT_REP2/css/agogo.css", + "hisat2/qualimap/WT_REP2/css/ajax-loader.gif", + "hisat2/qualimap/WT_REP2/css/basic.css", + "hisat2/qualimap/WT_REP2/css/bgfooter.png", + "hisat2/qualimap/WT_REP2/css/bgtop.png", + "hisat2/qualimap/WT_REP2/css/comment-bright.png", + "hisat2/qualimap/WT_REP2/css/comment-close.png", + "hisat2/qualimap/WT_REP2/css/comment.png", + "hisat2/qualimap/WT_REP2/css/doctools.js", + "hisat2/qualimap/WT_REP2/css/down-pressed.png", + "hisat2/qualimap/WT_REP2/css/down.png", + "hisat2/qualimap/WT_REP2/css/file.png", + "hisat2/qualimap/WT_REP2/css/jquery.js", + "hisat2/qualimap/WT_REP2/css/minus.png", + "hisat2/qualimap/WT_REP2/css/plus.png", + "hisat2/qualimap/WT_REP2/css/pygments.css", + "hisat2/qualimap/WT_REP2/css/qualimap_logo_small.png", + "hisat2/qualimap/WT_REP2/css/report.css", + "hisat2/qualimap/WT_REP2/css/searchtools.js", + "hisat2/qualimap/WT_REP2/css/underscore.js", + "hisat2/qualimap/WT_REP2/css/up-pressed.png", + "hisat2/qualimap/WT_REP2/css/up.png", + "hisat2/qualimap/WT_REP2/css/websupport.js", + "hisat2/qualimap/WT_REP2/images_qualimapReport", + "hisat2/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png", + "hisat2/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "hisat2/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "hisat2/qualimap/WT_REP2/images_qualimapReport/Junction Analysis.png", + "hisat2/qualimap/WT_REP2/images_qualimapReport/Reads Genomic Origin.png", + "hisat2/qualimap/WT_REP2/images_qualimapReport/Transcript coverage histogram.png", + "hisat2/qualimap/WT_REP2/qualimapReport.html", + "hisat2/qualimap/WT_REP2/raw_data_qualimapReport", + "hisat2/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "hisat2/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "hisat2/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "hisat2/qualimap/WT_REP2/rnaseq_qc_results.txt", + "hisat2/rseqc", + "hisat2/rseqc/bam_stat", + "hisat2/rseqc/bam_stat/RAP1_IAA_30M_REP1.bam_stat.txt", + "hisat2/rseqc/bam_stat/RAP1_UNINDUCED_REP1.bam_stat.txt", + "hisat2/rseqc/bam_stat/RAP1_UNINDUCED_REP2.bam_stat.txt", + "hisat2/rseqc/bam_stat/WT_REP1.bam_stat.txt", + "hisat2/rseqc/bam_stat/WT_REP2.bam_stat.txt", + "hisat2/rseqc/infer_experiment", + "hisat2/rseqc/infer_experiment/RAP1_IAA_30M_REP1.infer_experiment.txt", + "hisat2/rseqc/infer_experiment/RAP1_UNINDUCED_REP1.infer_experiment.txt", + "hisat2/rseqc/infer_experiment/RAP1_UNINDUCED_REP2.infer_experiment.txt", + "hisat2/rseqc/infer_experiment/WT_REP1.infer_experiment.txt", + "hisat2/rseqc/infer_experiment/WT_REP2.infer_experiment.txt", + "hisat2/rseqc/inner_distance", + "hisat2/rseqc/inner_distance/pdf", + "hisat2/rseqc/inner_distance/pdf/RAP1_IAA_30M_REP1.inner_distance_plot.pdf", + "hisat2/rseqc/inner_distance/pdf/WT_REP1.inner_distance_plot.pdf", + "hisat2/rseqc/inner_distance/pdf/WT_REP2.inner_distance_plot.pdf", + "hisat2/rseqc/inner_distance/rscript", + "hisat2/rseqc/inner_distance/rscript/RAP1_IAA_30M_REP1.inner_distance_plot.r", + "hisat2/rseqc/inner_distance/rscript/WT_REP1.inner_distance_plot.r", + "hisat2/rseqc/inner_distance/rscript/WT_REP2.inner_distance_plot.r", + "hisat2/rseqc/inner_distance/txt", + "hisat2/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance.txt", + "hisat2/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_freq.txt", + "hisat2/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_mean.txt", + "hisat2/rseqc/inner_distance/txt/WT_REP1.inner_distance.txt", + "hisat2/rseqc/inner_distance/txt/WT_REP1.inner_distance_freq.txt", + "hisat2/rseqc/inner_distance/txt/WT_REP1.inner_distance_mean.txt", + "hisat2/rseqc/inner_distance/txt/WT_REP2.inner_distance.txt", + "hisat2/rseqc/inner_distance/txt/WT_REP2.inner_distance_freq.txt", + "hisat2/rseqc/inner_distance/txt/WT_REP2.inner_distance_mean.txt", + "hisat2/rseqc/junction_annotation", + "hisat2/rseqc/junction_annotation/bed", + "hisat2/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.Interact.bed", + "hisat2/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.bed", + "hisat2/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.Interact.bed", + "hisat2/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.bed", + "hisat2/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.Interact.bed", + "hisat2/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.bed", + "hisat2/rseqc/junction_annotation/bed/WT_REP1.junction.Interact.bed", + "hisat2/rseqc/junction_annotation/bed/WT_REP1.junction.bed", + "hisat2/rseqc/junction_annotation/bed/WT_REP2.junction.Interact.bed", + "hisat2/rseqc/junction_annotation/bed/WT_REP2.junction.bed", + "hisat2/rseqc/junction_annotation/log", + "hisat2/rseqc/junction_annotation/log/RAP1_IAA_30M_REP1.junction_annotation.log", + "hisat2/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP1.junction_annotation.log", + "hisat2/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP2.junction_annotation.log", + "hisat2/rseqc/junction_annotation/log/WT_REP1.junction_annotation.log", + "hisat2/rseqc/junction_annotation/log/WT_REP2.junction_annotation.log", + "hisat2/rseqc/junction_annotation/pdf", + "hisat2/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_events.pdf", + "hisat2/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_junction.pdf", + "hisat2/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_events.pdf", + "hisat2/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_junction.pdf", + "hisat2/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_events.pdf", + "hisat2/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_junction.pdf", + "hisat2/rseqc/junction_annotation/pdf/WT_REP1.splice_events.pdf", + "hisat2/rseqc/junction_annotation/pdf/WT_REP1.splice_junction.pdf", + "hisat2/rseqc/junction_annotation/pdf/WT_REP2.splice_events.pdf", + "hisat2/rseqc/junction_annotation/pdf/WT_REP2.splice_junction.pdf", + "hisat2/rseqc/junction_annotation/rscript", + "hisat2/rseqc/junction_annotation/rscript/RAP1_IAA_30M_REP1.junction_plot.r", + "hisat2/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP1.junction_plot.r", + "hisat2/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP2.junction_plot.r", + "hisat2/rseqc/junction_annotation/rscript/WT_REP1.junction_plot.r", + "hisat2/rseqc/junction_annotation/rscript/WT_REP2.junction_plot.r", + "hisat2/rseqc/junction_annotation/xls", + "hisat2/rseqc/junction_annotation/xls/RAP1_IAA_30M_REP1.junction.xls", + "hisat2/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP1.junction.xls", + "hisat2/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP2.junction.xls", + "hisat2/rseqc/junction_annotation/xls/WT_REP1.junction.xls", + "hisat2/rseqc/junction_annotation/xls/WT_REP2.junction.xls", + "hisat2/rseqc/junction_saturation", + "hisat2/rseqc/junction_saturation/pdf", + "hisat2/rseqc/junction_saturation/pdf/RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf", + "hisat2/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf", + "hisat2/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf", + "hisat2/rseqc/junction_saturation/pdf/WT_REP1.junctionSaturation_plot.pdf", + "hisat2/rseqc/junction_saturation/pdf/WT_REP2.junctionSaturation_plot.pdf", + "hisat2/rseqc/junction_saturation/rscript", + "hisat2/rseqc/junction_saturation/rscript/RAP1_IAA_30M_REP1.junctionSaturation_plot.r", + "hisat2/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP1.junctionSaturation_plot.r", + "hisat2/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP2.junctionSaturation_plot.r", + "hisat2/rseqc/junction_saturation/rscript/WT_REP1.junctionSaturation_plot.r", + "hisat2/rseqc/junction_saturation/rscript/WT_REP2.junctionSaturation_plot.r", + "hisat2/rseqc/read_distribution", + "hisat2/rseqc/read_distribution/RAP1_IAA_30M_REP1.read_distribution.txt", + "hisat2/rseqc/read_distribution/RAP1_UNINDUCED_REP1.read_distribution.txt", + "hisat2/rseqc/read_distribution/RAP1_UNINDUCED_REP2.read_distribution.txt", + "hisat2/rseqc/read_distribution/WT_REP1.read_distribution.txt", + "hisat2/rseqc/read_distribution/WT_REP2.read_distribution.txt", + "hisat2/rseqc/read_duplication", + "hisat2/rseqc/read_duplication/pdf", + "hisat2/rseqc/read_duplication/pdf/RAP1_IAA_30M_REP1.DupRate_plot.pdf", + "hisat2/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP1.DupRate_plot.pdf", + "hisat2/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP2.DupRate_plot.pdf", + "hisat2/rseqc/read_duplication/pdf/WT_REP1.DupRate_plot.pdf", + "hisat2/rseqc/read_duplication/pdf/WT_REP2.DupRate_plot.pdf", + "hisat2/rseqc/read_duplication/rscript", + "hisat2/rseqc/read_duplication/rscript/RAP1_IAA_30M_REP1.DupRate_plot.r", + "hisat2/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP1.DupRate_plot.r", + "hisat2/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP2.DupRate_plot.r", + "hisat2/rseqc/read_duplication/rscript/WT_REP1.DupRate_plot.r", + "hisat2/rseqc/read_duplication/rscript/WT_REP2.DupRate_plot.r", + "hisat2/rseqc/read_duplication/xls", + "hisat2/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.pos.DupRate.xls", + "hisat2/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.seq.DupRate.xls", + "hisat2/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.pos.DupRate.xls", + "hisat2/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.seq.DupRate.xls", + "hisat2/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.pos.DupRate.xls", + "hisat2/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.seq.DupRate.xls", + "hisat2/rseqc/read_duplication/xls/WT_REP1.pos.DupRate.xls", + "hisat2/rseqc/read_duplication/xls/WT_REP1.seq.DupRate.xls", + "hisat2/rseqc/read_duplication/xls/WT_REP2.pos.DupRate.xls", + "hisat2/rseqc/read_duplication/xls/WT_REP2.seq.DupRate.xls", + "hisat2/samtools_stats", + "hisat2/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat", + "hisat2/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats", + "hisat2/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.stats", + "hisat2/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.flagstat", + "hisat2/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.idxstats", + "hisat2/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.stats", + "hisat2/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat", + "hisat2/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats", + "hisat2/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats", + "hisat2/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.flagstat", + "hisat2/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.idxstats", + "hisat2/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.stats", + "hisat2/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat", + "hisat2/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats", + "hisat2/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats", + "hisat2/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.flagstat", + "hisat2/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.idxstats", + "hisat2/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.stats", + "hisat2/samtools_stats/WT_REP1.markdup.sorted.bam.flagstat", + "hisat2/samtools_stats/WT_REP1.markdup.sorted.bam.idxstats", + "hisat2/samtools_stats/WT_REP1.markdup.sorted.bam.stats", + "hisat2/samtools_stats/WT_REP1.sorted.bam.flagstat", + "hisat2/samtools_stats/WT_REP1.sorted.bam.idxstats", + "hisat2/samtools_stats/WT_REP1.sorted.bam.stats", + "hisat2/samtools_stats/WT_REP2.markdup.sorted.bam.flagstat", + "hisat2/samtools_stats/WT_REP2.markdup.sorted.bam.idxstats", + "hisat2/samtools_stats/WT_REP2.markdup.sorted.bam.stats", + "hisat2/samtools_stats/WT_REP2.sorted.bam.flagstat", + "hisat2/samtools_stats/WT_REP2.sorted.bam.idxstats", + "hisat2/samtools_stats/WT_REP2.sorted.bam.stats", + "hisat2/stringtie", + "hisat2/stringtie/RAP1_IAA_30M_REP1.ballgown", + "hisat2/stringtie/RAP1_IAA_30M_REP1.ballgown/e2t.ctab", + "hisat2/stringtie/RAP1_IAA_30M_REP1.ballgown/e_data.ctab", + "hisat2/stringtie/RAP1_IAA_30M_REP1.ballgown/i2t.ctab", + "hisat2/stringtie/RAP1_IAA_30M_REP1.ballgown/i_data.ctab", + "hisat2/stringtie/RAP1_IAA_30M_REP1.ballgown/t_data.ctab", + "hisat2/stringtie/RAP1_IAA_30M_REP1.coverage.gtf", + "hisat2/stringtie/RAP1_IAA_30M_REP1.gene.abundance.txt", + "hisat2/stringtie/RAP1_IAA_30M_REP1.transcripts.gtf", + "hisat2/stringtie/RAP1_UNINDUCED_REP1.ballgown", + "hisat2/stringtie/RAP1_UNINDUCED_REP1.ballgown/e2t.ctab", + "hisat2/stringtie/RAP1_UNINDUCED_REP1.ballgown/e_data.ctab", + "hisat2/stringtie/RAP1_UNINDUCED_REP1.ballgown/i2t.ctab", + "hisat2/stringtie/RAP1_UNINDUCED_REP1.ballgown/i_data.ctab", + "hisat2/stringtie/RAP1_UNINDUCED_REP1.ballgown/t_data.ctab", + "hisat2/stringtie/RAP1_UNINDUCED_REP1.coverage.gtf", + "hisat2/stringtie/RAP1_UNINDUCED_REP1.gene.abundance.txt", + "hisat2/stringtie/RAP1_UNINDUCED_REP1.transcripts.gtf", + "hisat2/stringtie/RAP1_UNINDUCED_REP2.ballgown", + "hisat2/stringtie/RAP1_UNINDUCED_REP2.ballgown/e2t.ctab", + "hisat2/stringtie/RAP1_UNINDUCED_REP2.ballgown/e_data.ctab", + "hisat2/stringtie/RAP1_UNINDUCED_REP2.ballgown/i2t.ctab", + "hisat2/stringtie/RAP1_UNINDUCED_REP2.ballgown/i_data.ctab", + "hisat2/stringtie/RAP1_UNINDUCED_REP2.ballgown/t_data.ctab", + "hisat2/stringtie/RAP1_UNINDUCED_REP2.coverage.gtf", + "hisat2/stringtie/RAP1_UNINDUCED_REP2.gene.abundance.txt", + "hisat2/stringtie/RAP1_UNINDUCED_REP2.transcripts.gtf", + "hisat2/stringtie/WT_REP1.ballgown", + "hisat2/stringtie/WT_REP1.ballgown/e2t.ctab", + "hisat2/stringtie/WT_REP1.ballgown/e_data.ctab", + "hisat2/stringtie/WT_REP1.ballgown/i2t.ctab", + "hisat2/stringtie/WT_REP1.ballgown/i_data.ctab", + "hisat2/stringtie/WT_REP1.ballgown/t_data.ctab", + "hisat2/stringtie/WT_REP1.coverage.gtf", + "hisat2/stringtie/WT_REP1.gene.abundance.txt", + "hisat2/stringtie/WT_REP1.transcripts.gtf", + "hisat2/stringtie/WT_REP2.ballgown", + "hisat2/stringtie/WT_REP2.ballgown/e2t.ctab", + "hisat2/stringtie/WT_REP2.ballgown/e_data.ctab", + "hisat2/stringtie/WT_REP2.ballgown/i2t.ctab", + "hisat2/stringtie/WT_REP2.ballgown/i_data.ctab", + "hisat2/stringtie/WT_REP2.ballgown/t_data.ctab", + "hisat2/stringtie/WT_REP2.coverage.gtf", + "hisat2/stringtie/WT_REP2.gene.abundance.txt", + "hisat2/stringtie/WT_REP2.transcripts.gtf", + "multiqc", + "multiqc/hisat2", + "multiqc/hisat2/multiqc_report.html", + "multiqc/hisat2/multiqc_report_data", + "multiqc/hisat2/multiqc_report_data/cutadapt_filtered_reads_plot.txt", + "multiqc/hisat2/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Counts.txt", + "multiqc/hisat2/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt", + "multiqc/hisat2/multiqc_report_data/fastqc-status-check-heatmap-1.txt", + "multiqc/hisat2/multiqc_report_data/fastqc-status-check-heatmap.txt", + "multiqc/hisat2/multiqc_report_data/fastqc_adapter_content_plot.txt", + "multiqc/hisat2/multiqc_report_data/fastqc_overrepresented_sequences_plot-1.txt", + "multiqc/hisat2/multiqc_report_data/fastqc_overrepresented_sequences_plot.txt", + "multiqc/hisat2/multiqc_report_data/fastqc_per_base_n_content_plot-1.txt", + "multiqc/hisat2/multiqc_report_data/fastqc_per_base_n_content_plot.txt", + "multiqc/hisat2/multiqc_report_data/fastqc_per_base_sequence_quality_plot-1.txt", + "multiqc/hisat2/multiqc_report_data/fastqc_per_base_sequence_quality_plot.txt", + "multiqc/hisat2/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Counts.txt", + "multiqc/hisat2/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Percentages.txt", + "multiqc/hisat2/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Counts.txt", + "multiqc/hisat2/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Percentages.txt", + "multiqc/hisat2/multiqc_report_data/fastqc_per_sequence_quality_scores_plot-1.txt", + "multiqc/hisat2/multiqc_report_data/fastqc_per_sequence_quality_scores_plot.txt", + "multiqc/hisat2/multiqc_report_data/fastqc_sequence_counts_plot-1.txt", + "multiqc/hisat2/multiqc_report_data/fastqc_sequence_counts_plot.txt", + "multiqc/hisat2/multiqc_report_data/fastqc_sequence_duplication_levels_plot-1.txt", + "multiqc/hisat2/multiqc_report_data/fastqc_sequence_duplication_levels_plot.txt", + "multiqc/hisat2/multiqc_report_data/fastqc_sequence_length_distribution_plot.txt", + "multiqc/hisat2/multiqc_report_data/fastqc_top_overrepresented_sequences_table-1.txt", + "multiqc/hisat2/multiqc_report_data/fastqc_top_overrepresented_sequences_table.txt", + "multiqc/hisat2/multiqc_report_data/hisat2_pe_plot.txt", + "multiqc/hisat2/multiqc_report_data/hisat2_se_plot.txt", + "multiqc/hisat2/multiqc_report_data/junction_saturation_known.txt", + "multiqc/hisat2/multiqc_report_data/junction_saturation_novel.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_citations.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_cutadapt.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_data.json", + "multiqc/hisat2/multiqc_report_data/multiqc_dupradar-section-plot.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_fail_strand_check_table.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_fastqc_fastqc_raw.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_fastqc_fastqc_trimmed.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_featurecounts_biotype_plot.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_general_stats.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_hisat2.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_picard_dups.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_rseqc_bam_stat.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_rseqc_infer_experiment.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_rseqc_junction_annotation.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_rseqc_read_distribution.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_salmon.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_1.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_2.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_3.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_4.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_salmon_deseq2_pca-plot.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_samtools_flagstat.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_samtools_idxstats.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_samtools_stats.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_software_versions.txt", + "multiqc/hisat2/multiqc_report_data/multiqc_sources.txt", + "multiqc/hisat2/multiqc_report_data/picard_deduplication.txt", + "multiqc/hisat2/multiqc_report_data/picard_histogram.txt", + "multiqc/hisat2/multiqc_report_data/picard_histogram_1.txt", + "multiqc/hisat2/multiqc_report_data/picard_histogram_2.txt", + "multiqc/hisat2/multiqc_report_data/qualimap_gene_coverage_profile_Counts.txt", + "multiqc/hisat2/multiqc_report_data/qualimap_gene_coverage_profile_Normalised.txt", + "multiqc/hisat2/multiqc_report_data/qualimap_genomic_origin.txt", + "multiqc/hisat2/multiqc_report_data/qualimap_rnaseq_cov_hist.txt", + "multiqc/hisat2/multiqc_report_data/qualimap_rnaseq_genome_results.txt", + "multiqc/hisat2/multiqc_report_data/rseqc_bam_stat.txt", + "multiqc/hisat2/multiqc_report_data/rseqc_infer_experiment_plot.txt", + "multiqc/hisat2/multiqc_report_data/rseqc_inner_distance.txt", + "multiqc/hisat2/multiqc_report_data/rseqc_inner_distance_plot_Counts.txt", + "multiqc/hisat2/multiqc_report_data/rseqc_inner_distance_plot_Percentages.txt", + "multiqc/hisat2/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Events.txt", + "multiqc/hisat2/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Junctions.txt", + "multiqc/hisat2/multiqc_report_data/rseqc_junction_saturation_all.txt", + "multiqc/hisat2/multiqc_report_data/rseqc_junction_saturation_plot_All_Junctions.txt", + "multiqc/hisat2/multiqc_report_data/rseqc_junction_saturation_plot_Known_Junctions.txt", + "multiqc/hisat2/multiqc_report_data/rseqc_junction_saturation_plot_Novel_Junctions.txt", + "multiqc/hisat2/multiqc_report_data/rseqc_read_distribution_plot.txt", + "multiqc/hisat2/multiqc_report_data/rseqc_read_dups.txt", + "multiqc/hisat2/multiqc_report_data/rseqc_read_dups_plot.txt", + "multiqc/hisat2/multiqc_report_data/salmon_plot.txt", + "multiqc/hisat2/multiqc_report_data/samtools-flagstat-dp_Percentage_of_total.txt", + "multiqc/hisat2/multiqc_report_data/samtools-flagstat-dp_Read_counts.txt", + "multiqc/hisat2/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt", + "multiqc/hisat2/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt", + "multiqc/hisat2/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Raw_Counts.txt", + "multiqc/hisat2/multiqc_report_data/samtools-stats-dp.txt", + "multiqc/hisat2/multiqc_report_data/samtools_alignment_plot.txt", + "multiqc/hisat2/multiqc_report_plots", + "multiqc/hisat2/multiqc_report_plots/pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-cnt.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-pct.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Counts.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/dupradar-section-plot.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fail_strand_check_table.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc-status-check-heatmap-1.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc-status-check-heatmap.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_adapter_content_plot.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot-1.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot-1.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot-1.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Counts.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Percentages.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Counts.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Percentages.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot-1.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-cnt.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-pct.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-cnt.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-pct.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot-1.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_sequence_length_distribution_plot.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table-1.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/featurecounts_biotype_plot-cnt.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/featurecounts_biotype_plot-pct.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/general_stats_table.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/hisat2_pe_plot-cnt.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/hisat2_pe_plot-pct.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/hisat2_se_plot-cnt.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/hisat2_se_plot-pct.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/picard_deduplication-cnt.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/picard_deduplication-pct.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Counts.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Normalised.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/qualimap_genomic_origin-cnt.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/qualimap_genomic_origin-pct.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/rseqc_bam_stat.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/rseqc_infer_experiment_plot.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Counts.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Percentages.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-cnt.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-pct.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_All_Junctions.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Known_Junctions.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Novel_Junctions.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/rseqc_read_distribution_plot-cnt.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/rseqc_read_distribution_plot-pct.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/rseqc_read_dups_plot.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/salmon_deseq2_clustering-plot.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/salmon_deseq2_pca-plot.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/salmon_plot.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/samtools-flagstat-dp_Percentage_of_total.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/samtools-flagstat-dp_Read_counts.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/samtools-stats-dp.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/samtools_alignment_plot-cnt.pdf", + "multiqc/hisat2/multiqc_report_plots/pdf/samtools_alignment_plot-pct.pdf", + "multiqc/hisat2/multiqc_report_plots/png", + "multiqc/hisat2/multiqc_report_plots/png/cutadapt_filtered_reads_plot-cnt.png", + "multiqc/hisat2/multiqc_report_plots/png/cutadapt_filtered_reads_plot-pct.png", + "multiqc/hisat2/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Counts.png", + "multiqc/hisat2/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Obs_Exp.png", + "multiqc/hisat2/multiqc_report_plots/png/dupradar-section-plot.png", + "multiqc/hisat2/multiqc_report_plots/png/fail_strand_check_table.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc-status-check-heatmap-1.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc-status-check-heatmap.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_adapter_content_plot.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot-1.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_per_base_n_content_plot-1.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_per_base_n_content_plot.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot-1.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Counts.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Percentages.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Counts.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Percentages.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot-1.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-cnt.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-pct.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_sequence_counts_plot-cnt.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_sequence_counts_plot-pct.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot-1.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_sequence_length_distribution_plot.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table-1.png", + "multiqc/hisat2/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table.png", + "multiqc/hisat2/multiqc_report_plots/png/featurecounts_biotype_plot-cnt.png", + "multiqc/hisat2/multiqc_report_plots/png/featurecounts_biotype_plot-pct.png", + "multiqc/hisat2/multiqc_report_plots/png/general_stats_table.png", + "multiqc/hisat2/multiqc_report_plots/png/hisat2_pe_plot-cnt.png", + "multiqc/hisat2/multiqc_report_plots/png/hisat2_pe_plot-pct.png", + "multiqc/hisat2/multiqc_report_plots/png/hisat2_se_plot-cnt.png", + "multiqc/hisat2/multiqc_report_plots/png/hisat2_se_plot-pct.png", + "multiqc/hisat2/multiqc_report_plots/png/picard_deduplication-cnt.png", + "multiqc/hisat2/multiqc_report_plots/png/picard_deduplication-pct.png", + "multiqc/hisat2/multiqc_report_plots/png/qualimap_gene_coverage_profile_Counts.png", + "multiqc/hisat2/multiqc_report_plots/png/qualimap_gene_coverage_profile_Normalised.png", + "multiqc/hisat2/multiqc_report_plots/png/qualimap_genomic_origin-cnt.png", + "multiqc/hisat2/multiqc_report_plots/png/qualimap_genomic_origin-pct.png", + "multiqc/hisat2/multiqc_report_plots/png/rseqc_bam_stat.png", + "multiqc/hisat2/multiqc_report_plots/png/rseqc_infer_experiment_plot.png", + "multiqc/hisat2/multiqc_report_plots/png/rseqc_inner_distance_plot_Counts.png", + "multiqc/hisat2/multiqc_report_plots/png/rseqc_inner_distance_plot_Percentages.png", + "multiqc/hisat2/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-cnt.png", + "multiqc/hisat2/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-pct.png", + "multiqc/hisat2/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-cnt.png", + "multiqc/hisat2/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-pct.png", + "multiqc/hisat2/multiqc_report_plots/png/rseqc_junction_saturation_plot_All_Junctions.png", + "multiqc/hisat2/multiqc_report_plots/png/rseqc_junction_saturation_plot_Known_Junctions.png", + "multiqc/hisat2/multiqc_report_plots/png/rseqc_junction_saturation_plot_Novel_Junctions.png", + "multiqc/hisat2/multiqc_report_plots/png/rseqc_read_distribution_plot-cnt.png", + "multiqc/hisat2/multiqc_report_plots/png/rseqc_read_distribution_plot-pct.png", + "multiqc/hisat2/multiqc_report_plots/png/rseqc_read_dups_plot.png", + "multiqc/hisat2/multiqc_report_plots/png/salmon_deseq2_clustering-plot.png", + "multiqc/hisat2/multiqc_report_plots/png/salmon_deseq2_pca-plot.png", + "multiqc/hisat2/multiqc_report_plots/png/salmon_plot.png", + "multiqc/hisat2/multiqc_report_plots/png/samtools-flagstat-dp_Percentage_of_total.png", + "multiqc/hisat2/multiqc_report_plots/png/samtools-flagstat-dp_Read_counts.png", + "multiqc/hisat2/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png", + "multiqc/hisat2/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png", + "multiqc/hisat2/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png", + "multiqc/hisat2/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png", + "multiqc/hisat2/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png", + "multiqc/hisat2/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png", + "multiqc/hisat2/multiqc_report_plots/png/samtools-stats-dp.png", + "multiqc/hisat2/multiqc_report_plots/png/samtools_alignment_plot-cnt.png", + "multiqc/hisat2/multiqc_report_plots/png/samtools_alignment_plot-pct.png", + "multiqc/hisat2/multiqc_report_plots/svg", + "multiqc/hisat2/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-cnt.svg", + "multiqc/hisat2/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-pct.svg", + "multiqc/hisat2/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Counts.svg", + "multiqc/hisat2/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg", + "multiqc/hisat2/multiqc_report_plots/svg/dupradar-section-plot.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fail_strand_check_table.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc-status-check-heatmap-1.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc-status-check-heatmap.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_adapter_content_plot.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot-1.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_per_base_n_content_plot-1.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_per_base_n_content_plot.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot-1.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Counts.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Percentages.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Counts.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Percentages.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot-1.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-cnt.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-pct.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_sequence_counts_plot-cnt.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_sequence_counts_plot-pct.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot-1.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_sequence_length_distribution_plot.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table-1.svg", + "multiqc/hisat2/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table.svg", + "multiqc/hisat2/multiqc_report_plots/svg/featurecounts_biotype_plot-cnt.svg", + "multiqc/hisat2/multiqc_report_plots/svg/featurecounts_biotype_plot-pct.svg", + "multiqc/hisat2/multiqc_report_plots/svg/general_stats_table.svg", + "multiqc/hisat2/multiqc_report_plots/svg/hisat2_pe_plot-cnt.svg", + "multiqc/hisat2/multiqc_report_plots/svg/hisat2_pe_plot-pct.svg", + "multiqc/hisat2/multiqc_report_plots/svg/hisat2_se_plot-cnt.svg", + "multiqc/hisat2/multiqc_report_plots/svg/hisat2_se_plot-pct.svg", + "multiqc/hisat2/multiqc_report_plots/svg/picard_deduplication-cnt.svg", + "multiqc/hisat2/multiqc_report_plots/svg/picard_deduplication-pct.svg", + "multiqc/hisat2/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Counts.svg", + "multiqc/hisat2/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Normalised.svg", + "multiqc/hisat2/multiqc_report_plots/svg/qualimap_genomic_origin-cnt.svg", + "multiqc/hisat2/multiqc_report_plots/svg/qualimap_genomic_origin-pct.svg", + "multiqc/hisat2/multiqc_report_plots/svg/rseqc_bam_stat.svg", + "multiqc/hisat2/multiqc_report_plots/svg/rseqc_infer_experiment_plot.svg", + "multiqc/hisat2/multiqc_report_plots/svg/rseqc_inner_distance_plot_Counts.svg", + "multiqc/hisat2/multiqc_report_plots/svg/rseqc_inner_distance_plot_Percentages.svg", + "multiqc/hisat2/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-cnt.svg", + "multiqc/hisat2/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-pct.svg", + "multiqc/hisat2/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg", + "multiqc/hisat2/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-pct.svg", + "multiqc/hisat2/multiqc_report_plots/svg/rseqc_junction_saturation_plot_All_Junctions.svg", + "multiqc/hisat2/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Known_Junctions.svg", + "multiqc/hisat2/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Novel_Junctions.svg", + "multiqc/hisat2/multiqc_report_plots/svg/rseqc_read_distribution_plot-cnt.svg", + "multiqc/hisat2/multiqc_report_plots/svg/rseqc_read_distribution_plot-pct.svg", + "multiqc/hisat2/multiqc_report_plots/svg/rseqc_read_dups_plot.svg", + "multiqc/hisat2/multiqc_report_plots/svg/salmon_deseq2_clustering-plot.svg", + "multiqc/hisat2/multiqc_report_plots/svg/salmon_deseq2_pca-plot.svg", + "multiqc/hisat2/multiqc_report_plots/svg/salmon_plot.svg", + "multiqc/hisat2/multiqc_report_plots/svg/samtools-flagstat-dp_Percentage_of_total.svg", + "multiqc/hisat2/multiqc_report_plots/svg/samtools-flagstat-dp_Read_counts.svg", + "multiqc/hisat2/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg", + "multiqc/hisat2/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg", + "multiqc/hisat2/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg", + "multiqc/hisat2/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg", + "multiqc/hisat2/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg", + "multiqc/hisat2/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg", + "multiqc/hisat2/multiqc_report_plots/svg/samtools-stats-dp.svg", + "multiqc/hisat2/multiqc_report_plots/svg/samtools_alignment_plot-cnt.svg", + "multiqc/hisat2/multiqc_report_plots/svg/samtools_alignment_plot-pct.svg", + "pipeline_info", + "pipeline_info/nf_core_rnaseq_software_mqc_versions.yml", + "salmon", + "salmon/RAP1_IAA_30M_REP1", + "salmon/RAP1_IAA_30M_REP1/aux_info", + "salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv", + "salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json", + "salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz", + "salmon/RAP1_IAA_30M_REP1/cmd_info.json", + "salmon/RAP1_IAA_30M_REP1/libParams", + "salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt", + "salmon/RAP1_IAA_30M_REP1/lib_format_counts.json", + "salmon/RAP1_IAA_30M_REP1/logs", + "salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log", + "salmon/RAP1_IAA_30M_REP1/quant.genes.sf", + "salmon/RAP1_IAA_30M_REP1/quant.sf", + "salmon/RAP1_UNINDUCED_REP1", + "salmon/RAP1_UNINDUCED_REP1/aux_info", + "salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv", + "salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json", + "salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz", + "salmon/RAP1_UNINDUCED_REP1/cmd_info.json", + "salmon/RAP1_UNINDUCED_REP1/libParams", + "salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt", + "salmon/RAP1_UNINDUCED_REP1/lib_format_counts.json", + "salmon/RAP1_UNINDUCED_REP1/logs", + "salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log", + "salmon/RAP1_UNINDUCED_REP1/quant.genes.sf", + "salmon/RAP1_UNINDUCED_REP1/quant.sf", + "salmon/RAP1_UNINDUCED_REP2", + "salmon/RAP1_UNINDUCED_REP2/aux_info", + "salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv", + "salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json", + "salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz", + "salmon/RAP1_UNINDUCED_REP2/cmd_info.json", + "salmon/RAP1_UNINDUCED_REP2/libParams", + "salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt", + "salmon/RAP1_UNINDUCED_REP2/lib_format_counts.json", + "salmon/RAP1_UNINDUCED_REP2/logs", + "salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log", + "salmon/RAP1_UNINDUCED_REP2/quant.genes.sf", + "salmon/RAP1_UNINDUCED_REP2/quant.sf", + "salmon/WT_REP1", + "salmon/WT_REP1/aux_info", + "salmon/WT_REP1/aux_info/ambig_info.tsv", + "salmon/WT_REP1/aux_info/expected_bias.gz", + "salmon/WT_REP1/aux_info/fld.gz", + "salmon/WT_REP1/aux_info/meta_info.json", + "salmon/WT_REP1/aux_info/observed_bias.gz", + "salmon/WT_REP1/aux_info/observed_bias_3p.gz", + "salmon/WT_REP1/cmd_info.json", + "salmon/WT_REP1/libParams", + "salmon/WT_REP1/libParams/flenDist.txt", + "salmon/WT_REP1/lib_format_counts.json", + "salmon/WT_REP1/logs", + "salmon/WT_REP1/logs/salmon_quant.log", + "salmon/WT_REP1/quant.genes.sf", + "salmon/WT_REP1/quant.sf", + "salmon/WT_REP2", + "salmon/WT_REP2/aux_info", + "salmon/WT_REP2/aux_info/ambig_info.tsv", + "salmon/WT_REP2/aux_info/expected_bias.gz", + "salmon/WT_REP2/aux_info/fld.gz", + "salmon/WT_REP2/aux_info/meta_info.json", + "salmon/WT_REP2/aux_info/observed_bias.gz", + "salmon/WT_REP2/aux_info/observed_bias_3p.gz", + "salmon/WT_REP2/cmd_info.json", + "salmon/WT_REP2/libParams", + "salmon/WT_REP2/libParams/flenDist.txt", + "salmon/WT_REP2/lib_format_counts.json", + "salmon/WT_REP2/logs", + "salmon/WT_REP2/logs/salmon_quant.log", + "salmon/WT_REP2/quant.genes.sf", + "salmon/WT_REP2/quant.sf", + "salmon/deseq2_qc", + "salmon/deseq2_qc/R_sessionInfo.log", + "salmon/deseq2_qc/deseq2.dds.RData", + "salmon/deseq2_qc/deseq2.pca.vals.txt", + "salmon/deseq2_qc/deseq2.plots.pdf", + "salmon/deseq2_qc/deseq2.sample.dists.txt", + "salmon/deseq2_qc/size_factors", + "salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt", + "salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt", + "salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt", + "salmon/deseq2_qc/size_factors/WT_REP1.txt", + "salmon/deseq2_qc/size_factors/WT_REP2.txt", + "salmon/deseq2_qc/size_factors/deseq2.size_factors.RData", + "salmon/salmon.merged.gene_counts.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts.tsv", + "salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts_length_scaled.tsv", + "salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts_scaled.tsv", + "salmon/salmon.merged.gene_lengths.tsv", + "salmon/salmon.merged.gene_tpm.tsv", + "salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds", + "salmon/salmon.merged.transcript_counts.tsv", + "salmon/salmon.merged.transcript_lengths.tsv", + "salmon/salmon.merged.transcript_tpm.tsv", + "salmon/tx2gene.tsv", + "trimgalore", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" + ], + [ + "genome_gfp.fasta:md5,e23e302af63736a199985a169fdac055", + "genome_gfp.gtf:md5,c98b12c302f15731bfc36bcf297cfe28", + "RAP1_IAA_30M_REP1_dupMatrix.txt:md5,8a6bf324a928534cb7ed7a5522aff7d0", + "RAP1_UNINDUCED_REP1_dupMatrix.txt:md5,ae3e70edc98ec8117608f8f608effab9", + "RAP1_UNINDUCED_REP2_dupMatrix.txt:md5,9a5c2672c5817e930c7b884ada8fd92c", + "WT_REP1_dupMatrix.txt:md5,11371da7a087879340c2e7e6842a5d89", + "WT_REP2_dupMatrix.txt:md5,5176c7447c4295f94e2683dd9995cea0", + "RAP1_IAA_30M_REP1_intercept_slope.txt:md5,1285c70833b46849b726412858736ed7", + "RAP1_UNINDUCED_REP1_intercept_slope.txt:md5,a2efe7c3cad6f910d5dc208c2825a245", + "RAP1_UNINDUCED_REP2_intercept_slope.txt:md5,117712525fcbd396f77710f4f4b605d9", + "WT_REP1_intercept_slope.txt:md5,df33cbc6c3cb1c85c0c06cdba7df3873", + "WT_REP2_intercept_slope.txt:md5,38fbb93a419e666bc81020602852b1e2", + "RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv:md5,079b099e5c5e9fe5e2559dfc938aa48b", + "RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv:md5,dde2de0cb90e10d0195c726f768e9941", + "RAP1_IAA_30M_REP1.featureCounts.txt:md5,eedff929765dbc950528ee499e6d63ba", + "RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv:md5,4d1820a35481f454f17a14326356253d", + "RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv:md5,845ff9059c72bc6722a8de69776e22bb", + "RAP1_UNINDUCED_REP1.featureCounts.txt:md5,b007abbc78b08d8d2bb37a267665947d", + "RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv:md5,3632da2126cb33391428ba0d6d10787f", + "RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv:md5,6d3fa4c88c7fe61f638e4624ad5e22f0", + "RAP1_UNINDUCED_REP2.featureCounts.txt:md5,ea897231d1c447d8e395716741b876ab", + "WT_REP1.biotype_counts_mqc.tsv:md5,abc303e93390bb5bd8f916f8f5978de3", + "WT_REP1.biotype_counts_rrna_mqc.tsv:md5,8ef76d717492ca23764938aee8ea33a9", + "WT_REP1.featureCounts.txt:md5,39721c0d981304996438bc2f505bf98c", + "WT_REP2.biotype_counts_mqc.tsv:md5,74a5436a716a7d99f425f73914cb2794", + "WT_REP2.biotype_counts_rrna_mqc.tsv:md5,12294618fe44df1e7f39348372dcb481", + "WT_REP2.featureCounts.txt:md5,702446d50a5019c84fcef85d1cfef78c", + "RAP1_IAA_30M_REP1.hisat2.summary.log:md5,4273e7a9d0fa8a93ec62e25a70a7e212", + "RAP1_UNINDUCED_REP1.hisat2.summary.log:md5,e322e4f7bce12d889a59db517c2ad678", + "RAP1_UNINDUCED_REP2.hisat2.summary.log:md5,3f41605b1fbd4d40983915617f8a91f9", + "WT_REP1.hisat2.summary.log:md5,50cd2a4fe1f041774c572d09156d4ae8", + "WT_REP2.hisat2.summary.log:md5,e622496abff3ce68afcd1c21a7a1e0df", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,99a8749fb819be0f1bde152e2246d964", + "Coverage Profile Along Genes (Low).png:md5,31bed1d299f6e763c61a2866abc847c9", + "Coverage Profile Along Genes (Total).png:md5,97d15c2ffd8163b800b1ca6378ae0ce9", + "Transcript coverage histogram.png:md5,a0cd920b7f67ee02deb4fd5ee5a5b0fc", + "coverage_profile_along_genes_(high).txt:md5,b56043c3546cac003461c57abad93536", + "coverage_profile_along_genes_(low).txt:md5,1b55d86defcc541643137497c4c6bb06", + "coverage_profile_along_genes_(total).txt:md5,1b55d86defcc541643137497c4c6bb06", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,0c9e9983e2bb5688bca25d1697bcde9c", + "Coverage Profile Along Genes (Low).png:md5,07df4715abe4e9c49265b7cecec79fe6", + "Coverage Profile Along Genes (Total).png:md5,a4ed549db9b210e43955386957fdcd49", + "Transcript coverage histogram.png:md5,1ee5a0ec7f0eec36dd51e312d303ea55", + "coverage_profile_along_genes_(high).txt:md5,9ffadadb953cc9ea1b1c01ac92fcdf61", + "coverage_profile_along_genes_(low).txt:md5,fb281c857a2c4e093b0d8e1f756abf81", + "coverage_profile_along_genes_(total).txt:md5,fb281c857a2c4e093b0d8e1f756abf81", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,9e530e83b3ab308ece285c115b7bde7d", + "Coverage Profile Along Genes (Low).png:md5,b4181c86e9764bf7f543b24232ffea77", + "Coverage Profile Along Genes (Total).png:md5,ec77f7b0919d8537f31ecf3a6dd245b0", + "Transcript coverage histogram.png:md5,4017dc4254884805a327a6fd45e06562", + "coverage_profile_along_genes_(high).txt:md5,a31cb4ba804080544072cd57fc1bdf1c", + "coverage_profile_along_genes_(low).txt:md5,f744e295c3d034b1a86e1dde8bb18eff", + "coverage_profile_along_genes_(total).txt:md5,f744e295c3d034b1a86e1dde8bb18eff", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,9e4a7aa85ae86a7ab5b1c949ed10d913", + "Coverage Profile Along Genes (Low).png:md5,3f9d7d3842d827bb5a7a46a80e88e14b", + "Coverage Profile Along Genes (Total).png:md5,44826c2d3263ff4aaedfa3b4d0c068db", + "Transcript coverage histogram.png:md5,51e934c908640c9dda94d3de8c4dd81f", + "coverage_profile_along_genes_(high).txt:md5,be72a2c9023f6eb81bd5816af33abb65", + "coverage_profile_along_genes_(low).txt:md5,9fce120533ff57f8bc2a2f44f1b6decb", + "coverage_profile_along_genes_(total).txt:md5,9fce120533ff57f8bc2a2f44f1b6decb", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,f63458b8564de80c90c992926ea273ed", + "Coverage Profile Along Genes (Low).png:md5,44f0dd7c647a2ce2c1f06e3920266e95", + "Coverage Profile Along Genes (Total).png:md5,12780d9ad7b76dbdd39736099c45cf07", + "Transcript coverage histogram.png:md5,fcc848c9d318a28c7dff00cb2960e038", + "coverage_profile_along_genes_(high).txt:md5,83d436e0ddb7435bb343db5e4dfb744a", + "coverage_profile_along_genes_(low).txt:md5,58021e91f3595a0d6dc74abc41690638", + "coverage_profile_along_genes_(total).txt:md5,58021e91f3595a0d6dc74abc41690638", + "RAP1_IAA_30M_REP1.infer_experiment.txt:md5,1d4348685fa61819ff8076213d0873b3", + "RAP1_UNINDUCED_REP1.infer_experiment.txt:md5,3ee0f64e82f0b1ac16b5f3e2b30b024c", + "RAP1_UNINDUCED_REP2.infer_experiment.txt:md5,3d17628d178e5a3cc9dc03f32614bff7", + "WT_REP1.infer_experiment.txt:md5,13e3c748f5b968455a39eb9fefd87053", + "WT_REP2.infer_experiment.txt:md5,230910b354a5531d1c4bf711ccd6e493", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,c93ce5b90352398208e3d88c68df45c6", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,fe9d92d1d28e1bc1b223e2ce22b4ef05", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,293d64f70bd8353b822e4fa8a6f082a3", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,d279003d92f7feef9adb31203f84474a", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,ed48a29b77c315cb61a6bf09e68c877d", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,cf2506824949c02e0bfde17a9ed86e61", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,a17c7749a005a89875876eb2d90721d4", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,2e2d760739539fba09cbb666ab95afa1", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,22bdc84c1c4acce9798868e8c7b56004", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,80fe14762a8f7230d516bba37b7275d1", + "cutadapt_filtered_reads_plot.txt:md5,bf033e64e9d23bee85b6277f11c663f1", + "cutadapt_trimmed_sequences_plot_3_Counts.txt:md5,13dfa866fd91dbb072689efe9aa83b1f", + "cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt:md5,07145dd8dd3db654859b18eb0389046c", + "fastqc-status-check-heatmap-1.txt:md5,22a03548736b88b23be6bc0c9ef1b4a6", + "fastqc-status-check-heatmap.txt:md5,5a89b0d8d162f6b1dbdaf39457bbc03b", + "fastqc_adapter_content_plot.txt:md5,da0389be84cfdd189b1d045212eb2974", + "fastqc_overrepresented_sequences_plot-1.txt:md5,4adfeacd3a3a6c7c808f121b24e6b247", + "fastqc_overrepresented_sequences_plot.txt:md5,25d88ea8a72f55e8a374ae802bc7f0b1", + "fastqc_per_base_n_content_plot-1.txt:md5,418610c1ce119cb786ad434db75d366e", + "fastqc_per_base_n_content_plot.txt:md5,d368d7e36ca2f73dcde61f2b486d8213", + "fastqc_per_base_sequence_quality_plot-1.txt:md5,bd22e06e41c096ad4f745d40fe96a1e5", + "fastqc_per_base_sequence_quality_plot.txt:md5,5c3065b549129702b185ea1b817da420", + "fastqc_per_sequence_gc_content_plot-1_Counts.txt:md5,004c60768ceb6197765154e3eaa37b7a", + "fastqc_per_sequence_gc_content_plot-1_Percentages.txt:md5,95d29060b687f745288ad1ec47750037", + "fastqc_per_sequence_gc_content_plot_Counts.txt:md5,9ddaa50167117d3c9188ccf015427704", + "fastqc_per_sequence_gc_content_plot_Percentages.txt:md5,f10ee2881b61308af35f304aa3d810a3", + "fastqc_per_sequence_quality_scores_plot-1.txt:md5,0f9834cc19f76dd5c87cf8cba7435a7c", + "fastqc_per_sequence_quality_scores_plot.txt:md5,b5f9a02933e3065952237afd2ec9ce82", + "fastqc_sequence_counts_plot-1.txt:md5,3861354bbedfbde7ca36a72994f9425c", + "fastqc_sequence_counts_plot.txt:md5,d385a3e2c2573a0902c66e8c93876d3c", + "fastqc_sequence_duplication_levels_plot-1.txt:md5,c73407d55fc532e864fa1dc8dbc12874", + "fastqc_sequence_duplication_levels_plot.txt:md5,8812cee16f6ca65e2c33635754de1772", + "fastqc_sequence_length_distribution_plot.txt:md5,6fe2c985606abad947bcca99b015ae33", + "hisat2_se_plot.txt:md5,f8cd912353aa55e6e670b72a736b656c", + "multiqc_citations.txt:md5,da5043f8ab9b5bd51d91ccf3111c655e", + "multiqc_cutadapt.txt:md5,aac9581a5670cb55edf564f3d6c1f9a7", + "multiqc_fastqc_fastqc_raw.txt:md5,81c3c1a2575a1891a7f2a9637a0f2cc0", + "multiqc_fastqc_fastqc_trimmed.txt:md5,a3238f515e01d158d875d69968753804", + "multiqc_featurecounts_biotype_plot.txt:md5,d35ad008181f0f7be84d5770d17a3a65", + "multiqc_samtools_idxstats.txt:md5,66a8e8aecb6233f5a3521151b1ce8d49", + "picard_histogram.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "picard_histogram_1.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "picard_histogram_2.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "qualimap_gene_coverage_profile_Counts.txt:md5,f3b9bb1902af4c7b5e04c0830ded2c02", + "qualimap_gene_coverage_profile_Normalised.txt:md5,ebcedec8e5c959414a4e89ccae3fc07e", + "qualimap_rnaseq_cov_hist.txt:md5,b78ff616f267f9b061b3297b767e88fb", + "rseqc_infer_experiment_plot.txt:md5,0556a013129be7d78fac4345fddbe8c5", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt:md5,75acd04232d1804b5f960ee4c5db4722", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt:md5,3625f666cc09d0f07990716aeccd869f", + "samtools-idxstats-mapped-reads-plot_Raw_Counts.txt:md5,6c323b383a6506d124506405b9463d93", + "cutadapt_filtered_reads_plot-cnt.png:md5,704cf0d91bfa3dd658dd8c9590f669a2", + "cutadapt_filtered_reads_plot-pct.png:md5,2684d8b2afca3300e5786486b80237f0", + "cutadapt_trimmed_sequences_plot_3_Counts.png:md5,bef41d894629b0c4dab4478bbf197f50", + "cutadapt_trimmed_sequences_plot_3_Obs_Exp.png:md5,1e0d01537d3797623d0b3fd8fbe42787", + "dupradar-section-plot.png:md5,6074ea2315d296094bd10fad3dcc475b", + "fastqc-status-check-heatmap-1.png:md5,2402522f8c02e12aea9af088c6595890", + "fastqc-status-check-heatmap.png:md5,fe8b5b4ab4480d46a12a9005932a9b84", + "fastqc_overrepresented_sequences_plot-1.png:md5,40e450251b80ec0efc9364434234ec7f", + "fastqc_overrepresented_sequences_plot.png:md5,6f5ffbdf1bf61fabe5e028c8bc85de14", + "fastqc_per_sequence_gc_content_plot-1_Counts.png:md5,8a806cec2142f9911502e0a253d83d13", + "fastqc_per_sequence_gc_content_plot-1_Percentages.png:md5,953929d50c8490029880e205e4db7959", + "fastqc_per_sequence_gc_content_plot_Counts.png:md5,01f124545af788fd5cc7bbf41b005e16", + "fastqc_per_sequence_gc_content_plot_Percentages.png:md5,eba3abf8bedb2cb20bad90c54e9c8881", + "fastqc_per_sequence_quality_scores_plot-1.png:md5,d2c29cae169f35744500c751b4a7366e", + "fastqc_per_sequence_quality_scores_plot.png:md5,42fd7369a8aca78f620164a9e887c3cb", + "fastqc_sequence_counts_plot-1-cnt.png:md5,2874fea747c7ff46828bf4f17668caf8", + "fastqc_sequence_counts_plot-1-pct.png:md5,0022d7f5ac78b6eff157de24e37c5ab0", + "fastqc_sequence_counts_plot-cnt.png:md5,3890d5555f2a39b46b9f6efb14cb91f2", + "fastqc_sequence_counts_plot-pct.png:md5,55fa5838c8b2db978fcfa5cb83f6b054", + "fastqc_sequence_duplication_levels_plot-1.png:md5,fcd3b1ec2b95fe4bcd607dc28179a754", + "fastqc_sequence_duplication_levels_plot.png:md5,747431f0f38f8e4c41a11a072fa18780", + "featurecounts_biotype_plot-cnt.png:md5,138e00d2fe0af27f2979cf7bdff83b46", + "featurecounts_biotype_plot-pct.png:md5,3b7550efe9068f3ada2cc64e311f3338", + "qualimap_gene_coverage_profile_Counts.png:md5,1aa39028b017760d0b09f1b6f8c1fa3a", + "qualimap_gene_coverage_profile_Normalised.png:md5,1cd382a79b89564a006afe431aa3916d", + "rseqc_infer_experiment_plot.png:md5,73f5b860029912da9c3f6a887238d251", + "rseqc_read_dups_plot.png:md5,fbb8a2268f0468be5a94c960bd2ebd2a", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png:md5,ce6abb232fd5b5f2e66c0fe9a571d75f", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png:md5,6b44818f886ef020fb3646f152ad4af6", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png:md5,a56226e705754ce81c7709d40794dd92", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png:md5,3bb99f72a15a4159860008beea8c802b", + "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png:md5,25015f9be4710c4eccc50f30db3bf521", + "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png:md5,baa90f5ad4d999fc60db30840b72d8c6", + "ambig_info.tsv:md5,de973a4b22a4457217ae3dc04caf9401", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,1215f0c20f87d3aef8553ef119e1e74c", + "lib_format_counts.json:md5,c24ffe28d70476b5ccdd8bc2d22c0ac1", + "ambig_info.tsv:md5,45f252b4f0e11e6730cf0c29f800fdbb", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,621c6601aade5b1f2e3d6ca2fc71f636", + "lib_format_counts.json:md5,f6d44c0221f7fd559f11a9afe04c9935", + "ambig_info.tsv:md5,6dcc2891ea572e9b8d1ba52cd434ab84", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,9bed6e4dc5428d6f6297adcea29a6326", + "lib_format_counts.json:md5,7c562bf2f70e42f3a7292687dfd328c3", + "ambig_info.tsv:md5,194f574e0586416155e3f33d42e2b167", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,c7ed0aaa5d6c7934ddbebfd29e4eb86d", + "lib_format_counts.json:md5,d46250bb3677d72feeefc435fe6395a6", + "ambig_info.tsv:md5,a26e3f936e65d7da66392603c2f91f6f", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,69ebfc2c7ca6b221a0a22fa1dc8c20ac", + "lib_format_counts.json:md5,088fd51db07022ffde47033bbd029400", + "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", + "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe" + ] ], "meta": { "nf-test": "0.9.0", "nextflow": "24.04.4" }, - "timestamp": "2024-08-23T13:40:29.820359" + "timestamp": "2024-10-02T07:43:07.13584" } } \ No newline at end of file diff --git a/tests/kallisto.nf.test b/tests/kallisto.nf.test index 7343798f7..0c6816a59 100644 --- a/tests/kallisto.nf.test +++ b/tests/kallisto.nf.test @@ -15,176 +15,22 @@ nextflow_pipeline { } then { + // stable_name: All files + folders in ${params.outdir}/ with a stable name + def stable_name = getAllFilesFromDir(params.outdir, true, ['pipeline_info/*.{html,json,txt}'], null) + // stable_path: All files in ${params.outdir}/ with stable content + def stable_path = getAllFilesFromDir(params.outdir, false, null, 'tests/.nftignore') assertAll( - { assert workflow.success }, + { assert workflow.success}, { assert snapshot( - // These files are not stable - file("${params.outdir}/bbsplit/RAP1_IAA_30M_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/RAP1_UNINDUCED_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/RAP1_UNINDUCED_REP2.stats.txt").name, - file("${params.outdir}/bbsplit/WT_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/WT_REP2.stats.txt").name - ).match("bbsplit") }, - { assert snapshot( - path("${params.outdir}/custom/out/genome_gfp.fasta"), - path("${params.outdir}/custom/out/genome_gfp.gtf") - ).match("references") }, - { assert snapshot( - // HTMLs and ZIPs are not stable - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.zip").name - ).match("fastqc/trim") }, - { assert snapshot( - path("${params.outdir}/kallisto/tx2gene.tsv"), - // These files are not stable - file("${params.outdir}/kallisto/RAP1_IAA_30M_REP1/abundance.h5").name, - file("${params.outdir}/kallisto/RAP1_IAA_30M_REP1/abundance.tsv").name, - file("${params.outdir}/kallisto/RAP1_IAA_30M_REP1/kallisto_quant.log").name, - file("${params.outdir}/kallisto/RAP1_IAA_30M_REP1/run_info.json").name, - file("${params.outdir}/kallisto/RAP1_UNINDUCED_REP1/abundance.h5").name, - file("${params.outdir}/kallisto/RAP1_UNINDUCED_REP1/abundance.tsv").name, - file("${params.outdir}/kallisto/RAP1_UNINDUCED_REP1/kallisto_quant.log").name, - file("${params.outdir}/kallisto/RAP1_UNINDUCED_REP1/run_info.json").name, - file("${params.outdir}/kallisto/RAP1_UNINDUCED_REP2/abundance.h5").name, - file("${params.outdir}/kallisto/RAP1_UNINDUCED_REP2/abundance.tsv").name, - file("${params.outdir}/kallisto/RAP1_UNINDUCED_REP2/kallisto_quant.log").name, - file("${params.outdir}/kallisto/RAP1_UNINDUCED_REP2/run_info.json").name, - file("${params.outdir}/kallisto/WT_REP1/abundance.h5").name, - file("${params.outdir}/kallisto/WT_REP1/abundance.tsv").name, - file("${params.outdir}/kallisto/WT_REP1/kallisto_quant.log").name, - file("${params.outdir}/kallisto/WT_REP1/run_info.json").name, - file("${params.outdir}/kallisto/WT_REP2/abundance.h5").name, - file("${params.outdir}/kallisto/WT_REP2/abundance.tsv").name, - file("${params.outdir}/kallisto/WT_REP2/kallisto_quant.log").name, - file("${params.outdir}/kallisto/WT_REP2/run_info.json").name, - file("${params.outdir}/kallisto/kallisto.merged.gene_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/kallisto/kallisto.merged.gene_counts.tsv").name, - file("${params.outdir}/kallisto/kallisto.merged.gene_counts_length_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/kallisto/kallisto.merged.gene_counts_length_scaled.tsv").name, - file("${params.outdir}/kallisto/kallisto.merged.gene_counts_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/kallisto/kallisto.merged.gene_counts_scaled.tsv").name, - file("${params.outdir}/kallisto/kallisto.merged.gene_lengths.tsv").name, - file("${params.outdir}/kallisto/kallisto.merged.gene_tpm.tsv").name, - file("${params.outdir}/kallisto/kallisto.merged.transcript_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/kallisto/kallisto.merged.transcript_counts.tsv").name, - file("${params.outdir}/kallisto/kallisto.merged.transcript_lengths.tsv").name, - file("${params.outdir}/kallisto/kallisto.merged.transcript_tpm.tsv").name - ).match("kallisto") }, - { assert snapshot( - path("${params.outdir}/multiqc/multiqc_report_data/cutadapt_filtered_reads_plot.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Counts.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/fastqc-status-check-heatmap.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/fastqc_overrepresented_sequences_plot.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/fastqc_per_base_n_content_plot.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/fastqc_per_base_sequence_quality_plot.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Counts.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Percentages.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/fastqc_per_sequence_quality_scores_plot.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/fastqc_sequence_counts_plot.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/fastqc_sequence_duplication_levels_plot.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/fastqc_sequence_length_distribution_plot.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/multiqc_citations.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/multiqc_cutadapt.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/multiqc_fastqc_fastqc_trimmed.txt"), - // These files are not stable - file("${params.outdir}/multiqc/multiqc_report_data/fastqc_top_overrepresented_sequences_table.txt").name, - file("${params.outdir}/multiqc/multiqc_report_data/kallisto_alignment.txt").name, - file("${params.outdir}/multiqc/multiqc_report_data/multiqc_data.json").name, - file("${params.outdir}/multiqc/multiqc_report_data/multiqc_general_stats.txt").name, - file("${params.outdir}/multiqc/multiqc_report_data/multiqc_kallisto.txt").name, - file("${params.outdir}/multiqc/multiqc_report_data/multiqc_software_versions.txt").name, - file("${params.outdir}/multiqc/multiqc_report_data/multiqc_sources.txt").name - ).match("multiqc_data") }, - { assert snapshot( - path("${params.outdir}/multiqc/multiqc_report_plots/png/cutadapt_filtered_reads_plot-cnt.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/cutadapt_filtered_reads_plot-pct.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Counts.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Obs_Exp.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc-status-check-heatmap.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Counts.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Percentages.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_sequence_counts_plot-cnt.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_sequence_counts_plot-pct.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot.png"), - // PDFs, SVGs, some PNGs and HTML reports are not stable - file("${params.outdir}/multiqc/multiqc_report.html").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-pct.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Counts.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc-status-check-heatmap.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Counts.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Percentages.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-pct.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_sequence_length_distribution_plot.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/general_stats_table.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/kallisto_alignment-cnt.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/kallisto_alignment-pct.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_per_base_n_content_plot.png").name, - file("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot.png").name, - file("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_sequence_length_distribution_plot.png").name, - file("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table.png").name, - file("${params.outdir}/multiqc/multiqc_report_plots/png/general_stats_table.png").name, - file("${params.outdir}/multiqc/multiqc_report_plots/png/kallisto_alignment-cnt.png").name, - file("${params.outdir}/multiqc/multiqc_report_plots/png/kallisto_alignment-pct.png").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-cnt.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-pct.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Counts.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc-status-check-heatmap.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_per_base_n_content_plot.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Counts.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Percentages.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_sequence_counts_plot-cnt.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_sequence_counts_plot-pct.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_sequence_length_distribution_plot.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/general_stats_table.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/kallisto_alignment-cnt.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/kallisto_alignment-pct.svg").name - ).match("multiqc_plots") }, - { assert snapshot( - // These reports are not stable - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt").name - ).match("trimgalore") }, - { assert snapshot( - UTILS.removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml") - ).match("versions") } + // Number of successful tasks + workflow.trace.succeeded().size(), + // pipeline versions.yml file for multiqc from which Nextflow version is removed because we tests pipelines on multiple Nextflow versions + removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), + // All stable path name, with a relative path + getRelativePath(stable_name, outputDir), + // All files with stable contents + stable_path + ).match() } ) } } @@ -203,21 +49,21 @@ nextflow_pipeline { } then { + // stable_name: All files + folders in ${params.outdir}/ with a stable name + def stable_name = getAllFilesFromDir(params.outdir, true, ['pipeline_info/*.{html,json,txt}'], null) + // stable_path: All files in ${params.outdir}/ with stable content + def stable_path = getAllFilesFromDir(params.outdir, false, null, 'tests/.nftignore') assertAll( - { assert workflow.success }, + { assert workflow.success}, { assert snapshot( - UTILS.removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), - file("${params.outdir}/custom/out/genome_transcriptome.fasta").name, - file("${params.outdir}/custom/out/genome_transcriptome.gtf").name, - file("${params.outdir}/multiqc/multiqc_report.html").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt").name + // Number of successful tasks + workflow.trace.succeeded().size(), + // pipeline versions.yml file for multiqc from which Nextflow version is removed because we tests pipelines on multiple Nextflow versions + removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), + // All stable path name, with a relative path + getRelativePath(stable_name, outputDir), + // All files with stable contents + stable_path ).match() } ) } diff --git a/tests/kallisto.nf.test.snap b/tests/kallisto.nf.test.snap index a431f33fc..d69ef977c 100644 --- a/tests/kallisto.nf.test.snap +++ b/tests/kallisto.nf.test.snap @@ -1,241 +1,345 @@ { - "multiqc_data": { + "Params: --pseudo_aligner kallisto --skip_qc --skip_alignment": { "content": [ - "cutadapt_filtered_reads_plot.txt:md5,bf033e64e9d23bee85b6277f11c663f1", - "cutadapt_trimmed_sequences_plot_3_Counts.txt:md5,13dfa866fd91dbb072689efe9aa83b1f", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt:md5,07145dd8dd3db654859b18eb0389046c", - "fastqc-status-check-heatmap.txt:md5,22a03548736b88b23be6bc0c9ef1b4a6", - "fastqc_overrepresented_sequences_plot.txt:md5,4adfeacd3a3a6c7c808f121b24e6b247", - "fastqc_per_base_n_content_plot.txt:md5,418610c1ce119cb786ad434db75d366e", - "fastqc_per_base_sequence_quality_plot.txt:md5,bd22e06e41c096ad4f745d40fe96a1e5", - "fastqc_per_sequence_gc_content_plot_Counts.txt:md5,004c60768ceb6197765154e3eaa37b7a", - "fastqc_per_sequence_gc_content_plot_Percentages.txt:md5,95d29060b687f745288ad1ec47750037", - "fastqc_per_sequence_quality_scores_plot.txt:md5,0f9834cc19f76dd5c87cf8cba7435a7c", - "fastqc_sequence_counts_plot.txt:md5,3861354bbedfbde7ca36a72994f9425c", - "fastqc_sequence_duplication_levels_plot.txt:md5,c73407d55fc532e864fa1dc8dbc12874", - "fastqc_sequence_length_distribution_plot.txt:md5,6fe2c985606abad947bcca99b015ae33", - "multiqc_citations.txt:md5,4cece87a056a29c1338277736855e6ee", - "multiqc_cutadapt.txt:md5,aac9581a5670cb55edf564f3d6c1f9a7", - "multiqc_fastqc_fastqc_trimmed.txt:md5,a3238f515e01d158d875d69968753804", - "fastqc_top_overrepresented_sequences_table.txt", - "kallisto_alignment.txt", - "multiqc_data.json", - "multiqc_general_stats.txt", - "multiqc_kallisto.txt", - "multiqc_software_versions.txt", - "multiqc_sources.txt" + 35, + { + "BBMAP_BBSPLIT": { + "bbmap": 39.01 + }, + "CAT_FASTQ": { + "cat": 8.3 + }, + "CUSTOM_CATADDITIONALFASTA": { + "python": "3.9.5" + }, + "CUSTOM_GETCHROMSIZES": { + "getchromsizes": 1.2 + }, + "CUSTOM_TX2GENE": { + "python": "3.9.5" + }, + "FQ_SUBSAMPLE": { + "fq": "0.9.1 (2022-02-22)" + }, + "GTF2BED": { + "perl": "5.26.2" + }, + "GTF_FILTER": { + "python": "3.9.5" + }, + "GUNZIP_ADDITIONAL_FASTA": { + "gunzip": 1.1 + }, + "GUNZIP_GTF": { + "gunzip": 1.1 + }, + "KALLISTO_INDEX": { + "kallisto": "0.48.0" + }, + "KALLISTO_QUANT": { + "kallisto": "0.48.0" + }, + "SALMON_QUANT": { + "salmon": "1.10.1" + }, + "SE_GENE": { + "bioconductor-summarizedexperiment": "1.32.0" + }, + "TRIMGALORE": { + "trimgalore": "0.6.7", + "cutadapt": 3.4 + }, + "TXIMETA_TXIMPORT": { + "bioconductor-tximeta": "1.20.1" + }, + "UNTAR_SALMON_INDEX": { + "untar": 1.34 + }, + "Workflow": { + "nf-core/rnaseq": "v3.16.0dev" + } + }, + [ + "bbsplit", + "bbsplit/RAP1_IAA_30M_REP1.stats.txt", + "bbsplit/RAP1_UNINDUCED_REP1.stats.txt", + "bbsplit/RAP1_UNINDUCED_REP2.stats.txt", + "bbsplit/WT_REP1.stats.txt", + "bbsplit/WT_REP2.stats.txt", + "custom", + "custom/out", + "custom/out/genome_gfp.fasta", + "custom/out/genome_gfp.gtf", + "fastqc", + "fastqc/trim", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip", + "fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html", + "fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip", + "fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html", + "fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip", + "fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.html", + "fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.html", + "fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.zip", + "fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.html", + "fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.html", + "fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.zip", + "kallisto", + "kallisto/RAP1_IAA_30M_REP1", + "kallisto/RAP1_IAA_30M_REP1/abundance.h5", + "kallisto/RAP1_IAA_30M_REP1/abundance.tsv", + "kallisto/RAP1_IAA_30M_REP1/kallisto_quant.log", + "kallisto/RAP1_IAA_30M_REP1/run_info.json", + "kallisto/RAP1_UNINDUCED_REP1", + "kallisto/RAP1_UNINDUCED_REP1/abundance.h5", + "kallisto/RAP1_UNINDUCED_REP1/abundance.tsv", + "kallisto/RAP1_UNINDUCED_REP1/kallisto_quant.log", + "kallisto/RAP1_UNINDUCED_REP1/run_info.json", + "kallisto/RAP1_UNINDUCED_REP2", + "kallisto/RAP1_UNINDUCED_REP2/abundance.h5", + "kallisto/RAP1_UNINDUCED_REP2/abundance.tsv", + "kallisto/RAP1_UNINDUCED_REP2/kallisto_quant.log", + "kallisto/RAP1_UNINDUCED_REP2/run_info.json", + "kallisto/WT_REP1", + "kallisto/WT_REP1/abundance.h5", + "kallisto/WT_REP1/abundance.tsv", + "kallisto/WT_REP1/kallisto_quant.log", + "kallisto/WT_REP1/run_info.json", + "kallisto/WT_REP2", + "kallisto/WT_REP2/abundance.h5", + "kallisto/WT_REP2/abundance.tsv", + "kallisto/WT_REP2/kallisto_quant.log", + "kallisto/WT_REP2/run_info.json", + "kallisto/kallisto.merged.gene_counts.SummarizedExperiment.rds", + "kallisto/kallisto.merged.gene_counts.tsv", + "kallisto/kallisto.merged.gene_counts_length_scaled.SummarizedExperiment.rds", + "kallisto/kallisto.merged.gene_counts_length_scaled.tsv", + "kallisto/kallisto.merged.gene_counts_scaled.SummarizedExperiment.rds", + "kallisto/kallisto.merged.gene_counts_scaled.tsv", + "kallisto/kallisto.merged.gene_lengths.tsv", + "kallisto/kallisto.merged.gene_tpm.tsv", + "kallisto/kallisto.merged.transcript_counts.SummarizedExperiment.rds", + "kallisto/kallisto.merged.transcript_counts.tsv", + "kallisto/kallisto.merged.transcript_lengths.tsv", + "kallisto/kallisto.merged.transcript_tpm.tsv", + "kallisto/tx2gene.tsv", + "multiqc", + "multiqc/multiqc_report.html", + "multiqc/multiqc_report_data", + "multiqc/multiqc_report_data/cutadapt_filtered_reads_plot.txt", + "multiqc/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Counts.txt", + "multiqc/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt", + "multiqc/multiqc_report_data/fastqc-status-check-heatmap.txt", + "multiqc/multiqc_report_data/fastqc_overrepresented_sequences_plot.txt", + "multiqc/multiqc_report_data/fastqc_per_base_n_content_plot.txt", + "multiqc/multiqc_report_data/fastqc_per_base_sequence_quality_plot.txt", + "multiqc/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Counts.txt", + "multiqc/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Percentages.txt", + "multiqc/multiqc_report_data/fastqc_per_sequence_quality_scores_plot.txt", + "multiqc/multiqc_report_data/fastqc_sequence_counts_plot.txt", + "multiqc/multiqc_report_data/fastqc_sequence_duplication_levels_plot.txt", + "multiqc/multiqc_report_data/fastqc_sequence_length_distribution_plot.txt", + "multiqc/multiqc_report_data/fastqc_top_overrepresented_sequences_table.txt", + "multiqc/multiqc_report_data/kallisto_alignment.txt", + "multiqc/multiqc_report_data/multiqc_citations.txt", + "multiqc/multiqc_report_data/multiqc_cutadapt.txt", + "multiqc/multiqc_report_data/multiqc_data.json", + "multiqc/multiqc_report_data/multiqc_fastqc_fastqc_trimmed.txt", + "multiqc/multiqc_report_data/multiqc_general_stats.txt", + "multiqc/multiqc_report_data/multiqc_kallisto.txt", + "multiqc/multiqc_report_data/multiqc_software_versions.txt", + "multiqc/multiqc_report_data/multiqc_sources.txt", + "multiqc/multiqc_report_plots", + "multiqc/multiqc_report_plots/pdf", + "multiqc/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-cnt.pdf", + "multiqc/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-pct.pdf", + "multiqc/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Counts.pdf", + "multiqc/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc-status-check-heatmap.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Counts.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Percentages.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-cnt.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-pct.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_sequence_length_distribution_plot.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table.pdf", + "multiqc/multiqc_report_plots/pdf/general_stats_table.pdf", + "multiqc/multiqc_report_plots/pdf/kallisto_alignment-cnt.pdf", + "multiqc/multiqc_report_plots/pdf/kallisto_alignment-pct.pdf", + "multiqc/multiqc_report_plots/png", + "multiqc/multiqc_report_plots/png/cutadapt_filtered_reads_plot-cnt.png", + "multiqc/multiqc_report_plots/png/cutadapt_filtered_reads_plot-pct.png", + "multiqc/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Counts.png", + "multiqc/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Obs_Exp.png", + "multiqc/multiqc_report_plots/png/fastqc-status-check-heatmap.png", + "multiqc/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot.png", + "multiqc/multiqc_report_plots/png/fastqc_per_base_n_content_plot.png", + "multiqc/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot.png", + "multiqc/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Counts.png", + "multiqc/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Percentages.png", + "multiqc/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot.png", + "multiqc/multiqc_report_plots/png/fastqc_sequence_counts_plot-cnt.png", + "multiqc/multiqc_report_plots/png/fastqc_sequence_counts_plot-pct.png", + "multiqc/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot.png", + "multiqc/multiqc_report_plots/png/fastqc_sequence_length_distribution_plot.png", + "multiqc/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table.png", + "multiqc/multiqc_report_plots/png/general_stats_table.png", + "multiqc/multiqc_report_plots/png/kallisto_alignment-cnt.png", + "multiqc/multiqc_report_plots/png/kallisto_alignment-pct.png", + "multiqc/multiqc_report_plots/svg", + "multiqc/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-cnt.svg", + "multiqc/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-pct.svg", + "multiqc/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Counts.svg", + "multiqc/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg", + "multiqc/multiqc_report_plots/svg/fastqc-status-check-heatmap.svg", + "multiqc/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot.svg", + "multiqc/multiqc_report_plots/svg/fastqc_per_base_n_content_plot.svg", + "multiqc/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot.svg", + "multiqc/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Counts.svg", + "multiqc/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Percentages.svg", + "multiqc/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot.svg", + "multiqc/multiqc_report_plots/svg/fastqc_sequence_counts_plot-cnt.svg", + "multiqc/multiqc_report_plots/svg/fastqc_sequence_counts_plot-pct.svg", + "multiqc/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot.svg", + "multiqc/multiqc_report_plots/svg/fastqc_sequence_length_distribution_plot.svg", + "multiqc/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table.svg", + "multiqc/multiqc_report_plots/svg/general_stats_table.svg", + "multiqc/multiqc_report_plots/svg/kallisto_alignment-cnt.svg", + "multiqc/multiqc_report_plots/svg/kallisto_alignment-pct.svg", + "pipeline_info", + "pipeline_info/nf_core_rnaseq_software_mqc_versions.yml", + "trimgalore", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" + ], + [ + "genome_gfp.fasta:md5,e23e302af63736a199985a169fdac055", + "genome_gfp.gtf:md5,c98b12c302f15731bfc36bcf297cfe28", + "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", + "cutadapt_filtered_reads_plot.txt:md5,bf033e64e9d23bee85b6277f11c663f1", + "cutadapt_trimmed_sequences_plot_3_Counts.txt:md5,13dfa866fd91dbb072689efe9aa83b1f", + "cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt:md5,07145dd8dd3db654859b18eb0389046c", + "fastqc-status-check-heatmap.txt:md5,22a03548736b88b23be6bc0c9ef1b4a6", + "fastqc_overrepresented_sequences_plot.txt:md5,4adfeacd3a3a6c7c808f121b24e6b247", + "fastqc_per_base_n_content_plot.txt:md5,418610c1ce119cb786ad434db75d366e", + "fastqc_per_base_sequence_quality_plot.txt:md5,bd22e06e41c096ad4f745d40fe96a1e5", + "fastqc_per_sequence_gc_content_plot_Counts.txt:md5,004c60768ceb6197765154e3eaa37b7a", + "fastqc_per_sequence_gc_content_plot_Percentages.txt:md5,95d29060b687f745288ad1ec47750037", + "fastqc_per_sequence_quality_scores_plot.txt:md5,0f9834cc19f76dd5c87cf8cba7435a7c", + "fastqc_sequence_counts_plot.txt:md5,3861354bbedfbde7ca36a72994f9425c", + "fastqc_sequence_duplication_levels_plot.txt:md5,c73407d55fc532e864fa1dc8dbc12874", + "fastqc_sequence_length_distribution_plot.txt:md5,6fe2c985606abad947bcca99b015ae33", + "multiqc_citations.txt:md5,4cece87a056a29c1338277736855e6ee", + "multiqc_cutadapt.txt:md5,aac9581a5670cb55edf564f3d6c1f9a7", + "multiqc_fastqc_fastqc_trimmed.txt:md5,a3238f515e01d158d875d69968753804", + "cutadapt_filtered_reads_plot-cnt.png:md5,704cf0d91bfa3dd658dd8c9590f669a2", + "cutadapt_filtered_reads_plot-pct.png:md5,2684d8b2afca3300e5786486b80237f0", + "cutadapt_trimmed_sequences_plot_3_Counts.png:md5,bef41d894629b0c4dab4478bbf197f50", + "cutadapt_trimmed_sequences_plot_3_Obs_Exp.png:md5,1e0d01537d3797623d0b3fd8fbe42787", + "fastqc-status-check-heatmap.png:md5,2402522f8c02e12aea9af088c6595890", + "fastqc_overrepresented_sequences_plot.png:md5,40e450251b80ec0efc9364434234ec7f", + "fastqc_per_sequence_gc_content_plot_Counts.png:md5,8a806cec2142f9911502e0a253d83d13", + "fastqc_per_sequence_gc_content_plot_Percentages.png:md5,953929d50c8490029880e205e4db7959", + "fastqc_per_sequence_quality_scores_plot.png:md5,d2c29cae169f35744500c751b4a7366e", + "fastqc_sequence_counts_plot-cnt.png:md5,2874fea747c7ff46828bf4f17668caf8", + "fastqc_sequence_counts_plot-pct.png:md5,0022d7f5ac78b6eff157de24e37c5ab0", + "fastqc_sequence_duplication_levels_plot.png:md5,fcd3b1ec2b95fe4bcd607dc28179a754" + ] ], "meta": { "nf-test": "0.9.0", "nextflow": "24.04.4" }, - "timestamp": "2024-08-23T15:53:37.272547" - }, - "trimgalore": { - "content": [ - "RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T15:35:31.545385" - }, - "kallisto": { - "content": [ - "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", - "abundance.h5", - "abundance.tsv", - "kallisto_quant.log", - "run_info.json", - "abundance.h5", - "abundance.tsv", - "kallisto_quant.log", - "run_info.json", - "abundance.h5", - "abundance.tsv", - "kallisto_quant.log", - "run_info.json", - "abundance.h5", - "abundance.tsv", - "kallisto_quant.log", - "run_info.json", - "abundance.h5", - "abundance.tsv", - "kallisto_quant.log", - "run_info.json", - "kallisto.merged.gene_counts.SummarizedExperiment.rds", - "kallisto.merged.gene_counts.tsv", - "kallisto.merged.gene_counts_length_scaled.SummarizedExperiment.rds", - "kallisto.merged.gene_counts_length_scaled.tsv", - "kallisto.merged.gene_counts_scaled.SummarizedExperiment.rds", - "kallisto.merged.gene_counts_scaled.tsv", - "kallisto.merged.gene_lengths.tsv", - "kallisto.merged.gene_tpm.tsv", - "kallisto.merged.transcript_counts.SummarizedExperiment.rds", - "kallisto.merged.transcript_counts.tsv", - "kallisto.merged.transcript_lengths.tsv", - "kallisto.merged.transcript_tpm.tsv" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T15:53:37.166056" - }, - "references": { - "content": [ - "genome_gfp.fasta:md5,e23e302af63736a199985a169fdac055", - "genome_gfp.gtf:md5,c98b12c302f15731bfc36bcf297cfe28" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T15:25:12.683541" - }, - "versions": { - "content": [ - "{BBMAP_BBSPLIT={bbmap=39.01}, CAT_FASTQ={cat=8.3}, CUSTOM_CATADDITIONALFASTA={python=3.9.5}, CUSTOM_GETCHROMSIZES={getchromsizes=1.2}, CUSTOM_TX2GENE={python=3.9.5}, FQ_SUBSAMPLE={fq=0.9.1 (2022-02-22)}, GTF2BED={perl=5.26.2}, GTF_FILTER={python=3.9.5}, GUNZIP_ADDITIONAL_FASTA={gunzip=1.1}, GUNZIP_GTF={gunzip=1.1}, KALLISTO_INDEX={kallisto=0.48.0}, KALLISTO_QUANT={kallisto=0.48.0}, SALMON_QUANT={salmon=1.10.1}, SE_GENE={bioconductor-summarizedexperiment=1.32.0}, TRIMGALORE={trimgalore=0.6.7, cutadapt=3.4}, TXIMETA_TXIMPORT={bioconductor-tximeta=1.20.1}, UNTAR_SALMON_INDEX={untar=1.34}, Workflow={nf-core/rnaseq=v3.16.0dev}}" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T15:35:31.742801" - }, - "fastqc/trim": { - "content": [ - "RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html", - "RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip", - "RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html", - "RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip", - "RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html", - "RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip", - "RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html", - "RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip", - "WT_REP1_trimmed_1_val_1_fastqc.html", - "WT_REP1_trimmed_1_val_1_fastqc.zip", - "WT_REP1_trimmed_2_val_2_fastqc.html", - "WT_REP1_trimmed_2_val_2_fastqc.zip", - "WT_REP2_trimmed_1_val_1_fastqc.html", - "WT_REP2_trimmed_1_val_1_fastqc.zip", - "WT_REP2_trimmed_2_val_2_fastqc.html", - "WT_REP2_trimmed_2_val_2_fastqc.zip" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T15:25:12.695474" - }, - "multiqc_plots": { - "content": [ - "cutadapt_filtered_reads_plot-cnt.png:md5,704cf0d91bfa3dd658dd8c9590f669a2", - "cutadapt_filtered_reads_plot-pct.png:md5,2684d8b2afca3300e5786486b80237f0", - "cutadapt_trimmed_sequences_plot_3_Counts.png:md5,bef41d894629b0c4dab4478bbf197f50", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.png:md5,1e0d01537d3797623d0b3fd8fbe42787", - "fastqc-status-check-heatmap.png:md5,2402522f8c02e12aea9af088c6595890", - "fastqc_overrepresented_sequences_plot.png:md5,40e450251b80ec0efc9364434234ec7f", - "fastqc_per_sequence_gc_content_plot_Counts.png:md5,8a806cec2142f9911502e0a253d83d13", - "fastqc_per_sequence_gc_content_plot_Percentages.png:md5,953929d50c8490029880e205e4db7959", - "fastqc_per_sequence_quality_scores_plot.png:md5,d2c29cae169f35744500c751b4a7366e", - "fastqc_sequence_counts_plot-cnt.png:md5,2874fea747c7ff46828bf4f17668caf8", - "fastqc_sequence_counts_plot-pct.png:md5,0022d7f5ac78b6eff157de24e37c5ab0", - "fastqc_sequence_duplication_levels_plot.png:md5,fcd3b1ec2b95fe4bcd607dc28179a754", - "multiqc_report.html", - "cutadapt_filtered_reads_plot-cnt.pdf", - "cutadapt_filtered_reads_plot-pct.pdf", - "cutadapt_trimmed_sequences_plot_3_Counts.pdf", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf", - "fastqc-status-check-heatmap.pdf", - "fastqc_overrepresented_sequences_plot.pdf", - "fastqc_per_base_n_content_plot.pdf", - "fastqc_per_base_sequence_quality_plot.pdf", - "fastqc_per_sequence_gc_content_plot_Counts.pdf", - "fastqc_per_sequence_gc_content_plot_Percentages.pdf", - "fastqc_per_sequence_quality_scores_plot.pdf", - "fastqc_sequence_counts_plot-cnt.pdf", - "fastqc_sequence_counts_plot-pct.pdf", - "fastqc_sequence_duplication_levels_plot.pdf", - "fastqc_sequence_length_distribution_plot.pdf", - "fastqc_top_overrepresented_sequences_table.pdf", - "general_stats_table.pdf", - "kallisto_alignment-cnt.pdf", - "kallisto_alignment-pct.pdf", - "fastqc_per_base_n_content_plot.png", - "fastqc_per_base_sequence_quality_plot.png", - "fastqc_sequence_length_distribution_plot.png", - "fastqc_top_overrepresented_sequences_table.png", - "general_stats_table.png", - "kallisto_alignment-cnt.png", - "kallisto_alignment-pct.png", - "cutadapt_filtered_reads_plot-cnt.svg", - "cutadapt_filtered_reads_plot-pct.svg", - "cutadapt_trimmed_sequences_plot_3_Counts.svg", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg", - "fastqc-status-check-heatmap.svg", - "fastqc_overrepresented_sequences_plot.svg", - "fastqc_per_base_n_content_plot.svg", - "fastqc_per_base_sequence_quality_plot.svg", - "fastqc_per_sequence_gc_content_plot_Counts.svg", - "fastqc_per_sequence_gc_content_plot_Percentages.svg", - "fastqc_per_sequence_quality_scores_plot.svg", - "fastqc_sequence_counts_plot-cnt.svg", - "fastqc_sequence_counts_plot-pct.svg", - "fastqc_sequence_duplication_levels_plot.svg", - "fastqc_sequence_length_distribution_plot.svg", - "fastqc_top_overrepresented_sequences_table.svg", - "general_stats_table.svg", - "kallisto_alignment-cnt.svg", - "kallisto_alignment-pct.svg" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T15:53:37.413284" - }, - "bbsplit": { - "content": [ - "RAP1_IAA_30M_REP1.stats.txt", - "RAP1_UNINDUCED_REP1.stats.txt", - "RAP1_UNINDUCED_REP2.stats.txt", - "WT_REP1.stats.txt", - "WT_REP2.stats.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T15:25:12.672876" + "timestamp": "2024-10-02T07:46:44.393695" }, "Params: --pseudo_aligner kallisto --skip_qc --skip_alignment - stub": { "content": [ - "{BBMAP_BBSPLIT={bbmap=39.01}, CAT_FASTQ={cat=8.3}, CUSTOM_CATADDITIONALFASTA={python=null}, CUSTOM_GETCHROMSIZES={getchromsizes=1.2}, GTF2BED={perl=5.26.2}, GTF_FILTER={python=3.9.5}, GUNZIP_ADDITIONAL_FASTA={gunzip=1.1}, GUNZIP_GTF={gunzip=1.1}, KALLISTO_INDEX={kallisto=0.48.0}, TRIMGALORE={trimgalore=0.6.7, cutadapt=3.4}, UNTAR_SALMON_INDEX={untar=1.34}, Workflow={nf-core/rnaseq=v3.16.0dev}}", - "genome_transcriptome.fasta", - "genome_transcriptome.gtf", - "multiqc_report.html", - "RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" + 17, + { + "BBMAP_BBSPLIT": { + "bbmap": 39.01 + }, + "CAT_FASTQ": { + "cat": 8.3 + }, + "CUSTOM_CATADDITIONALFASTA": { + "python": null + }, + "CUSTOM_GETCHROMSIZES": { + "getchromsizes": 1.2 + }, + "GTF2BED": { + "perl": "5.26.2" + }, + "GTF_FILTER": { + "python": "3.9.5" + }, + "GUNZIP_ADDITIONAL_FASTA": { + "gunzip": 1.1 + }, + "GUNZIP_GTF": { + "gunzip": 1.1 + }, + "KALLISTO_INDEX": { + "kallisto": "0.48.0" + }, + "TRIMGALORE": { + "trimgalore": "0.6.7", + "cutadapt": 3.4 + }, + "UNTAR_SALMON_INDEX": { + "untar": 1.34 + }, + "Workflow": { + "nf-core/rnaseq": "v3.16.0dev" + } + }, + [ + "custom", + "custom/out", + "custom/out/genome_transcriptome.fasta", + "custom/out/genome_transcriptome.gtf", + "fastqc", + "fastqc/trim", + "multiqc", + "multiqc/multiqc_data", + "multiqc/multiqc_plots", + "multiqc/multiqc_report.html", + "pipeline_info", + "pipeline_info/nf_core_rnaseq_software_mqc_versions.yml", + "trimgalore", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" + ], + [ + "genome_transcriptome.fasta:md5,d41d8cd98f00b204e9800998ecf8427e", + "genome_transcriptome.gtf:md5,d41d8cd98f00b204e9800998ecf8427e" + ] ], "meta": { "nf-test": "0.9.0", "nextflow": "24.04.4" }, - "timestamp": "2024-08-23T15:36:19.174739" + "timestamp": "2024-10-02T07:47:31.044439" } } \ No newline at end of file diff --git a/tests/lib/UTILS.groovy b/tests/lib/UTILS.groovy deleted file mode 100644 index 1bd58a496..000000000 --- a/tests/lib/UTILS.groovy +++ /dev/null @@ -1,11 +0,0 @@ -// Function to remove Nextflow version from pipeline_software_mqc_versions.yml - -class UTILS { - public static String removeNextflowVersion(pipeline_software_mqc_versions) { - def softwareVersions = path(pipeline_software_mqc_versions).yaml - if (softwareVersions.containsKey("Workflow")) { - softwareVersions.Workflow.remove("Nextflow") - } - return softwareVersions - } -} diff --git a/tests/min_mapped_reads.nf.test b/tests/min_mapped_reads.nf.test index dde1c3706..7ffef71de 100644 --- a/tests/min_mapped_reads.nf.test +++ b/tests/min_mapped_reads.nf.test @@ -13,797 +13,22 @@ nextflow_pipeline { } then { + // stable_name: All files + folders in ${params.outdir}/ with a stable name + def stable_name = getAllFilesFromDir(params.outdir, true, ['pipeline_info/*.{html,json,txt}'], null) + // stable_path: All files in ${params.outdir}/ with stable content + def stable_path = getAllFilesFromDir(params.outdir, false, null, 'tests/.nftignore') assertAll( - { assert workflow.success }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/bbsplit/RAP1_IAA_30M_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/RAP1_UNINDUCED_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/RAP1_UNINDUCED_REP2.stats.txt").name, - file("${params.outdir}/bbsplit/WT_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/WT_REP2.stats.txt").name - ).match("bbsplit") }, - { assert snapshot( - path("${params.outdir}/custom/out/genome_gfp.fasta"), - path("${params.outdir}/custom/out/genome_gfp.gtf") - ).match("references") }, - { assert snapshot( - // HTMLs and ZIPs are not stable - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_2_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_2_fastqc.zip").name - ).match("fastqc/raw") }, - { assert snapshot( - // HTMLs and ZIPs are not stable - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.zip").name - ).match("fastqc/trim") }, - { assert snapshot( - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/cutadapt_filtered_reads_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc-status-check-heatmap-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc-status-check-heatmap.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_adapter_content_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_overrepresented_sequences_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_overrepresented_sequences_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_base_n_content_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_base_n_content_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_base_sequence_quality_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_base_sequence_quality_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Percentages.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Percentages.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_quality_scores_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_quality_scores_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_counts_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_counts_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_duplication_levels_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_duplication_levels_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_length_distribution_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_citations.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_cutadapt.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_fail_mapped_samples_table.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_fastqc_fastqc_raw.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_fastqc_fastqc_trimmed.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_featurecounts_biotype_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_samtools_idxstats.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_histogram.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_histogram_1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_histogram_2.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_gene_coverage_profile_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_gene_coverage_profile_Normalised.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_rnaseq_cov_hist.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_infer_experiment_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Raw_Counts.txt"), - // These files are not stable - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_top_overrepresented_sequences_table-1.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_top_overrepresented_sequences_table.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/junction_saturation_known.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/junction_saturation_novel.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_data.json").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_dupradar-section-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_fail_strand_check_table.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_general_stats.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_picard_dups.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_bam_stat.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_infer_experiment.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_junction_annotation.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_read_distribution.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_1.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_2.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_3.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_4.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_pca-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_samtools_flagstat.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_samtools_stats.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_software_versions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_sources.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_1.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_2.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_3.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_4.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_pca-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_deduplication.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_genomic_origin.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_rnaseq_genome_results.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_bam_stat.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance_plot_Counts.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance_plot_Percentages.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Events.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Junctions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_all.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_All_Junctions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_Known_Junctions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_Novel_Junctions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_read_distribution_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_read_dups.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_read_dups_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/salmon_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Percentage_of_total.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Read_counts.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-stats-dp.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools_alignment_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/star_alignment_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/star_summary_table.txt").name - ).match("multiqc_data") }, - { assert snapshot( - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/cutadapt_filtered_reads_plot-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/cutadapt_filtered_reads_plot-pct.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Counts.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Obs_Exp.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/dupradar-section-plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fail_mapped_samples_table.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc-status-check-heatmap-1.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc-status-check-heatmap.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot-1.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Counts.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Percentages.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Counts.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Percentages.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot-1.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-pct.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-pct.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot-1.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/featurecounts_biotype_plot-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/featurecounts_biotype_plot-pct.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/qualimap_gene_coverage_profile_Counts.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/qualimap_gene_coverage_profile_Normalised.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_infer_experiment_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_dups_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png"), - // PDFs, SVGs, some PNGs and HTML reports are not stable - file("${params.outdir}/multiqc/star_salmon/multiqc_report.html").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/dupradar-section-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fail_mapped_samples_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fail_strand_check_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc-status-check-heatmap-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc-status-check-heatmap.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_adapter_content_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Percentages.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Percentages.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_length_distribution_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/featurecounts_biotype_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/featurecounts_biotype_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/general_stats_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Normalised.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_genomic_origin-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_genomic_origin-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_bam_stat.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_infer_experiment_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Percentages.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_All_Junctions.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Known_Junctions.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Novel_Junctions.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_distribution_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_distribution_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_dups_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/salmon_deseq2_clustering-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/salmon_deseq2_pca-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/salmon_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Percentage_of_total.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Read_counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-stats-dp.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_salmon_deseq2_clustering-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_salmon_deseq2_pca-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_summary_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fail_strand_check_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_adapter_content_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_n_content_plot-1.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_n_content_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot-1.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_length_distribution_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table-1.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/general_stats_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/qualimap_genomic_origin-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/qualimap_genomic_origin-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_bam_stat.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_inner_distance_plot_Counts.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_inner_distance_plot_Percentages.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_All_Junctions.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_Known_Junctions.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_Novel_Junctions.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_distribution_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_distribution_plot-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/salmon_deseq2_clustering-plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/salmon_deseq2_pca-plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/salmon_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Percentage_of_total.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Read_counts.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-stats-dp.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_salmon_deseq2_clustering-plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_salmon_deseq2_pca-plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_summary_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/dupradar-section-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fail_mapped_samples_table.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fail_strand_check_table.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc-status-check-heatmap-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc-status-check-heatmap.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_adapter_content_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_n_content_plot-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_n_content_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Percentages.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Percentages.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_length_distribution_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/featurecounts_biotype_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/featurecounts_biotype_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/general_stats_table.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Normalised.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/qualimap_genomic_origin-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/qualimap_genomic_origin-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_bam_stat.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_infer_experiment_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_inner_distance_plot_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_inner_distance_plot_Percentages.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_All_Junctions.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Known_Junctions.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Novel_Junctions.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_distribution_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_distribution_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_dups_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/salmon_deseq2_clustering-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/salmon_deseq2_pca-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/salmon_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Percentage_of_total.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Read_counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-stats-dp.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_salmon_deseq2_clustering-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_salmon_deseq2_pca-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_summary_table.svg").name - ).match("multiqc_plots") }, - { assert snapshot( - path("${params.outdir}/salmon/deseq2_qc/R_sessionInfo.log"), - // These files are not stable - file("${params.outdir}/salmon/deseq2_qc/deseq2.dds.RData").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.pca.vals.txt").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.plots.pdf").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.sample.dists.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/WT_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/WT_REP2.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/deseq2.size_factors.RData").name - ).match("salmon/deseq2_qc") }, - { assert snapshot( - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/lib_format_counts.json"), - path("${params.outdir}/salmon/WT_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/WT_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/WT_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/WT_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/WT_REP1/cmd_info.json"), - path("${params.outdir}/salmon/WT_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/WT_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/WT_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/WT_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/WT_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/WT_REP2/cmd_info.json"), - path("${params.outdir}/salmon/WT_REP2/lib_format_counts.json"), - // These files are not stable - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/quant.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/quant.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/quant.sf").name, - file("${params.outdir}/salmon/WT_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/WT_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/WT_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/WT_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/WT_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/WT_REP1/quant.sf").name, - file("${params.outdir}/salmon/WT_REP2/aux_info/fld.gz").name, - file("${params.outdir}/salmon/WT_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/WT_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/WT_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/WT_REP2/quant.genes.sf").name, - file("${params.outdir}/salmon/WT_REP2/quant.sf").name - ).match("salmon_quant") }, - { assert snapshot( - path("${params.outdir}/salmon/tx2gene.tsv"), - // These files are not stable - file("${params.outdir}/salmon/salmon.merged.gene_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_length_scaled.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_scaled.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_lengths.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_tpm.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.transcript_counts.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_lengths.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_tpm.tsv").name - ).match("salmon") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/star_salmon/bigwig/RAP1_IAA_30M_REP1.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_IAA_30M_REP1.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP1.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP1.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP2.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP2.reverse.bigWig").name - ).match("star_salmon/bigwig") }, - { assert snapshot( - path("${params.outdir}/star_salmon/deseq2_qc/R_sessionInfo.log"), - // These files are not stable - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/WT_REP1.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/WT_REP2.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/deseq2.size_factors.RData").name, - file("${params.outdir}/star_salmon/deseq2_qc/deseq2.dds.RData").name, - file("${params.outdir}/star_salmon/deseq2_qc/deseq2.pca.vals.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/deseq2.plots.pdf").name, - file("${params.outdir}/star_salmon/deseq2_qc/deseq2.sample.dists.txt").name - ).match("star_salmon/deseq2_qc") }, - { assert snapshot( - path("${params.outdir}/star_salmon/dupradar/gene_data/RAP1_IAA_30M_REP1_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/gene_data/RAP1_UNINDUCED_REP1_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/gene_data/RAP1_UNINDUCED_REP2_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/RAP1_IAA_30M_REP1_intercept_slope.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/RAP1_UNINDUCED_REP1_intercept_slope.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/RAP1_UNINDUCED_REP2_intercept_slope.txt"), - // PDFs are not stable - file("${params.outdir}/star_salmon/dupradar/box_plot/RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/box_plot/RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/box_plot/RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/RAP1_IAA_30M_REP1_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/RAP1_UNINDUCED_REP1_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/RAP1_UNINDUCED_REP2_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/RAP1_IAA_30M_REP1_duprateExpDens.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/RAP1_UNINDUCED_REP1_duprateExpDens.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/RAP1_UNINDUCED_REP2_duprateExpDens.pdf").name - ).match("star_salmon/dupradar") }, - { assert snapshot( - path("${params.outdir}/star_salmon/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt"), - file("${params.outdir}/star_salmon/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt.summary").name, - file("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt.summary").name, - file("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt.summary").name - ).match("star_salmon/featurecounts") }, - { assert snapshot( - path("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/WT_REP1.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/WT_REP2.SJ.out.tab"), - // Logs are not stable - file("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.Log.final.out").name, - file("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.Log.out").name, - file("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.Log.final.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.Log.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.Log.final.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.Log.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/WT_REP1.Log.final.out").name, - file("${params.outdir}/star_salmon/log/WT_REP1.Log.out").name, - file("${params.outdir}/star_salmon/log/WT_REP1.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/WT_REP2.Log.final.out").name, - file("${params.outdir}/star_salmon/log/WT_REP2.Log.out").name, - file("${params.outdir}/star_salmon/log/WT_REP2.Log.progress.out").name - ).match("star_salmon/log") }, - { assert snapshot( - // Metrics are not stable - file("${params.outdir}/star_salmon/picard_metrics/RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt").name - ).match("star_salmon/picard_metrics") }, - { assert snapshot( - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - // HTML reports and these files are not stable - file("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/rnaseq_qc_results.txt").name - ).match("star_salmon/qualimap") }, - { assert snapshot( - path("${params.outdir}/star_salmon/rseqc/infer_experiment/RAP1_IAA_30M_REP1.infer_experiment.txt"), - path("${params.outdir}/star_salmon/rseqc/infer_experiment/RAP1_UNINDUCED_REP1.infer_experiment.txt"), - path("${params.outdir}/star_salmon/rseqc/infer_experiment/RAP1_UNINDUCED_REP2.infer_experiment.txt"), - // PDFs, R scripts and all these files are not stable - file("${params.outdir}/star_salmon/rseqc/bam_stat/RAP1_IAA_30M_REP1.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/bam_stat/RAP1_UNINDUCED_REP1.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/bam_stat/RAP1_UNINDUCED_REP2.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/pdf/RAP1_IAA_30M_REP1.inner_distance_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/rscript/RAP1_IAA_30M_REP1.inner_distance_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_freq.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_mean.txt").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/RAP1_IAA_30M_REP1.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP1.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP2.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/RAP1_IAA_30M_REP1.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP1.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP2.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/RAP1_IAA_30M_REP1.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP1.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP2.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/RAP1_IAA_30M_REP1.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP1.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP2.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/RAP1_IAA_30M_REP1.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/RAP1_UNINDUCED_REP1.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/RAP1_UNINDUCED_REP2.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/RAP1_IAA_30M_REP1.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP1.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP2.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/RAP1_IAA_30M_REP1.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP1.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP2.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.seq.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.seq.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.seq.DupRate.xls").name - ).match("star_salmon/rseqc") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/star_salmon/salmon.merged.gene_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_length_scaled.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_scaled.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_lengths.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_tpm.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_counts.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_lengths.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_tpm.tsv").name - ).match("star_salmon/salmon") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.sorted.bam.stats").name - ).match("star_salmon/samtools_stats") }, - { assert snapshot( - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i_data.ctab"), - // These files are not stable - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.transcripts.gtf").name - ).match("star_salmon/stringtie") }, - { assert snapshot( - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai").name - ).match("star_salmon/markdup") }, - { assert snapshot( - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/cmd_info.json"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/cmd_info.json"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/cmd_info.json"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/WT_REP1/cmd_info.json"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/WT_REP2/cmd_info.json"), - path("${params.outdir}/star_salmon/tx2gene.tsv"), - // These files are not stable - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/quant.genes.sf").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/quant.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/quant.genes.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/quant.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/quant.genes.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/quant.sf").name, - file("${params.outdir}/star_salmon/WT_REP1/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/WT_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/WT_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/WT_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/WT_REP1/quant.genes.sf").name, - file("${params.outdir}/star_salmon/WT_REP1/quant.sf").name, - file("${params.outdir}/star_salmon/WT_REP2/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/WT_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/WT_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/WT_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/WT_REP2/quant.genes.sf").name, - file("${params.outdir}/star_salmon/WT_REP2/quant.sf").name - ).match("star_salmon/salmon_quant") }, - { assert snapshot( - // These reports are not stable - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt").name - ).match("trimgalore") }, - { assert snapshot( - UTILS.removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml") - ).match("versions") } + { assert workflow.success}, + { assert snapshot( + // Number of successful tasks + workflow.trace.succeeded().size(), + // pipeline versions.yml file for multiqc from which Nextflow version is removed because we tests pipelines on multiple Nextflow versions + removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), + // All stable path name, with a relative path + getRelativePath(stable_name, outputDir), + // All files with stable contents + stable_path + ).match() } ) } } @@ -820,31 +45,21 @@ nextflow_pipeline { } then { + // stable_name: All files + folders in ${params.outdir}/ with a stable name + def stable_name = getAllFilesFromDir(params.outdir, true, ['pipeline_info/*.{html,json,txt}'], null) + // stable_path: All files in ${params.outdir}/ with stable content + def stable_path = getAllFilesFromDir(params.outdir, false, null, 'tests/.nftignore') assertAll( - { assert workflow.success }, - { assert snapshot( - UTILS.removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), - file("${params.outdir}/custom/out/genome_transcriptome.fasta").name, - file("${params.outdir}/custom/out/genome_transcriptome.gtf").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw.zip").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report.html").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt").name + { assert workflow.success}, + { assert snapshot( + // Number of successful tasks + workflow.trace.succeeded().size(), + // pipeline versions.yml file for multiqc from which Nextflow version is removed because we tests pipelines on multiple Nextflow versions + removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), + // All stable path name, with a relative path + getRelativePath(stable_name, outputDir), + // All files with stable contents + stable_path ).match() } ) } diff --git a/tests/min_mapped_reads.nf.test.snap b/tests/min_mapped_reads.nf.test.snap index c68828368..69637a301 100644 --- a/tests/min_mapped_reads.nf.test.snap +++ b/tests/min_mapped_reads.nf.test.snap @@ -1,970 +1,1373 @@ { - "star_salmon/log": { + "Params: --min_mapped_reads 90": { "content": [ - "RAP1_IAA_30M_REP1.SJ.out.tab:md5,ea95e243278af55534f2c52eb5fff7ee", - "RAP1_UNINDUCED_REP1.SJ.out.tab:md5,e548d13942535dc0821f3ec6d9743ec8", - "RAP1_UNINDUCED_REP2.SJ.out.tab:md5,1f294365343a1a5e95682792fdb77033", - "WT_REP1.SJ.out.tab:md5,1350c2fa6a675bf107386c6cd3fc5204", - "WT_REP2.SJ.out.tab:md5,f6cc03643a5e3c1025a5b4754eb1be23", - "RAP1_IAA_30M_REP1.Log.final.out", - "RAP1_IAA_30M_REP1.Log.out", - "RAP1_IAA_30M_REP1.Log.progress.out", - "RAP1_UNINDUCED_REP1.Log.final.out", - "RAP1_UNINDUCED_REP1.Log.out", - "RAP1_UNINDUCED_REP1.Log.progress.out", - "RAP1_UNINDUCED_REP2.Log.final.out", - "RAP1_UNINDUCED_REP2.Log.out", - "RAP1_UNINDUCED_REP2.Log.progress.out", - "WT_REP1.Log.final.out", - "WT_REP1.Log.out", - "WT_REP1.Log.progress.out", - "WT_REP2.Log.final.out", - "WT_REP2.Log.out", - "WT_REP2.Log.progress.out" + 152, + { + "BBMAP_BBSPLIT": { + "bbmap": 39.01 + }, + "BEDTOOLS_GENOMECOV_FW": { + "bedtools": "2.31.1" + }, + "CAT_FASTQ": { + "cat": 8.3 + }, + "CUSTOM_CATADDITIONALFASTA": { + "python": "3.9.5" + }, + "CUSTOM_GETCHROMSIZES": { + "getchromsizes": 1.2 + }, + "CUSTOM_TX2GENE": { + "python": "3.9.5" + }, + "DESEQ2_QC_PSEUDO": { + "r-base": "4.0.3", + "bioconductor-deseq2": "1.28.0" + }, + "DESEQ2_QC_STAR_SALMON": { + "r-base": "4.0.3", + "bioconductor-deseq2": "1.28.0" + }, + "DUPRADAR": { + "bioconductor-dupradar": "1.32.0" + }, + "FASTQC": { + "fastqc": "0.12.1" + }, + "FQ_SUBSAMPLE": { + "fq": "0.9.1 (2022-02-22)" + }, + "GTF2BED": { + "perl": "5.26.2" + }, + "GTF_FILTER": { + "python": "3.9.5" + }, + "GUNZIP_ADDITIONAL_FASTA": { + "gunzip": 1.1 + }, + "GUNZIP_GTF": { + "gunzip": 1.1 + }, + "MULTIQC_CUSTOM_BIOTYPE": { + "python": "3.9.5" + }, + "PICARD_MARKDUPLICATES": { + "picard": "3.1.1" + }, + "QUALIMAP_RNASEQ": { + "qualimap": 2.3 + }, + "RSEQC_BAMSTAT": { + "rseqc": "5.0.2" + }, + "RSEQC_INFEREXPERIMENT": { + "rseqc": "5.0.2" + }, + "RSEQC_INNERDISTANCE": { + "rseqc": "5.0.2" + }, + "RSEQC_JUNCTIONANNOTATION": { + "rseqc": "5.0.2" + }, + "RSEQC_JUNCTIONSATURATION": { + "rseqc": "5.0.2" + }, + "RSEQC_READDISTRIBUTION": { + "rseqc": "5.0.2" + }, + "RSEQC_READDUPLICATION": { + "rseqc": "5.0.2" + }, + "SALMON_QUANT": { + "salmon": "1.10.1" + }, + "SAMTOOLS_FLAGSTAT": { + "samtools": 1.2 + }, + "SAMTOOLS_IDXSTATS": { + "samtools": 1.2 + }, + "SAMTOOLS_INDEX": { + "samtools": 1.2 + }, + "SAMTOOLS_SORT": { + "samtools": 1.2 + }, + "SAMTOOLS_STATS": { + "samtools": 1.2 + }, + "SE_GENE": { + "bioconductor-summarizedexperiment": "1.32.0" + }, + "STAR_ALIGN": { + "star": "2.7.10a", + "samtools": 1.18, + "gawk": "5.1.0" + }, + "STAR_GENOMEGENERATE": { + "star": "2.7.10a", + "samtools": 1.18, + "gawk": "5.1.0" + }, + "STRINGTIE_STRINGTIE": { + "stringtie": "2.2.1" + }, + "SUBREAD_FEATURECOUNTS": { + "subread": "2.0.1" + }, + "TRIMGALORE": { + "trimgalore": "0.6.7", + "cutadapt": 3.4 + }, + "TXIMETA_TXIMPORT": { + "bioconductor-tximeta": "1.20.1" + }, + "UCSC_BEDCLIP": { + "ucsc": 377 + }, + "UCSC_BEDGRAPHTOBIGWIG": { + "ucsc": 445 + }, + "UNTAR_SALMON_INDEX": { + "untar": 1.34 + }, + "Workflow": { + "nf-core/rnaseq": "v3.16.0dev" + } + }, + [ + "bbsplit", + "bbsplit/RAP1_IAA_30M_REP1.stats.txt", + "bbsplit/RAP1_UNINDUCED_REP1.stats.txt", + "bbsplit/RAP1_UNINDUCED_REP2.stats.txt", + "bbsplit/WT_REP1.stats.txt", + "bbsplit/WT_REP2.stats.txt", + "custom", + "custom/out", + "custom/out/genome_gfp.fasta", + "custom/out/genome_gfp.gtf", + "fastqc", + "fastqc/raw", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.html", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.zip", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.html", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.zip", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.html", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.zip", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.html", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.zip", + "fastqc/raw/WT_REP1_raw_1_fastqc.html", + "fastqc/raw/WT_REP1_raw_1_fastqc.zip", + "fastqc/raw/WT_REP1_raw_2_fastqc.html", + "fastqc/raw/WT_REP1_raw_2_fastqc.zip", + "fastqc/raw/WT_REP2_raw_1_fastqc.html", + "fastqc/raw/WT_REP2_raw_1_fastqc.zip", + "fastqc/raw/WT_REP2_raw_2_fastqc.html", + "fastqc/raw/WT_REP2_raw_2_fastqc.zip", + "fastqc/trim", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip", + "fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html", + "fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip", + "fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html", + "fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip", + "fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.html", + "fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.html", + "fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.zip", + "fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.html", + "fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.html", + "fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.zip", + "multiqc", + "multiqc/star_salmon", + "multiqc/star_salmon/multiqc_report.html", + "multiqc/star_salmon/multiqc_report_data", + "multiqc/star_salmon/multiqc_report_data/cutadapt_filtered_reads_plot.txt", + "multiqc/star_salmon/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc-status-check-heatmap-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc-status-check-heatmap.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_adapter_content_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_overrepresented_sequences_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_overrepresented_sequences_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_base_n_content_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_base_n_content_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_base_sequence_quality_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_base_sequence_quality_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Percentages.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Percentages.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_quality_scores_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_quality_scores_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_counts_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_counts_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_duplication_levels_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_duplication_levels_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_length_distribution_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_top_overrepresented_sequences_table-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_top_overrepresented_sequences_table.txt", + "multiqc/star_salmon/multiqc_report_data/junction_saturation_known.txt", + "multiqc/star_salmon/multiqc_report_data/junction_saturation_novel.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_citations.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_cutadapt.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_data.json", + "multiqc/star_salmon/multiqc_report_data/multiqc_dupradar-section-plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_fail_mapped_samples_table.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_fail_strand_check_table.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_fastqc_fastqc_raw.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_fastqc_fastqc_trimmed.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_featurecounts_biotype_plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_general_stats.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_picard_dups.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_bam_stat.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_infer_experiment.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_junction_annotation.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_read_distribution.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_1.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_2.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_3.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_4.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_pca-plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_samtools_flagstat.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_samtools_idxstats.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_samtools_stats.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_software_versions.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_sources.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_1.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_2.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_3.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_4.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_pca-plot.txt", + "multiqc/star_salmon/multiqc_report_data/picard_deduplication.txt", + "multiqc/star_salmon/multiqc_report_data/picard_histogram.txt", + "multiqc/star_salmon/multiqc_report_data/picard_histogram_1.txt", + "multiqc/star_salmon/multiqc_report_data/picard_histogram_2.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_gene_coverage_profile_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_gene_coverage_profile_Normalised.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_genomic_origin.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_rnaseq_cov_hist.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_rnaseq_genome_results.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_bam_stat.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_infer_experiment_plot.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance_plot_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance_plot_Percentages.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Events.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Junctions.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_all.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_All_Junctions.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_Known_Junctions.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_Novel_Junctions.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_read_distribution_plot.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_read_dups.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_read_dups_plot.txt", + "multiqc/star_salmon/multiqc_report_data/salmon_plot.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Percentage_of_total.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Read_counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Raw_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-stats-dp.txt", + "multiqc/star_salmon/multiqc_report_data/samtools_alignment_plot.txt", + "multiqc/star_salmon/multiqc_report_data/star_alignment_plot.txt", + "multiqc/star_salmon/multiqc_report_data/star_summary_table.txt", + "multiqc/star_salmon/multiqc_report_plots", + "multiqc/star_salmon/multiqc_report_plots/pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/dupradar-section-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fail_mapped_samples_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fail_strand_check_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc-status-check-heatmap-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc-status-check-heatmap.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_adapter_content_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Percentages.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Percentages.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_length_distribution_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/featurecounts_biotype_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/featurecounts_biotype_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/general_stats_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Normalised.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_genomic_origin-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_genomic_origin-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_bam_stat.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_infer_experiment_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Percentages.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_All_Junctions.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Known_Junctions.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Novel_Junctions.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_distribution_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_distribution_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_dups_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/salmon_deseq2_clustering-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/salmon_deseq2_pca-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/salmon_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Percentage_of_total.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Read_counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-stats-dp.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_salmon_deseq2_clustering-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_salmon_deseq2_pca-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_summary_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/png", + "multiqc/star_salmon/multiqc_report_plots/png/cutadapt_filtered_reads_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/cutadapt_filtered_reads_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Obs_Exp.png", + "multiqc/star_salmon/multiqc_report_plots/png/dupradar-section-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fail_mapped_samples_table.png", + "multiqc/star_salmon/multiqc_report_plots/png/fail_strand_check_table.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc-status-check-heatmap-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc-status-check-heatmap.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_adapter_content_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_n_content_plot-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_n_content_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Percentages.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Percentages.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_length_distribution_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table.png", + "multiqc/star_salmon/multiqc_report_plots/png/featurecounts_biotype_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/featurecounts_biotype_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/general_stats_table.png", + "multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/qualimap_gene_coverage_profile_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/qualimap_gene_coverage_profile_Normalised.png", + "multiqc/star_salmon/multiqc_report_plots/png/qualimap_genomic_origin-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/qualimap_genomic_origin-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_bam_stat.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_infer_experiment_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_inner_distance_plot_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_inner_distance_plot_Percentages.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_All_Junctions.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_Known_Junctions.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_Novel_Junctions.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_distribution_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_distribution_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_dups_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/salmon_deseq2_clustering-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/salmon_deseq2_pca-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/salmon_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Percentage_of_total.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Read_counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-stats-dp.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_salmon_deseq2_clustering-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_salmon_deseq2_pca-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_summary_table.png", + "multiqc/star_salmon/multiqc_report_plots/svg", + "multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/dupradar-section-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fail_mapped_samples_table.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fail_strand_check_table.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc-status-check-heatmap-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc-status-check-heatmap.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_adapter_content_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_n_content_plot-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_n_content_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Percentages.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Percentages.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_length_distribution_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/featurecounts_biotype_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/featurecounts_biotype_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/general_stats_table.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Normalised.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/qualimap_genomic_origin-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/qualimap_genomic_origin-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_bam_stat.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_infer_experiment_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_inner_distance_plot_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_inner_distance_plot_Percentages.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_All_Junctions.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Known_Junctions.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Novel_Junctions.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_distribution_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_distribution_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_dups_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/salmon_deseq2_clustering-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/salmon_deseq2_pca-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/salmon_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Percentage_of_total.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Read_counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-stats-dp.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_salmon_deseq2_clustering-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_salmon_deseq2_pca-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_summary_table.svg", + "pipeline_info", + "pipeline_info/nf_core_rnaseq_software_mqc_versions.yml", + "salmon", + "salmon/RAP1_IAA_30M_REP1", + "salmon/RAP1_IAA_30M_REP1/aux_info", + "salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv", + "salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json", + "salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz", + "salmon/RAP1_IAA_30M_REP1/cmd_info.json", + "salmon/RAP1_IAA_30M_REP1/libParams", + "salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt", + "salmon/RAP1_IAA_30M_REP1/lib_format_counts.json", + "salmon/RAP1_IAA_30M_REP1/logs", + "salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log", + "salmon/RAP1_IAA_30M_REP1/quant.genes.sf", + "salmon/RAP1_IAA_30M_REP1/quant.sf", + "salmon/RAP1_UNINDUCED_REP1", + "salmon/RAP1_UNINDUCED_REP1/aux_info", + "salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv", + "salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json", + "salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz", + "salmon/RAP1_UNINDUCED_REP1/cmd_info.json", + "salmon/RAP1_UNINDUCED_REP1/libParams", + "salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt", + "salmon/RAP1_UNINDUCED_REP1/lib_format_counts.json", + "salmon/RAP1_UNINDUCED_REP1/logs", + "salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log", + "salmon/RAP1_UNINDUCED_REP1/quant.genes.sf", + "salmon/RAP1_UNINDUCED_REP1/quant.sf", + "salmon/RAP1_UNINDUCED_REP2", + "salmon/RAP1_UNINDUCED_REP2/aux_info", + "salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv", + "salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json", + "salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz", + "salmon/RAP1_UNINDUCED_REP2/cmd_info.json", + "salmon/RAP1_UNINDUCED_REP2/libParams", + "salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt", + "salmon/RAP1_UNINDUCED_REP2/lib_format_counts.json", + "salmon/RAP1_UNINDUCED_REP2/logs", + "salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log", + "salmon/RAP1_UNINDUCED_REP2/quant.genes.sf", + "salmon/RAP1_UNINDUCED_REP2/quant.sf", + "salmon/WT_REP1", + "salmon/WT_REP1/aux_info", + "salmon/WT_REP1/aux_info/ambig_info.tsv", + "salmon/WT_REP1/aux_info/expected_bias.gz", + "salmon/WT_REP1/aux_info/fld.gz", + "salmon/WT_REP1/aux_info/meta_info.json", + "salmon/WT_REP1/aux_info/observed_bias.gz", + "salmon/WT_REP1/aux_info/observed_bias_3p.gz", + "salmon/WT_REP1/cmd_info.json", + "salmon/WT_REP1/libParams", + "salmon/WT_REP1/libParams/flenDist.txt", + "salmon/WT_REP1/lib_format_counts.json", + "salmon/WT_REP1/logs", + "salmon/WT_REP1/logs/salmon_quant.log", + "salmon/WT_REP1/quant.genes.sf", + "salmon/WT_REP1/quant.sf", + "salmon/WT_REP2", + "salmon/WT_REP2/aux_info", + "salmon/WT_REP2/aux_info/ambig_info.tsv", + "salmon/WT_REP2/aux_info/expected_bias.gz", + "salmon/WT_REP2/aux_info/fld.gz", + "salmon/WT_REP2/aux_info/meta_info.json", + "salmon/WT_REP2/aux_info/observed_bias.gz", + "salmon/WT_REP2/aux_info/observed_bias_3p.gz", + "salmon/WT_REP2/cmd_info.json", + "salmon/WT_REP2/libParams", + "salmon/WT_REP2/libParams/flenDist.txt", + "salmon/WT_REP2/lib_format_counts.json", + "salmon/WT_REP2/logs", + "salmon/WT_REP2/logs/salmon_quant.log", + "salmon/WT_REP2/quant.genes.sf", + "salmon/WT_REP2/quant.sf", + "salmon/deseq2_qc", + "salmon/deseq2_qc/R_sessionInfo.log", + "salmon/deseq2_qc/deseq2.dds.RData", + "salmon/deseq2_qc/deseq2.pca.vals.txt", + "salmon/deseq2_qc/deseq2.plots.pdf", + "salmon/deseq2_qc/deseq2.sample.dists.txt", + "salmon/deseq2_qc/size_factors", + "salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt", + "salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt", + "salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt", + "salmon/deseq2_qc/size_factors/WT_REP1.txt", + "salmon/deseq2_qc/size_factors/WT_REP2.txt", + "salmon/deseq2_qc/size_factors/deseq2.size_factors.RData", + "salmon/salmon.merged.gene_counts.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts.tsv", + "salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts_length_scaled.tsv", + "salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts_scaled.tsv", + "salmon/salmon.merged.gene_lengths.tsv", + "salmon/salmon.merged.gene_tpm.tsv", + "salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds", + "salmon/salmon.merged.transcript_counts.tsv", + "salmon/salmon.merged.transcript_lengths.tsv", + "salmon/salmon.merged.transcript_tpm.tsv", + "salmon/tx2gene.tsv", + "star_salmon", + "star_salmon/RAP1_IAA_30M_REP1", + "star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam", + "star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam.bai", + "star_salmon/RAP1_IAA_30M_REP1/aux_info", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz", + "star_salmon/RAP1_IAA_30M_REP1/cmd_info.json", + "star_salmon/RAP1_IAA_30M_REP1/libParams", + "star_salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt", + "star_salmon/RAP1_IAA_30M_REP1/logs", + "star_salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log", + "star_salmon/RAP1_IAA_30M_REP1/quant.genes.sf", + "star_salmon/RAP1_IAA_30M_REP1/quant.sf", + "star_salmon/RAP1_UNINDUCED_REP1", + "star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam", + "star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz", + "star_salmon/RAP1_UNINDUCED_REP1/cmd_info.json", + "star_salmon/RAP1_UNINDUCED_REP1/libParams", + "star_salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt", + "star_salmon/RAP1_UNINDUCED_REP1/logs", + "star_salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log", + "star_salmon/RAP1_UNINDUCED_REP1/quant.genes.sf", + "star_salmon/RAP1_UNINDUCED_REP1/quant.sf", + "star_salmon/RAP1_UNINDUCED_REP2", + "star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam", + "star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz", + "star_salmon/RAP1_UNINDUCED_REP2/cmd_info.json", + "star_salmon/RAP1_UNINDUCED_REP2/libParams", + "star_salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt", + "star_salmon/RAP1_UNINDUCED_REP2/logs", + "star_salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log", + "star_salmon/RAP1_UNINDUCED_REP2/quant.genes.sf", + "star_salmon/RAP1_UNINDUCED_REP2/quant.sf", + "star_salmon/WT_REP1", + "star_salmon/WT_REP1/aux_info", + "star_salmon/WT_REP1/aux_info/ambig_info.tsv", + "star_salmon/WT_REP1/aux_info/expected_bias.gz", + "star_salmon/WT_REP1/aux_info/fld.gz", + "star_salmon/WT_REP1/aux_info/meta_info.json", + "star_salmon/WT_REP1/aux_info/observed_bias.gz", + "star_salmon/WT_REP1/aux_info/observed_bias_3p.gz", + "star_salmon/WT_REP1/cmd_info.json", + "star_salmon/WT_REP1/libParams", + "star_salmon/WT_REP1/libParams/flenDist.txt", + "star_salmon/WT_REP1/logs", + "star_salmon/WT_REP1/logs/salmon_quant.log", + "star_salmon/WT_REP1/quant.genes.sf", + "star_salmon/WT_REP1/quant.sf", + "star_salmon/WT_REP2", + "star_salmon/WT_REP2/aux_info", + "star_salmon/WT_REP2/aux_info/ambig_info.tsv", + "star_salmon/WT_REP2/aux_info/expected_bias.gz", + "star_salmon/WT_REP2/aux_info/fld.gz", + "star_salmon/WT_REP2/aux_info/meta_info.json", + "star_salmon/WT_REP2/aux_info/observed_bias.gz", + "star_salmon/WT_REP2/aux_info/observed_bias_3p.gz", + "star_salmon/WT_REP2/cmd_info.json", + "star_salmon/WT_REP2/libParams", + "star_salmon/WT_REP2/libParams/flenDist.txt", + "star_salmon/WT_REP2/logs", + "star_salmon/WT_REP2/logs/salmon_quant.log", + "star_salmon/WT_REP2/quant.genes.sf", + "star_salmon/WT_REP2/quant.sf", + "star_salmon/bigwig", + "star_salmon/bigwig/RAP1_IAA_30M_REP1.forward.bigWig", + "star_salmon/bigwig/RAP1_IAA_30M_REP1.reverse.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP1.forward.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP1.reverse.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP2.forward.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP2.reverse.bigWig", + "star_salmon/deseq2_qc", + "star_salmon/deseq2_qc/R_sessionInfo.log", + "star_salmon/deseq2_qc/deseq2.dds.RData", + "star_salmon/deseq2_qc/deseq2.pca.vals.txt", + "star_salmon/deseq2_qc/deseq2.plots.pdf", + "star_salmon/deseq2_qc/deseq2.sample.dists.txt", + "star_salmon/deseq2_qc/size_factors", + "star_salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt", + "star_salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt", + "star_salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt", + "star_salmon/deseq2_qc/size_factors/WT_REP1.txt", + "star_salmon/deseq2_qc/size_factors/WT_REP2.txt", + "star_salmon/deseq2_qc/size_factors/deseq2.size_factors.RData", + "star_salmon/dupradar", + "star_salmon/dupradar/box_plot", + "star_salmon/dupradar/box_plot/RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf", + "star_salmon/dupradar/box_plot/RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf", + "star_salmon/dupradar/box_plot/RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf", + "star_salmon/dupradar/gene_data", + "star_salmon/dupradar/gene_data/RAP1_IAA_30M_REP1_dupMatrix.txt", + "star_salmon/dupradar/gene_data/RAP1_UNINDUCED_REP1_dupMatrix.txt", + "star_salmon/dupradar/gene_data/RAP1_UNINDUCED_REP2_dupMatrix.txt", + "star_salmon/dupradar/histogram", + "star_salmon/dupradar/histogram/RAP1_IAA_30M_REP1_expressionHist.pdf", + "star_salmon/dupradar/histogram/RAP1_UNINDUCED_REP1_expressionHist.pdf", + "star_salmon/dupradar/histogram/RAP1_UNINDUCED_REP2_expressionHist.pdf", + "star_salmon/dupradar/intercepts_slope", + "star_salmon/dupradar/intercepts_slope/RAP1_IAA_30M_REP1_intercept_slope.txt", + "star_salmon/dupradar/intercepts_slope/RAP1_UNINDUCED_REP1_intercept_slope.txt", + "star_salmon/dupradar/intercepts_slope/RAP1_UNINDUCED_REP2_intercept_slope.txt", + "star_salmon/dupradar/scatter_plot", + "star_salmon/dupradar/scatter_plot/RAP1_IAA_30M_REP1_duprateExpDens.pdf", + "star_salmon/dupradar/scatter_plot/RAP1_UNINDUCED_REP1_duprateExpDens.pdf", + "star_salmon/dupradar/scatter_plot/RAP1_UNINDUCED_REP2_duprateExpDens.pdf", + "star_salmon/featurecounts", + "star_salmon/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv", + "star_salmon/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv", + "star_salmon/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt", + "star_salmon/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt.summary", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt.summary", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt.summary", + "star_salmon/log", + "star_salmon/log/RAP1_IAA_30M_REP1.Log.final.out", + "star_salmon/log/RAP1_IAA_30M_REP1.Log.out", + "star_salmon/log/RAP1_IAA_30M_REP1.Log.progress.out", + "star_salmon/log/RAP1_IAA_30M_REP1.SJ.out.tab", + "star_salmon/log/RAP1_UNINDUCED_REP1.Log.final.out", + "star_salmon/log/RAP1_UNINDUCED_REP1.Log.out", + "star_salmon/log/RAP1_UNINDUCED_REP1.Log.progress.out", + "star_salmon/log/RAP1_UNINDUCED_REP1.SJ.out.tab", + "star_salmon/log/RAP1_UNINDUCED_REP2.Log.final.out", + "star_salmon/log/RAP1_UNINDUCED_REP2.Log.out", + "star_salmon/log/RAP1_UNINDUCED_REP2.Log.progress.out", + "star_salmon/log/RAP1_UNINDUCED_REP2.SJ.out.tab", + "star_salmon/log/WT_REP1.Log.final.out", + "star_salmon/log/WT_REP1.Log.out", + "star_salmon/log/WT_REP1.Log.progress.out", + "star_salmon/log/WT_REP1.SJ.out.tab", + "star_salmon/log/WT_REP2.Log.final.out", + "star_salmon/log/WT_REP2.Log.out", + "star_salmon/log/WT_REP2.Log.progress.out", + "star_salmon/log/WT_REP2.SJ.out.tab", + "star_salmon/picard_metrics", + "star_salmon/picard_metrics/RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/qualimap", + "star_salmon/qualimap/RAP1_IAA_30M_REP1", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/agogo.css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/ajax-loader.gif", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/basic.css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/bgfooter.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/bgtop.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/comment-bright.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/comment-close.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/comment.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/doctools.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/down-pressed.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/down.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/file.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/jquery.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/minus.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/plus.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/pygments.css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/qualimap_logo_small.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/report.css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/searchtools.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/underscore.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/up-pressed.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/up.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/websupport.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/qualimapReport.html", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/rnaseq_qc_results.txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/agogo.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/ajax-loader.gif", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/basic.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/bgfooter.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/bgtop.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/comment-bright.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/comment-close.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/comment.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/doctools.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/down-pressed.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/down.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/file.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/jquery.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/minus.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/plus.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/pygments.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/qualimap_logo_small.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/report.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/searchtools.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/underscore.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/up-pressed.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/up.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/websupport.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/qualimapReport.html", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/rnaseq_qc_results.txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/agogo.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/ajax-loader.gif", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/basic.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/bgfooter.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/bgtop.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/comment-bright.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/comment-close.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/comment.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/doctools.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/down-pressed.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/down.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/file.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/jquery.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/minus.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/plus.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/pygments.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/qualimap_logo_small.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/report.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/searchtools.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/underscore.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/up-pressed.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/up.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/websupport.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/qualimapReport.html", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/rnaseq_qc_results.txt", + "star_salmon/rseqc", + "star_salmon/rseqc/bam_stat", + "star_salmon/rseqc/bam_stat/RAP1_IAA_30M_REP1.bam_stat.txt", + "star_salmon/rseqc/bam_stat/RAP1_UNINDUCED_REP1.bam_stat.txt", + "star_salmon/rseqc/bam_stat/RAP1_UNINDUCED_REP2.bam_stat.txt", + "star_salmon/rseqc/infer_experiment", + "star_salmon/rseqc/infer_experiment/RAP1_IAA_30M_REP1.infer_experiment.txt", + "star_salmon/rseqc/infer_experiment/RAP1_UNINDUCED_REP1.infer_experiment.txt", + "star_salmon/rseqc/infer_experiment/RAP1_UNINDUCED_REP2.infer_experiment.txt", + "star_salmon/rseqc/inner_distance", + "star_salmon/rseqc/inner_distance/pdf", + "star_salmon/rseqc/inner_distance/pdf/RAP1_IAA_30M_REP1.inner_distance_plot.pdf", + "star_salmon/rseqc/inner_distance/rscript", + "star_salmon/rseqc/inner_distance/rscript/RAP1_IAA_30M_REP1.inner_distance_plot.r", + "star_salmon/rseqc/inner_distance/txt", + "star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance.txt", + "star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_freq.txt", + "star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_mean.txt", + "star_salmon/rseqc/junction_annotation", + "star_salmon/rseqc/junction_annotation/bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.bed", + "star_salmon/rseqc/junction_annotation/log", + "star_salmon/rseqc/junction_annotation/log/RAP1_IAA_30M_REP1.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP1.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP2.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/rscript", + "star_salmon/rseqc/junction_annotation/rscript/RAP1_IAA_30M_REP1.junction_plot.r", + "star_salmon/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP1.junction_plot.r", + "star_salmon/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP2.junction_plot.r", + "star_salmon/rseqc/junction_annotation/xls", + "star_salmon/rseqc/junction_annotation/xls/RAP1_IAA_30M_REP1.junction.xls", + "star_salmon/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP1.junction.xls", + "star_salmon/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP2.junction.xls", + "star_salmon/rseqc/junction_saturation", + "star_salmon/rseqc/junction_saturation/pdf", + "star_salmon/rseqc/junction_saturation/pdf/RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/rscript", + "star_salmon/rseqc/junction_saturation/rscript/RAP1_IAA_30M_REP1.junctionSaturation_plot.r", + "star_salmon/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP1.junctionSaturation_plot.r", + "star_salmon/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP2.junctionSaturation_plot.r", + "star_salmon/rseqc/read_distribution", + "star_salmon/rseqc/read_distribution/RAP1_IAA_30M_REP1.read_distribution.txt", + "star_salmon/rseqc/read_distribution/RAP1_UNINDUCED_REP1.read_distribution.txt", + "star_salmon/rseqc/read_distribution/RAP1_UNINDUCED_REP2.read_distribution.txt", + "star_salmon/rseqc/read_duplication", + "star_salmon/rseqc/read_duplication/pdf", + "star_salmon/rseqc/read_duplication/pdf/RAP1_IAA_30M_REP1.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP1.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP2.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/rscript", + "star_salmon/rseqc/read_duplication/rscript/RAP1_IAA_30M_REP1.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP1.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP2.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.seq.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.seq.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.seq.DupRate.xls", + "star_salmon/salmon.merged.gene_counts.SummarizedExperiment.rds", + "star_salmon/salmon.merged.gene_counts.tsv", + "star_salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", + "star_salmon/salmon.merged.gene_counts_length_scaled.tsv", + "star_salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", + "star_salmon/salmon.merged.gene_counts_scaled.tsv", + "star_salmon/salmon.merged.gene_lengths.tsv", + "star_salmon/salmon.merged.gene_tpm.tsv", + "star_salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds", + "star_salmon/salmon.merged.transcript_counts.tsv", + "star_salmon/salmon.merged.transcript_lengths.tsv", + "star_salmon/salmon.merged.transcript_tpm.tsv", + "star_salmon/samtools_stats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP1.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP1.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP1.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP2.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP2.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP2.sorted.bam.stats", + "star_salmon/stringtie", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e2t.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e_data.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i2t.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i_data.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/t_data.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.coverage.gtf", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.gene.abundance.txt", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.transcripts.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/t_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.coverage.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.gene.abundance.txt", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.transcripts.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/t_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.coverage.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.gene.abundance.txt", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.transcripts.gtf", + "star_salmon/tx2gene.tsv", + "trimgalore", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" + ], + [ + "genome_gfp.fasta:md5,e23e302af63736a199985a169fdac055", + "genome_gfp.gtf:md5,c98b12c302f15731bfc36bcf297cfe28", + "cutadapt_filtered_reads_plot.txt:md5,bf033e64e9d23bee85b6277f11c663f1", + "cutadapt_trimmed_sequences_plot_3_Counts.txt:md5,13dfa866fd91dbb072689efe9aa83b1f", + "cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt:md5,07145dd8dd3db654859b18eb0389046c", + "fastqc-status-check-heatmap-1.txt:md5,22a03548736b88b23be6bc0c9ef1b4a6", + "fastqc-status-check-heatmap.txt:md5,5a89b0d8d162f6b1dbdaf39457bbc03b", + "fastqc_adapter_content_plot.txt:md5,da0389be84cfdd189b1d045212eb2974", + "fastqc_overrepresented_sequences_plot-1.txt:md5,4adfeacd3a3a6c7c808f121b24e6b247", + "fastqc_overrepresented_sequences_plot.txt:md5,25d88ea8a72f55e8a374ae802bc7f0b1", + "fastqc_per_base_n_content_plot-1.txt:md5,418610c1ce119cb786ad434db75d366e", + "fastqc_per_base_n_content_plot.txt:md5,d368d7e36ca2f73dcde61f2b486d8213", + "fastqc_per_base_sequence_quality_plot-1.txt:md5,bd22e06e41c096ad4f745d40fe96a1e5", + "fastqc_per_base_sequence_quality_plot.txt:md5,5c3065b549129702b185ea1b817da420", + "fastqc_per_sequence_gc_content_plot-1_Counts.txt:md5,004c60768ceb6197765154e3eaa37b7a", + "fastqc_per_sequence_gc_content_plot-1_Percentages.txt:md5,95d29060b687f745288ad1ec47750037", + "fastqc_per_sequence_gc_content_plot_Counts.txt:md5,9ddaa50167117d3c9188ccf015427704", + "fastqc_per_sequence_gc_content_plot_Percentages.txt:md5,f10ee2881b61308af35f304aa3d810a3", + "fastqc_per_sequence_quality_scores_plot-1.txt:md5,0f9834cc19f76dd5c87cf8cba7435a7c", + "fastqc_per_sequence_quality_scores_plot.txt:md5,b5f9a02933e3065952237afd2ec9ce82", + "fastqc_sequence_counts_plot-1.txt:md5,3861354bbedfbde7ca36a72994f9425c", + "fastqc_sequence_counts_plot.txt:md5,d385a3e2c2573a0902c66e8c93876d3c", + "fastqc_sequence_duplication_levels_plot-1.txt:md5,c73407d55fc532e864fa1dc8dbc12874", + "fastqc_sequence_duplication_levels_plot.txt:md5,8812cee16f6ca65e2c33635754de1772", + "fastqc_sequence_length_distribution_plot.txt:md5,6fe2c985606abad947bcca99b015ae33", + "multiqc_citations.txt:md5,2d2ab6df367e36e98e081c33dec187a0", + "multiqc_cutadapt.txt:md5,aac9581a5670cb55edf564f3d6c1f9a7", + "multiqc_fail_mapped_samples_table.txt:md5,5dd9b06f326b1a55d78878343af89927", + "multiqc_fastqc_fastqc_raw.txt:md5,81c3c1a2575a1891a7f2a9637a0f2cc0", + "multiqc_fastqc_fastqc_trimmed.txt:md5,a3238f515e01d158d875d69968753804", + "multiqc_featurecounts_biotype_plot.txt:md5,f3c566d2eaf6bf2ffe5ad12036ce3500", + "multiqc_samtools_idxstats.txt:md5,fd7d03a91f0b9e01a6939941f7f2243f", + "picard_histogram.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "picard_histogram_1.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "picard_histogram_2.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "qualimap_gene_coverage_profile_Counts.txt:md5,6d377444d29c3d4135980982ab1df2fb", + "qualimap_gene_coverage_profile_Normalised.txt:md5,dc8b4f9fddc08e06668f9ee87faac008", + "qualimap_rnaseq_cov_hist.txt:md5,a409821701f60811027daef4e7f3ebee", + "rseqc_infer_experiment_plot.txt:md5,749a802379ada3ec9d2083ecbe6aef7e", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt:md5,75acd04232d1804b5f960ee4c5db4722", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt:md5,ae45731d8d4595f77e6b271004f3a070", + "samtools-idxstats-mapped-reads-plot_Raw_Counts.txt:md5,01637c600d3840500851eb4118564cc6", + "cutadapt_filtered_reads_plot-cnt.png:md5,704cf0d91bfa3dd658dd8c9590f669a2", + "cutadapt_filtered_reads_plot-pct.png:md5,2684d8b2afca3300e5786486b80237f0", + "cutadapt_trimmed_sequences_plot_3_Counts.png:md5,bef41d894629b0c4dab4478bbf197f50", + "cutadapt_trimmed_sequences_plot_3_Obs_Exp.png:md5,1e0d01537d3797623d0b3fd8fbe42787", + "dupradar-section-plot.png:md5,eacbc664cc29a7a59a6aa366b4618582", + "fastqc-status-check-heatmap-1.png:md5,2402522f8c02e12aea9af088c6595890", + "fastqc-status-check-heatmap.png:md5,fe8b5b4ab4480d46a12a9005932a9b84", + "fastqc_overrepresented_sequences_plot-1.png:md5,40e450251b80ec0efc9364434234ec7f", + "fastqc_overrepresented_sequences_plot.png:md5,6f5ffbdf1bf61fabe5e028c8bc85de14", + "fastqc_per_sequence_gc_content_plot-1_Counts.png:md5,8a806cec2142f9911502e0a253d83d13", + "fastqc_per_sequence_gc_content_plot-1_Percentages.png:md5,953929d50c8490029880e205e4db7959", + "fastqc_per_sequence_gc_content_plot_Counts.png:md5,01f124545af788fd5cc7bbf41b005e16", + "fastqc_per_sequence_gc_content_plot_Percentages.png:md5,eba3abf8bedb2cb20bad90c54e9c8881", + "fastqc_per_sequence_quality_scores_plot-1.png:md5,d2c29cae169f35744500c751b4a7366e", + "fastqc_per_sequence_quality_scores_plot.png:md5,42fd7369a8aca78f620164a9e887c3cb", + "fastqc_sequence_counts_plot-1-cnt.png:md5,2874fea747c7ff46828bf4f17668caf8", + "fastqc_sequence_counts_plot-1-pct.png:md5,0022d7f5ac78b6eff157de24e37c5ab0", + "fastqc_sequence_counts_plot-cnt.png:md5,3890d5555f2a39b46b9f6efb14cb91f2", + "fastqc_sequence_counts_plot-pct.png:md5,55fa5838c8b2db978fcfa5cb83f6b054", + "fastqc_sequence_duplication_levels_plot-1.png:md5,fcd3b1ec2b95fe4bcd607dc28179a754", + "fastqc_sequence_duplication_levels_plot.png:md5,747431f0f38f8e4c41a11a072fa18780", + "featurecounts_biotype_plot-cnt.png:md5,95b10627fff1af0a209b8e380f4a4d0b", + "featurecounts_biotype_plot-pct.png:md5,f9c1cf03824ff9ba7da8537ecd93945b", + "qualimap_gene_coverage_profile_Counts.png:md5,2d54a60bef3dfa978da48c1b6872c41c", + "qualimap_gene_coverage_profile_Normalised.png:md5,a85a901be4c08c9dfcfd9fc87d890c1e", + "rseqc_infer_experiment_plot.png:md5,5ce01a7b923f4e6433b76dd88ca22f42", + "rseqc_read_dups_plot.png:md5,bdc7281c52b54a5784aa0d714f9c255e", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png:md5,ce6abb232fd5b5f2e66c0fe9a571d75f", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png:md5,6b44818f886ef020fb3646f152ad4af6", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png:md5,d5d8a85b7ad72a0cb93d9283ea12b23f", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png:md5,19317ad8f1448cd7eb1d319f85cc5c4d", + "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png:md5,a6849cd92ae738441212b681a411614d", + "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png:md5,4c06988372df63a1fb5f8be93f73ae8f", + "ambig_info.tsv:md5,de973a4b22a4457217ae3dc04caf9401", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,1215f0c20f87d3aef8553ef119e1e74c", + "lib_format_counts.json:md5,c24ffe28d70476b5ccdd8bc2d22c0ac1", + "ambig_info.tsv:md5,45f252b4f0e11e6730cf0c29f800fdbb", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,621c6601aade5b1f2e3d6ca2fc71f636", + "lib_format_counts.json:md5,f6d44c0221f7fd559f11a9afe04c9935", + "ambig_info.tsv:md5,6dcc2891ea572e9b8d1ba52cd434ab84", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,9bed6e4dc5428d6f6297adcea29a6326", + "lib_format_counts.json:md5,7c562bf2f70e42f3a7292687dfd328c3", + "ambig_info.tsv:md5,194f574e0586416155e3f33d42e2b167", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,c7ed0aaa5d6c7934ddbebfd29e4eb86d", + "lib_format_counts.json:md5,d46250bb3677d72feeefc435fe6395a6", + "ambig_info.tsv:md5,a26e3f936e65d7da66392603c2f91f6f", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,69ebfc2c7ca6b221a0a22fa1dc8c20ac", + "lib_format_counts.json:md5,088fd51db07022ffde47033bbd029400", + "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", + "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", + "ambig_info.tsv:md5,f9a605d54a0a103566f7a9b8e0867a73", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,4cc2492f557e5e0a2911a0bd83a51020", + "ambig_info.tsv:md5,8f97be8af4e47cc48650c62227a40203", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,dc750c3564c63da54979c852794d58a5", + "ambig_info.tsv:md5,a044fe7a3ad445c9a91a0d54ab5015d1", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,db43ed650e6e7b42cd2c5b8101bb6748", + "ambig_info.tsv:md5,7a8ea02d74058efb801e8c62bca96fd4", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,e418b4e899623449c6babdf53e5aabde", + "ambig_info.tsv:md5,543a047a549437026a1363ea8ddf5b03", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,f234c8d322df3b59d990594c63b24eae", + "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", + "RAP1_IAA_30M_REP1_dupMatrix.txt:md5,2e0d518a450bb57801cdd075d4e9c217", + "RAP1_UNINDUCED_REP1_dupMatrix.txt:md5,96e2f9e1fc5a22a7d468e6fb4a613370", + "RAP1_UNINDUCED_REP2_dupMatrix.txt:md5,28c30ce734d78d53b1c47c3f87414e4b", + "RAP1_IAA_30M_REP1_intercept_slope.txt:md5,c677048855caf5190f29fa5f7137cd79", + "RAP1_UNINDUCED_REP1_intercept_slope.txt:md5,ea1b4323d3bc83759e8a026416bca32b", + "RAP1_UNINDUCED_REP2_intercept_slope.txt:md5,b062f49a5223a3452075062cdd308043", + "RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv:md5,f3688a214d33a43ad79abe4b31df0c4b", + "RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv:md5,dde2de0cb90e10d0195c726f768e9941", + "RAP1_IAA_30M_REP1.featureCounts.txt:md5,b38da3230d4d29ebc8d4af36852d7212", + "RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv:md5,d241d50e582ceb97e6f16b3556f5f5a9", + "RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv:md5,845ff9059c72bc6722a8de69776e22bb", + "RAP1_UNINDUCED_REP1.featureCounts.txt:md5,2ab175746532de1c54020c1eabc27bb5", + "RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv:md5,b621ce1e803d8670ece6c66391c33ba4", + "RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv:md5,6d3fa4c88c7fe61f638e4624ad5e22f0", + "RAP1_UNINDUCED_REP2.featureCounts.txt:md5,480b2586a878bc22f5b73f94051b41d8", + "RAP1_IAA_30M_REP1.SJ.out.tab:md5,ea95e243278af55534f2c52eb5fff7ee", + "RAP1_UNINDUCED_REP1.SJ.out.tab:md5,e548d13942535dc0821f3ec6d9743ec8", + "RAP1_UNINDUCED_REP2.SJ.out.tab:md5,1f294365343a1a5e95682792fdb77033", + "WT_REP1.SJ.out.tab:md5,1350c2fa6a675bf107386c6cd3fc5204", + "WT_REP2.SJ.out.tab:md5,f6cc03643a5e3c1025a5b4754eb1be23", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,876c1b88f33bd3e5fe1a41679729573d", + "Coverage Profile Along Genes (Low).png:md5,ee1f2c9cc4dd4867811eda1e68864ab4", + "Coverage Profile Along Genes (Total).png:md5,53747a8f9813744902756ad60638380a", + "Transcript coverage histogram.png:md5,4f9072d4b11216373b59396293803a37", + "coverage_profile_along_genes_(high).txt:md5,fcb06d460810c0555de5396b9dae05e8", + "coverage_profile_along_genes_(low).txt:md5,e3c9a1ddfdb89f8534ff7548b70fce32", + "coverage_profile_along_genes_(total).txt:md5,e3c9a1ddfdb89f8534ff7548b70fce32", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,bbf0531018e7fccfc1dfdd1c05715518", + "Coverage Profile Along Genes (Low).png:md5,3c147d9c831d4be98615a22a72fad05d", + "Coverage Profile Along Genes (Total).png:md5,5a8a6db3a8d19a2dcb8f715b11e67c50", + "Transcript coverage histogram.png:md5,488440d7b6d73bcd4567316712e281fe", + "coverage_profile_along_genes_(high).txt:md5,9f1e29a4d6eec52e8796b080daaedca3", + "coverage_profile_along_genes_(low).txt:md5,353f42a84ff34167646fc83909eac2ff", + "coverage_profile_along_genes_(total).txt:md5,353f42a84ff34167646fc83909eac2ff", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,5a5d99cc7a1dba3762d67f4aa4adad58", + "Coverage Profile Along Genes (Low).png:md5,b6adc296e9a732aa0495a6da8fa4ed90", + "Coverage Profile Along Genes (Total).png:md5,fcb94fb9c1a51c1db32f884d05929cc8", + "Transcript coverage histogram.png:md5,3aeb52ff3e3752727a370b0d7ceb0518", + "coverage_profile_along_genes_(high).txt:md5,3b20a736708df02ea8c86dc5829ae67e", + "coverage_profile_along_genes_(low).txt:md5,02b314b76ef1317f20e129412340755d", + "coverage_profile_along_genes_(total).txt:md5,02b314b76ef1317f20e129412340755d", + "RAP1_IAA_30M_REP1.infer_experiment.txt:md5,169d25b95c008bebe9ce886fea6a4e33", + "RAP1_UNINDUCED_REP1.infer_experiment.txt:md5,2ca0ce0fd3204bd2cc4812c4655b1f1f", + "RAP1_UNINDUCED_REP2.infer_experiment.txt:md5,7d5705880188f9beab1939e08d6b8f40", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,3f149502efe2a9d4bac98b1dd18c15e7", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,a052ab04070e72cc318fb7680b0764e3", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,e82329a443b9ff50a86e42aff91bd704", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,d279003d92f7feef9adb31203f84474a", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,10e2d00f93f9e74f224bd3c1bfbeb29b", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,525413b70bcf62c24c8f96182e09883e", + "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe" + ] ], "meta": { "nf-test": "0.9.0", "nextflow": "24.04.4" }, - "timestamp": "2024-08-23T16:36:12.254374" - }, - "star_salmon/salmon_quant": { - "content": [ - "ambig_info.tsv:md5,f9a605d54a0a103566f7a9b8e0867a73", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,4cc2492f557e5e0a2911a0bd83a51020", - "ambig_info.tsv:md5,8f97be8af4e47cc48650c62227a40203", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,dc750c3564c63da54979c852794d58a5", - "ambig_info.tsv:md5,a044fe7a3ad445c9a91a0d54ab5015d1", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,db43ed650e6e7b42cd2c5b8101bb6748", - "ambig_info.tsv:md5,7a8ea02d74058efb801e8c62bca96fd4", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,e418b4e899623449c6babdf53e5aabde", - "ambig_info.tsv:md5,543a047a549437026a1363ea8ddf5b03", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,f234c8d322df3b59d990594c63b24eae", - "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T16:36:12.647521" - }, - "trimgalore": { - "content": [ - "RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T16:36:12.719201" - }, - "star_salmon/rseqc": { - "content": [ - "RAP1_IAA_30M_REP1.infer_experiment.txt:md5,169d25b95c008bebe9ce886fea6a4e33", - "RAP1_UNINDUCED_REP1.infer_experiment.txt:md5,2ca0ce0fd3204bd2cc4812c4655b1f1f", - "RAP1_UNINDUCED_REP2.infer_experiment.txt:md5,7d5705880188f9beab1939e08d6b8f40", - "RAP1_IAA_30M_REP1.bam_stat.txt", - "RAP1_UNINDUCED_REP1.bam_stat.txt", - "RAP1_UNINDUCED_REP2.bam_stat.txt", - "RAP1_IAA_30M_REP1.inner_distance_plot.pdf", - "RAP1_IAA_30M_REP1.inner_distance_plot.r", - "RAP1_IAA_30M_REP1.inner_distance.txt", - "RAP1_IAA_30M_REP1.inner_distance_freq.txt", - "RAP1_IAA_30M_REP1.inner_distance_mean.txt", - "RAP1_IAA_30M_REP1.junction.Interact.bed", - "RAP1_IAA_30M_REP1.junction.bed", - "RAP1_UNINDUCED_REP1.junction.Interact.bed", - "RAP1_UNINDUCED_REP1.junction.bed", - "RAP1_UNINDUCED_REP2.junction.Interact.bed", - "RAP1_UNINDUCED_REP2.junction.bed", - "RAP1_IAA_30M_REP1.junction_annotation.log", - "RAP1_UNINDUCED_REP1.junction_annotation.log", - "RAP1_UNINDUCED_REP2.junction_annotation.log", - "RAP1_IAA_30M_REP1.splice_events.pdf", - "RAP1_IAA_30M_REP1.splice_junction.pdf", - "RAP1_UNINDUCED_REP1.splice_events.pdf", - "RAP1_UNINDUCED_REP1.splice_junction.pdf", - "RAP1_UNINDUCED_REP2.splice_events.pdf", - "RAP1_UNINDUCED_REP2.splice_junction.pdf", - "RAP1_IAA_30M_REP1.junction_plot.r", - "RAP1_UNINDUCED_REP1.junction_plot.r", - "RAP1_UNINDUCED_REP2.junction_plot.r", - "RAP1_IAA_30M_REP1.junction.xls", - "RAP1_UNINDUCED_REP1.junction.xls", - "RAP1_UNINDUCED_REP2.junction.xls", - "RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf", - "RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf", - "RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf", - "RAP1_IAA_30M_REP1.junctionSaturation_plot.r", - "RAP1_UNINDUCED_REP1.junctionSaturation_plot.r", - "RAP1_UNINDUCED_REP2.junctionSaturation_plot.r", - "RAP1_IAA_30M_REP1.read_distribution.txt", - "RAP1_UNINDUCED_REP1.read_distribution.txt", - "RAP1_UNINDUCED_REP2.read_distribution.txt", - "RAP1_IAA_30M_REP1.DupRate_plot.pdf", - "RAP1_UNINDUCED_REP1.DupRate_plot.pdf", - "RAP1_UNINDUCED_REP2.DupRate_plot.pdf", - "RAP1_IAA_30M_REP1.DupRate_plot.r", - "RAP1_UNINDUCED_REP1.DupRate_plot.r", - "RAP1_UNINDUCED_REP2.DupRate_plot.r", - "RAP1_IAA_30M_REP1.pos.DupRate.xls", - "RAP1_IAA_30M_REP1.seq.DupRate.xls", - "RAP1_UNINDUCED_REP1.pos.DupRate.xls", - "RAP1_UNINDUCED_REP1.seq.DupRate.xls", - "RAP1_UNINDUCED_REP2.pos.DupRate.xls", - "RAP1_UNINDUCED_REP2.seq.DupRate.xls" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T13:06:37.124481" - }, - "references": { - "content": [ - "genome_gfp.fasta:md5,e23e302af63736a199985a169fdac055", - "genome_gfp.gtf:md5,c98b12c302f15731bfc36bcf297cfe28" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T16:04:54.733969" - }, - "star_salmon/samtools_stats": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.stats", - "RAP1_IAA_30M_REP1.sorted.bam.flagstat", - "RAP1_IAA_30M_REP1.sorted.bam.idxstats", - "RAP1_IAA_30M_REP1.sorted.bam.stats", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats", - "RAP1_UNINDUCED_REP1.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP1.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP1.sorted.bam.stats", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats", - "RAP1_UNINDUCED_REP2.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP2.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP2.sorted.bam.stats", - "WT_REP1.sorted.bam.flagstat", - "WT_REP1.sorted.bam.idxstats", - "WT_REP1.sorted.bam.stats", - "WT_REP2.sorted.bam.flagstat", - "WT_REP2.sorted.bam.idxstats", - "WT_REP2.sorted.bam.stats" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T19:09:21.84327" - }, - "multiqc_plots": { - "content": [ - "cutadapt_filtered_reads_plot-cnt.png:md5,704cf0d91bfa3dd658dd8c9590f669a2", - "cutadapt_filtered_reads_plot-pct.png:md5,2684d8b2afca3300e5786486b80237f0", - "cutadapt_trimmed_sequences_plot_3_Counts.png:md5,bef41d894629b0c4dab4478bbf197f50", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.png:md5,1e0d01537d3797623d0b3fd8fbe42787", - "dupradar-section-plot.png:md5,eacbc664cc29a7a59a6aa366b4618582", - "fail_mapped_samples_table.png:md5,e0702273ab75b55895e566cb2945d893", - "fastqc-status-check-heatmap-1.png:md5,2402522f8c02e12aea9af088c6595890", - "fastqc-status-check-heatmap.png:md5,fe8b5b4ab4480d46a12a9005932a9b84", - "fastqc_overrepresented_sequences_plot-1.png:md5,40e450251b80ec0efc9364434234ec7f", - "fastqc_overrepresented_sequences_plot.png:md5,6f5ffbdf1bf61fabe5e028c8bc85de14", - "fastqc_per_sequence_gc_content_plot-1_Counts.png:md5,8a806cec2142f9911502e0a253d83d13", - "fastqc_per_sequence_gc_content_plot-1_Percentages.png:md5,953929d50c8490029880e205e4db7959", - "fastqc_per_sequence_gc_content_plot_Counts.png:md5,01f124545af788fd5cc7bbf41b005e16", - "fastqc_per_sequence_gc_content_plot_Percentages.png:md5,eba3abf8bedb2cb20bad90c54e9c8881", - "fastqc_per_sequence_quality_scores_plot-1.png:md5,d2c29cae169f35744500c751b4a7366e", - "fastqc_per_sequence_quality_scores_plot.png:md5,42fd7369a8aca78f620164a9e887c3cb", - "fastqc_sequence_counts_plot-1-cnt.png:md5,2874fea747c7ff46828bf4f17668caf8", - "fastqc_sequence_counts_plot-1-pct.png:md5,0022d7f5ac78b6eff157de24e37c5ab0", - "fastqc_sequence_counts_plot-cnt.png:md5,3890d5555f2a39b46b9f6efb14cb91f2", - "fastqc_sequence_counts_plot-pct.png:md5,55fa5838c8b2db978fcfa5cb83f6b054", - "fastqc_sequence_duplication_levels_plot-1.png:md5,fcd3b1ec2b95fe4bcd607dc28179a754", - "fastqc_sequence_duplication_levels_plot.png:md5,747431f0f38f8e4c41a11a072fa18780", - "featurecounts_biotype_plot-cnt.png:md5,95b10627fff1af0a209b8e380f4a4d0b", - "featurecounts_biotype_plot-pct.png:md5,f9c1cf03824ff9ba7da8537ecd93945b", - "qualimap_gene_coverage_profile_Counts.png:md5,2d54a60bef3dfa978da48c1b6872c41c", - "qualimap_gene_coverage_profile_Normalised.png:md5,a85a901be4c08c9dfcfd9fc87d890c1e", - "rseqc_infer_experiment_plot.png:md5,5ce01a7b923f4e6433b76dd88ca22f42", - "rseqc_read_dups_plot.png:md5,bdc7281c52b54a5784aa0d714f9c255e", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png:md5,ce6abb232fd5b5f2e66c0fe9a571d75f", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png:md5,6b44818f886ef020fb3646f152ad4af6", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png:md5,d5d8a85b7ad72a0cb93d9283ea12b23f", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png:md5,19317ad8f1448cd7eb1d319f85cc5c4d", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png:md5,a6849cd92ae738441212b681a411614d", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png:md5,4c06988372df63a1fb5f8be93f73ae8f", - "multiqc_report.html", - "cutadapt_filtered_reads_plot-cnt.pdf", - "cutadapt_filtered_reads_plot-pct.pdf", - "cutadapt_trimmed_sequences_plot_3_Counts.pdf", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf", - "dupradar-section-plot.pdf", - "fail_mapped_samples_table.pdf", - "fail_strand_check_table.pdf", - "fastqc-status-check-heatmap-1.pdf", - "fastqc-status-check-heatmap.pdf", - "fastqc_adapter_content_plot.pdf", - "fastqc_overrepresented_sequences_plot-1.pdf", - "fastqc_overrepresented_sequences_plot.pdf", - "fastqc_per_base_n_content_plot-1.pdf", - "fastqc_per_base_n_content_plot.pdf", - "fastqc_per_base_sequence_quality_plot-1.pdf", - "fastqc_per_base_sequence_quality_plot.pdf", - "fastqc_per_sequence_gc_content_plot-1_Counts.pdf", - "fastqc_per_sequence_gc_content_plot-1_Percentages.pdf", - "fastqc_per_sequence_gc_content_plot_Counts.pdf", - "fastqc_per_sequence_gc_content_plot_Percentages.pdf", - "fastqc_per_sequence_quality_scores_plot-1.pdf", - "fastqc_per_sequence_quality_scores_plot.pdf", - "fastqc_sequence_counts_plot-1-cnt.pdf", - "fastqc_sequence_counts_plot-1-pct.pdf", - "fastqc_sequence_counts_plot-cnt.pdf", - "fastqc_sequence_counts_plot-pct.pdf", - "fastqc_sequence_duplication_levels_plot-1.pdf", - "fastqc_sequence_duplication_levels_plot.pdf", - "fastqc_sequence_length_distribution_plot.pdf", - "fastqc_top_overrepresented_sequences_table-1.pdf", - "fastqc_top_overrepresented_sequences_table.pdf", - "featurecounts_biotype_plot-cnt.pdf", - "featurecounts_biotype_plot-pct.pdf", - "general_stats_table.pdf", - "picard_deduplication-cnt.pdf", - "picard_deduplication-pct.pdf", - "qualimap_gene_coverage_profile_Counts.pdf", - "qualimap_gene_coverage_profile_Normalised.pdf", - "qualimap_genomic_origin-cnt.pdf", - "qualimap_genomic_origin-pct.pdf", - "rseqc_bam_stat.pdf", - "rseqc_infer_experiment_plot.pdf", - "rseqc_inner_distance_plot_Counts.pdf", - "rseqc_inner_distance_plot_Percentages.pdf", - "rseqc_junction_annotation_junctions_plot_Events-cnt.pdf", - "rseqc_junction_annotation_junctions_plot_Events-pct.pdf", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf", - "rseqc_junction_saturation_plot_All_Junctions.pdf", - "rseqc_junction_saturation_plot_Known_Junctions.pdf", - "rseqc_junction_saturation_plot_Novel_Junctions.pdf", - "rseqc_read_distribution_plot-cnt.pdf", - "rseqc_read_distribution_plot-pct.pdf", - "rseqc_read_dups_plot.pdf", - "salmon_deseq2_clustering-plot.pdf", - "salmon_deseq2_pca-plot.pdf", - "salmon_plot.pdf", - "samtools-flagstat-dp_Percentage_of_total.pdf", - "samtools-flagstat-dp_Read_counts.pdf", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf", - "samtools-stats-dp.pdf", - "samtools_alignment_plot-cnt.pdf", - "samtools_alignment_plot-pct.pdf", - "star_alignment_plot-cnt.pdf", - "star_alignment_plot-pct.pdf", - "star_salmon_deseq2_clustering-plot.pdf", - "star_salmon_deseq2_pca-plot.pdf", - "star_summary_table.pdf", - "fail_strand_check_table.png", - "fastqc_adapter_content_plot.png", - "fastqc_per_base_n_content_plot-1.png", - "fastqc_per_base_n_content_plot.png", - "fastqc_per_base_sequence_quality_plot-1.png", - "fastqc_per_base_sequence_quality_plot.png", - "fastqc_sequence_length_distribution_plot.png", - "fastqc_top_overrepresented_sequences_table-1.png", - "fastqc_top_overrepresented_sequences_table.png", - "general_stats_table.png", - "picard_deduplication-cnt.png", - "picard_deduplication-pct.png", - "qualimap_genomic_origin-cnt.png", - "qualimap_genomic_origin-pct.png", - "rseqc_bam_stat.png", - "rseqc_inner_distance_plot_Counts.png", - "rseqc_inner_distance_plot_Percentages.png", - "rseqc_junction_annotation_junctions_plot_Events-cnt.png", - "rseqc_junction_annotation_junctions_plot_Events-pct.png", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.png", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.png", - "rseqc_junction_saturation_plot_All_Junctions.png", - "rseqc_junction_saturation_plot_Known_Junctions.png", - "rseqc_junction_saturation_plot_Novel_Junctions.png", - "rseqc_read_distribution_plot-cnt.png", - "rseqc_read_distribution_plot-pct.png", - "salmon_deseq2_clustering-plot.png", - "salmon_deseq2_pca-plot.png", - "salmon_plot.png", - "samtools-flagstat-dp_Percentage_of_total.png", - "samtools-flagstat-dp_Read_counts.png", - "samtools-stats-dp.png", - "samtools_alignment_plot-cnt.png", - "samtools_alignment_plot-pct.png", - "star_alignment_plot-cnt.png", - "star_alignment_plot-pct.png", - "star_salmon_deseq2_clustering-plot.png", - "star_salmon_deseq2_pca-plot.png", - "star_summary_table.png", - "cutadapt_filtered_reads_plot-cnt.svg", - "cutadapt_filtered_reads_plot-pct.svg", - "cutadapt_trimmed_sequences_plot_3_Counts.svg", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg", - "dupradar-section-plot.svg", - "fail_mapped_samples_table.svg", - "fail_strand_check_table.svg", - "fastqc-status-check-heatmap-1.svg", - "fastqc-status-check-heatmap.svg", - "fastqc_adapter_content_plot.svg", - "fastqc_overrepresented_sequences_plot-1.svg", - "fastqc_overrepresented_sequences_plot.svg", - "fastqc_per_base_n_content_plot-1.svg", - "fastqc_per_base_n_content_plot.svg", - "fastqc_per_base_sequence_quality_plot-1.svg", - "fastqc_per_base_sequence_quality_plot.svg", - "fastqc_per_sequence_gc_content_plot-1_Counts.svg", - "fastqc_per_sequence_gc_content_plot-1_Percentages.svg", - "fastqc_per_sequence_gc_content_plot_Counts.svg", - "fastqc_per_sequence_gc_content_plot_Percentages.svg", - "fastqc_per_sequence_quality_scores_plot-1.svg", - "fastqc_per_sequence_quality_scores_plot.svg", - "fastqc_sequence_counts_plot-1-cnt.svg", - "fastqc_sequence_counts_plot-1-pct.svg", - "fastqc_sequence_counts_plot-cnt.svg", - "fastqc_sequence_counts_plot-pct.svg", - "fastqc_sequence_duplication_levels_plot-1.svg", - "fastqc_sequence_duplication_levels_plot.svg", - "fastqc_sequence_length_distribution_plot.svg", - "fastqc_top_overrepresented_sequences_table-1.svg", - "fastqc_top_overrepresented_sequences_table.svg", - "featurecounts_biotype_plot-cnt.svg", - "featurecounts_biotype_plot-pct.svg", - "general_stats_table.svg", - "picard_deduplication-cnt.svg", - "picard_deduplication-pct.svg", - "qualimap_gene_coverage_profile_Counts.svg", - "qualimap_gene_coverage_profile_Normalised.svg", - "qualimap_genomic_origin-cnt.svg", - "qualimap_genomic_origin-pct.svg", - "rseqc_bam_stat.svg", - "rseqc_infer_experiment_plot.svg", - "rseqc_inner_distance_plot_Counts.svg", - "rseqc_inner_distance_plot_Percentages.svg", - "rseqc_junction_annotation_junctions_plot_Events-cnt.svg", - "rseqc_junction_annotation_junctions_plot_Events-pct.svg", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.svg", - "rseqc_junction_saturation_plot_All_Junctions.svg", - "rseqc_junction_saturation_plot_Known_Junctions.svg", - "rseqc_junction_saturation_plot_Novel_Junctions.svg", - "rseqc_read_distribution_plot-cnt.svg", - "rseqc_read_distribution_plot-pct.svg", - "rseqc_read_dups_plot.svg", - "salmon_deseq2_clustering-plot.svg", - "salmon_deseq2_pca-plot.svg", - "salmon_plot.svg", - "samtools-flagstat-dp_Percentage_of_total.svg", - "samtools-flagstat-dp_Read_counts.svg", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg", - "samtools-stats-dp.svg", - "samtools_alignment_plot-cnt.svg", - "samtools_alignment_plot-pct.svg", - "star_alignment_plot-cnt.svg", - "star_alignment_plot-pct.svg", - "star_salmon_deseq2_clustering-plot.svg", - "star_salmon_deseq2_pca-plot.svg", - "star_summary_table.svg" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T19:09:21.766479" + "timestamp": "2024-10-02T07:54:27.006271" }, "Params: --min_mapped_reads 90 - stub": { "content": [ - "{BBMAP_BBSPLIT={bbmap=39.01}, CAT_FASTQ={cat=8.3}, CUSTOM_CATADDITIONALFASTA={python=null}, CUSTOM_GETCHROMSIZES={getchromsizes=1.2}, FASTQC={fastqc=0.12.1}, GTF2BED={perl=5.26.2}, GTF_FILTER={python=3.9.5}, GUNZIP_ADDITIONAL_FASTA={gunzip=1.1}, GUNZIP_GTF={gunzip=1.1}, STAR_GENOMEGENERATE={star=2.7.10a, samtools=1.18, gawk=5.1.0}, TRIMGALORE={trimgalore=0.6.7, cutadapt=3.4}, UNTAR_SALMON_INDEX={untar=1.34}, Workflow={nf-core/rnaseq=v3.16.0dev}}", - "genome_transcriptome.fasta", - "genome_transcriptome.gtf", - "RAP1_IAA_30M_REP1_raw.html", - "RAP1_IAA_30M_REP1_raw.zip", - "RAP1_UNINDUCED_REP1_raw.html", - "RAP1_UNINDUCED_REP1_raw.zip", - "RAP1_UNINDUCED_REP2_raw.html", - "RAP1_UNINDUCED_REP2_raw.zip", - "WT_REP1_raw.html", - "WT_REP1_raw.zip", - "WT_REP2_raw.html", - "WT_REP2_raw.zip", - "multiqc_report.html", - "RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T16:57:32.155191" - }, - "fastqc/raw": { - "content": [ - "RAP1_IAA_30M_REP1_raw_1_fastqc.html", - "RAP1_IAA_30M_REP1_raw_1_fastqc.zip", - "RAP1_IAA_30M_REP1_raw_2_fastqc.html", - "RAP1_IAA_30M_REP1_raw_2_fastqc.zip", - "RAP1_UNINDUCED_REP1_raw_fastqc.html", - "RAP1_UNINDUCED_REP1_raw_fastqc.zip", - "RAP1_UNINDUCED_REP2_raw_fastqc.html", - "RAP1_UNINDUCED_REP2_raw_fastqc.zip", - "WT_REP1_raw_1_fastqc.html", - "WT_REP1_raw_1_fastqc.zip", - "WT_REP1_raw_2_fastqc.html", - "WT_REP1_raw_2_fastqc.zip", - "WT_REP2_raw_1_fastqc.html", - "WT_REP2_raw_1_fastqc.zip", - "WT_REP2_raw_2_fastqc.html", - "WT_REP2_raw_2_fastqc.zip" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T16:04:54.746531" - }, - "star_salmon/stringtie": { - "content": [ - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,3f149502efe2a9d4bac98b1dd18c15e7", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,a052ab04070e72cc318fb7680b0764e3", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,e82329a443b9ff50a86e42aff91bd704", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,d279003d92f7feef9adb31203f84474a", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,10e2d00f93f9e74f224bd3c1bfbeb29b", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,525413b70bcf62c24c8f96182e09883e", - "t_data.ctab", - "RAP1_IAA_30M_REP1.coverage.gtf", - "RAP1_IAA_30M_REP1.gene.abundance.txt", - "RAP1_IAA_30M_REP1.transcripts.gtf", - "t_data.ctab", - "RAP1_UNINDUCED_REP1.coverage.gtf", - "RAP1_UNINDUCED_REP1.gene.abundance.txt", - "RAP1_UNINDUCED_REP1.transcripts.gtf", - "t_data.ctab", - "RAP1_UNINDUCED_REP2.coverage.gtf", - "RAP1_UNINDUCED_REP2.gene.abundance.txt", - "RAP1_UNINDUCED_REP2.transcripts.gtf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T16:36:12.537334" - }, - "salmon_quant": { - "content": [ - "ambig_info.tsv:md5,de973a4b22a4457217ae3dc04caf9401", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,1215f0c20f87d3aef8553ef119e1e74c", - "lib_format_counts.json:md5,c24ffe28d70476b5ccdd8bc2d22c0ac1", - "ambig_info.tsv:md5,45f252b4f0e11e6730cf0c29f800fdbb", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,621c6601aade5b1f2e3d6ca2fc71f636", - "lib_format_counts.json:md5,f6d44c0221f7fd559f11a9afe04c9935", - "ambig_info.tsv:md5,6dcc2891ea572e9b8d1ba52cd434ab84", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,9bed6e4dc5428d6f6297adcea29a6326", - "lib_format_counts.json:md5,7c562bf2f70e42f3a7292687dfd328c3", - "ambig_info.tsv:md5,194f574e0586416155e3f33d42e2b167", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,c7ed0aaa5d6c7934ddbebfd29e4eb86d", - "lib_format_counts.json:md5,d46250bb3677d72feeefc435fe6395a6", - "ambig_info.tsv:md5,a26e3f936e65d7da66392603c2f91f6f", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,69ebfc2c7ca6b221a0a22fa1dc8c20ac", - "lib_format_counts.json:md5,088fd51db07022ffde47033bbd029400", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T16:04:55.0893" - }, - "multiqc_data": { - "content": [ - "cutadapt_filtered_reads_plot.txt:md5,bf033e64e9d23bee85b6277f11c663f1", - "cutadapt_trimmed_sequences_plot_3_Counts.txt:md5,13dfa866fd91dbb072689efe9aa83b1f", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt:md5,07145dd8dd3db654859b18eb0389046c", - "fastqc-status-check-heatmap-1.txt:md5,22a03548736b88b23be6bc0c9ef1b4a6", - "fastqc-status-check-heatmap.txt:md5,5a89b0d8d162f6b1dbdaf39457bbc03b", - "fastqc_adapter_content_plot.txt:md5,da0389be84cfdd189b1d045212eb2974", - "fastqc_overrepresented_sequences_plot-1.txt:md5,4adfeacd3a3a6c7c808f121b24e6b247", - "fastqc_overrepresented_sequences_plot.txt:md5,25d88ea8a72f55e8a374ae802bc7f0b1", - "fastqc_per_base_n_content_plot-1.txt:md5,418610c1ce119cb786ad434db75d366e", - "fastqc_per_base_n_content_plot.txt:md5,d368d7e36ca2f73dcde61f2b486d8213", - "fastqc_per_base_sequence_quality_plot-1.txt:md5,bd22e06e41c096ad4f745d40fe96a1e5", - "fastqc_per_base_sequence_quality_plot.txt:md5,5c3065b549129702b185ea1b817da420", - "fastqc_per_sequence_gc_content_plot-1_Counts.txt:md5,004c60768ceb6197765154e3eaa37b7a", - "fastqc_per_sequence_gc_content_plot-1_Percentages.txt:md5,95d29060b687f745288ad1ec47750037", - "fastqc_per_sequence_gc_content_plot_Counts.txt:md5,9ddaa50167117d3c9188ccf015427704", - "fastqc_per_sequence_gc_content_plot_Percentages.txt:md5,f10ee2881b61308af35f304aa3d810a3", - "fastqc_per_sequence_quality_scores_plot-1.txt:md5,0f9834cc19f76dd5c87cf8cba7435a7c", - "fastqc_per_sequence_quality_scores_plot.txt:md5,b5f9a02933e3065952237afd2ec9ce82", - "fastqc_sequence_counts_plot-1.txt:md5,3861354bbedfbde7ca36a72994f9425c", - "fastqc_sequence_counts_plot.txt:md5,d385a3e2c2573a0902c66e8c93876d3c", - "fastqc_sequence_duplication_levels_plot-1.txt:md5,c73407d55fc532e864fa1dc8dbc12874", - "fastqc_sequence_duplication_levels_plot.txt:md5,8812cee16f6ca65e2c33635754de1772", - "fastqc_sequence_length_distribution_plot.txt:md5,6fe2c985606abad947bcca99b015ae33", - "multiqc_citations.txt:md5,2d2ab6df367e36e98e081c33dec187a0", - "multiqc_cutadapt.txt:md5,aac9581a5670cb55edf564f3d6c1f9a7", - "multiqc_fail_mapped_samples_table.txt:md5,5dd9b06f326b1a55d78878343af89927", - "multiqc_fastqc_fastqc_raw.txt:md5,81c3c1a2575a1891a7f2a9637a0f2cc0", - "multiqc_fastqc_fastqc_trimmed.txt:md5,a3238f515e01d158d875d69968753804", - "multiqc_featurecounts_biotype_plot.txt:md5,f3c566d2eaf6bf2ffe5ad12036ce3500", - "multiqc_samtools_idxstats.txt:md5,fd7d03a91f0b9e01a6939941f7f2243f", - "picard_histogram.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "picard_histogram_1.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "picard_histogram_2.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "qualimap_gene_coverage_profile_Counts.txt:md5,6d377444d29c3d4135980982ab1df2fb", - "qualimap_gene_coverage_profile_Normalised.txt:md5,dc8b4f9fddc08e06668f9ee87faac008", - "qualimap_rnaseq_cov_hist.txt:md5,a409821701f60811027daef4e7f3ebee", - "rseqc_infer_experiment_plot.txt:md5,749a802379ada3ec9d2083ecbe6aef7e", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt:md5,75acd04232d1804b5f960ee4c5db4722", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt:md5,ae45731d8d4595f77e6b271004f3a070", - "samtools-idxstats-mapped-reads-plot_Raw_Counts.txt:md5,01637c600d3840500851eb4118564cc6", - "fastqc_top_overrepresented_sequences_table-1.txt", - "fastqc_top_overrepresented_sequences_table.txt", - "junction_saturation_known.txt", - "junction_saturation_novel.txt", - "multiqc_data.json", - "multiqc_dupradar-section-plot.txt", - "multiqc_fail_strand_check_table.txt", - "multiqc_general_stats.txt", - "multiqc_picard_dups.txt", - "multiqc_rseqc_bam_stat.txt", - "multiqc_rseqc_infer_experiment.txt", - "multiqc_rseqc_junction_annotation.txt", - "multiqc_rseqc_read_distribution.txt", - "multiqc_salmon.txt", - "multiqc_salmon_deseq2_clustering-plot.txt", - "multiqc_salmon_deseq2_clustering-plot_1.txt", - "multiqc_salmon_deseq2_clustering-plot_2.txt", - "multiqc_salmon_deseq2_clustering-plot_3.txt", - "multiqc_salmon_deseq2_clustering-plot_4.txt", - "multiqc_salmon_deseq2_pca-plot.txt", - "multiqc_samtools_flagstat.txt", - "multiqc_samtools_stats.txt", - "multiqc_software_versions.txt", - "multiqc_sources.txt", - "multiqc_star.txt", - "multiqc_star_salmon_deseq2_clustering-plot.txt", - "multiqc_star_salmon_deseq2_clustering-plot_1.txt", - "multiqc_star_salmon_deseq2_clustering-plot_2.txt", - "multiqc_star_salmon_deseq2_clustering-plot_3.txt", - "multiqc_star_salmon_deseq2_clustering-plot_4.txt", - "multiqc_star_salmon_deseq2_pca-plot.txt", - "picard_deduplication.txt", - "qualimap_genomic_origin.txt", - "qualimap_rnaseq_genome_results.txt", - "rseqc_bam_stat.txt", - "rseqc_inner_distance.txt", - "rseqc_inner_distance_plot_Counts.txt", - "rseqc_inner_distance_plot_Percentages.txt", - "rseqc_junction_annotation_junctions_plot_Events.txt", - "rseqc_junction_annotation_junctions_plot_Junctions.txt", - "rseqc_junction_saturation_all.txt", - "rseqc_junction_saturation_plot_All_Junctions.txt", - "rseqc_junction_saturation_plot_Known_Junctions.txt", - "rseqc_junction_saturation_plot_Novel_Junctions.txt", - "rseqc_read_distribution_plot.txt", - "rseqc_read_dups.txt", - "rseqc_read_dups_plot.txt", - "salmon_plot.txt", - "samtools-flagstat-dp_Percentage_of_total.txt", - "samtools-flagstat-dp_Read_counts.txt", - "samtools-stats-dp.txt", - "samtools_alignment_plot.txt", - "star_alignment_plot.txt", - "star_summary_table.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T19:09:21.700284" - }, - "star_salmon/deseq2_qc": { - "content": [ - "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", - "RAP1_IAA_30M_REP1.txt", - "RAP1_UNINDUCED_REP1.txt", - "RAP1_UNINDUCED_REP2.txt", - "WT_REP1.txt", - "WT_REP2.txt", - "deseq2.size_factors.RData", - "deseq2.dds.RData", - "deseq2.pca.vals.txt", - "deseq2.plots.pdf", - "deseq2.sample.dists.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T16:20:15.658024" - }, - "star_salmon/markdup": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.bam", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.bai", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T16:36:12.596967" - }, - "star_salmon/featurecounts": { - "content": [ - "RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv:md5,f3688a214d33a43ad79abe4b31df0c4b", - "RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv:md5,dde2de0cb90e10d0195c726f768e9941", - "RAP1_IAA_30M_REP1.featureCounts.txt:md5,b38da3230d4d29ebc8d4af36852d7212", - "RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv:md5,d241d50e582ceb97e6f16b3556f5f5a9", - "RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv:md5,845ff9059c72bc6722a8de69776e22bb", - "RAP1_UNINDUCED_REP1.featureCounts.txt:md5,2ab175746532de1c54020c1eabc27bb5", - "RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv:md5,b621ce1e803d8670ece6c66391c33ba4", - "RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv:md5,6d3fa4c88c7fe61f638e4624ad5e22f0", - "RAP1_UNINDUCED_REP2.featureCounts.txt:md5,480b2586a878bc22f5b73f94051b41d8", - "RAP1_IAA_30M_REP1.featureCounts.txt.summary", - "RAP1_UNINDUCED_REP1.featureCounts.txt.summary", - "RAP1_UNINDUCED_REP2.featureCounts.txt.summary" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T13:06:36.957812" - }, - "salmon/deseq2_qc": { - "content": [ - "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", - "deseq2.dds.RData", - "deseq2.pca.vals.txt", - "deseq2.plots.pdf", - "deseq2.sample.dists.txt", - "RAP1_IAA_30M_REP1.txt", - "RAP1_UNINDUCED_REP1.txt", - "RAP1_UNINDUCED_REP2.txt", - "WT_REP1.txt", - "WT_REP2.txt", - "deseq2.size_factors.RData" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T16:04:54.964861" - }, - "salmon": { - "content": [ - "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", - "salmon.merged.gene_counts.SummarizedExperiment.rds", - "salmon.merged.gene_counts.tsv", - "salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_length_scaled.tsv", - "salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_scaled.tsv", - "salmon.merged.gene_lengths.tsv", - "salmon.merged.gene_tpm.tsv", - "salmon.merged.transcript_counts.SummarizedExperiment.rds", - "salmon.merged.transcript_counts.tsv", - "salmon.merged.transcript_lengths.tsv", - "salmon.merged.transcript_tpm.tsv" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T16:04:55.21324" - }, - "star_salmon/picard_metrics": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T16:36:12.280587" - }, - "star_salmon/salmon": { - "content": [ - "salmon.merged.gene_counts.SummarizedExperiment.rds", - "salmon.merged.gene_counts.tsv", - "salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_length_scaled.tsv", - "salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_scaled.tsv", - "salmon.merged.gene_lengths.tsv", - "salmon.merged.gene_tpm.tsv", - "salmon.merged.transcript_counts.SummarizedExperiment.rds", - "salmon.merged.transcript_counts.tsv", - "salmon.merged.transcript_lengths.tsv", - "salmon.merged.transcript_tpm.tsv" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T16:36:12.406892" - }, - "star_salmon/bigwig": { - "content": [ - "RAP1_IAA_30M_REP1.forward.bigWig", - "RAP1_IAA_30M_REP1.reverse.bigWig", - "RAP1_UNINDUCED_REP1.forward.bigWig", - "RAP1_UNINDUCED_REP1.reverse.bigWig", - "RAP1_UNINDUCED_REP2.forward.bigWig", - "RAP1_UNINDUCED_REP2.reverse.bigWig" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T16:20:15.635275" - }, - "versions": { - "content": [ - "{BBMAP_BBSPLIT={bbmap=39.01}, BEDTOOLS_GENOMECOV_FW={bedtools=2.31.1}, CAT_FASTQ={cat=8.3}, CUSTOM_CATADDITIONALFASTA={python=3.9.5}, CUSTOM_GETCHROMSIZES={getchromsizes=1.2}, CUSTOM_TX2GENE={python=3.9.5}, DESEQ2_QC_PSEUDO={r-base=4.0.3, bioconductor-deseq2=1.28.0}, DESEQ2_QC_STAR_SALMON={r-base=4.0.3, bioconductor-deseq2=1.28.0}, DUPRADAR={bioconductor-dupradar=1.32.0}, FASTQC={fastqc=0.12.1}, FQ_SUBSAMPLE={fq=0.9.1 (2022-02-22)}, GTF2BED={perl=5.26.2}, GTF_FILTER={python=3.9.5}, GUNZIP_ADDITIONAL_FASTA={gunzip=1.1}, GUNZIP_GTF={gunzip=1.1}, MULTIQC_CUSTOM_BIOTYPE={python=3.9.5}, PICARD_MARKDUPLICATES={picard=3.1.1}, QUALIMAP_RNASEQ={qualimap=2.3}, RSEQC_BAMSTAT={rseqc=5.0.2}, RSEQC_INFEREXPERIMENT={rseqc=5.0.2}, RSEQC_INNERDISTANCE={rseqc=5.0.2}, RSEQC_JUNCTIONANNOTATION={rseqc=5.0.2}, RSEQC_JUNCTIONSATURATION={rseqc=5.0.2}, RSEQC_READDISTRIBUTION={rseqc=5.0.2}, RSEQC_READDUPLICATION={rseqc=5.0.2}, SALMON_QUANT={salmon=1.10.1}, SAMTOOLS_FLAGSTAT={samtools=1.2}, SAMTOOLS_IDXSTATS={samtools=1.2}, SAMTOOLS_INDEX={samtools=1.2}, SAMTOOLS_SORT={samtools=1.2}, SAMTOOLS_STATS={samtools=1.2}, SE_GENE={bioconductor-summarizedexperiment=1.32.0}, STAR_ALIGN={star=2.7.10a, samtools=1.18, gawk=5.1.0}, STAR_GENOMEGENERATE={star=2.7.10a, samtools=1.18, gawk=5.1.0}, STRINGTIE_STRINGTIE={stringtie=2.2.1}, SUBREAD_FEATURECOUNTS={subread=2.0.1}, TRIMGALORE={trimgalore=0.6.7, cutadapt=3.4}, TXIMETA_TXIMPORT={bioconductor-tximeta=1.20.1}, UCSC_BEDCLIP={ucsc=377}, UCSC_BEDGRAPHTOBIGWIG={ucsc=445}, UNTAR_SALMON_INDEX={untar=1.34}, Workflow={nf-core/rnaseq=v3.16.0dev}}" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T16:36:12.954252" - }, - "fastqc/trim": { - "content": [ - "RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html", - "RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip", - "RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html", - "RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip", - "RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html", - "RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip", - "RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html", - "RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip", - "WT_REP1_trimmed_1_val_1_fastqc.html", - "WT_REP1_trimmed_1_val_1_fastqc.zip", - "WT_REP1_trimmed_2_val_2_fastqc.html", - "WT_REP1_trimmed_2_val_2_fastqc.zip", - "WT_REP2_trimmed_1_val_1_fastqc.html", - "WT_REP2_trimmed_1_val_1_fastqc.zip", - "WT_REP2_trimmed_2_val_2_fastqc.html", - "WT_REP2_trimmed_2_val_2_fastqc.zip" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T16:04:54.759052" - }, - "star_salmon/dupradar": { - "content": [ - "RAP1_IAA_30M_REP1_dupMatrix.txt:md5,2e0d518a450bb57801cdd075d4e9c217", - "RAP1_UNINDUCED_REP1_dupMatrix.txt:md5,96e2f9e1fc5a22a7d468e6fb4a613370", - "RAP1_UNINDUCED_REP2_dupMatrix.txt:md5,28c30ce734d78d53b1c47c3f87414e4b", - "RAP1_IAA_30M_REP1_intercept_slope.txt:md5,c677048855caf5190f29fa5f7137cd79", - "RAP1_UNINDUCED_REP1_intercept_slope.txt:md5,ea1b4323d3bc83759e8a026416bca32b", - "RAP1_UNINDUCED_REP2_intercept_slope.txt:md5,b062f49a5223a3452075062cdd308043", - "RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf", - "RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf", - "RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf", - "RAP1_IAA_30M_REP1_expressionHist.pdf", - "RAP1_UNINDUCED_REP1_expressionHist.pdf", - "RAP1_UNINDUCED_REP2_expressionHist.pdf", - "RAP1_IAA_30M_REP1_duprateExpDens.pdf", - "RAP1_UNINDUCED_REP1_duprateExpDens.pdf", - "RAP1_UNINDUCED_REP2_duprateExpDens.pdf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T16:36:12.202189" - }, - "bbsplit": { - "content": [ - "RAP1_IAA_30M_REP1.stats.txt", - "RAP1_UNINDUCED_REP1.stats.txt", - "RAP1_UNINDUCED_REP2.stats.txt", - "WT_REP1.stats.txt", - "WT_REP2.stats.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T16:04:54.719906" - }, - "star_salmon/qualimap": { - "content": [ - "Coverage Profile Along Genes (High).png:md5,876c1b88f33bd3e5fe1a41679729573d", - "Coverage Profile Along Genes (Low).png:md5,ee1f2c9cc4dd4867811eda1e68864ab4", - "Coverage Profile Along Genes (Total).png:md5,53747a8f9813744902756ad60638380a", - "Transcript coverage histogram.png:md5,4f9072d4b11216373b59396293803a37", - "coverage_profile_along_genes_(high).txt:md5,fcb06d460810c0555de5396b9dae05e8", - "coverage_profile_along_genes_(low).txt:md5,e3c9a1ddfdb89f8534ff7548b70fce32", - "coverage_profile_along_genes_(total).txt:md5,e3c9a1ddfdb89f8534ff7548b70fce32", - "Coverage Profile Along Genes (High).png:md5,bbf0531018e7fccfc1dfdd1c05715518", - "Coverage Profile Along Genes (Low).png:md5,3c147d9c831d4be98615a22a72fad05d", - "Coverage Profile Along Genes (Total).png:md5,5a8a6db3a8d19a2dcb8f715b11e67c50", - "Transcript coverage histogram.png:md5,488440d7b6d73bcd4567316712e281fe", - "coverage_profile_along_genes_(high).txt:md5,9f1e29a4d6eec52e8796b080daaedca3", - "coverage_profile_along_genes_(low).txt:md5,353f42a84ff34167646fc83909eac2ff", - "coverage_profile_along_genes_(total).txt:md5,353f42a84ff34167646fc83909eac2ff", - "Coverage Profile Along Genes (High).png:md5,5a5d99cc7a1dba3762d67f4aa4adad58", - "Coverage Profile Along Genes (Low).png:md5,b6adc296e9a732aa0495a6da8fa4ed90", - "Coverage Profile Along Genes (Total).png:md5,fcb94fb9c1a51c1db32f884d05929cc8", - "Transcript coverage histogram.png:md5,3aeb52ff3e3752727a370b0d7ceb0518", - "coverage_profile_along_genes_(high).txt:md5,3b20a736708df02ea8c86dc5829ae67e", - "coverage_profile_along_genes_(low).txt:md5,02b314b76ef1317f20e129412340755d", - "coverage_profile_along_genes_(total).txt:md5,02b314b76ef1317f20e129412340755d", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt" + 22, + { + "BBMAP_BBSPLIT": { + "bbmap": 39.01 + }, + "CAT_FASTQ": { + "cat": 8.3 + }, + "CUSTOM_CATADDITIONALFASTA": { + "python": null + }, + "CUSTOM_GETCHROMSIZES": { + "getchromsizes": 1.2 + }, + "FASTQC": { + "fastqc": "0.12.1" + }, + "GTF2BED": { + "perl": "5.26.2" + }, + "GTF_FILTER": { + "python": "3.9.5" + }, + "GUNZIP_ADDITIONAL_FASTA": { + "gunzip": 1.1 + }, + "GUNZIP_GTF": { + "gunzip": 1.1 + }, + "STAR_GENOMEGENERATE": { + "star": "2.7.10a", + "samtools": 1.18, + "gawk": "5.1.0" + }, + "TRIMGALORE": { + "trimgalore": "0.6.7", + "cutadapt": 3.4 + }, + "UNTAR_SALMON_INDEX": { + "untar": 1.34 + }, + "Workflow": { + "nf-core/rnaseq": "v3.16.0dev" + } + }, + [ + "custom", + "custom/out", + "custom/out/genome_transcriptome.fasta", + "custom/out/genome_transcriptome.gtf", + "fastqc", + "fastqc/raw", + "fastqc/raw/RAP1_IAA_30M_REP1_raw.html", + "fastqc/raw/RAP1_IAA_30M_REP1_raw.zip", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw.html", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw.zip", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw.html", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw.zip", + "fastqc/raw/WT_REP1_raw.html", + "fastqc/raw/WT_REP1_raw.zip", + "fastqc/raw/WT_REP2_raw.html", + "fastqc/raw/WT_REP2_raw.zip", + "fastqc/trim", + "multiqc", + "multiqc/star_salmon", + "multiqc/star_salmon/multiqc_data", + "multiqc/star_salmon/multiqc_plots", + "multiqc/star_salmon/multiqc_report.html", + "pipeline_info", + "pipeline_info/nf_core_rnaseq_software_mqc_versions.yml", + "trimgalore", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" + ], + [ + "genome_transcriptome.fasta:md5,d41d8cd98f00b204e9800998ecf8427e", + "genome_transcriptome.gtf:md5,d41d8cd98f00b204e9800998ecf8427e" + ] ], "meta": { "nf-test": "0.9.0", "nextflow": "24.04.4" }, - "timestamp": "2024-08-26T13:06:37.041504" + "timestamp": "2024-10-02T07:55:19.233936" } } \ No newline at end of file diff --git a/tests/remove_ribo_rna.nf.test b/tests/remove_ribo_rna.nf.test index 430f18b6f..66084a8c9 100644 --- a/tests/remove_ribo_rna.nf.test +++ b/tests/remove_ribo_rna.nf.test @@ -13,923 +13,22 @@ nextflow_pipeline { } then { + // stable_name: All files + folders in ${params.outdir}/ with a stable name + def stable_name = getAllFilesFromDir(params.outdir, true, ['pipeline_info/*.{html,json,txt}'], null) + // stable_path: All files in ${params.outdir}/ with stable content + def stable_path = getAllFilesFromDir(params.outdir, false, null, 'tests/.nftignore') assertAll( - { assert workflow.success }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/bbsplit/RAP1_IAA_30M_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/RAP1_UNINDUCED_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/RAP1_UNINDUCED_REP2.stats.txt").name, - file("${params.outdir}/bbsplit/WT_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/WT_REP2.stats.txt").name - ).match("bbsplit") }, - { assert snapshot( - path("${params.outdir}/custom/out/genome_gfp.fasta"), - path("${params.outdir}/custom/out/genome_gfp.gtf") - ).match("references") }, - { assert snapshot( - // HTMLs and ZIPs are not stable - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_2_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_2_fastqc.zip").name - ).match("fastqc/raw") }, - { assert snapshot( - // HTMLs and ZIPs are not stable - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.zip").name - ).match("fastqc/trim") }, - { assert snapshot( - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/cutadapt_filtered_reads_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc-status-check-heatmap-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc-status-check-heatmap.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_adapter_content_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_overrepresented_sequences_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_overrepresented_sequences_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_base_n_content_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_base_n_content_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_base_sequence_quality_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_base_sequence_quality_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Percentages.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Percentages.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_quality_scores_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_quality_scores_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_counts_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_counts_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_duplication_levels_plot-1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_duplication_levels_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_length_distribution_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_citations.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_cutadapt.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_fastqc_fastqc_raw.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_fastqc_fastqc_trimmed.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_featurecounts_biotype_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_samtools_idxstats.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_histogram.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_histogram_1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_histogram_2.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_gene_coverage_profile_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_gene_coverage_profile_Normalised.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_rnaseq_cov_hist.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_infer_experiment_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Raw_Counts.txt"), - // These files are not stable - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_top_overrepresented_sequences_table-1.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_top_overrepresented_sequences_table.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/junction_saturation_known.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/junction_saturation_novel.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_data.json").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_dupradar-section-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_fail_strand_check_table.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_general_stats.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_picard_dups.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_bam_stat.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_infer_experiment.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_junction_annotation.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_read_distribution.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_1.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_2.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_3.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_4.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_pca-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_samtools_flagstat.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_samtools_stats.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_software_versions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_sortmerna.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_sources.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_1.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_2.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_3.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_4.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_pca-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_deduplication.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_genomic_origin.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_rnaseq_genome_results.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_bam_stat.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance_plot_Counts.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance_plot_Percentages.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Events.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Junctions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_all.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_All_Junctions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_Known_Junctions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_Novel_Junctions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_read_distribution_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_read_dups.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_read_dups_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/salmon_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Percentage_of_total.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Read_counts.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-stats-dp.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools_alignment_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/sortmerna-detailed-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/star_alignment_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/star_summary_table.txt").name - ).match("multiqc_data") }, - { assert snapshot( - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/cutadapt_filtered_reads_plot-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/cutadapt_filtered_reads_plot-pct.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Counts.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Obs_Exp.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/dupradar-section-plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc-status-check-heatmap-1.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc-status-check-heatmap.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot-1.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Counts.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Percentages.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Counts.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Percentages.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot-1.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-pct.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-pct.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot-1.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/featurecounts_biotype_plot-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/featurecounts_biotype_plot-pct.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/qualimap_gene_coverage_profile_Counts.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/qualimap_gene_coverage_profile_Normalised.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_infer_experiment_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_dups_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/sortmerna-detailed-plot-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/sortmerna-detailed-plot-pct.png"), - // PDFs, SVGs, some PNGs and HTML reports are not stable - file("${params.outdir}/multiqc/star_salmon/multiqc_report.html").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/dupradar-section-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fail_strand_check_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc-status-check-heatmap-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc-status-check-heatmap.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_adapter_content_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Percentages.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Percentages.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_length_distribution_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table-1.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/featurecounts_biotype_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/featurecounts_biotype_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/general_stats_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Normalised.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_genomic_origin-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_genomic_origin-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_bam_stat.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_infer_experiment_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Percentages.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_All_Junctions.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Known_Junctions.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Novel_Junctions.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_distribution_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_distribution_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_dups_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/salmon_deseq2_clustering-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/salmon_deseq2_pca-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/salmon_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Percentage_of_total.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Read_counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-stats-dp.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/sortmerna-detailed-plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/sortmerna-detailed-plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_salmon_deseq2_clustering-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_salmon_deseq2_pca-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_summary_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fail_strand_check_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_adapter_content_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_n_content_plot-1.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_n_content_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot-1.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_length_distribution_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table-1.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/general_stats_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/qualimap_genomic_origin-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/qualimap_genomic_origin-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_bam_stat.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_inner_distance_plot_Counts.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_inner_distance_plot_Percentages.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_All_Junctions.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_Known_Junctions.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_Novel_Junctions.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_distribution_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_distribution_plot-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/salmon_deseq2_clustering-plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/salmon_deseq2_pca-plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/salmon_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Percentage_of_total.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Read_counts.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-stats-dp.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_salmon_deseq2_clustering-plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_salmon_deseq2_pca-plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_summary_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/dupradar-section-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fail_strand_check_table.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc-status-check-heatmap-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc-status-check-heatmap.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_adapter_content_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_n_content_plot-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_n_content_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Percentages.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Percentages.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_length_distribution_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table-1.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/featurecounts_biotype_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/featurecounts_biotype_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/general_stats_table.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Normalised.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/qualimap_genomic_origin-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/qualimap_genomic_origin-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_bam_stat.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_infer_experiment_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_inner_distance_plot_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_inner_distance_plot_Percentages.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_All_Junctions.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Known_Junctions.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Novel_Junctions.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_distribution_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_distribution_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_dups_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/salmon_deseq2_clustering-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/salmon_deseq2_pca-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/salmon_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Percentage_of_total.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Read_counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-stats-dp.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/sortmerna-detailed-plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/sortmerna-detailed-plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_salmon_deseq2_clustering-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_salmon_deseq2_pca-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_summary_table.svg").name - ).match("multiqc_plots") }, - { assert snapshot( - path("${params.outdir}/salmon/deseq2_qc/R_sessionInfo.log"), - // These files are not stable - file("${params.outdir}/salmon/deseq2_qc/deseq2.dds.RData").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.pca.vals.txt").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.plots.pdf").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.sample.dists.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/WT_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/WT_REP2.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/deseq2.size_factors.RData").name - ).match("salmon/deseq2_qc") }, - { assert snapshot( - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/lib_format_counts.json"), - path("${params.outdir}/salmon/WT_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/WT_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/WT_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/WT_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/WT_REP1/cmd_info.json"), - path("${params.outdir}/salmon/WT_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/WT_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/WT_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/WT_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/WT_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/WT_REP2/cmd_info.json"), - path("${params.outdir}/salmon/WT_REP2/lib_format_counts.json"), - // These files are not stable - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/quant.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/quant.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/quant.sf").name, - file("${params.outdir}/salmon/WT_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/WT_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/WT_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/WT_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/WT_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/WT_REP1/quant.sf").name, - file("${params.outdir}/salmon/WT_REP2/aux_info/fld.gz").name, - file("${params.outdir}/salmon/WT_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/WT_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/WT_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/WT_REP2/quant.genes.sf").name, - file("${params.outdir}/salmon/WT_REP2/quant.sf").name - ).match("salmon_quant") }, - { assert snapshot( - path("${params.outdir}/salmon/tx2gene.tsv"), - // These files are not stable - file("${params.outdir}/salmon/salmon.merged.gene_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_length_scaled.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_scaled.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_lengths.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_tpm.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.transcript_counts.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_lengths.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_tpm.tsv").name - ).match("salmon") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/sortmerna/RAP1_IAA_30M_REP1.sortmerna.log").name, - file("${params.outdir}/sortmerna/RAP1_UNINDUCED_REP1.sortmerna.log").name, - file("${params.outdir}/sortmerna/RAP1_UNINDUCED_REP2.sortmerna.log").name, - file("${params.outdir}/sortmerna/WT_REP1.sortmerna.log").name, - file("${params.outdir}/sortmerna/WT_REP2.sortmerna.log").name - ).match("star_salmon/sortmerna") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/star_salmon/bigwig/RAP1_IAA_30M_REP1.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_IAA_30M_REP1.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP1.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP1.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP2.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP2.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/WT_REP1.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/WT_REP1.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/WT_REP2.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/WT_REP2.reverse.bigWig").name - ).match("star_salmon/bigwig") }, - { assert snapshot( - path("${params.outdir}/star_salmon/deseq2_qc/R_sessionInfo.log"), - // These files are not stable - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/WT_REP1.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/WT_REP2.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/deseq2.size_factors.RData").name, - file("${params.outdir}/star_salmon/deseq2_qc/deseq2.dds.RData").name, - file("${params.outdir}/star_salmon/deseq2_qc/deseq2.pca.vals.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/deseq2.plots.pdf").name, - file("${params.outdir}/star_salmon/deseq2_qc/deseq2.sample.dists.txt").name - ).match("star_salmon/deseq2_qc") }, - { assert snapshot( - path("${params.outdir}/star_salmon/dupradar/gene_data/RAP1_IAA_30M_REP1_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/gene_data/RAP1_UNINDUCED_REP1_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/gene_data/RAP1_UNINDUCED_REP2_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/gene_data/WT_REP1_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/gene_data/WT_REP2_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/RAP1_IAA_30M_REP1_intercept_slope.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/RAP1_UNINDUCED_REP1_intercept_slope.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/RAP1_UNINDUCED_REP2_intercept_slope.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/WT_REP1_intercept_slope.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/WT_REP2_intercept_slope.txt"), - // PDFs are not stable - file("${params.outdir}/star_salmon/dupradar/box_plot/RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/box_plot/RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/box_plot/RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/box_plot/WT_REP1_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/box_plot/WT_REP2_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/RAP1_IAA_30M_REP1_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/RAP1_UNINDUCED_REP1_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/RAP1_UNINDUCED_REP2_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/WT_REP1_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/WT_REP2_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/RAP1_IAA_30M_REP1_duprateExpDens.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/RAP1_UNINDUCED_REP1_duprateExpDens.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/RAP1_UNINDUCED_REP2_duprateExpDens.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/WT_REP1_duprateExpDens.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/WT_REP2_duprateExpDens.pdf").name - ).match("star_salmon/dupradar") }, - { assert snapshot( - path("${params.outdir}/star_salmon/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt"), - path("${params.outdir}/star_salmon/featurecounts/WT_REP1.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/WT_REP1.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/WT_REP1.featureCounts.txt"), - path("${params.outdir}/star_salmon/featurecounts/WT_REP2.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/WT_REP2.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/WT_REP2.featureCounts.txt"), - file("${params.outdir}/star_salmon/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt.summary").name, - file("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt.summary").name, - file("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt.summary").name, - file("${params.outdir}/star_salmon/featurecounts/WT_REP1.featureCounts.txt.summary").name, - file("${params.outdir}/star_salmon/featurecounts/WT_REP2.featureCounts.txt.summary").name - ).match("star_salmon/featurecounts") }, - { assert snapshot( - path("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/WT_REP1.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/WT_REP2.SJ.out.tab"), - // Logs are not stable - file("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.Log.final.out").name, - file("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.Log.out").name, - file("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.Log.final.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.Log.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.Log.final.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.Log.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/WT_REP1.Log.final.out").name, - file("${params.outdir}/star_salmon/log/WT_REP1.Log.out").name, - file("${params.outdir}/star_salmon/log/WT_REP1.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/WT_REP2.Log.final.out").name, - file("${params.outdir}/star_salmon/log/WT_REP2.Log.out").name, - file("${params.outdir}/star_salmon/log/WT_REP2.Log.progress.out").name - ).match("star_salmon/log") }, - { assert snapshot( - // Metrics are not stable - file("${params.outdir}/star_salmon/picard_metrics/RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt").name - ).match("star_salmon/picard_metrics") }, - { assert snapshot( - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - // HTML reports and these files are not stable - file("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP1/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP1/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP2/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP2/rnaseq_qc_results.txt").name - ).match("star_salmon/qualimap") }, - { assert snapshot( - path("${params.outdir}/star_salmon/rseqc/infer_experiment/RAP1_IAA_30M_REP1.infer_experiment.txt"), - path("${params.outdir}/star_salmon/rseqc/infer_experiment/RAP1_UNINDUCED_REP1.infer_experiment.txt"), - path("${params.outdir}/star_salmon/rseqc/infer_experiment/RAP1_UNINDUCED_REP2.infer_experiment.txt"), - path("${params.outdir}/star_salmon/rseqc/infer_experiment/WT_REP1.infer_experiment.txt"), - path("${params.outdir}/star_salmon/rseqc/infer_experiment/WT_REP2.infer_experiment.txt"), - // PDFs, R scripts and all these files are not stable - file("${params.outdir}/star_salmon/rseqc/bam_stat/RAP1_IAA_30M_REP1.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/bam_stat/RAP1_UNINDUCED_REP1.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/bam_stat/RAP1_UNINDUCED_REP2.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/bam_stat/WT_REP1.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/bam_stat/WT_REP2.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/pdf/RAP1_IAA_30M_REP1.inner_distance_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/pdf/WT_REP1.inner_distance_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/pdf/WT_REP2.inner_distance_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/rscript/RAP1_IAA_30M_REP1.inner_distance_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/rscript/WT_REP1.inner_distance_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/rscript/WT_REP2.inner_distance_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_freq.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_mean.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance_freq.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance_mean.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance_freq.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance_mean.txt").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/WT_REP1.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/WT_REP1.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/WT_REP2.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/WT_REP2.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/RAP1_IAA_30M_REP1.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP1.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP2.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/WT_REP1.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/WT_REP2.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/WT_REP1.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/WT_REP1.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/WT_REP2.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/WT_REP2.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/RAP1_IAA_30M_REP1.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP1.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP2.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/WT_REP1.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/WT_REP2.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/RAP1_IAA_30M_REP1.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP1.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP2.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/WT_REP1.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/WT_REP2.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/WT_REP1.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/WT_REP2.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/RAP1_IAA_30M_REP1.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP1.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP2.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/WT_REP1.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/WT_REP2.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/RAP1_IAA_30M_REP1.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/RAP1_UNINDUCED_REP1.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/RAP1_UNINDUCED_REP2.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/WT_REP1.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/WT_REP2.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/RAP1_IAA_30M_REP1.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP1.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP2.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/WT_REP1.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/WT_REP2.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/RAP1_IAA_30M_REP1.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP1.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP2.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/WT_REP1.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/WT_REP2.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.seq.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.seq.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.seq.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/WT_REP1.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/WT_REP1.seq.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/WT_REP2.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/WT_REP2.seq.DupRate.xls").name - ).match("star_salmon/rseqc") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/star_salmon/salmon.merged.gene_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_length_scaled.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_scaled.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_lengths.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_tpm.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_counts.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_lengths.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_tpm.tsv").name - ).match("star_salmon/salmon") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.sorted.bam.stats").name - ).match("star_salmon/samtools_stats") }, - { assert snapshot( - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/i_data.ctab"), - // These files are not stable - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP1.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP1.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP1.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP2.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP2.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP2.transcripts.gtf").name - ).match("star_salmon/stringtie") }, - { assert snapshot( - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/WT_REP1.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/WT_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/WT_REP2.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/WT_REP2.markdup.sorted.bam.bai").name - ).match("star_salmon/markdup") }, - { assert snapshot( - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/cmd_info.json"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/cmd_info.json"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/cmd_info.json"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/WT_REP1/cmd_info.json"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/WT_REP2/cmd_info.json"), - path("${params.outdir}/star_salmon/tx2gene.tsv"), - // These files are not stable - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/quant.genes.sf").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/quant.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/quant.genes.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/quant.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/quant.genes.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/quant.sf").name, - file("${params.outdir}/star_salmon/WT_REP1/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/WT_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/WT_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/WT_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/WT_REP1/quant.genes.sf").name, - file("${params.outdir}/star_salmon/WT_REP1/quant.sf").name, - file("${params.outdir}/star_salmon/WT_REP2/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/WT_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/WT_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/WT_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/WT_REP2/quant.genes.sf").name, - file("${params.outdir}/star_salmon/WT_REP2/quant.sf").name - ).match("star_salmon/salmon_quant") }, - { assert snapshot( - // These reports are not stable - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt").name - ).match("trimgalore") }, - { assert snapshot( - UTILS.removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml") - ).match("versions") } + { assert workflow.success}, + { assert snapshot( + // Number of successful tasks + workflow.trace.succeeded().size(), + // pipeline versions.yml file for multiqc from which Nextflow version is removed because we tests pipelines on multiple Nextflow versions + removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), + // All stable path name, with a relative path + getRelativePath(stable_name, outputDir), + // All files with stable contents + stable_path + ).match() } ) } } @@ -946,31 +45,21 @@ nextflow_pipeline { } then { + // stable_name: All files + folders in ${params.outdir}/ with a stable name + def stable_name = getAllFilesFromDir(params.outdir, true, ['pipeline_info/*.{html,json,txt}'], null) + // stable_path: All files in ${params.outdir}/ with stable content + def stable_path = getAllFilesFromDir(params.outdir, false, null, 'tests/.nftignore') assertAll( - { assert workflow.success }, - { assert snapshot( - UTILS.removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), - file("${params.outdir}/custom/out/genome_transcriptome.fasta").name, - file("${params.outdir}/custom/out/genome_transcriptome.gtf").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw.zip").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report.html").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt").name + { assert workflow.success}, + { assert snapshot( + // Number of successful tasks + workflow.trace.succeeded().size(), + // pipeline versions.yml file for multiqc from which Nextflow version is removed because we tests pipelines on multiple Nextflow versions + removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), + // All stable path name, with a relative path + getRelativePath(stable_name, outputDir), + // All files with stable contents + stable_path ).match() } ) } diff --git a/tests/remove_ribo_rna.nf.test.snap b/tests/remove_ribo_rna.nf.test.snap index a6e841b08..528163582 100644 --- a/tests/remove_ribo_rna.nf.test.snap +++ b/tests/remove_ribo_rna.nf.test.snap @@ -1,1102 +1,1623 @@ { - "star_salmon/log": { + "Params: --remove_ribo_rna": { "content": [ - "RAP1_IAA_30M_REP1.SJ.out.tab:md5,ea95e243278af55534f2c52eb5fff7ee", - "RAP1_UNINDUCED_REP1.SJ.out.tab:md5,e548d13942535dc0821f3ec6d9743ec8", - "RAP1_UNINDUCED_REP2.SJ.out.tab:md5,1f294365343a1a5e95682792fdb77033", - "WT_REP1.SJ.out.tab:md5,1350c2fa6a675bf107386c6cd3fc5204", - "WT_REP2.SJ.out.tab:md5,f6cc03643a5e3c1025a5b4754eb1be23", - "RAP1_IAA_30M_REP1.Log.final.out", - "RAP1_IAA_30M_REP1.Log.out", - "RAP1_IAA_30M_REP1.Log.progress.out", - "RAP1_UNINDUCED_REP1.Log.final.out", - "RAP1_UNINDUCED_REP1.Log.out", - "RAP1_UNINDUCED_REP1.Log.progress.out", - "RAP1_UNINDUCED_REP2.Log.final.out", - "RAP1_UNINDUCED_REP2.Log.out", - "RAP1_UNINDUCED_REP2.Log.progress.out", - "WT_REP1.Log.final.out", - "WT_REP1.Log.out", - "WT_REP1.Log.progress.out", - "WT_REP2.Log.final.out", - "WT_REP2.Log.out", - "WT_REP2.Log.progress.out" + 205, + { + "BBMAP_BBSPLIT": { + "bbmap": 39.01 + }, + "BEDTOOLS_GENOMECOV_FW": { + "bedtools": "2.31.1" + }, + "CAT_FASTQ": { + "cat": 8.3 + }, + "CUSTOM_CATADDITIONALFASTA": { + "python": "3.9.5" + }, + "CUSTOM_GETCHROMSIZES": { + "getchromsizes": 1.2 + }, + "CUSTOM_TX2GENE": { + "python": "3.9.5" + }, + "DESEQ2_QC_PSEUDO": { + "r-base": "4.0.3", + "bioconductor-deseq2": "1.28.0" + }, + "DESEQ2_QC_STAR_SALMON": { + "r-base": "4.0.3", + "bioconductor-deseq2": "1.28.0" + }, + "DUPRADAR": { + "bioconductor-dupradar": "1.32.0" + }, + "FASTQC": { + "fastqc": "0.12.1" + }, + "FQ_SUBSAMPLE": { + "fq": "0.9.1 (2022-02-22)" + }, + "GTF2BED": { + "perl": "5.26.2" + }, + "GTF_FILTER": { + "python": "3.9.5" + }, + "GUNZIP_ADDITIONAL_FASTA": { + "gunzip": 1.1 + }, + "GUNZIP_GTF": { + "gunzip": 1.1 + }, + "MULTIQC_CUSTOM_BIOTYPE": { + "python": "3.9.5" + }, + "PICARD_MARKDUPLICATES": { + "picard": "3.1.1" + }, + "QUALIMAP_RNASEQ": { + "qualimap": 2.3 + }, + "RSEQC_BAMSTAT": { + "rseqc": "5.0.2" + }, + "RSEQC_INFEREXPERIMENT": { + "rseqc": "5.0.2" + }, + "RSEQC_INNERDISTANCE": { + "rseqc": "5.0.2" + }, + "RSEQC_JUNCTIONANNOTATION": { + "rseqc": "5.0.2" + }, + "RSEQC_JUNCTIONSATURATION": { + "rseqc": "5.0.2" + }, + "RSEQC_READDISTRIBUTION": { + "rseqc": "5.0.2" + }, + "RSEQC_READDUPLICATION": { + "rseqc": "5.0.2" + }, + "SALMON_QUANT": { + "salmon": "1.10.1" + }, + "SAMTOOLS_FLAGSTAT": { + "samtools": 1.2 + }, + "SAMTOOLS_IDXSTATS": { + "samtools": 1.2 + }, + "SAMTOOLS_INDEX": { + "samtools": 1.2 + }, + "SAMTOOLS_SORT": { + "samtools": 1.2 + }, + "SAMTOOLS_STATS": { + "samtools": 1.2 + }, + "SE_GENE": { + "bioconductor-summarizedexperiment": "1.32.0" + }, + "SORTMERNA": { + "sortmerna": "4.3.6" + }, + "SORTMERNA_INDEX": { + "sortmerna": "4.3.6" + }, + "STAR_ALIGN": { + "star": "2.7.10a", + "samtools": 1.18, + "gawk": "5.1.0" + }, + "STAR_GENOMEGENERATE": { + "star": "2.7.10a", + "samtools": 1.18, + "gawk": "5.1.0" + }, + "STRINGTIE_STRINGTIE": { + "stringtie": "2.2.1" + }, + "SUBREAD_FEATURECOUNTS": { + "subread": "2.0.1" + }, + "TRIMGALORE": { + "trimgalore": "0.6.7", + "cutadapt": 3.4 + }, + "TXIMETA_TXIMPORT": { + "bioconductor-tximeta": "1.20.1" + }, + "UCSC_BEDCLIP": { + "ucsc": 377 + }, + "UCSC_BEDGRAPHTOBIGWIG": { + "ucsc": 445 + }, + "UNTAR_SALMON_INDEX": { + "untar": 1.34 + }, + "Workflow": { + "nf-core/rnaseq": "v3.16.0dev" + } + }, + [ + "bbsplit", + "bbsplit/RAP1_IAA_30M_REP1.stats.txt", + "bbsplit/RAP1_UNINDUCED_REP1.stats.txt", + "bbsplit/RAP1_UNINDUCED_REP2.stats.txt", + "bbsplit/WT_REP1.stats.txt", + "bbsplit/WT_REP2.stats.txt", + "custom", + "custom/out", + "custom/out/genome_gfp.fasta", + "custom/out/genome_gfp.gtf", + "fastqc", + "fastqc/raw", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.html", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.zip", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.html", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.zip", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.html", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.zip", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.html", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.zip", + "fastqc/raw/WT_REP1_raw_1_fastqc.html", + "fastqc/raw/WT_REP1_raw_1_fastqc.zip", + "fastqc/raw/WT_REP1_raw_2_fastqc.html", + "fastqc/raw/WT_REP1_raw_2_fastqc.zip", + "fastqc/raw/WT_REP2_raw_1_fastqc.html", + "fastqc/raw/WT_REP2_raw_1_fastqc.zip", + "fastqc/raw/WT_REP2_raw_2_fastqc.html", + "fastqc/raw/WT_REP2_raw_2_fastqc.zip", + "fastqc/trim", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip", + "fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html", + "fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip", + "fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html", + "fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip", + "fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.html", + "fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.html", + "fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.zip", + "fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.html", + "fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.html", + "fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.zip", + "multiqc", + "multiqc/star_salmon", + "multiqc/star_salmon/multiqc_report.html", + "multiqc/star_salmon/multiqc_report_data", + "multiqc/star_salmon/multiqc_report_data/cutadapt_filtered_reads_plot.txt", + "multiqc/star_salmon/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc-status-check-heatmap-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc-status-check-heatmap.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_adapter_content_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_overrepresented_sequences_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_overrepresented_sequences_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_base_n_content_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_base_n_content_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_base_sequence_quality_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_base_sequence_quality_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Percentages.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Percentages.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_quality_scores_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_quality_scores_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_counts_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_counts_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_duplication_levels_plot-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_duplication_levels_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_length_distribution_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_top_overrepresented_sequences_table-1.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_top_overrepresented_sequences_table.txt", + "multiqc/star_salmon/multiqc_report_data/junction_saturation_known.txt", + "multiqc/star_salmon/multiqc_report_data/junction_saturation_novel.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_citations.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_cutadapt.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_data.json", + "multiqc/star_salmon/multiqc_report_data/multiqc_dupradar-section-plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_fail_strand_check_table.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_fastqc_fastqc_raw.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_fastqc_fastqc_trimmed.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_featurecounts_biotype_plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_general_stats.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_picard_dups.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_bam_stat.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_infer_experiment.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_junction_annotation.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_read_distribution.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_1.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_2.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_3.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_4.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_pca-plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_samtools_flagstat.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_samtools_idxstats.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_samtools_stats.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_software_versions.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_sortmerna.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_sources.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_1.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_2.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_3.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_4.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_pca-plot.txt", + "multiqc/star_salmon/multiqc_report_data/picard_deduplication.txt", + "multiqc/star_salmon/multiqc_report_data/picard_histogram.txt", + "multiqc/star_salmon/multiqc_report_data/picard_histogram_1.txt", + "multiqc/star_salmon/multiqc_report_data/picard_histogram_2.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_gene_coverage_profile_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_gene_coverage_profile_Normalised.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_genomic_origin.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_rnaseq_cov_hist.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_rnaseq_genome_results.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_bam_stat.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_infer_experiment_plot.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance_plot_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance_plot_Percentages.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Events.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Junctions.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_all.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_All_Junctions.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_Known_Junctions.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_Novel_Junctions.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_read_distribution_plot.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_read_dups.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_read_dups_plot.txt", + "multiqc/star_salmon/multiqc_report_data/salmon_plot.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Percentage_of_total.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Read_counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Raw_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-stats-dp.txt", + "multiqc/star_salmon/multiqc_report_data/samtools_alignment_plot.txt", + "multiqc/star_salmon/multiqc_report_data/sortmerna-detailed-plot.txt", + "multiqc/star_salmon/multiqc_report_data/star_alignment_plot.txt", + "multiqc/star_salmon/multiqc_report_data/star_summary_table.txt", + "multiqc/star_salmon/multiqc_report_plots", + "multiqc/star_salmon/multiqc_report_plots/pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/dupradar-section-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fail_strand_check_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc-status-check-heatmap-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc-status-check-heatmap.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_adapter_content_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Percentages.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Percentages.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_length_distribution_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table-1.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/featurecounts_biotype_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/featurecounts_biotype_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/general_stats_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Normalised.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_genomic_origin-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_genomic_origin-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_bam_stat.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_infer_experiment_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Percentages.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_All_Junctions.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Known_Junctions.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Novel_Junctions.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_distribution_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_distribution_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_dups_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/salmon_deseq2_clustering-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/salmon_deseq2_pca-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/salmon_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Percentage_of_total.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Read_counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-stats-dp.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/sortmerna-detailed-plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/sortmerna-detailed-plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_salmon_deseq2_clustering-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_salmon_deseq2_pca-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_summary_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/png", + "multiqc/star_salmon/multiqc_report_plots/png/cutadapt_filtered_reads_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/cutadapt_filtered_reads_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Obs_Exp.png", + "multiqc/star_salmon/multiqc_report_plots/png/dupradar-section-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fail_strand_check_table.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc-status-check-heatmap-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc-status-check-heatmap.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_adapter_content_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_n_content_plot-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_n_content_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Percentages.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Percentages.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_length_distribution_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table-1.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table.png", + "multiqc/star_salmon/multiqc_report_plots/png/featurecounts_biotype_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/featurecounts_biotype_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/general_stats_table.png", + "multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/qualimap_gene_coverage_profile_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/qualimap_gene_coverage_profile_Normalised.png", + "multiqc/star_salmon/multiqc_report_plots/png/qualimap_genomic_origin-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/qualimap_genomic_origin-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_bam_stat.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_infer_experiment_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_inner_distance_plot_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_inner_distance_plot_Percentages.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_All_Junctions.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_Known_Junctions.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_Novel_Junctions.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_distribution_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_distribution_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_dups_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/salmon_deseq2_clustering-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/salmon_deseq2_pca-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/salmon_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Percentage_of_total.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Read_counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-stats-dp.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/sortmerna-detailed-plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/sortmerna-detailed-plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_salmon_deseq2_clustering-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_salmon_deseq2_pca-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_summary_table.png", + "multiqc/star_salmon/multiqc_report_plots/svg", + "multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/dupradar-section-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fail_strand_check_table.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc-status-check-heatmap-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc-status-check-heatmap.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_adapter_content_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_n_content_plot-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_n_content_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Percentages.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Percentages.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_length_distribution_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table-1.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/featurecounts_biotype_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/featurecounts_biotype_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/general_stats_table.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Normalised.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/qualimap_genomic_origin-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/qualimap_genomic_origin-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_bam_stat.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_infer_experiment_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_inner_distance_plot_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_inner_distance_plot_Percentages.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_All_Junctions.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Known_Junctions.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Novel_Junctions.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_distribution_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_distribution_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_dups_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/salmon_deseq2_clustering-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/salmon_deseq2_pca-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/salmon_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Percentage_of_total.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Read_counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-stats-dp.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/sortmerna-detailed-plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/sortmerna-detailed-plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_salmon_deseq2_clustering-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_salmon_deseq2_pca-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_summary_table.svg", + "pipeline_info", + "pipeline_info/nf_core_rnaseq_software_mqc_versions.yml", + "salmon", + "salmon/RAP1_IAA_30M_REP1", + "salmon/RAP1_IAA_30M_REP1/aux_info", + "salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv", + "salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json", + "salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz", + "salmon/RAP1_IAA_30M_REP1/cmd_info.json", + "salmon/RAP1_IAA_30M_REP1/libParams", + "salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt", + "salmon/RAP1_IAA_30M_REP1/lib_format_counts.json", + "salmon/RAP1_IAA_30M_REP1/logs", + "salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log", + "salmon/RAP1_IAA_30M_REP1/quant.genes.sf", + "salmon/RAP1_IAA_30M_REP1/quant.sf", + "salmon/RAP1_UNINDUCED_REP1", + "salmon/RAP1_UNINDUCED_REP1/aux_info", + "salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv", + "salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json", + "salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz", + "salmon/RAP1_UNINDUCED_REP1/cmd_info.json", + "salmon/RAP1_UNINDUCED_REP1/libParams", + "salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt", + "salmon/RAP1_UNINDUCED_REP1/lib_format_counts.json", + "salmon/RAP1_UNINDUCED_REP1/logs", + "salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log", + "salmon/RAP1_UNINDUCED_REP1/quant.genes.sf", + "salmon/RAP1_UNINDUCED_REP1/quant.sf", + "salmon/RAP1_UNINDUCED_REP2", + "salmon/RAP1_UNINDUCED_REP2/aux_info", + "salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv", + "salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json", + "salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz", + "salmon/RAP1_UNINDUCED_REP2/cmd_info.json", + "salmon/RAP1_UNINDUCED_REP2/libParams", + "salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt", + "salmon/RAP1_UNINDUCED_REP2/lib_format_counts.json", + "salmon/RAP1_UNINDUCED_REP2/logs", + "salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log", + "salmon/RAP1_UNINDUCED_REP2/quant.genes.sf", + "salmon/RAP1_UNINDUCED_REP2/quant.sf", + "salmon/WT_REP1", + "salmon/WT_REP1/aux_info", + "salmon/WT_REP1/aux_info/ambig_info.tsv", + "salmon/WT_REP1/aux_info/expected_bias.gz", + "salmon/WT_REP1/aux_info/fld.gz", + "salmon/WT_REP1/aux_info/meta_info.json", + "salmon/WT_REP1/aux_info/observed_bias.gz", + "salmon/WT_REP1/aux_info/observed_bias_3p.gz", + "salmon/WT_REP1/cmd_info.json", + "salmon/WT_REP1/libParams", + "salmon/WT_REP1/libParams/flenDist.txt", + "salmon/WT_REP1/lib_format_counts.json", + "salmon/WT_REP1/logs", + "salmon/WT_REP1/logs/salmon_quant.log", + "salmon/WT_REP1/quant.genes.sf", + "salmon/WT_REP1/quant.sf", + "salmon/WT_REP2", + "salmon/WT_REP2/aux_info", + "salmon/WT_REP2/aux_info/ambig_info.tsv", + "salmon/WT_REP2/aux_info/expected_bias.gz", + "salmon/WT_REP2/aux_info/fld.gz", + "salmon/WT_REP2/aux_info/meta_info.json", + "salmon/WT_REP2/aux_info/observed_bias.gz", + "salmon/WT_REP2/aux_info/observed_bias_3p.gz", + "salmon/WT_REP2/cmd_info.json", + "salmon/WT_REP2/libParams", + "salmon/WT_REP2/libParams/flenDist.txt", + "salmon/WT_REP2/lib_format_counts.json", + "salmon/WT_REP2/logs", + "salmon/WT_REP2/logs/salmon_quant.log", + "salmon/WT_REP2/quant.genes.sf", + "salmon/WT_REP2/quant.sf", + "salmon/deseq2_qc", + "salmon/deseq2_qc/R_sessionInfo.log", + "salmon/deseq2_qc/deseq2.dds.RData", + "salmon/deseq2_qc/deseq2.pca.vals.txt", + "salmon/deseq2_qc/deseq2.plots.pdf", + "salmon/deseq2_qc/deseq2.sample.dists.txt", + "salmon/deseq2_qc/size_factors", + "salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt", + "salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt", + "salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt", + "salmon/deseq2_qc/size_factors/WT_REP1.txt", + "salmon/deseq2_qc/size_factors/WT_REP2.txt", + "salmon/deseq2_qc/size_factors/deseq2.size_factors.RData", + "salmon/salmon.merged.gene_counts.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts.tsv", + "salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts_length_scaled.tsv", + "salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts_scaled.tsv", + "salmon/salmon.merged.gene_lengths.tsv", + "salmon/salmon.merged.gene_tpm.tsv", + "salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds", + "salmon/salmon.merged.transcript_counts.tsv", + "salmon/salmon.merged.transcript_lengths.tsv", + "salmon/salmon.merged.transcript_tpm.tsv", + "salmon/tx2gene.tsv", + "sortmerna", + "sortmerna/RAP1_IAA_30M_REP1.sortmerna.log", + "sortmerna/RAP1_UNINDUCED_REP1.sortmerna.log", + "sortmerna/RAP1_UNINDUCED_REP2.sortmerna.log", + "sortmerna/WT_REP1.sortmerna.log", + "sortmerna/WT_REP2.sortmerna.log", + "star_salmon", + "star_salmon/RAP1_IAA_30M_REP1", + "star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam", + "star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam.bai", + "star_salmon/RAP1_IAA_30M_REP1/aux_info", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz", + "star_salmon/RAP1_IAA_30M_REP1/cmd_info.json", + "star_salmon/RAP1_IAA_30M_REP1/libParams", + "star_salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt", + "star_salmon/RAP1_IAA_30M_REP1/logs", + "star_salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log", + "star_salmon/RAP1_IAA_30M_REP1/quant.genes.sf", + "star_salmon/RAP1_IAA_30M_REP1/quant.sf", + "star_salmon/RAP1_UNINDUCED_REP1", + "star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam", + "star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz", + "star_salmon/RAP1_UNINDUCED_REP1/cmd_info.json", + "star_salmon/RAP1_UNINDUCED_REP1/libParams", + "star_salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt", + "star_salmon/RAP1_UNINDUCED_REP1/logs", + "star_salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log", + "star_salmon/RAP1_UNINDUCED_REP1/quant.genes.sf", + "star_salmon/RAP1_UNINDUCED_REP1/quant.sf", + "star_salmon/RAP1_UNINDUCED_REP2", + "star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam", + "star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz", + "star_salmon/RAP1_UNINDUCED_REP2/cmd_info.json", + "star_salmon/RAP1_UNINDUCED_REP2/libParams", + "star_salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt", + "star_salmon/RAP1_UNINDUCED_REP2/logs", + "star_salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log", + "star_salmon/RAP1_UNINDUCED_REP2/quant.genes.sf", + "star_salmon/RAP1_UNINDUCED_REP2/quant.sf", + "star_salmon/WT_REP1", + "star_salmon/WT_REP1.markdup.sorted.bam", + "star_salmon/WT_REP1.markdup.sorted.bam.bai", + "star_salmon/WT_REP1/aux_info", + "star_salmon/WT_REP1/aux_info/ambig_info.tsv", + "star_salmon/WT_REP1/aux_info/expected_bias.gz", + "star_salmon/WT_REP1/aux_info/fld.gz", + "star_salmon/WT_REP1/aux_info/meta_info.json", + "star_salmon/WT_REP1/aux_info/observed_bias.gz", + "star_salmon/WT_REP1/aux_info/observed_bias_3p.gz", + "star_salmon/WT_REP1/cmd_info.json", + "star_salmon/WT_REP1/libParams", + "star_salmon/WT_REP1/libParams/flenDist.txt", + "star_salmon/WT_REP1/logs", + "star_salmon/WT_REP1/logs/salmon_quant.log", + "star_salmon/WT_REP1/quant.genes.sf", + "star_salmon/WT_REP1/quant.sf", + "star_salmon/WT_REP2", + "star_salmon/WT_REP2.markdup.sorted.bam", + "star_salmon/WT_REP2.markdup.sorted.bam.bai", + "star_salmon/WT_REP2/aux_info", + "star_salmon/WT_REP2/aux_info/ambig_info.tsv", + "star_salmon/WT_REP2/aux_info/expected_bias.gz", + "star_salmon/WT_REP2/aux_info/fld.gz", + "star_salmon/WT_REP2/aux_info/meta_info.json", + "star_salmon/WT_REP2/aux_info/observed_bias.gz", + "star_salmon/WT_REP2/aux_info/observed_bias_3p.gz", + "star_salmon/WT_REP2/cmd_info.json", + "star_salmon/WT_REP2/libParams", + "star_salmon/WT_REP2/libParams/flenDist.txt", + "star_salmon/WT_REP2/logs", + "star_salmon/WT_REP2/logs/salmon_quant.log", + "star_salmon/WT_REP2/quant.genes.sf", + "star_salmon/WT_REP2/quant.sf", + "star_salmon/bigwig", + "star_salmon/bigwig/RAP1_IAA_30M_REP1.forward.bigWig", + "star_salmon/bigwig/RAP1_IAA_30M_REP1.reverse.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP1.forward.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP1.reverse.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP2.forward.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP2.reverse.bigWig", + "star_salmon/bigwig/WT_REP1.forward.bigWig", + "star_salmon/bigwig/WT_REP1.reverse.bigWig", + "star_salmon/bigwig/WT_REP2.forward.bigWig", + "star_salmon/bigwig/WT_REP2.reverse.bigWig", + "star_salmon/deseq2_qc", + "star_salmon/deseq2_qc/R_sessionInfo.log", + "star_salmon/deseq2_qc/deseq2.dds.RData", + "star_salmon/deseq2_qc/deseq2.pca.vals.txt", + "star_salmon/deseq2_qc/deseq2.plots.pdf", + "star_salmon/deseq2_qc/deseq2.sample.dists.txt", + "star_salmon/deseq2_qc/size_factors", + "star_salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt", + "star_salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt", + "star_salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt", + "star_salmon/deseq2_qc/size_factors/WT_REP1.txt", + "star_salmon/deseq2_qc/size_factors/WT_REP2.txt", + "star_salmon/deseq2_qc/size_factors/deseq2.size_factors.RData", + "star_salmon/dupradar", + "star_salmon/dupradar/box_plot", + "star_salmon/dupradar/box_plot/RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf", + "star_salmon/dupradar/box_plot/RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf", + "star_salmon/dupradar/box_plot/RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf", + "star_salmon/dupradar/box_plot/WT_REP1_duprateExpBoxplot.pdf", + "star_salmon/dupradar/box_plot/WT_REP2_duprateExpBoxplot.pdf", + "star_salmon/dupradar/gene_data", + "star_salmon/dupradar/gene_data/RAP1_IAA_30M_REP1_dupMatrix.txt", + "star_salmon/dupradar/gene_data/RAP1_UNINDUCED_REP1_dupMatrix.txt", + "star_salmon/dupradar/gene_data/RAP1_UNINDUCED_REP2_dupMatrix.txt", + "star_salmon/dupradar/gene_data/WT_REP1_dupMatrix.txt", + "star_salmon/dupradar/gene_data/WT_REP2_dupMatrix.txt", + "star_salmon/dupradar/histogram", + "star_salmon/dupradar/histogram/RAP1_IAA_30M_REP1_expressionHist.pdf", + "star_salmon/dupradar/histogram/RAP1_UNINDUCED_REP1_expressionHist.pdf", + "star_salmon/dupradar/histogram/RAP1_UNINDUCED_REP2_expressionHist.pdf", + "star_salmon/dupradar/histogram/WT_REP1_expressionHist.pdf", + "star_salmon/dupradar/histogram/WT_REP2_expressionHist.pdf", + "star_salmon/dupradar/intercepts_slope", + "star_salmon/dupradar/intercepts_slope/RAP1_IAA_30M_REP1_intercept_slope.txt", + "star_salmon/dupradar/intercepts_slope/RAP1_UNINDUCED_REP1_intercept_slope.txt", + "star_salmon/dupradar/intercepts_slope/RAP1_UNINDUCED_REP2_intercept_slope.txt", + "star_salmon/dupradar/intercepts_slope/WT_REP1_intercept_slope.txt", + "star_salmon/dupradar/intercepts_slope/WT_REP2_intercept_slope.txt", + "star_salmon/dupradar/scatter_plot", + "star_salmon/dupradar/scatter_plot/RAP1_IAA_30M_REP1_duprateExpDens.pdf", + "star_salmon/dupradar/scatter_plot/RAP1_UNINDUCED_REP1_duprateExpDens.pdf", + "star_salmon/dupradar/scatter_plot/RAP1_UNINDUCED_REP2_duprateExpDens.pdf", + "star_salmon/dupradar/scatter_plot/WT_REP1_duprateExpDens.pdf", + "star_salmon/dupradar/scatter_plot/WT_REP2_duprateExpDens.pdf", + "star_salmon/featurecounts", + "star_salmon/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv", + "star_salmon/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv", + "star_salmon/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt", + "star_salmon/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt.summary", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt.summary", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt.summary", + "star_salmon/featurecounts/WT_REP1.biotype_counts_mqc.tsv", + "star_salmon/featurecounts/WT_REP1.biotype_counts_rrna_mqc.tsv", + "star_salmon/featurecounts/WT_REP1.featureCounts.txt", + "star_salmon/featurecounts/WT_REP1.featureCounts.txt.summary", + "star_salmon/featurecounts/WT_REP2.biotype_counts_mqc.tsv", + "star_salmon/featurecounts/WT_REP2.biotype_counts_rrna_mqc.tsv", + "star_salmon/featurecounts/WT_REP2.featureCounts.txt", + "star_salmon/featurecounts/WT_REP2.featureCounts.txt.summary", + "star_salmon/log", + "star_salmon/log/RAP1_IAA_30M_REP1.Log.final.out", + "star_salmon/log/RAP1_IAA_30M_REP1.Log.out", + "star_salmon/log/RAP1_IAA_30M_REP1.Log.progress.out", + "star_salmon/log/RAP1_IAA_30M_REP1.SJ.out.tab", + "star_salmon/log/RAP1_UNINDUCED_REP1.Log.final.out", + "star_salmon/log/RAP1_UNINDUCED_REP1.Log.out", + "star_salmon/log/RAP1_UNINDUCED_REP1.Log.progress.out", + "star_salmon/log/RAP1_UNINDUCED_REP1.SJ.out.tab", + "star_salmon/log/RAP1_UNINDUCED_REP2.Log.final.out", + "star_salmon/log/RAP1_UNINDUCED_REP2.Log.out", + "star_salmon/log/RAP1_UNINDUCED_REP2.Log.progress.out", + "star_salmon/log/RAP1_UNINDUCED_REP2.SJ.out.tab", + "star_salmon/log/WT_REP1.Log.final.out", + "star_salmon/log/WT_REP1.Log.out", + "star_salmon/log/WT_REP1.Log.progress.out", + "star_salmon/log/WT_REP1.SJ.out.tab", + "star_salmon/log/WT_REP2.Log.final.out", + "star_salmon/log/WT_REP2.Log.out", + "star_salmon/log/WT_REP2.Log.progress.out", + "star_salmon/log/WT_REP2.SJ.out.tab", + "star_salmon/picard_metrics", + "star_salmon/picard_metrics/RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/qualimap", + "star_salmon/qualimap/RAP1_IAA_30M_REP1", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/agogo.css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/ajax-loader.gif", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/basic.css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/bgfooter.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/bgtop.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/comment-bright.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/comment-close.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/comment.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/doctools.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/down-pressed.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/down.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/file.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/jquery.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/minus.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/plus.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/pygments.css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/qualimap_logo_small.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/report.css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/searchtools.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/underscore.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/up-pressed.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/up.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/websupport.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/qualimapReport.html", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/rnaseq_qc_results.txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/agogo.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/ajax-loader.gif", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/basic.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/bgfooter.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/bgtop.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/comment-bright.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/comment-close.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/comment.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/doctools.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/down-pressed.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/down.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/file.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/jquery.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/minus.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/plus.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/pygments.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/qualimap_logo_small.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/report.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/searchtools.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/underscore.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/up-pressed.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/up.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/websupport.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/qualimapReport.html", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/rnaseq_qc_results.txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/agogo.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/ajax-loader.gif", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/basic.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/bgfooter.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/bgtop.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/comment-bright.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/comment-close.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/comment.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/doctools.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/down-pressed.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/down.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/file.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/jquery.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/minus.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/plus.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/pygments.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/qualimap_logo_small.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/report.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/searchtools.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/underscore.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/up-pressed.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/up.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/websupport.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/qualimapReport.html", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/rnaseq_qc_results.txt", + "star_salmon/qualimap/WT_REP1", + "star_salmon/qualimap/WT_REP1/css", + "star_salmon/qualimap/WT_REP1/css/agogo.css", + "star_salmon/qualimap/WT_REP1/css/ajax-loader.gif", + "star_salmon/qualimap/WT_REP1/css/basic.css", + "star_salmon/qualimap/WT_REP1/css/bgfooter.png", + "star_salmon/qualimap/WT_REP1/css/bgtop.png", + "star_salmon/qualimap/WT_REP1/css/comment-bright.png", + "star_salmon/qualimap/WT_REP1/css/comment-close.png", + "star_salmon/qualimap/WT_REP1/css/comment.png", + "star_salmon/qualimap/WT_REP1/css/doctools.js", + "star_salmon/qualimap/WT_REP1/css/down-pressed.png", + "star_salmon/qualimap/WT_REP1/css/down.png", + "star_salmon/qualimap/WT_REP1/css/file.png", + "star_salmon/qualimap/WT_REP1/css/jquery.js", + "star_salmon/qualimap/WT_REP1/css/minus.png", + "star_salmon/qualimap/WT_REP1/css/plus.png", + "star_salmon/qualimap/WT_REP1/css/pygments.css", + "star_salmon/qualimap/WT_REP1/css/qualimap_logo_small.png", + "star_salmon/qualimap/WT_REP1/css/report.css", + "star_salmon/qualimap/WT_REP1/css/searchtools.js", + "star_salmon/qualimap/WT_REP1/css/underscore.js", + "star_salmon/qualimap/WT_REP1/css/up-pressed.png", + "star_salmon/qualimap/WT_REP1/css/up.png", + "star_salmon/qualimap/WT_REP1/css/websupport.js", + "star_salmon/qualimap/WT_REP1/images_qualimapReport", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/WT_REP1/qualimapReport.html", + "star_salmon/qualimap/WT_REP1/raw_data_qualimapReport", + "star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/WT_REP1/rnaseq_qc_results.txt", + "star_salmon/qualimap/WT_REP2", + "star_salmon/qualimap/WT_REP2/css", + "star_salmon/qualimap/WT_REP2/css/agogo.css", + "star_salmon/qualimap/WT_REP2/css/ajax-loader.gif", + "star_salmon/qualimap/WT_REP2/css/basic.css", + "star_salmon/qualimap/WT_REP2/css/bgfooter.png", + "star_salmon/qualimap/WT_REP2/css/bgtop.png", + "star_salmon/qualimap/WT_REP2/css/comment-bright.png", + "star_salmon/qualimap/WT_REP2/css/comment-close.png", + "star_salmon/qualimap/WT_REP2/css/comment.png", + "star_salmon/qualimap/WT_REP2/css/doctools.js", + "star_salmon/qualimap/WT_REP2/css/down-pressed.png", + "star_salmon/qualimap/WT_REP2/css/down.png", + "star_salmon/qualimap/WT_REP2/css/file.png", + "star_salmon/qualimap/WT_REP2/css/jquery.js", + "star_salmon/qualimap/WT_REP2/css/minus.png", + "star_salmon/qualimap/WT_REP2/css/plus.png", + "star_salmon/qualimap/WT_REP2/css/pygments.css", + "star_salmon/qualimap/WT_REP2/css/qualimap_logo_small.png", + "star_salmon/qualimap/WT_REP2/css/report.css", + "star_salmon/qualimap/WT_REP2/css/searchtools.js", + "star_salmon/qualimap/WT_REP2/css/underscore.js", + "star_salmon/qualimap/WT_REP2/css/up-pressed.png", + "star_salmon/qualimap/WT_REP2/css/up.png", + "star_salmon/qualimap/WT_REP2/css/websupport.js", + "star_salmon/qualimap/WT_REP2/images_qualimapReport", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/WT_REP2/qualimapReport.html", + "star_salmon/qualimap/WT_REP2/raw_data_qualimapReport", + "star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/WT_REP2/rnaseq_qc_results.txt", + "star_salmon/rseqc", + "star_salmon/rseqc/bam_stat", + "star_salmon/rseqc/bam_stat/RAP1_IAA_30M_REP1.bam_stat.txt", + "star_salmon/rseqc/bam_stat/RAP1_UNINDUCED_REP1.bam_stat.txt", + "star_salmon/rseqc/bam_stat/RAP1_UNINDUCED_REP2.bam_stat.txt", + "star_salmon/rseqc/bam_stat/WT_REP1.bam_stat.txt", + "star_salmon/rseqc/bam_stat/WT_REP2.bam_stat.txt", + "star_salmon/rseqc/infer_experiment", + "star_salmon/rseqc/infer_experiment/RAP1_IAA_30M_REP1.infer_experiment.txt", + "star_salmon/rseqc/infer_experiment/RAP1_UNINDUCED_REP1.infer_experiment.txt", + "star_salmon/rseqc/infer_experiment/RAP1_UNINDUCED_REP2.infer_experiment.txt", + "star_salmon/rseqc/infer_experiment/WT_REP1.infer_experiment.txt", + "star_salmon/rseqc/infer_experiment/WT_REP2.infer_experiment.txt", + "star_salmon/rseqc/inner_distance", + "star_salmon/rseqc/inner_distance/pdf", + "star_salmon/rseqc/inner_distance/pdf/RAP1_IAA_30M_REP1.inner_distance_plot.pdf", + "star_salmon/rseqc/inner_distance/pdf/WT_REP1.inner_distance_plot.pdf", + "star_salmon/rseqc/inner_distance/pdf/WT_REP2.inner_distance_plot.pdf", + "star_salmon/rseqc/inner_distance/rscript", + "star_salmon/rseqc/inner_distance/rscript/RAP1_IAA_30M_REP1.inner_distance_plot.r", + "star_salmon/rseqc/inner_distance/rscript/WT_REP1.inner_distance_plot.r", + "star_salmon/rseqc/inner_distance/rscript/WT_REP2.inner_distance_plot.r", + "star_salmon/rseqc/inner_distance/txt", + "star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance.txt", + "star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_freq.txt", + "star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_mean.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance_freq.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance_mean.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance_freq.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance_mean.txt", + "star_salmon/rseqc/junction_annotation", + "star_salmon/rseqc/junction_annotation/bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.bed", + "star_salmon/rseqc/junction_annotation/bed/WT_REP1.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/WT_REP1.junction.bed", + "star_salmon/rseqc/junction_annotation/bed/WT_REP2.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/WT_REP2.junction.bed", + "star_salmon/rseqc/junction_annotation/log", + "star_salmon/rseqc/junction_annotation/log/RAP1_IAA_30M_REP1.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP1.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP2.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/log/WT_REP1.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/log/WT_REP2.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/pdf/WT_REP1.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/WT_REP1.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/pdf/WT_REP2.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/WT_REP2.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/rscript", + "star_salmon/rseqc/junction_annotation/rscript/RAP1_IAA_30M_REP1.junction_plot.r", + "star_salmon/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP1.junction_plot.r", + "star_salmon/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP2.junction_plot.r", + "star_salmon/rseqc/junction_annotation/rscript/WT_REP1.junction_plot.r", + "star_salmon/rseqc/junction_annotation/rscript/WT_REP2.junction_plot.r", + "star_salmon/rseqc/junction_annotation/xls", + "star_salmon/rseqc/junction_annotation/xls/RAP1_IAA_30M_REP1.junction.xls", + "star_salmon/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP1.junction.xls", + "star_salmon/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP2.junction.xls", + "star_salmon/rseqc/junction_annotation/xls/WT_REP1.junction.xls", + "star_salmon/rseqc/junction_annotation/xls/WT_REP2.junction.xls", + "star_salmon/rseqc/junction_saturation", + "star_salmon/rseqc/junction_saturation/pdf", + "star_salmon/rseqc/junction_saturation/pdf/RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/pdf/WT_REP1.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/pdf/WT_REP2.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/rscript", + "star_salmon/rseqc/junction_saturation/rscript/RAP1_IAA_30M_REP1.junctionSaturation_plot.r", + "star_salmon/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP1.junctionSaturation_plot.r", + "star_salmon/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP2.junctionSaturation_plot.r", + "star_salmon/rseqc/junction_saturation/rscript/WT_REP1.junctionSaturation_plot.r", + "star_salmon/rseqc/junction_saturation/rscript/WT_REP2.junctionSaturation_plot.r", + "star_salmon/rseqc/read_distribution", + "star_salmon/rseqc/read_distribution/RAP1_IAA_30M_REP1.read_distribution.txt", + "star_salmon/rseqc/read_distribution/RAP1_UNINDUCED_REP1.read_distribution.txt", + "star_salmon/rseqc/read_distribution/RAP1_UNINDUCED_REP2.read_distribution.txt", + "star_salmon/rseqc/read_distribution/WT_REP1.read_distribution.txt", + "star_salmon/rseqc/read_distribution/WT_REP2.read_distribution.txt", + "star_salmon/rseqc/read_duplication", + "star_salmon/rseqc/read_duplication/pdf", + "star_salmon/rseqc/read_duplication/pdf/RAP1_IAA_30M_REP1.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP1.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP2.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/pdf/WT_REP1.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/pdf/WT_REP2.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/rscript", + "star_salmon/rseqc/read_duplication/rscript/RAP1_IAA_30M_REP1.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP1.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP2.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/rscript/WT_REP1.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/rscript/WT_REP2.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.seq.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.seq.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.seq.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/WT_REP1.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/WT_REP1.seq.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/WT_REP2.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/WT_REP2.seq.DupRate.xls", + "star_salmon/salmon.merged.gene_counts.SummarizedExperiment.rds", + "star_salmon/salmon.merged.gene_counts.tsv", + "star_salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", + "star_salmon/salmon.merged.gene_counts_length_scaled.tsv", + "star_salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", + "star_salmon/salmon.merged.gene_counts_scaled.tsv", + "star_salmon/salmon.merged.gene_lengths.tsv", + "star_salmon/salmon.merged.gene_tpm.tsv", + "star_salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds", + "star_salmon/salmon.merged.transcript_counts.tsv", + "star_salmon/salmon.merged.transcript_lengths.tsv", + "star_salmon/salmon.merged.transcript_tpm.tsv", + "star_salmon/samtools_stats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP1.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP1.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP1.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP2.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP2.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP2.sorted.bam.stats", + "star_salmon/stringtie", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e2t.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e_data.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i2t.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i_data.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/t_data.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.coverage.gtf", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.gene.abundance.txt", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.transcripts.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/t_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.coverage.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.gene.abundance.txt", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.transcripts.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/t_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.coverage.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.gene.abundance.txt", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.transcripts.gtf", + "star_salmon/stringtie/WT_REP1.ballgown", + "star_salmon/stringtie/WT_REP1.ballgown/e2t.ctab", + "star_salmon/stringtie/WT_REP1.ballgown/e_data.ctab", + "star_salmon/stringtie/WT_REP1.ballgown/i2t.ctab", + "star_salmon/stringtie/WT_REP1.ballgown/i_data.ctab", + "star_salmon/stringtie/WT_REP1.ballgown/t_data.ctab", + "star_salmon/stringtie/WT_REP1.coverage.gtf", + "star_salmon/stringtie/WT_REP1.gene.abundance.txt", + "star_salmon/stringtie/WT_REP1.transcripts.gtf", + "star_salmon/stringtie/WT_REP2.ballgown", + "star_salmon/stringtie/WT_REP2.ballgown/e2t.ctab", + "star_salmon/stringtie/WT_REP2.ballgown/e_data.ctab", + "star_salmon/stringtie/WT_REP2.ballgown/i2t.ctab", + "star_salmon/stringtie/WT_REP2.ballgown/i_data.ctab", + "star_salmon/stringtie/WT_REP2.ballgown/t_data.ctab", + "star_salmon/stringtie/WT_REP2.coverage.gtf", + "star_salmon/stringtie/WT_REP2.gene.abundance.txt", + "star_salmon/stringtie/WT_REP2.transcripts.gtf", + "star_salmon/tx2gene.tsv", + "trimgalore", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" + ], + [ + "genome_gfp.fasta:md5,e23e302af63736a199985a169fdac055", + "genome_gfp.gtf:md5,c98b12c302f15731bfc36bcf297cfe28", + "cutadapt_filtered_reads_plot.txt:md5,bf033e64e9d23bee85b6277f11c663f1", + "cutadapt_trimmed_sequences_plot_3_Counts.txt:md5,13dfa866fd91dbb072689efe9aa83b1f", + "cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt:md5,07145dd8dd3db654859b18eb0389046c", + "fastqc-status-check-heatmap-1.txt:md5,22a03548736b88b23be6bc0c9ef1b4a6", + "fastqc-status-check-heatmap.txt:md5,5a89b0d8d162f6b1dbdaf39457bbc03b", + "fastqc_adapter_content_plot.txt:md5,da0389be84cfdd189b1d045212eb2974", + "fastqc_overrepresented_sequences_plot-1.txt:md5,4adfeacd3a3a6c7c808f121b24e6b247", + "fastqc_overrepresented_sequences_plot.txt:md5,25d88ea8a72f55e8a374ae802bc7f0b1", + "fastqc_per_base_n_content_plot-1.txt:md5,418610c1ce119cb786ad434db75d366e", + "fastqc_per_base_n_content_plot.txt:md5,d368d7e36ca2f73dcde61f2b486d8213", + "fastqc_per_base_sequence_quality_plot-1.txt:md5,bd22e06e41c096ad4f745d40fe96a1e5", + "fastqc_per_base_sequence_quality_plot.txt:md5,5c3065b549129702b185ea1b817da420", + "fastqc_per_sequence_gc_content_plot-1_Counts.txt:md5,004c60768ceb6197765154e3eaa37b7a", + "fastqc_per_sequence_gc_content_plot-1_Percentages.txt:md5,95d29060b687f745288ad1ec47750037", + "fastqc_per_sequence_gc_content_plot_Counts.txt:md5,9ddaa50167117d3c9188ccf015427704", + "fastqc_per_sequence_gc_content_plot_Percentages.txt:md5,f10ee2881b61308af35f304aa3d810a3", + "fastqc_per_sequence_quality_scores_plot-1.txt:md5,0f9834cc19f76dd5c87cf8cba7435a7c", + "fastqc_per_sequence_quality_scores_plot.txt:md5,b5f9a02933e3065952237afd2ec9ce82", + "fastqc_sequence_counts_plot-1.txt:md5,3861354bbedfbde7ca36a72994f9425c", + "fastqc_sequence_counts_plot.txt:md5,d385a3e2c2573a0902c66e8c93876d3c", + "fastqc_sequence_duplication_levels_plot-1.txt:md5,c73407d55fc532e864fa1dc8dbc12874", + "fastqc_sequence_duplication_levels_plot.txt:md5,8812cee16f6ca65e2c33635754de1772", + "fastqc_sequence_length_distribution_plot.txt:md5,6fe2c985606abad947bcca99b015ae33", + "multiqc_citations.txt:md5,bfa9fd61367cd7265e324d009c974778", + "multiqc_cutadapt.txt:md5,aac9581a5670cb55edf564f3d6c1f9a7", + "multiqc_fastqc_fastqc_raw.txt:md5,81c3c1a2575a1891a7f2a9637a0f2cc0", + "multiqc_fastqc_fastqc_trimmed.txt:md5,a3238f515e01d158d875d69968753804", + "multiqc_featurecounts_biotype_plot.txt:md5,54f0eef4ab0ecf6a03505b18752b43cd", + "multiqc_samtools_idxstats.txt:md5,413ba06f3d8e4ab0dbde8ef8952c4b32", + "picard_histogram.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "picard_histogram_1.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "picard_histogram_2.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "qualimap_gene_coverage_profile_Counts.txt:md5,50e9209baeaafe181ce3b5caa05cf789", + "qualimap_gene_coverage_profile_Normalised.txt:md5,6ed32f112c679e73396350cbe5cb9459", + "qualimap_rnaseq_cov_hist.txt:md5,a895b3af229f661da1edbc21ec72edaa", + "rseqc_infer_experiment_plot.txt:md5,d8741451248f1a5a4ebe3230c1af9c95", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt:md5,75acd04232d1804b5f960ee4c5db4722", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt:md5,53addd7b78d8ae224920ec9b97489d72", + "samtools-idxstats-mapped-reads-plot_Raw_Counts.txt:md5,97fc7bde65a7efc5ab3af48ef0400c20", + "cutadapt_filtered_reads_plot-cnt.png:md5,704cf0d91bfa3dd658dd8c9590f669a2", + "cutadapt_filtered_reads_plot-pct.png:md5,2684d8b2afca3300e5786486b80237f0", + "cutadapt_trimmed_sequences_plot_3_Counts.png:md5,bef41d894629b0c4dab4478bbf197f50", + "cutadapt_trimmed_sequences_plot_3_Obs_Exp.png:md5,1e0d01537d3797623d0b3fd8fbe42787", + "dupradar-section-plot.png:md5,62ee84d3b32bdbfb9766fa970680f92c", + "fastqc-status-check-heatmap-1.png:md5,2402522f8c02e12aea9af088c6595890", + "fastqc-status-check-heatmap.png:md5,fe8b5b4ab4480d46a12a9005932a9b84", + "fastqc_overrepresented_sequences_plot-1.png:md5,40e450251b80ec0efc9364434234ec7f", + "fastqc_overrepresented_sequences_plot.png:md5,6f5ffbdf1bf61fabe5e028c8bc85de14", + "fastqc_per_sequence_gc_content_plot-1_Counts.png:md5,8a806cec2142f9911502e0a253d83d13", + "fastqc_per_sequence_gc_content_plot-1_Percentages.png:md5,953929d50c8490029880e205e4db7959", + "fastqc_per_sequence_gc_content_plot_Counts.png:md5,01f124545af788fd5cc7bbf41b005e16", + "fastqc_per_sequence_gc_content_plot_Percentages.png:md5,eba3abf8bedb2cb20bad90c54e9c8881", + "fastqc_per_sequence_quality_scores_plot-1.png:md5,d2c29cae169f35744500c751b4a7366e", + "fastqc_per_sequence_quality_scores_plot.png:md5,42fd7369a8aca78f620164a9e887c3cb", + "fastqc_sequence_counts_plot-1-cnt.png:md5,2874fea747c7ff46828bf4f17668caf8", + "fastqc_sequence_counts_plot-1-pct.png:md5,0022d7f5ac78b6eff157de24e37c5ab0", + "fastqc_sequence_counts_plot-cnt.png:md5,3890d5555f2a39b46b9f6efb14cb91f2", + "fastqc_sequence_counts_plot-pct.png:md5,55fa5838c8b2db978fcfa5cb83f6b054", + "fastqc_sequence_duplication_levels_plot-1.png:md5,fcd3b1ec2b95fe4bcd607dc28179a754", + "fastqc_sequence_duplication_levels_plot.png:md5,747431f0f38f8e4c41a11a072fa18780", + "featurecounts_biotype_plot-cnt.png:md5,ed2c5826034fcf2417afe79902897c45", + "featurecounts_biotype_plot-pct.png:md5,96abf028d347f568289b3a741aa8c08d", + "qualimap_gene_coverage_profile_Counts.png:md5,fb739f4297a156f0913f21f20090f598", + "qualimap_gene_coverage_profile_Normalised.png:md5,710960caa692f0d0eceadcc83650cf00", + "rseqc_infer_experiment_plot.png:md5,49f1faa0849545b8a75af2657d0ee5fa", + "rseqc_read_dups_plot.png:md5,1a18ce4ca5f36722f1fdd579d7eb41e1", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png:md5,ce6abb232fd5b5f2e66c0fe9a571d75f", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png:md5,6b44818f886ef020fb3646f152ad4af6", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png:md5,af332971e3158b3cfee3a65311ebfe2c", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png:md5,f12bcf930eac8ed45da7b4668b1169c8", + "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png:md5,ff8e0f61b02f8c9abcce5e83214c87fd", + "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png:md5,1a029e5d23f82d537470363a065b644a", + "sortmerna-detailed-plot-cnt.png:md5,3875997f21c98e8906cd182d959e0020", + "sortmerna-detailed-plot-pct.png:md5,971398875e5cbd50313b6fee7eeb302c", + "ambig_info.tsv:md5,25ced9693254994a7878241225baabb6", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,306609f606004616a89ec50dc59f22b0", + "lib_format_counts.json:md5,b814fed52bd197a64544086dba0f127a", + "ambig_info.tsv:md5,c83b0f9ebe9b8dfc284595ec56d4f092", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,6b367a9cdd2837b88890209459acf45f", + "lib_format_counts.json:md5,3f4d67ace359562564dd336aa47a479c", + "ambig_info.tsv:md5,00a1f9de7095a68dfb43e0a0301b6ecd", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,c8c6208e1082ec150de56679b2b8cfe3", + "lib_format_counts.json:md5,f56087bcbd494c7fa78200f65a2400e2", + "ambig_info.tsv:md5,54d942ddf69b4e8f1598064e09428256", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,5523405c02d30489d276e5d734cb54da", + "lib_format_counts.json:md5,43fc5463eada79e466d6ba9848739f06", + "ambig_info.tsv:md5,933feffdaf6cf6ff407469ade0d7684d", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,998c89efb00fa5e63fd1d18c0602a019", + "lib_format_counts.json:md5,e6e3d7746e9abee6a0e097ae0ee1781a", + "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", + "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", + "ambig_info.tsv:md5,6cd02367152bb2dd59a6f1f70df2d7f8", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,4cc2492f557e5e0a2911a0bd83a51020", + "ambig_info.tsv:md5,8611b6c03f6aa1a5f3dfceb0e65ad4ef", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,dc750c3564c63da54979c852794d58a5", + "ambig_info.tsv:md5,1b69f9b651dfa6799e310004c1e3309f", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,db43ed650e6e7b42cd2c5b8101bb6748", + "ambig_info.tsv:md5,070c7d50eab5ce0f211cdb06f9d7cc29", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,e418b4e899623449c6babdf53e5aabde", + "ambig_info.tsv:md5,b8c61854b56a1c9a0fc8f158ea0c7599", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,f234c8d322df3b59d990594c63b24eae", + "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", + "RAP1_IAA_30M_REP1_dupMatrix.txt:md5,ddadea4a08511aae6faeb632eb6aafea", + "RAP1_UNINDUCED_REP1_dupMatrix.txt:md5,1db4c86723cf69052c4386760a9750bb", + "RAP1_UNINDUCED_REP2_dupMatrix.txt:md5,c0bf1135d2d70c5918d87f706c0c54bc", + "WT_REP1_dupMatrix.txt:md5,b0de1683f2a9bfa42437e924a11648fd", + "WT_REP2_dupMatrix.txt:md5,bab18079153627205e5d907d8dfba677", + "RAP1_IAA_30M_REP1_intercept_slope.txt:md5,b21a53b0156b0afdfc28c237cb11218d", + "RAP1_UNINDUCED_REP1_intercept_slope.txt:md5,eccc5ca37855c717d35477e684188695", + "RAP1_UNINDUCED_REP2_intercept_slope.txt:md5,c3900f3bb24cd339d0e0ecf65ae43217", + "WT_REP1_intercept_slope.txt:md5,f38c8525b7fcb990b7158f1518e451ad", + "WT_REP2_intercept_slope.txt:md5,9bcbc18d0d331fe3c972538456ffd5b2", + "RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv:md5,f36792d25b268b6d556f8728300f4afc", + "RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv:md5,dde2de0cb90e10d0195c726f768e9941", + "RAP1_IAA_30M_REP1.featureCounts.txt:md5,c5865ded7168476d93057d2aedaec694", + "RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv:md5,782f5001d411ba79314ba77f7d36b157", + "RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv:md5,845ff9059c72bc6722a8de69776e22bb", + "RAP1_UNINDUCED_REP1.featureCounts.txt:md5,a0fb30c2b937a5a41ac865ab09367af7", + "RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv:md5,1c9d07d9f9d12219d2b9f761f854eced", + "RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv:md5,6d3fa4c88c7fe61f638e4624ad5e22f0", + "RAP1_UNINDUCED_REP2.featureCounts.txt:md5,de016e691f5d56b13bbaa626ce2cc93e", + "WT_REP1.biotype_counts_mqc.tsv:md5,eca4a76b9243248d01df5f4289b8201e", + "WT_REP1.biotype_counts_rrna_mqc.tsv:md5,8ef76d717492ca23764938aee8ea33a9", + "WT_REP1.featureCounts.txt:md5,7aadafd0a26f5047a9ae7266eccfce05", + "WT_REP2.biotype_counts_mqc.tsv:md5,530605b80da27915a90d452249f3243a", + "WT_REP2.biotype_counts_rrna_mqc.tsv:md5,12294618fe44df1e7f39348372dcb481", + "WT_REP2.featureCounts.txt:md5,809af01851125c401d576c21efca7b5a", + "RAP1_IAA_30M_REP1.SJ.out.tab:md5,ea95e243278af55534f2c52eb5fff7ee", + "RAP1_UNINDUCED_REP1.SJ.out.tab:md5,e548d13942535dc0821f3ec6d9743ec8", + "RAP1_UNINDUCED_REP2.SJ.out.tab:md5,1f294365343a1a5e95682792fdb77033", + "WT_REP1.SJ.out.tab:md5,1350c2fa6a675bf107386c6cd3fc5204", + "WT_REP2.SJ.out.tab:md5,f6cc03643a5e3c1025a5b4754eb1be23", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,1a837e43161d7133e9156c7b18123aa9", + "Coverage Profile Along Genes (Low).png:md5,46c5ba09af49602b956efd780f7a39e4", + "Coverage Profile Along Genes (Total).png:md5,b04cac9c2d15b1b9623d87d44caadff6", + "Transcript coverage histogram.png:md5,cbb250c6903bfe6ecab5fb4b2ca661e5", + "coverage_profile_along_genes_(high).txt:md5,5aee6c959137a8c9bfbd0ddaa79dddba", + "coverage_profile_along_genes_(low).txt:md5,d2742410803e0de7cc606ef118010ea8", + "coverage_profile_along_genes_(total).txt:md5,d2742410803e0de7cc606ef118010ea8", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,8c8b46f9bfb6cf952a95d85a6b917444", + "Coverage Profile Along Genes (Low).png:md5,5c56671f085c6db7fd86b41bb5b7e6d0", + "Coverage Profile Along Genes (Total).png:md5,b83fbaedfe4dcfdd7b3970d2ff27d517", + "Transcript coverage histogram.png:md5,488440d7b6d73bcd4567316712e281fe", + "coverage_profile_along_genes_(high).txt:md5,f5ac8f74fcad5d9ac72dbb6b65184bd0", + "coverage_profile_along_genes_(low).txt:md5,d66da6e3f49b0870184fc881a162e785", + "coverage_profile_along_genes_(total).txt:md5,d66da6e3f49b0870184fc881a162e785", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,015aa34b0d32f38bade831a3ef497984", + "Coverage Profile Along Genes (Low).png:md5,5798e0d977e0fee55ec4fc5192bfc0f4", + "Coverage Profile Along Genes (Total).png:md5,2bbec5e165075024cb1f74a042b1385a", + "Transcript coverage histogram.png:md5,bfd09f8b3282958a6a73b7924edac664", + "coverage_profile_along_genes_(high).txt:md5,634f447f91db940d2148af74cf36febd", + "coverage_profile_along_genes_(low).txt:md5,db2e0acbe9f07c68bcd7e08e036f02d3", + "coverage_profile_along_genes_(total).txt:md5,db2e0acbe9f07c68bcd7e08e036f02d3", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,d8a36870a6f262c41995b4b5bd26a149", + "Coverage Profile Along Genes (Low).png:md5,5570af90ee685a3c95117519aa6bdc46", + "Coverage Profile Along Genes (Total).png:md5,eb53e699213ce453cbea7f71f5204b08", + "Transcript coverage histogram.png:md5,f0bd8d82a8b7adec6e1f1ef85633eded", + "coverage_profile_along_genes_(high).txt:md5,a349232d75f6c0adab6afcd9f6cbbafb", + "coverage_profile_along_genes_(low).txt:md5,b2c696661e6c524b1641eb7267c70edc", + "coverage_profile_along_genes_(total).txt:md5,b2c696661e6c524b1641eb7267c70edc", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,3c1c603d63f3f7f9ba1ab6e7749b7771", + "Coverage Profile Along Genes (Low).png:md5,9f80251ed043cf900fa939cc254ccc81", + "Coverage Profile Along Genes (Total).png:md5,a420f287f986a8db317be712ac0a2237", + "Transcript coverage histogram.png:md5,c467c5eac12a95f8569198927434440d", + "coverage_profile_along_genes_(high).txt:md5,3f76529bd723d5320c86cc407fbb3294", + "coverage_profile_along_genes_(low).txt:md5,b9be191fdec82c78057e083d3adf20dd", + "coverage_profile_along_genes_(total).txt:md5,b9be191fdec82c78057e083d3adf20dd", + "RAP1_IAA_30M_REP1.infer_experiment.txt:md5,ee69422d6e76fba223aa6b20a13027d2", + "RAP1_UNINDUCED_REP1.infer_experiment.txt:md5,ec9ec42ddfd3ffbb5373d3d6b6713b2c", + "RAP1_UNINDUCED_REP2.infer_experiment.txt:md5,484e2860c6c496b1da5fac475a0cd3e4", + "WT_REP1.infer_experiment.txt:md5,298c430c61cb7a46b48af867a0dfe00b", + "WT_REP2.infer_experiment.txt:md5,18758f433cf5c19bce599e5329da39a9", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,ee43fdd5d543e24c53b6031cdbabb656", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,a052ab04070e72cc318fb7680b0764e3", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,52a62313943891cc8dcb3b4c1e117f18", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,d279003d92f7feef9adb31203f84474a", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,3c7b9cf3bb1dcb98d79f8226eef7aa4c", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,525413b70bcf62c24c8f96182e09883e", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,682817a9d0a1ac9c1637249e007d3514", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,907ab2e06346df131cbdb929afc005a8", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,f2cf8aa2786c710fb6be5857e1545e0e", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,041edee3193df311f621c09f4991892b", + "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe" + ] ], "meta": { "nf-test": "0.9.0", "nextflow": "24.04.4" }, - "timestamp": "2024-08-23T18:00:12.426991" - }, - "star_salmon/salmon_quant": { - "content": [ - "ambig_info.tsv:md5,6cd02367152bb2dd59a6f1f70df2d7f8", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,4cc2492f557e5e0a2911a0bd83a51020", - "ambig_info.tsv:md5,8611b6c03f6aa1a5f3dfceb0e65ad4ef", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,dc750c3564c63da54979c852794d58a5", - "ambig_info.tsv:md5,1b69f9b651dfa6799e310004c1e3309f", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,db43ed650e6e7b42cd2c5b8101bb6748", - "ambig_info.tsv:md5,070c7d50eab5ce0f211cdb06f9d7cc29", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,e418b4e899623449c6babdf53e5aabde", - "ambig_info.tsv:md5,b8c61854b56a1c9a0fc8f158ea0c7599", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,f234c8d322df3b59d990594c63b24eae", - "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T18:00:13.580621" - }, - "trimgalore": { - "content": [ - "RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T18:00:13.706881" - }, - "star_salmon/rseqc": { - "content": [ - "RAP1_IAA_30M_REP1.infer_experiment.txt:md5,ee69422d6e76fba223aa6b20a13027d2", - "RAP1_UNINDUCED_REP1.infer_experiment.txt:md5,ec9ec42ddfd3ffbb5373d3d6b6713b2c", - "RAP1_UNINDUCED_REP2.infer_experiment.txt:md5,484e2860c6c496b1da5fac475a0cd3e4", - "WT_REP1.infer_experiment.txt:md5,298c430c61cb7a46b48af867a0dfe00b", - "WT_REP2.infer_experiment.txt:md5,18758f433cf5c19bce599e5329da39a9", - "RAP1_IAA_30M_REP1.bam_stat.txt", - "RAP1_UNINDUCED_REP1.bam_stat.txt", - "RAP1_UNINDUCED_REP2.bam_stat.txt", - "WT_REP1.bam_stat.txt", - "WT_REP2.bam_stat.txt", - "RAP1_IAA_30M_REP1.inner_distance_plot.pdf", - "WT_REP1.inner_distance_plot.pdf", - "WT_REP2.inner_distance_plot.pdf", - "RAP1_IAA_30M_REP1.inner_distance_plot.r", - "WT_REP1.inner_distance_plot.r", - "WT_REP2.inner_distance_plot.r", - "RAP1_IAA_30M_REP1.inner_distance.txt", - "RAP1_IAA_30M_REP1.inner_distance_freq.txt", - "RAP1_IAA_30M_REP1.inner_distance_mean.txt", - "WT_REP1.inner_distance.txt", - "WT_REP1.inner_distance_freq.txt", - "WT_REP1.inner_distance_mean.txt", - "WT_REP2.inner_distance.txt", - "WT_REP2.inner_distance_freq.txt", - "WT_REP2.inner_distance_mean.txt", - "RAP1_IAA_30M_REP1.junction.Interact.bed", - "RAP1_IAA_30M_REP1.junction.bed", - "RAP1_UNINDUCED_REP1.junction.Interact.bed", - "RAP1_UNINDUCED_REP1.junction.bed", - "RAP1_UNINDUCED_REP2.junction.Interact.bed", - "RAP1_UNINDUCED_REP2.junction.bed", - "WT_REP1.junction.Interact.bed", - "WT_REP1.junction.bed", - "WT_REP2.junction.Interact.bed", - "WT_REP2.junction.bed", - "RAP1_IAA_30M_REP1.junction_annotation.log", - "RAP1_UNINDUCED_REP1.junction_annotation.log", - "RAP1_UNINDUCED_REP2.junction_annotation.log", - "WT_REP1.junction_annotation.log", - "WT_REP2.junction_annotation.log", - "RAP1_IAA_30M_REP1.splice_events.pdf", - "RAP1_IAA_30M_REP1.splice_junction.pdf", - "RAP1_UNINDUCED_REP1.splice_events.pdf", - "RAP1_UNINDUCED_REP1.splice_junction.pdf", - "RAP1_UNINDUCED_REP2.splice_events.pdf", - "RAP1_UNINDUCED_REP2.splice_junction.pdf", - "WT_REP1.splice_events.pdf", - "WT_REP1.splice_junction.pdf", - "WT_REP2.splice_events.pdf", - "WT_REP2.splice_junction.pdf", - "RAP1_IAA_30M_REP1.junction_plot.r", - "RAP1_UNINDUCED_REP1.junction_plot.r", - "RAP1_UNINDUCED_REP2.junction_plot.r", - "WT_REP1.junction_plot.r", - "WT_REP2.junction_plot.r", - "RAP1_IAA_30M_REP1.junction.xls", - "RAP1_UNINDUCED_REP1.junction.xls", - "RAP1_UNINDUCED_REP2.junction.xls", - "WT_REP1.junction.xls", - "WT_REP2.junction.xls", - "RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf", - "RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf", - "RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf", - "WT_REP1.junctionSaturation_plot.pdf", - "WT_REP2.junctionSaturation_plot.pdf", - "RAP1_IAA_30M_REP1.junctionSaturation_plot.r", - "RAP1_UNINDUCED_REP1.junctionSaturation_plot.r", - "RAP1_UNINDUCED_REP2.junctionSaturation_plot.r", - "WT_REP1.junctionSaturation_plot.r", - "WT_REP2.junctionSaturation_plot.r", - "RAP1_IAA_30M_REP1.read_distribution.txt", - "RAP1_UNINDUCED_REP1.read_distribution.txt", - "RAP1_UNINDUCED_REP2.read_distribution.txt", - "WT_REP1.read_distribution.txt", - "WT_REP2.read_distribution.txt", - "RAP1_IAA_30M_REP1.DupRate_plot.pdf", - "RAP1_UNINDUCED_REP1.DupRate_plot.pdf", - "RAP1_UNINDUCED_REP2.DupRate_plot.pdf", - "WT_REP1.DupRate_plot.pdf", - "WT_REP2.DupRate_plot.pdf", - "RAP1_IAA_30M_REP1.DupRate_plot.r", - "RAP1_UNINDUCED_REP1.DupRate_plot.r", - "RAP1_UNINDUCED_REP2.DupRate_plot.r", - "WT_REP1.DupRate_plot.r", - "WT_REP2.DupRate_plot.r", - "RAP1_IAA_30M_REP1.pos.DupRate.xls", - "RAP1_IAA_30M_REP1.seq.DupRate.xls", - "RAP1_UNINDUCED_REP1.pos.DupRate.xls", - "RAP1_UNINDUCED_REP1.seq.DupRate.xls", - "RAP1_UNINDUCED_REP2.pos.DupRate.xls", - "RAP1_UNINDUCED_REP2.seq.DupRate.xls", - "WT_REP1.pos.DupRate.xls", - "WT_REP1.seq.DupRate.xls", - "WT_REP2.pos.DupRate.xls", - "WT_REP2.seq.DupRate.xls" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T13:19:36.262464" - }, - "references": { - "content": [ - "genome_gfp.fasta:md5,e23e302af63736a199985a169fdac055", - "genome_gfp.gtf:md5,c98b12c302f15731bfc36bcf297cfe28" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T18:00:10.758518" - }, - "star_salmon/samtools_stats": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.stats", - "RAP1_IAA_30M_REP1.sorted.bam.flagstat", - "RAP1_IAA_30M_REP1.sorted.bam.idxstats", - "RAP1_IAA_30M_REP1.sorted.bam.stats", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats", - "RAP1_UNINDUCED_REP1.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP1.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP1.sorted.bam.stats", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats", - "RAP1_UNINDUCED_REP2.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP2.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP2.sorted.bam.stats", - "WT_REP1.markdup.sorted.bam.flagstat", - "WT_REP1.markdup.sorted.bam.idxstats", - "WT_REP1.markdup.sorted.bam.stats", - "WT_REP1.sorted.bam.flagstat", - "WT_REP1.sorted.bam.idxstats", - "WT_REP1.sorted.bam.stats", - "WT_REP2.markdup.sorted.bam.flagstat", - "WT_REP2.markdup.sorted.bam.idxstats", - "WT_REP2.markdup.sorted.bam.stats", - "WT_REP2.sorted.bam.flagstat", - "WT_REP2.sorted.bam.idxstats", - "WT_REP2.sorted.bam.stats" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T19:21:47.319657" - }, - "multiqc_plots": { - "content": [ - "cutadapt_filtered_reads_plot-cnt.png:md5,704cf0d91bfa3dd658dd8c9590f669a2", - "cutadapt_filtered_reads_plot-pct.png:md5,2684d8b2afca3300e5786486b80237f0", - "cutadapt_trimmed_sequences_plot_3_Counts.png:md5,bef41d894629b0c4dab4478bbf197f50", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.png:md5,1e0d01537d3797623d0b3fd8fbe42787", - "dupradar-section-plot.png:md5,62ee84d3b32bdbfb9766fa970680f92c", - "fastqc-status-check-heatmap-1.png:md5,2402522f8c02e12aea9af088c6595890", - "fastqc-status-check-heatmap.png:md5,fe8b5b4ab4480d46a12a9005932a9b84", - "fastqc_overrepresented_sequences_plot-1.png:md5,40e450251b80ec0efc9364434234ec7f", - "fastqc_overrepresented_sequences_plot.png:md5,6f5ffbdf1bf61fabe5e028c8bc85de14", - "fastqc_per_sequence_gc_content_plot-1_Counts.png:md5,8a806cec2142f9911502e0a253d83d13", - "fastqc_per_sequence_gc_content_plot-1_Percentages.png:md5,953929d50c8490029880e205e4db7959", - "fastqc_per_sequence_gc_content_plot_Counts.png:md5,01f124545af788fd5cc7bbf41b005e16", - "fastqc_per_sequence_gc_content_plot_Percentages.png:md5,eba3abf8bedb2cb20bad90c54e9c8881", - "fastqc_per_sequence_quality_scores_plot-1.png:md5,d2c29cae169f35744500c751b4a7366e", - "fastqc_per_sequence_quality_scores_plot.png:md5,42fd7369a8aca78f620164a9e887c3cb", - "fastqc_sequence_counts_plot-1-cnt.png:md5,2874fea747c7ff46828bf4f17668caf8", - "fastqc_sequence_counts_plot-1-pct.png:md5,0022d7f5ac78b6eff157de24e37c5ab0", - "fastqc_sequence_counts_plot-cnt.png:md5,3890d5555f2a39b46b9f6efb14cb91f2", - "fastqc_sequence_counts_plot-pct.png:md5,55fa5838c8b2db978fcfa5cb83f6b054", - "fastqc_sequence_duplication_levels_plot-1.png:md5,fcd3b1ec2b95fe4bcd607dc28179a754", - "fastqc_sequence_duplication_levels_plot.png:md5,747431f0f38f8e4c41a11a072fa18780", - "featurecounts_biotype_plot-cnt.png:md5,ed2c5826034fcf2417afe79902897c45", - "featurecounts_biotype_plot-pct.png:md5,96abf028d347f568289b3a741aa8c08d", - "qualimap_gene_coverage_profile_Counts.png:md5,fb739f4297a156f0913f21f20090f598", - "qualimap_gene_coverage_profile_Normalised.png:md5,710960caa692f0d0eceadcc83650cf00", - "rseqc_infer_experiment_plot.png:md5,49f1faa0849545b8a75af2657d0ee5fa", - "rseqc_read_dups_plot.png:md5,1a18ce4ca5f36722f1fdd579d7eb41e1", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png:md5,ce6abb232fd5b5f2e66c0fe9a571d75f", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png:md5,6b44818f886ef020fb3646f152ad4af6", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png:md5,af332971e3158b3cfee3a65311ebfe2c", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png:md5,f12bcf930eac8ed45da7b4668b1169c8", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png:md5,ff8e0f61b02f8c9abcce5e83214c87fd", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png:md5,1a029e5d23f82d537470363a065b644a", - "sortmerna-detailed-plot-cnt.png:md5,3875997f21c98e8906cd182d959e0020", - "sortmerna-detailed-plot-pct.png:md5,971398875e5cbd50313b6fee7eeb302c", - "multiqc_report.html", - "cutadapt_filtered_reads_plot-cnt.pdf", - "cutadapt_filtered_reads_plot-pct.pdf", - "cutadapt_trimmed_sequences_plot_3_Counts.pdf", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf", - "dupradar-section-plot.pdf", - "fail_strand_check_table.pdf", - "fastqc-status-check-heatmap-1.pdf", - "fastqc-status-check-heatmap.pdf", - "fastqc_adapter_content_plot.pdf", - "fastqc_overrepresented_sequences_plot-1.pdf", - "fastqc_overrepresented_sequences_plot.pdf", - "fastqc_per_base_n_content_plot-1.pdf", - "fastqc_per_base_n_content_plot.pdf", - "fastqc_per_base_sequence_quality_plot-1.pdf", - "fastqc_per_base_sequence_quality_plot.pdf", - "fastqc_per_sequence_gc_content_plot-1_Counts.pdf", - "fastqc_per_sequence_gc_content_plot-1_Percentages.pdf", - "fastqc_per_sequence_gc_content_plot_Counts.pdf", - "fastqc_per_sequence_gc_content_plot_Percentages.pdf", - "fastqc_per_sequence_quality_scores_plot-1.pdf", - "fastqc_per_sequence_quality_scores_plot.pdf", - "fastqc_sequence_counts_plot-1-cnt.pdf", - "fastqc_sequence_counts_plot-1-pct.pdf", - "fastqc_sequence_counts_plot-cnt.pdf", - "fastqc_sequence_counts_plot-pct.pdf", - "fastqc_sequence_duplication_levels_plot-1.pdf", - "fastqc_sequence_duplication_levels_plot.pdf", - "fastqc_sequence_length_distribution_plot.pdf", - "fastqc_top_overrepresented_sequences_table-1.pdf", - "fastqc_top_overrepresented_sequences_table.pdf", - "featurecounts_biotype_plot-cnt.pdf", - "featurecounts_biotype_plot-pct.pdf", - "general_stats_table.pdf", - "picard_deduplication-cnt.pdf", - "picard_deduplication-pct.pdf", - "qualimap_gene_coverage_profile_Counts.pdf", - "qualimap_gene_coverage_profile_Normalised.pdf", - "qualimap_genomic_origin-cnt.pdf", - "qualimap_genomic_origin-pct.pdf", - "rseqc_bam_stat.pdf", - "rseqc_infer_experiment_plot.pdf", - "rseqc_inner_distance_plot_Counts.pdf", - "rseqc_inner_distance_plot_Percentages.pdf", - "rseqc_junction_annotation_junctions_plot_Events-cnt.pdf", - "rseqc_junction_annotation_junctions_plot_Events-pct.pdf", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf", - "rseqc_junction_saturation_plot_All_Junctions.pdf", - "rseqc_junction_saturation_plot_Known_Junctions.pdf", - "rseqc_junction_saturation_plot_Novel_Junctions.pdf", - "rseqc_read_distribution_plot-cnt.pdf", - "rseqc_read_distribution_plot-pct.pdf", - "rseqc_read_dups_plot.pdf", - "salmon_deseq2_clustering-plot.pdf", - "salmon_deseq2_pca-plot.pdf", - "salmon_plot.pdf", - "samtools-flagstat-dp_Percentage_of_total.pdf", - "samtools-flagstat-dp_Read_counts.pdf", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf", - "samtools-stats-dp.pdf", - "samtools_alignment_plot-cnt.pdf", - "samtools_alignment_plot-pct.pdf", - "sortmerna-detailed-plot-cnt.pdf", - "sortmerna-detailed-plot-pct.pdf", - "star_alignment_plot-cnt.pdf", - "star_alignment_plot-pct.pdf", - "star_salmon_deseq2_clustering-plot.pdf", - "star_salmon_deseq2_pca-plot.pdf", - "star_summary_table.pdf", - "fail_strand_check_table.png", - "fastqc_adapter_content_plot.png", - "fastqc_per_base_n_content_plot-1.png", - "fastqc_per_base_n_content_plot.png", - "fastqc_per_base_sequence_quality_plot-1.png", - "fastqc_per_base_sequence_quality_plot.png", - "fastqc_sequence_length_distribution_plot.png", - "fastqc_top_overrepresented_sequences_table-1.png", - "fastqc_top_overrepresented_sequences_table.png", - "general_stats_table.png", - "picard_deduplication-cnt.png", - "picard_deduplication-pct.png", - "qualimap_genomic_origin-cnt.png", - "qualimap_genomic_origin-pct.png", - "rseqc_bam_stat.png", - "rseqc_inner_distance_plot_Counts.png", - "rseqc_inner_distance_plot_Percentages.png", - "rseqc_junction_annotation_junctions_plot_Events-cnt.png", - "rseqc_junction_annotation_junctions_plot_Events-pct.png", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.png", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.png", - "rseqc_junction_saturation_plot_All_Junctions.png", - "rseqc_junction_saturation_plot_Known_Junctions.png", - "rseqc_junction_saturation_plot_Novel_Junctions.png", - "rseqc_read_distribution_plot-cnt.png", - "rseqc_read_distribution_plot-pct.png", - "salmon_deseq2_clustering-plot.png", - "salmon_deseq2_pca-plot.png", - "salmon_plot.png", - "samtools-flagstat-dp_Percentage_of_total.png", - "samtools-flagstat-dp_Read_counts.png", - "samtools-stats-dp.png", - "samtools_alignment_plot-cnt.png", - "samtools_alignment_plot-pct.png", - "star_alignment_plot-cnt.png", - "star_alignment_plot-pct.png", - "star_salmon_deseq2_clustering-plot.png", - "star_salmon_deseq2_pca-plot.png", - "star_summary_table.png", - "cutadapt_filtered_reads_plot-cnt.svg", - "cutadapt_filtered_reads_plot-pct.svg", - "cutadapt_trimmed_sequences_plot_3_Counts.svg", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg", - "dupradar-section-plot.svg", - "fail_strand_check_table.svg", - "fastqc-status-check-heatmap-1.svg", - "fastqc-status-check-heatmap.svg", - "fastqc_adapter_content_plot.svg", - "fastqc_overrepresented_sequences_plot-1.svg", - "fastqc_overrepresented_sequences_plot.svg", - "fastqc_per_base_n_content_plot-1.svg", - "fastqc_per_base_n_content_plot.svg", - "fastqc_per_base_sequence_quality_plot-1.svg", - "fastqc_per_base_sequence_quality_plot.svg", - "fastqc_per_sequence_gc_content_plot-1_Counts.svg", - "fastqc_per_sequence_gc_content_plot-1_Percentages.svg", - "fastqc_per_sequence_gc_content_plot_Counts.svg", - "fastqc_per_sequence_gc_content_plot_Percentages.svg", - "fastqc_per_sequence_quality_scores_plot-1.svg", - "fastqc_per_sequence_quality_scores_plot.svg", - "fastqc_sequence_counts_plot-1-cnt.svg", - "fastqc_sequence_counts_plot-1-pct.svg", - "fastqc_sequence_counts_plot-cnt.svg", - "fastqc_sequence_counts_plot-pct.svg", - "fastqc_sequence_duplication_levels_plot-1.svg", - "fastqc_sequence_duplication_levels_plot.svg", - "fastqc_sequence_length_distribution_plot.svg", - "fastqc_top_overrepresented_sequences_table-1.svg", - "fastqc_top_overrepresented_sequences_table.svg", - "featurecounts_biotype_plot-cnt.svg", - "featurecounts_biotype_plot-pct.svg", - "general_stats_table.svg", - "picard_deduplication-cnt.svg", - "picard_deduplication-pct.svg", - "qualimap_gene_coverage_profile_Counts.svg", - "qualimap_gene_coverage_profile_Normalised.svg", - "qualimap_genomic_origin-cnt.svg", - "qualimap_genomic_origin-pct.svg", - "rseqc_bam_stat.svg", - "rseqc_infer_experiment_plot.svg", - "rseqc_inner_distance_plot_Counts.svg", - "rseqc_inner_distance_plot_Percentages.svg", - "rseqc_junction_annotation_junctions_plot_Events-cnt.svg", - "rseqc_junction_annotation_junctions_plot_Events-pct.svg", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.svg", - "rseqc_junction_saturation_plot_All_Junctions.svg", - "rseqc_junction_saturation_plot_Known_Junctions.svg", - "rseqc_junction_saturation_plot_Novel_Junctions.svg", - "rseqc_read_distribution_plot-cnt.svg", - "rseqc_read_distribution_plot-pct.svg", - "rseqc_read_dups_plot.svg", - "salmon_deseq2_clustering-plot.svg", - "salmon_deseq2_pca-plot.svg", - "salmon_plot.svg", - "samtools-flagstat-dp_Percentage_of_total.svg", - "samtools-flagstat-dp_Read_counts.svg", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg", - "samtools-stats-dp.svg", - "samtools_alignment_plot-cnt.svg", - "samtools_alignment_plot-pct.svg", - "sortmerna-detailed-plot-cnt.svg", - "sortmerna-detailed-plot-pct.svg", - "star_alignment_plot-cnt.svg", - "star_alignment_plot-pct.svg", - "star_salmon_deseq2_clustering-plot.svg", - "star_salmon_deseq2_pca-plot.svg", - "star_summary_table.svg" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T19:21:47.217167" + "timestamp": "2024-10-02T08:07:16.890773" }, "Params: --remove_ribo_rna - stub": { "content": [ - "{BBMAP_BBSPLIT={bbmap=39.01}, CAT_FASTQ={cat=8.3}, CUSTOM_CATADDITIONALFASTA={python=null}, CUSTOM_GETCHROMSIZES={getchromsizes=1.2}, FASTQC={fastqc=0.12.1}, GTF2BED={perl=5.26.2}, GTF_FILTER={python=3.9.5}, GUNZIP_ADDITIONAL_FASTA={gunzip=1.1}, GUNZIP_GTF={gunzip=1.1}, SORTMERNA_INDEX={sortmerna=4.3.6}, STAR_GENOMEGENERATE={star=2.7.10a, samtools=1.18, gawk=5.1.0}, TRIMGALORE={trimgalore=0.6.7, cutadapt=3.4}, UNTAR_SALMON_INDEX={untar=1.34}, Workflow={nf-core/rnaseq=v3.16.0dev}}", - "genome_transcriptome.fasta", - "genome_transcriptome.gtf", - "RAP1_IAA_30M_REP1_raw.html", - "RAP1_IAA_30M_REP1_raw.zip", - "RAP1_UNINDUCED_REP1_raw.html", - "RAP1_UNINDUCED_REP1_raw.zip", - "RAP1_UNINDUCED_REP2_raw.html", - "RAP1_UNINDUCED_REP2_raw.zip", - "WT_REP1_raw.html", - "WT_REP1_raw.zip", - "WT_REP2_raw.html", - "WT_REP2_raw.zip", - "multiqc_report.html", - "RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T18:20:03.148673" - }, - "fastqc/raw": { - "content": [ - "RAP1_IAA_30M_REP1_raw_1_fastqc.html", - "RAP1_IAA_30M_REP1_raw_1_fastqc.zip", - "RAP1_IAA_30M_REP1_raw_2_fastqc.html", - "RAP1_IAA_30M_REP1_raw_2_fastqc.zip", - "RAP1_UNINDUCED_REP1_raw_fastqc.html", - "RAP1_UNINDUCED_REP1_raw_fastqc.zip", - "RAP1_UNINDUCED_REP2_raw_fastqc.html", - "RAP1_UNINDUCED_REP2_raw_fastqc.zip", - "WT_REP1_raw_1_fastqc.html", - "WT_REP1_raw_1_fastqc.zip", - "WT_REP1_raw_2_fastqc.html", - "WT_REP1_raw_2_fastqc.zip", - "WT_REP2_raw_1_fastqc.html", - "WT_REP2_raw_1_fastqc.zip", - "WT_REP2_raw_2_fastqc.html", - "WT_REP2_raw_2_fastqc.zip" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T18:00:10.774446" - }, - "star_salmon/stringtie": { - "content": [ - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,ee43fdd5d543e24c53b6031cdbabb656", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,a052ab04070e72cc318fb7680b0764e3", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,52a62313943891cc8dcb3b4c1e117f18", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,d279003d92f7feef9adb31203f84474a", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,3c7b9cf3bb1dcb98d79f8226eef7aa4c", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,525413b70bcf62c24c8f96182e09883e", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,682817a9d0a1ac9c1637249e007d3514", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,907ab2e06346df131cbdb929afc005a8", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,f2cf8aa2786c710fb6be5857e1545e0e", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,041edee3193df311f621c09f4991892b", - "t_data.ctab", - "RAP1_IAA_30M_REP1.coverage.gtf", - "RAP1_IAA_30M_REP1.gene.abundance.txt", - "RAP1_IAA_30M_REP1.transcripts.gtf", - "t_data.ctab", - "RAP1_UNINDUCED_REP1.coverage.gtf", - "RAP1_UNINDUCED_REP1.gene.abundance.txt", - "RAP1_UNINDUCED_REP1.transcripts.gtf", - "t_data.ctab", - "RAP1_UNINDUCED_REP2.coverage.gtf", - "RAP1_UNINDUCED_REP2.gene.abundance.txt", - "RAP1_UNINDUCED_REP2.transcripts.gtf", - "t_data.ctab", - "WT_REP1.coverage.gtf", - "WT_REP1.gene.abundance.txt", - "WT_REP1.transcripts.gtf", - "t_data.ctab", - "WT_REP2.coverage.gtf", - "WT_REP2.gene.abundance.txt", - "WT_REP2.transcripts.gtf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T18:00:13.357765" - }, - "salmon_quant": { - "content": [ - "ambig_info.tsv:md5,25ced9693254994a7878241225baabb6", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,306609f606004616a89ec50dc59f22b0", - "lib_format_counts.json:md5,b814fed52bd197a64544086dba0f127a", - "ambig_info.tsv:md5,c83b0f9ebe9b8dfc284595ec56d4f092", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,6b367a9cdd2837b88890209459acf45f", - "lib_format_counts.json:md5,3f4d67ace359562564dd336aa47a479c", - "ambig_info.tsv:md5,00a1f9de7095a68dfb43e0a0301b6ecd", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,c8c6208e1082ec150de56679b2b8cfe3", - "lib_format_counts.json:md5,f56087bcbd494c7fa78200f65a2400e2", - "ambig_info.tsv:md5,54d942ddf69b4e8f1598064e09428256", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,5523405c02d30489d276e5d734cb54da", - "lib_format_counts.json:md5,43fc5463eada79e466d6ba9848739f06", - "ambig_info.tsv:md5,933feffdaf6cf6ff407469ade0d7684d", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,998c89efb00fa5e63fd1d18c0602a019", - "lib_format_counts.json:md5,e6e3d7746e9abee6a0e097ae0ee1781a", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T18:00:11.15975" - }, - "multiqc_data": { - "content": [ - "cutadapt_filtered_reads_plot.txt:md5,bf033e64e9d23bee85b6277f11c663f1", - "cutadapt_trimmed_sequences_plot_3_Counts.txt:md5,13dfa866fd91dbb072689efe9aa83b1f", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt:md5,07145dd8dd3db654859b18eb0389046c", - "fastqc-status-check-heatmap-1.txt:md5,22a03548736b88b23be6bc0c9ef1b4a6", - "fastqc-status-check-heatmap.txt:md5,5a89b0d8d162f6b1dbdaf39457bbc03b", - "fastqc_adapter_content_plot.txt:md5,da0389be84cfdd189b1d045212eb2974", - "fastqc_overrepresented_sequences_plot-1.txt:md5,4adfeacd3a3a6c7c808f121b24e6b247", - "fastqc_overrepresented_sequences_plot.txt:md5,25d88ea8a72f55e8a374ae802bc7f0b1", - "fastqc_per_base_n_content_plot-1.txt:md5,418610c1ce119cb786ad434db75d366e", - "fastqc_per_base_n_content_plot.txt:md5,d368d7e36ca2f73dcde61f2b486d8213", - "fastqc_per_base_sequence_quality_plot-1.txt:md5,bd22e06e41c096ad4f745d40fe96a1e5", - "fastqc_per_base_sequence_quality_plot.txt:md5,5c3065b549129702b185ea1b817da420", - "fastqc_per_sequence_gc_content_plot-1_Counts.txt:md5,004c60768ceb6197765154e3eaa37b7a", - "fastqc_per_sequence_gc_content_plot-1_Percentages.txt:md5,95d29060b687f745288ad1ec47750037", - "fastqc_per_sequence_gc_content_plot_Counts.txt:md5,9ddaa50167117d3c9188ccf015427704", - "fastqc_per_sequence_gc_content_plot_Percentages.txt:md5,f10ee2881b61308af35f304aa3d810a3", - "fastqc_per_sequence_quality_scores_plot-1.txt:md5,0f9834cc19f76dd5c87cf8cba7435a7c", - "fastqc_per_sequence_quality_scores_plot.txt:md5,b5f9a02933e3065952237afd2ec9ce82", - "fastqc_sequence_counts_plot-1.txt:md5,3861354bbedfbde7ca36a72994f9425c", - "fastqc_sequence_counts_plot.txt:md5,d385a3e2c2573a0902c66e8c93876d3c", - "fastqc_sequence_duplication_levels_plot-1.txt:md5,c73407d55fc532e864fa1dc8dbc12874", - "fastqc_sequence_duplication_levels_plot.txt:md5,8812cee16f6ca65e2c33635754de1772", - "fastqc_sequence_length_distribution_plot.txt:md5,6fe2c985606abad947bcca99b015ae33", - "multiqc_citations.txt:md5,bfa9fd61367cd7265e324d009c974778", - "multiqc_cutadapt.txt:md5,aac9581a5670cb55edf564f3d6c1f9a7", - "multiqc_fastqc_fastqc_raw.txt:md5,81c3c1a2575a1891a7f2a9637a0f2cc0", - "multiqc_fastqc_fastqc_trimmed.txt:md5,a3238f515e01d158d875d69968753804", - "multiqc_featurecounts_biotype_plot.txt:md5,54f0eef4ab0ecf6a03505b18752b43cd", - "multiqc_samtools_idxstats.txt:md5,413ba06f3d8e4ab0dbde8ef8952c4b32", - "picard_histogram.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "picard_histogram_1.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "picard_histogram_2.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "qualimap_gene_coverage_profile_Counts.txt:md5,50e9209baeaafe181ce3b5caa05cf789", - "qualimap_gene_coverage_profile_Normalised.txt:md5,6ed32f112c679e73396350cbe5cb9459", - "qualimap_rnaseq_cov_hist.txt:md5,a895b3af229f661da1edbc21ec72edaa", - "rseqc_infer_experiment_plot.txt:md5,d8741451248f1a5a4ebe3230c1af9c95", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt:md5,75acd04232d1804b5f960ee4c5db4722", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt:md5,53addd7b78d8ae224920ec9b97489d72", - "samtools-idxstats-mapped-reads-plot_Raw_Counts.txt:md5,97fc7bde65a7efc5ab3af48ef0400c20", - "fastqc_top_overrepresented_sequences_table-1.txt", - "fastqc_top_overrepresented_sequences_table.txt", - "junction_saturation_known.txt", - "junction_saturation_novel.txt", - "multiqc_data.json", - "multiqc_dupradar-section-plot.txt", - "multiqc_fail_strand_check_table.txt", - "multiqc_general_stats.txt", - "multiqc_picard_dups.txt", - "multiqc_rseqc_bam_stat.txt", - "multiqc_rseqc_infer_experiment.txt", - "multiqc_rseqc_junction_annotation.txt", - "multiqc_rseqc_read_distribution.txt", - "multiqc_salmon.txt", - "multiqc_salmon_deseq2_clustering-plot.txt", - "multiqc_salmon_deseq2_clustering-plot_1.txt", - "multiqc_salmon_deseq2_clustering-plot_2.txt", - "multiqc_salmon_deseq2_clustering-plot_3.txt", - "multiqc_salmon_deseq2_clustering-plot_4.txt", - "multiqc_salmon_deseq2_pca-plot.txt", - "multiqc_samtools_flagstat.txt", - "multiqc_samtools_stats.txt", - "multiqc_software_versions.txt", - "multiqc_sortmerna.txt", - "multiqc_sources.txt", - "multiqc_star.txt", - "multiqc_star_salmon_deseq2_clustering-plot.txt", - "multiqc_star_salmon_deseq2_clustering-plot_1.txt", - "multiqc_star_salmon_deseq2_clustering-plot_2.txt", - "multiqc_star_salmon_deseq2_clustering-plot_3.txt", - "multiqc_star_salmon_deseq2_clustering-plot_4.txt", - "multiqc_star_salmon_deseq2_pca-plot.txt", - "picard_deduplication.txt", - "qualimap_genomic_origin.txt", - "qualimap_rnaseq_genome_results.txt", - "rseqc_bam_stat.txt", - "rseqc_inner_distance.txt", - "rseqc_inner_distance_plot_Counts.txt", - "rseqc_inner_distance_plot_Percentages.txt", - "rseqc_junction_annotation_junctions_plot_Events.txt", - "rseqc_junction_annotation_junctions_plot_Junctions.txt", - "rseqc_junction_saturation_all.txt", - "rseqc_junction_saturation_plot_All_Junctions.txt", - "rseqc_junction_saturation_plot_Known_Junctions.txt", - "rseqc_junction_saturation_plot_Novel_Junctions.txt", - "rseqc_read_distribution_plot.txt", - "rseqc_read_dups.txt", - "rseqc_read_dups_plot.txt", - "salmon_plot.txt", - "samtools-flagstat-dp_Percentage_of_total.txt", - "samtools-flagstat-dp_Read_counts.txt", - "samtools-stats-dp.txt", - "samtools_alignment_plot.txt", - "sortmerna-detailed-plot.txt", - "star_alignment_plot.txt", - "star_summary_table.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T19:21:47.111212" - }, - "star_salmon/deseq2_qc": { - "content": [ - "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", - "RAP1_IAA_30M_REP1.txt", - "RAP1_UNINDUCED_REP1.txt", - "RAP1_UNINDUCED_REP2.txt", - "WT_REP1.txt", - "WT_REP2.txt", - "deseq2.size_factors.RData", - "deseq2.dds.RData", - "deseq2.pca.vals.txt", - "deseq2.plots.pdf", - "deseq2.sample.dists.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T18:00:11.802609" - }, - "star_salmon/markdup": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.bam", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.bai", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai", - "WT_REP1.markdup.sorted.bam", - "WT_REP1.markdup.sorted.bam.bai", - "WT_REP2.markdup.sorted.bam", - "WT_REP2.markdup.sorted.bam.bai" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T18:00:13.466637" - }, - "star_salmon/featurecounts": { - "content": [ - "RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv:md5,f36792d25b268b6d556f8728300f4afc", - "RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv:md5,dde2de0cb90e10d0195c726f768e9941", - "RAP1_IAA_30M_REP1.featureCounts.txt:md5,c5865ded7168476d93057d2aedaec694", - "RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv:md5,782f5001d411ba79314ba77f7d36b157", - "RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv:md5,845ff9059c72bc6722a8de69776e22bb", - "RAP1_UNINDUCED_REP1.featureCounts.txt:md5,a0fb30c2b937a5a41ac865ab09367af7", - "RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv:md5,1c9d07d9f9d12219d2b9f761f854eced", - "RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv:md5,6d3fa4c88c7fe61f638e4624ad5e22f0", - "RAP1_UNINDUCED_REP2.featureCounts.txt:md5,de016e691f5d56b13bbaa626ce2cc93e", - "WT_REP1.biotype_counts_mqc.tsv:md5,eca4a76b9243248d01df5f4289b8201e", - "WT_REP1.biotype_counts_rrna_mqc.tsv:md5,8ef76d717492ca23764938aee8ea33a9", - "WT_REP1.featureCounts.txt:md5,7aadafd0a26f5047a9ae7266eccfce05", - "WT_REP2.biotype_counts_mqc.tsv:md5,530605b80da27915a90d452249f3243a", - "WT_REP2.biotype_counts_rrna_mqc.tsv:md5,12294618fe44df1e7f39348372dcb481", - "WT_REP2.featureCounts.txt:md5,809af01851125c401d576c21efca7b5a", - "RAP1_IAA_30M_REP1.featureCounts.txt.summary", - "RAP1_UNINDUCED_REP1.featureCounts.txt.summary", - "RAP1_UNINDUCED_REP2.featureCounts.txt.summary", - "WT_REP1.featureCounts.txt.summary", - "WT_REP2.featureCounts.txt.summary" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T13:19:35.982363" - }, - "salmon/deseq2_qc": { - "content": [ - "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", - "deseq2.dds.RData", - "deseq2.pca.vals.txt", - "deseq2.plots.pdf", - "deseq2.sample.dists.txt", - "RAP1_IAA_30M_REP1.txt", - "RAP1_UNINDUCED_REP1.txt", - "RAP1_UNINDUCED_REP2.txt", - "WT_REP1.txt", - "WT_REP2.txt", - "deseq2.size_factors.RData" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T18:00:11.010569" - }, - "salmon": { - "content": [ - "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", - "salmon.merged.gene_counts.SummarizedExperiment.rds", - "salmon.merged.gene_counts.tsv", - "salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_length_scaled.tsv", - "salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_scaled.tsv", - "salmon.merged.gene_lengths.tsv", - "salmon.merged.gene_tpm.tsv", - "salmon.merged.transcript_counts.SummarizedExperiment.rds", - "salmon.merged.transcript_counts.tsv", - "salmon.merged.transcript_lengths.tsv", - "salmon.merged.transcript_tpm.tsv" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T18:00:11.336679" - }, - "star_salmon/picard_metrics": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt", - "WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T18:00:12.629115" - }, - "star_salmon/salmon": { - "content": [ - "salmon.merged.gene_counts.SummarizedExperiment.rds", - "salmon.merged.gene_counts.tsv", - "salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_length_scaled.tsv", - "salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_scaled.tsv", - "salmon.merged.gene_lengths.tsv", - "salmon.merged.gene_tpm.tsv", - "salmon.merged.transcript_counts.SummarizedExperiment.rds", - "salmon.merged.transcript_counts.tsv", - "salmon.merged.transcript_lengths.tsv", - "salmon.merged.transcript_tpm.tsv" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T18:00:13.112566" - }, - "star_salmon/bigwig": { - "content": [ - "RAP1_IAA_30M_REP1.forward.bigWig", - "RAP1_IAA_30M_REP1.reverse.bigWig", - "RAP1_UNINDUCED_REP1.forward.bigWig", - "RAP1_UNINDUCED_REP1.reverse.bigWig", - "RAP1_UNINDUCED_REP2.forward.bigWig", - "RAP1_UNINDUCED_REP2.reverse.bigWig", - "WT_REP1.forward.bigWig", - "WT_REP1.reverse.bigWig", - "WT_REP2.forward.bigWig", - "WT_REP2.reverse.bigWig" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T18:18:52.080654" - }, - "star_salmon/sortmerna": { - "content": [ - "RAP1_IAA_30M_REP1.sortmerna.log", - "RAP1_UNINDUCED_REP1.sortmerna.log", - "RAP1_UNINDUCED_REP2.sortmerna.log", - "WT_REP1.sortmerna.log", - "WT_REP2.sortmerna.log" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T18:18:51.881667" - }, - "versions": { - "content": [ - "{BBMAP_BBSPLIT={bbmap=39.01}, BEDTOOLS_GENOMECOV_FW={bedtools=2.31.1}, CAT_FASTQ={cat=8.3}, CUSTOM_CATADDITIONALFASTA={python=3.9.5}, CUSTOM_GETCHROMSIZES={getchromsizes=1.2}, CUSTOM_TX2GENE={python=3.9.5}, DESEQ2_QC_PSEUDO={r-base=4.0.3, bioconductor-deseq2=1.28.0}, DESEQ2_QC_STAR_SALMON={r-base=4.0.3, bioconductor-deseq2=1.28.0}, DUPRADAR={bioconductor-dupradar=1.32.0}, FASTQC={fastqc=0.12.1}, FQ_SUBSAMPLE={fq=0.9.1 (2022-02-22)}, GTF2BED={perl=5.26.2}, GTF_FILTER={python=3.9.5}, GUNZIP_ADDITIONAL_FASTA={gunzip=1.1}, GUNZIP_GTF={gunzip=1.1}, MULTIQC_CUSTOM_BIOTYPE={python=3.9.5}, PICARD_MARKDUPLICATES={picard=3.1.1}, QUALIMAP_RNASEQ={qualimap=2.3}, RSEQC_BAMSTAT={rseqc=5.0.2}, RSEQC_INFEREXPERIMENT={rseqc=5.0.2}, RSEQC_INNERDISTANCE={rseqc=5.0.2}, RSEQC_JUNCTIONANNOTATION={rseqc=5.0.2}, RSEQC_JUNCTIONSATURATION={rseqc=5.0.2}, RSEQC_READDISTRIBUTION={rseqc=5.0.2}, RSEQC_READDUPLICATION={rseqc=5.0.2}, SALMON_QUANT={salmon=1.10.1}, SAMTOOLS_FLAGSTAT={samtools=1.2}, SAMTOOLS_IDXSTATS={samtools=1.2}, SAMTOOLS_INDEX={samtools=1.2}, SAMTOOLS_SORT={samtools=1.2}, SAMTOOLS_STATS={samtools=1.2}, SE_GENE={bioconductor-summarizedexperiment=1.32.0}, SORTMERNA={sortmerna=4.3.6}, SORTMERNA_INDEX={sortmerna=4.3.6}, STAR_ALIGN={star=2.7.10a, samtools=1.18, gawk=5.1.0}, STAR_GENOMEGENERATE={star=2.7.10a, samtools=1.18, gawk=5.1.0}, STRINGTIE_STRINGTIE={stringtie=2.2.1}, SUBREAD_FEATURECOUNTS={subread=2.0.1}, TRIMGALORE={trimgalore=0.6.7, cutadapt=3.4}, TXIMETA_TXIMPORT={bioconductor-tximeta=1.20.1}, UCSC_BEDCLIP={ucsc=377}, UCSC_BEDGRAPHTOBIGWIG={ucsc=445}, UNTAR_SALMON_INDEX={untar=1.34}, Workflow={nf-core/rnaseq=v3.16.0dev}}" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T18:00:14.01652" - }, - "fastqc/trim": { - "content": [ - "RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html", - "RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip", - "RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html", - "RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip", - "RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html", - "RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip", - "RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html", - "RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip", - "WT_REP1_trimmed_1_val_1_fastqc.html", - "WT_REP1_trimmed_1_val_1_fastqc.zip", - "WT_REP1_trimmed_2_val_2_fastqc.html", - "WT_REP1_trimmed_2_val_2_fastqc.zip", - "WT_REP2_trimmed_1_val_1_fastqc.html", - "WT_REP2_trimmed_1_val_1_fastqc.zip", - "WT_REP2_trimmed_2_val_2_fastqc.html", - "WT_REP2_trimmed_2_val_2_fastqc.zip" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T18:00:10.790876" - }, - "star_salmon/dupradar": { - "content": [ - "RAP1_IAA_30M_REP1_dupMatrix.txt:md5,ddadea4a08511aae6faeb632eb6aafea", - "RAP1_UNINDUCED_REP1_dupMatrix.txt:md5,1db4c86723cf69052c4386760a9750bb", - "RAP1_UNINDUCED_REP2_dupMatrix.txt:md5,c0bf1135d2d70c5918d87f706c0c54bc", - "WT_REP1_dupMatrix.txt:md5,b0de1683f2a9bfa42437e924a11648fd", - "WT_REP2_dupMatrix.txt:md5,bab18079153627205e5d907d8dfba677", - "RAP1_IAA_30M_REP1_intercept_slope.txt:md5,b21a53b0156b0afdfc28c237cb11218d", - "RAP1_UNINDUCED_REP1_intercept_slope.txt:md5,eccc5ca37855c717d35477e684188695", - "RAP1_UNINDUCED_REP2_intercept_slope.txt:md5,c3900f3bb24cd339d0e0ecf65ae43217", - "WT_REP1_intercept_slope.txt:md5,f38c8525b7fcb990b7158f1518e451ad", - "WT_REP2_intercept_slope.txt:md5,9bcbc18d0d331fe3c972538456ffd5b2", - "RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf", - "RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf", - "RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf", - "WT_REP1_duprateExpBoxplot.pdf", - "WT_REP2_duprateExpBoxplot.pdf", - "RAP1_IAA_30M_REP1_expressionHist.pdf", - "RAP1_UNINDUCED_REP1_expressionHist.pdf", - "RAP1_UNINDUCED_REP2_expressionHist.pdf", - "WT_REP1_expressionHist.pdf", - "WT_REP2_expressionHist.pdf", - "RAP1_IAA_30M_REP1_duprateExpDens.pdf", - "RAP1_UNINDUCED_REP1_duprateExpDens.pdf", - "RAP1_UNINDUCED_REP2_duprateExpDens.pdf", - "WT_REP1_duprateExpDens.pdf", - "WT_REP2_duprateExpDens.pdf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T18:00:12.064305" - }, - "bbsplit": { - "content": [ - "RAP1_IAA_30M_REP1.stats.txt", - "RAP1_UNINDUCED_REP1.stats.txt", - "RAP1_UNINDUCED_REP2.stats.txt", - "WT_REP1.stats.txt", - "WT_REP2.stats.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-23T18:00:10.74095" - }, - "star_salmon/qualimap": { - "content": [ - "Coverage Profile Along Genes (High).png:md5,1a837e43161d7133e9156c7b18123aa9", - "Coverage Profile Along Genes (Low).png:md5,46c5ba09af49602b956efd780f7a39e4", - "Coverage Profile Along Genes (Total).png:md5,b04cac9c2d15b1b9623d87d44caadff6", - "Transcript coverage histogram.png:md5,cbb250c6903bfe6ecab5fb4b2ca661e5", - "coverage_profile_along_genes_(high).txt:md5,5aee6c959137a8c9bfbd0ddaa79dddba", - "coverage_profile_along_genes_(low).txt:md5,d2742410803e0de7cc606ef118010ea8", - "coverage_profile_along_genes_(total).txt:md5,d2742410803e0de7cc606ef118010ea8", - "Coverage Profile Along Genes (High).png:md5,8c8b46f9bfb6cf952a95d85a6b917444", - "Coverage Profile Along Genes (Low).png:md5,5c56671f085c6db7fd86b41bb5b7e6d0", - "Coverage Profile Along Genes (Total).png:md5,b83fbaedfe4dcfdd7b3970d2ff27d517", - "Transcript coverage histogram.png:md5,488440d7b6d73bcd4567316712e281fe", - "coverage_profile_along_genes_(high).txt:md5,f5ac8f74fcad5d9ac72dbb6b65184bd0", - "coverage_profile_along_genes_(low).txt:md5,d66da6e3f49b0870184fc881a162e785", - "coverage_profile_along_genes_(total).txt:md5,d66da6e3f49b0870184fc881a162e785", - "Coverage Profile Along Genes (High).png:md5,015aa34b0d32f38bade831a3ef497984", - "Coverage Profile Along Genes (Low).png:md5,5798e0d977e0fee55ec4fc5192bfc0f4", - "Coverage Profile Along Genes (Total).png:md5,2bbec5e165075024cb1f74a042b1385a", - "Transcript coverage histogram.png:md5,bfd09f8b3282958a6a73b7924edac664", - "coverage_profile_along_genes_(high).txt:md5,634f447f91db940d2148af74cf36febd", - "coverage_profile_along_genes_(low).txt:md5,db2e0acbe9f07c68bcd7e08e036f02d3", - "coverage_profile_along_genes_(total).txt:md5,db2e0acbe9f07c68bcd7e08e036f02d3", - "Coverage Profile Along Genes (High).png:md5,d8a36870a6f262c41995b4b5bd26a149", - "Coverage Profile Along Genes (Low).png:md5,5570af90ee685a3c95117519aa6bdc46", - "Coverage Profile Along Genes (Total).png:md5,eb53e699213ce453cbea7f71f5204b08", - "Transcript coverage histogram.png:md5,f0bd8d82a8b7adec6e1f1ef85633eded", - "coverage_profile_along_genes_(high).txt:md5,a349232d75f6c0adab6afcd9f6cbbafb", - "coverage_profile_along_genes_(low).txt:md5,b2c696661e6c524b1641eb7267c70edc", - "coverage_profile_along_genes_(total).txt:md5,b2c696661e6c524b1641eb7267c70edc", - "Coverage Profile Along Genes (High).png:md5,3c1c603d63f3f7f9ba1ab6e7749b7771", - "Coverage Profile Along Genes (Low).png:md5,9f80251ed043cf900fa939cc254ccc81", - "Coverage Profile Along Genes (Total).png:md5,a420f287f986a8db317be712ac0a2237", - "Transcript coverage histogram.png:md5,c467c5eac12a95f8569198927434440d", - "coverage_profile_along_genes_(high).txt:md5,3f76529bd723d5320c86cc407fbb3294", - "coverage_profile_along_genes_(low).txt:md5,b9be191fdec82c78057e083d3adf20dd", - "coverage_profile_along_genes_(total).txt:md5,b9be191fdec82c78057e083d3adf20dd", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt" + 24, + { + "BBMAP_BBSPLIT": { + "bbmap": 39.01 + }, + "CAT_FASTQ": { + "cat": 8.3 + }, + "CUSTOM_CATADDITIONALFASTA": { + "python": null + }, + "CUSTOM_GETCHROMSIZES": { + "getchromsizes": 1.2 + }, + "FASTQC": { + "fastqc": "0.12.1" + }, + "GTF2BED": { + "perl": "5.26.2" + }, + "GTF_FILTER": { + "python": "3.9.5" + }, + "GUNZIP_ADDITIONAL_FASTA": { + "gunzip": 1.1 + }, + "GUNZIP_GTF": { + "gunzip": 1.1 + }, + "SORTMERNA_INDEX": { + "sortmerna": "4.3.6" + }, + "STAR_GENOMEGENERATE": { + "star": "2.7.10a", + "samtools": 1.18, + "gawk": "5.1.0" + }, + "TRIMGALORE": { + "trimgalore": "0.6.7", + "cutadapt": 3.4 + }, + "UNTAR_SALMON_INDEX": { + "untar": 1.34 + }, + "Workflow": { + "nf-core/rnaseq": "v3.16.0dev" + } + }, + [ + "custom", + "custom/out", + "custom/out/genome_transcriptome.fasta", + "custom/out/genome_transcriptome.gtf", + "fastqc", + "fastqc/raw", + "fastqc/raw/RAP1_IAA_30M_REP1_raw.html", + "fastqc/raw/RAP1_IAA_30M_REP1_raw.zip", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw.html", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw.zip", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw.html", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw.zip", + "fastqc/raw/WT_REP1_raw.html", + "fastqc/raw/WT_REP1_raw.zip", + "fastqc/raw/WT_REP2_raw.html", + "fastqc/raw/WT_REP2_raw.zip", + "fastqc/trim", + "multiqc", + "multiqc/star_salmon", + "multiqc/star_salmon/multiqc_data", + "multiqc/star_salmon/multiqc_plots", + "multiqc/star_salmon/multiqc_report.html", + "pipeline_info", + "pipeline_info/nf_core_rnaseq_software_mqc_versions.yml", + "trimgalore", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" + ], + [ + "genome_transcriptome.fasta:md5,d41d8cd98f00b204e9800998ecf8427e", + "genome_transcriptome.gtf:md5,d41d8cd98f00b204e9800998ecf8427e" + ] ], "meta": { "nf-test": "0.9.0", "nextflow": "24.04.4" }, - "timestamp": "2024-08-26T13:19:36.107982" + "timestamp": "2024-10-02T08:08:00.752563" } } \ No newline at end of file diff --git a/tests/salmon.nf.test b/tests/salmon.nf.test index 9105ed9fa..c0a386da0 100644 --- a/tests/salmon.nf.test +++ b/tests/salmon.nf.test @@ -15,216 +15,22 @@ nextflow_pipeline { } then { + // stable_name: All files + folders in ${params.outdir}/ with a stable name + def stable_name = getAllFilesFromDir(params.outdir, true, ['pipeline_info/*.{html,json,txt}'], null) + // stable_path: All files in ${params.outdir}/ with stable content + def stable_path = getAllFilesFromDir(params.outdir, false, null, 'tests/.nftignore') assertAll( - { assert workflow.success }, + { assert workflow.success}, { assert snapshot( - // These files are not stable - file("${params.outdir}/bbsplit/RAP1_IAA_30M_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/RAP1_UNINDUCED_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/RAP1_UNINDUCED_REP2.stats.txt").name, - file("${params.outdir}/bbsplit/WT_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/WT_REP2.stats.txt").name - ).match("bbsplit") }, - { assert snapshot( - path("${params.outdir}/custom/out/genome_gfp.fasta"), - path("${params.outdir}/custom/out/genome_gfp.gtf") - ).match("references") }, - { assert snapshot( - // HTMLs and ZIPs are not stable - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.zip").name - ).match("fastqc/trim") }, - { assert snapshot( - path("${params.outdir}/multiqc/multiqc_report_data/cutadapt_filtered_reads_plot.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Counts.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/fastqc-status-check-heatmap.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/fastqc_overrepresented_sequences_plot.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/fastqc_per_base_n_content_plot.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/fastqc_per_base_sequence_quality_plot.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Counts.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Percentages.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/fastqc_per_sequence_quality_scores_plot.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/fastqc_sequence_counts_plot.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/fastqc_sequence_duplication_levels_plot.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/fastqc_sequence_length_distribution_plot.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/multiqc_citations.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/multiqc_cutadapt.txt"), - path("${params.outdir}/multiqc/multiqc_report_data/multiqc_fastqc_fastqc_trimmed.txt"), - // These files are not stable - file("${params.outdir}/multiqc/multiqc_report_data/fastqc_top_overrepresented_sequences_table.txt").name, - file("${params.outdir}/multiqc/multiqc_report_data/multiqc_data.json").name, - file("${params.outdir}/multiqc/multiqc_report_data/multiqc_general_stats.txt").name, - file("${params.outdir}/multiqc/multiqc_report_data/multiqc_salmon.txt").name, - file("${params.outdir}/multiqc/multiqc_report_data/multiqc_software_versions.txt").name, - file("${params.outdir}/multiqc/multiqc_report_data/multiqc_sources.txt").name, - file("${params.outdir}/multiqc/multiqc_report_data/salmon_plot.txt").name - ).match("multiqc_data") }, - { assert snapshot( - path("${params.outdir}/multiqc/multiqc_report_plots/png/cutadapt_filtered_reads_plot-cnt.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/cutadapt_filtered_reads_plot-pct.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Counts.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Obs_Exp.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc-status-check-heatmap.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Counts.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Percentages.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_sequence_counts_plot-cnt.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_sequence_counts_plot-pct.png"), - path("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot.png"), - // PDFs, SVGs, some PNGs and HTML reports are not stable - file("${params.outdir}/multiqc/multiqc_report.html").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-pct.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Counts.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc-status-check-heatmap.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Counts.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Percentages.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-pct.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_sequence_length_distribution_plot.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/general_stats_table.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/pdf/salmon_plot.pdf").name, - file("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_per_base_n_content_plot.png").name, - file("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot.png").name, - file("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_sequence_length_distribution_plot.png").name, - file("${params.outdir}/multiqc/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table.png").name, - file("${params.outdir}/multiqc/multiqc_report_plots/png/general_stats_table.png").name, - file("${params.outdir}/multiqc/multiqc_report_plots/png/salmon_plot.png").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-cnt.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-pct.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Counts.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc-status-check-heatmap.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_per_base_n_content_plot.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Counts.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Percentages.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_sequence_counts_plot-cnt.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_sequence_counts_plot-pct.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_sequence_length_distribution_plot.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/general_stats_table.svg").name, - file("${params.outdir}/multiqc/multiqc_report_plots/svg/salmon_plot.svg").name - ).match("multiqc_plots") }, - { assert snapshot( - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/lib_format_counts.json"), - path("${params.outdir}/salmon/WT_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/WT_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/WT_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/WT_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/WT_REP1/cmd_info.json"), - path("${params.outdir}/salmon/WT_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/WT_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/WT_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/WT_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/WT_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/WT_REP2/cmd_info.json"), - path("${params.outdir}/salmon/WT_REP2/lib_format_counts.json"), - // These files are not stable - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/quant.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/quant.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/quant.sf").name, - file("${params.outdir}/salmon/WT_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/WT_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/WT_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/WT_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/WT_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/WT_REP1/quant.sf").name, - file("${params.outdir}/salmon/WT_REP2/aux_info/fld.gz").name, - file("${params.outdir}/salmon/WT_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/WT_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/WT_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/WT_REP2/quant.genes.sf").name, - file("${params.outdir}/salmon/WT_REP2/quant.sf").name - ).match("salmon_quant") }, - { assert snapshot( - path("${params.outdir}/salmon/tx2gene.tsv"), - // These files are not stable - file("${params.outdir}/salmon/salmon.merged.gene_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_length_scaled.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_scaled.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_lengths.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_tpm.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.transcript_counts.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_lengths.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_tpm.tsv").name - ).match("salmon") }, - { assert snapshot( - // These reports are not stable - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt").name - ).match("trimgalore") }, - { assert snapshot( - UTILS.removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml") - ).match("versions") } + // Number of successful tasks + workflow.trace.succeeded().size(), + // pipeline versions.yml file for multiqc from which Nextflow version is removed because we tests pipelines on multiple Nextflow versions + removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), + // All stable path name, with a relative path + getRelativePath(stable_name, outputDir), + // All files with stable contents + stable_path + ).match() } ) } } @@ -243,31 +49,21 @@ nextflow_pipeline { } then { + // stable_name: All files + folders in ${params.outdir}/ with a stable name + def stable_name = getAllFilesFromDir(params.outdir, true, ['pipeline_info/*.{html,json,txt}'], null) + // stable_path: All files in ${params.outdir}/ with stable content + def stable_path = getAllFilesFromDir(params.outdir, false, null, 'tests/.nftignore') assertAll( - { assert workflow.success }, + { assert workflow.success}, { assert snapshot( - UTILS.removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), - file("${params.outdir}/custom/out/genome_transcriptome.fasta").name, - file("${params.outdir}/custom/out/genome_transcriptome.gtf").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw.zip").name, - file("${params.outdir}/multiqc/multiqc_report.html").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt").name + // Number of successful tasks + workflow.trace.succeeded().size(), + // pipeline versions.yml file for multiqc from which Nextflow version is removed because we tests pipelines on multiple Nextflow versions + removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), + // All stable path name, with a relative path + getRelativePath(stable_name, outputDir), + // All files with stable contents + stable_path ).match() } ) } diff --git a/tests/salmon.nf.test.snap b/tests/salmon.nf.test.snap index 004c15ad4..a66fb0068 100644 --- a/tests/salmon.nf.test.snap +++ b/tests/salmon.nf.test.snap @@ -1,297 +1,418 @@ { - "multiqc_data": { + "Params: --pseudo_aligner salmon --skip_qc --skip_alignment": { "content": [ - "cutadapt_filtered_reads_plot.txt:md5,bf033e64e9d23bee85b6277f11c663f1", - "cutadapt_trimmed_sequences_plot_3_Counts.txt:md5,13dfa866fd91dbb072689efe9aa83b1f", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt:md5,07145dd8dd3db654859b18eb0389046c", - "fastqc-status-check-heatmap.txt:md5,22a03548736b88b23be6bc0c9ef1b4a6", - "fastqc_overrepresented_sequences_plot.txt:md5,4adfeacd3a3a6c7c808f121b24e6b247", - "fastqc_per_base_n_content_plot.txt:md5,418610c1ce119cb786ad434db75d366e", - "fastqc_per_base_sequence_quality_plot.txt:md5,bd22e06e41c096ad4f745d40fe96a1e5", - "fastqc_per_sequence_gc_content_plot_Counts.txt:md5,004c60768ceb6197765154e3eaa37b7a", - "fastqc_per_sequence_gc_content_plot_Percentages.txt:md5,95d29060b687f745288ad1ec47750037", - "fastqc_per_sequence_quality_scores_plot.txt:md5,0f9834cc19f76dd5c87cf8cba7435a7c", - "fastqc_sequence_counts_plot.txt:md5,3861354bbedfbde7ca36a72994f9425c", - "fastqc_sequence_duplication_levels_plot.txt:md5,c73407d55fc532e864fa1dc8dbc12874", - "fastqc_sequence_length_distribution_plot.txt:md5,6fe2c985606abad947bcca99b015ae33", - "multiqc_citations.txt:md5,f789abe663d4b4214f0ddeb413a7f150", - "multiqc_cutadapt.txt:md5,aac9581a5670cb55edf564f3d6c1f9a7", - "multiqc_fastqc_fastqc_trimmed.txt:md5,a3238f515e01d158d875d69968753804", - "fastqc_top_overrepresented_sequences_table.txt", - "multiqc_data.json", - "multiqc_general_stats.txt", - "multiqc_salmon.txt", - "multiqc_software_versions.txt", - "multiqc_sources.txt", - "salmon_plot.txt" + 34, + { + "BBMAP_BBSPLIT": { + "bbmap": 39.01 + }, + "CAT_FASTQ": { + "cat": 8.3 + }, + "CUSTOM_CATADDITIONALFASTA": { + "python": "3.9.5" + }, + "CUSTOM_GETCHROMSIZES": { + "getchromsizes": 1.2 + }, + "CUSTOM_TX2GENE": { + "python": "3.9.5" + }, + "FQ_SUBSAMPLE": { + "fq": "0.9.1 (2022-02-22)" + }, + "GTF2BED": { + "perl": "5.26.2" + }, + "GTF_FILTER": { + "python": "3.9.5" + }, + "GUNZIP_ADDITIONAL_FASTA": { + "gunzip": 1.1 + }, + "GUNZIP_GTF": { + "gunzip": 1.1 + }, + "SALMON_QUANT": { + "salmon": "1.10.1" + }, + "SE_GENE": { + "bioconductor-summarizedexperiment": "1.32.0" + }, + "TRIMGALORE": { + "trimgalore": "0.6.7", + "cutadapt": 3.4 + }, + "TXIMETA_TXIMPORT": { + "bioconductor-tximeta": "1.20.1" + }, + "UNTAR_SALMON_INDEX": { + "untar": 1.34 + }, + "Workflow": { + "nf-core/rnaseq": "v3.16.0dev" + } + }, + [ + "bbsplit", + "bbsplit/RAP1_IAA_30M_REP1.stats.txt", + "bbsplit/RAP1_UNINDUCED_REP1.stats.txt", + "bbsplit/RAP1_UNINDUCED_REP2.stats.txt", + "bbsplit/WT_REP1.stats.txt", + "bbsplit/WT_REP2.stats.txt", + "custom", + "custom/out", + "custom/out/genome_gfp.fasta", + "custom/out/genome_gfp.gtf", + "fastqc", + "fastqc/trim", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip", + "fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html", + "fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip", + "fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html", + "fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip", + "fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.html", + "fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.html", + "fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.zip", + "fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.html", + "fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.html", + "fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.zip", + "multiqc", + "multiqc/multiqc_report.html", + "multiqc/multiqc_report_data", + "multiqc/multiqc_report_data/cutadapt_filtered_reads_plot.txt", + "multiqc/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Counts.txt", + "multiqc/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt", + "multiqc/multiqc_report_data/fastqc-status-check-heatmap.txt", + "multiqc/multiqc_report_data/fastqc_overrepresented_sequences_plot.txt", + "multiqc/multiqc_report_data/fastqc_per_base_n_content_plot.txt", + "multiqc/multiqc_report_data/fastqc_per_base_sequence_quality_plot.txt", + "multiqc/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Counts.txt", + "multiqc/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Percentages.txt", + "multiqc/multiqc_report_data/fastqc_per_sequence_quality_scores_plot.txt", + "multiqc/multiqc_report_data/fastqc_sequence_counts_plot.txt", + "multiqc/multiqc_report_data/fastqc_sequence_duplication_levels_plot.txt", + "multiqc/multiqc_report_data/fastqc_sequence_length_distribution_plot.txt", + "multiqc/multiqc_report_data/fastqc_top_overrepresented_sequences_table.txt", + "multiqc/multiqc_report_data/multiqc_citations.txt", + "multiqc/multiqc_report_data/multiqc_cutadapt.txt", + "multiqc/multiqc_report_data/multiqc_data.json", + "multiqc/multiqc_report_data/multiqc_fastqc_fastqc_trimmed.txt", + "multiqc/multiqc_report_data/multiqc_general_stats.txt", + "multiqc/multiqc_report_data/multiqc_salmon.txt", + "multiqc/multiqc_report_data/multiqc_software_versions.txt", + "multiqc/multiqc_report_data/multiqc_sources.txt", + "multiqc/multiqc_report_data/salmon_plot.txt", + "multiqc/multiqc_report_plots", + "multiqc/multiqc_report_plots/pdf", + "multiqc/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-cnt.pdf", + "multiqc/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-pct.pdf", + "multiqc/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Counts.pdf", + "multiqc/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc-status-check-heatmap.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Counts.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Percentages.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-cnt.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-pct.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_sequence_length_distribution_plot.pdf", + "multiqc/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table.pdf", + "multiqc/multiqc_report_plots/pdf/general_stats_table.pdf", + "multiqc/multiqc_report_plots/pdf/salmon_plot.pdf", + "multiqc/multiqc_report_plots/png", + "multiqc/multiqc_report_plots/png/cutadapt_filtered_reads_plot-cnt.png", + "multiqc/multiqc_report_plots/png/cutadapt_filtered_reads_plot-pct.png", + "multiqc/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Counts.png", + "multiqc/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Obs_Exp.png", + "multiqc/multiqc_report_plots/png/fastqc-status-check-heatmap.png", + "multiqc/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot.png", + "multiqc/multiqc_report_plots/png/fastqc_per_base_n_content_plot.png", + "multiqc/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot.png", + "multiqc/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Counts.png", + "multiqc/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Percentages.png", + "multiqc/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot.png", + "multiqc/multiqc_report_plots/png/fastqc_sequence_counts_plot-cnt.png", + "multiqc/multiqc_report_plots/png/fastqc_sequence_counts_plot-pct.png", + "multiqc/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot.png", + "multiqc/multiqc_report_plots/png/fastqc_sequence_length_distribution_plot.png", + "multiqc/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table.png", + "multiqc/multiqc_report_plots/png/general_stats_table.png", + "multiqc/multiqc_report_plots/png/salmon_plot.png", + "multiqc/multiqc_report_plots/svg", + "multiqc/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-cnt.svg", + "multiqc/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-pct.svg", + "multiqc/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Counts.svg", + "multiqc/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg", + "multiqc/multiqc_report_plots/svg/fastqc-status-check-heatmap.svg", + "multiqc/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot.svg", + "multiqc/multiqc_report_plots/svg/fastqc_per_base_n_content_plot.svg", + "multiqc/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot.svg", + "multiqc/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Counts.svg", + "multiqc/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Percentages.svg", + "multiqc/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot.svg", + "multiqc/multiqc_report_plots/svg/fastqc_sequence_counts_plot-cnt.svg", + "multiqc/multiqc_report_plots/svg/fastqc_sequence_counts_plot-pct.svg", + "multiqc/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot.svg", + "multiqc/multiqc_report_plots/svg/fastqc_sequence_length_distribution_plot.svg", + "multiqc/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table.svg", + "multiqc/multiqc_report_plots/svg/general_stats_table.svg", + "multiqc/multiqc_report_plots/svg/salmon_plot.svg", + "pipeline_info", + "pipeline_info/nf_core_rnaseq_software_mqc_versions.yml", + "salmon", + "salmon/RAP1_IAA_30M_REP1", + "salmon/RAP1_IAA_30M_REP1/aux_info", + "salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv", + "salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json", + "salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz", + "salmon/RAP1_IAA_30M_REP1/cmd_info.json", + "salmon/RAP1_IAA_30M_REP1/libParams", + "salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt", + "salmon/RAP1_IAA_30M_REP1/lib_format_counts.json", + "salmon/RAP1_IAA_30M_REP1/logs", + "salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log", + "salmon/RAP1_IAA_30M_REP1/quant.genes.sf", + "salmon/RAP1_IAA_30M_REP1/quant.sf", + "salmon/RAP1_UNINDUCED_REP1", + "salmon/RAP1_UNINDUCED_REP1/aux_info", + "salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv", + "salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json", + "salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz", + "salmon/RAP1_UNINDUCED_REP1/cmd_info.json", + "salmon/RAP1_UNINDUCED_REP1/libParams", + "salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt", + "salmon/RAP1_UNINDUCED_REP1/lib_format_counts.json", + "salmon/RAP1_UNINDUCED_REP1/logs", + "salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log", + "salmon/RAP1_UNINDUCED_REP1/quant.genes.sf", + "salmon/RAP1_UNINDUCED_REP1/quant.sf", + "salmon/RAP1_UNINDUCED_REP2", + "salmon/RAP1_UNINDUCED_REP2/aux_info", + "salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv", + "salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json", + "salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz", + "salmon/RAP1_UNINDUCED_REP2/cmd_info.json", + "salmon/RAP1_UNINDUCED_REP2/libParams", + "salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt", + "salmon/RAP1_UNINDUCED_REP2/lib_format_counts.json", + "salmon/RAP1_UNINDUCED_REP2/logs", + "salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log", + "salmon/RAP1_UNINDUCED_REP2/quant.genes.sf", + "salmon/RAP1_UNINDUCED_REP2/quant.sf", + "salmon/WT_REP1", + "salmon/WT_REP1/aux_info", + "salmon/WT_REP1/aux_info/ambig_info.tsv", + "salmon/WT_REP1/aux_info/expected_bias.gz", + "salmon/WT_REP1/aux_info/fld.gz", + "salmon/WT_REP1/aux_info/meta_info.json", + "salmon/WT_REP1/aux_info/observed_bias.gz", + "salmon/WT_REP1/aux_info/observed_bias_3p.gz", + "salmon/WT_REP1/cmd_info.json", + "salmon/WT_REP1/libParams", + "salmon/WT_REP1/libParams/flenDist.txt", + "salmon/WT_REP1/lib_format_counts.json", + "salmon/WT_REP1/logs", + "salmon/WT_REP1/logs/salmon_quant.log", + "salmon/WT_REP1/quant.genes.sf", + "salmon/WT_REP1/quant.sf", + "salmon/WT_REP2", + "salmon/WT_REP2/aux_info", + "salmon/WT_REP2/aux_info/ambig_info.tsv", + "salmon/WT_REP2/aux_info/expected_bias.gz", + "salmon/WT_REP2/aux_info/fld.gz", + "salmon/WT_REP2/aux_info/meta_info.json", + "salmon/WT_REP2/aux_info/observed_bias.gz", + "salmon/WT_REP2/aux_info/observed_bias_3p.gz", + "salmon/WT_REP2/cmd_info.json", + "salmon/WT_REP2/libParams", + "salmon/WT_REP2/libParams/flenDist.txt", + "salmon/WT_REP2/lib_format_counts.json", + "salmon/WT_REP2/logs", + "salmon/WT_REP2/logs/salmon_quant.log", + "salmon/WT_REP2/quant.genes.sf", + "salmon/WT_REP2/quant.sf", + "salmon/salmon.merged.gene_counts.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts.tsv", + "salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts_length_scaled.tsv", + "salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts_scaled.tsv", + "salmon/salmon.merged.gene_lengths.tsv", + "salmon/salmon.merged.gene_tpm.tsv", + "salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds", + "salmon/salmon.merged.transcript_counts.tsv", + "salmon/salmon.merged.transcript_lengths.tsv", + "salmon/salmon.merged.transcript_tpm.tsv", + "salmon/tx2gene.tsv", + "trimgalore", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" + ], + [ + "genome_gfp.fasta:md5,e23e302af63736a199985a169fdac055", + "genome_gfp.gtf:md5,c98b12c302f15731bfc36bcf297cfe28", + "cutadapt_filtered_reads_plot.txt:md5,bf033e64e9d23bee85b6277f11c663f1", + "cutadapt_trimmed_sequences_plot_3_Counts.txt:md5,13dfa866fd91dbb072689efe9aa83b1f", + "cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt:md5,07145dd8dd3db654859b18eb0389046c", + "fastqc-status-check-heatmap.txt:md5,22a03548736b88b23be6bc0c9ef1b4a6", + "fastqc_overrepresented_sequences_plot.txt:md5,4adfeacd3a3a6c7c808f121b24e6b247", + "fastqc_per_base_n_content_plot.txt:md5,418610c1ce119cb786ad434db75d366e", + "fastqc_per_base_sequence_quality_plot.txt:md5,bd22e06e41c096ad4f745d40fe96a1e5", + "fastqc_per_sequence_gc_content_plot_Counts.txt:md5,004c60768ceb6197765154e3eaa37b7a", + "fastqc_per_sequence_gc_content_plot_Percentages.txt:md5,95d29060b687f745288ad1ec47750037", + "fastqc_per_sequence_quality_scores_plot.txt:md5,0f9834cc19f76dd5c87cf8cba7435a7c", + "fastqc_sequence_counts_plot.txt:md5,3861354bbedfbde7ca36a72994f9425c", + "fastqc_sequence_duplication_levels_plot.txt:md5,c73407d55fc532e864fa1dc8dbc12874", + "fastqc_sequence_length_distribution_plot.txt:md5,6fe2c985606abad947bcca99b015ae33", + "multiqc_citations.txt:md5,f789abe663d4b4214f0ddeb413a7f150", + "multiqc_cutadapt.txt:md5,aac9581a5670cb55edf564f3d6c1f9a7", + "multiqc_fastqc_fastqc_trimmed.txt:md5,a3238f515e01d158d875d69968753804", + "cutadapt_filtered_reads_plot-cnt.png:md5,704cf0d91bfa3dd658dd8c9590f669a2", + "cutadapt_filtered_reads_plot-pct.png:md5,2684d8b2afca3300e5786486b80237f0", + "cutadapt_trimmed_sequences_plot_3_Counts.png:md5,bef41d894629b0c4dab4478bbf197f50", + "cutadapt_trimmed_sequences_plot_3_Obs_Exp.png:md5,1e0d01537d3797623d0b3fd8fbe42787", + "fastqc-status-check-heatmap.png:md5,2402522f8c02e12aea9af088c6595890", + "fastqc_overrepresented_sequences_plot.png:md5,40e450251b80ec0efc9364434234ec7f", + "fastqc_per_sequence_gc_content_plot_Counts.png:md5,8a806cec2142f9911502e0a253d83d13", + "fastqc_per_sequence_gc_content_plot_Percentages.png:md5,953929d50c8490029880e205e4db7959", + "fastqc_per_sequence_quality_scores_plot.png:md5,d2c29cae169f35744500c751b4a7366e", + "fastqc_sequence_counts_plot-cnt.png:md5,2874fea747c7ff46828bf4f17668caf8", + "fastqc_sequence_counts_plot-pct.png:md5,0022d7f5ac78b6eff157de24e37c5ab0", + "fastqc_sequence_duplication_levels_plot.png:md5,fcd3b1ec2b95fe4bcd607dc28179a754", + "ambig_info.tsv:md5,de973a4b22a4457217ae3dc04caf9401", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,1215f0c20f87d3aef8553ef119e1e74c", + "lib_format_counts.json:md5,c24ffe28d70476b5ccdd8bc2d22c0ac1", + "ambig_info.tsv:md5,45f252b4f0e11e6730cf0c29f800fdbb", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,621c6601aade5b1f2e3d6ca2fc71f636", + "lib_format_counts.json:md5,f6d44c0221f7fd559f11a9afe04c9935", + "ambig_info.tsv:md5,6dcc2891ea572e9b8d1ba52cd434ab84", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,9bed6e4dc5428d6f6297adcea29a6326", + "lib_format_counts.json:md5,7c562bf2f70e42f3a7292687dfd328c3", + "ambig_info.tsv:md5,194f574e0586416155e3f33d42e2b167", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,c7ed0aaa5d6c7934ddbebfd29e4eb86d", + "lib_format_counts.json:md5,d46250bb3677d72feeefc435fe6395a6", + "ambig_info.tsv:md5,a26e3f936e65d7da66392603c2f91f6f", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,69ebfc2c7ca6b221a0a22fa1dc8c20ac", + "lib_format_counts.json:md5,088fd51db07022ffde47033bbd029400", + "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe" + ] ], "meta": { "nf-test": "0.9.0", "nextflow": "24.04.4" }, - "timestamp": "2024-08-26T10:25:09.703525" - }, - "trimgalore": { - "content": [ - "RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T10:25:09.861436" - }, - "references": { - "content": [ - "genome_gfp.fasta:md5,e23e302af63736a199985a169fdac055", - "genome_gfp.gtf:md5,c98b12c302f15731bfc36bcf297cfe28" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T10:25:09.678308" - }, - "versions": { - "content": [ - "{BBMAP_BBSPLIT={bbmap=39.01}, CAT_FASTQ={cat=8.3}, CUSTOM_CATADDITIONALFASTA={python=3.9.5}, CUSTOM_GETCHROMSIZES={getchromsizes=1.2}, CUSTOM_TX2GENE={python=3.9.5}, FQ_SUBSAMPLE={fq=0.9.1 (2022-02-22)}, GTF2BED={perl=5.26.2}, GTF_FILTER={python=3.9.5}, GUNZIP_ADDITIONAL_FASTA={gunzip=1.1}, GUNZIP_GTF={gunzip=1.1}, SALMON_QUANT={salmon=1.10.1}, SE_GENE={bioconductor-summarizedexperiment=1.32.0}, TRIMGALORE={trimgalore=0.6.7, cutadapt=3.4}, TXIMETA_TXIMPORT={bioconductor-tximeta=1.20.1}, UNTAR_SALMON_INDEX={untar=1.34}, Workflow={nf-core/rnaseq=v3.16.0dev}}" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T10:25:10.110511" - }, - "fastqc/trim": { - "content": [ - "RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html", - "RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip", - "RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html", - "RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip", - "RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html", - "RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip", - "RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html", - "RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip", - "WT_REP1_trimmed_1_val_1_fastqc.html", - "WT_REP1_trimmed_1_val_1_fastqc.zip", - "WT_REP1_trimmed_2_val_2_fastqc.html", - "WT_REP1_trimmed_2_val_2_fastqc.zip", - "WT_REP2_trimmed_1_val_1_fastqc.html", - "WT_REP2_trimmed_1_val_1_fastqc.zip", - "WT_REP2_trimmed_2_val_2_fastqc.html", - "WT_REP2_trimmed_2_val_2_fastqc.zip" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T10:25:09.69038" - }, - "salmon": { - "content": [ - "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", - "salmon.merged.gene_counts.SummarizedExperiment.rds", - "salmon.merged.gene_counts.tsv", - "salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_length_scaled.tsv", - "salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_scaled.tsv", - "salmon.merged.gene_lengths.tsv", - "salmon.merged.gene_tpm.tsv", - "salmon.merged.transcript_counts.SummarizedExperiment.rds", - "salmon.merged.transcript_counts.tsv", - "salmon.merged.transcript_lengths.tsv", - "salmon.merged.transcript_tpm.tsv" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T10:25:09.804203" - }, - "multiqc_plots": { - "content": [ - "cutadapt_filtered_reads_plot-cnt.png:md5,704cf0d91bfa3dd658dd8c9590f669a2", - "cutadapt_filtered_reads_plot-pct.png:md5,2684d8b2afca3300e5786486b80237f0", - "cutadapt_trimmed_sequences_plot_3_Counts.png:md5,bef41d894629b0c4dab4478bbf197f50", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.png:md5,1e0d01537d3797623d0b3fd8fbe42787", - "fastqc-status-check-heatmap.png:md5,2402522f8c02e12aea9af088c6595890", - "fastqc_overrepresented_sequences_plot.png:md5,40e450251b80ec0efc9364434234ec7f", - "fastqc_per_sequence_gc_content_plot_Counts.png:md5,8a806cec2142f9911502e0a253d83d13", - "fastqc_per_sequence_gc_content_plot_Percentages.png:md5,953929d50c8490029880e205e4db7959", - "fastqc_per_sequence_quality_scores_plot.png:md5,d2c29cae169f35744500c751b4a7366e", - "fastqc_sequence_counts_plot-cnt.png:md5,2874fea747c7ff46828bf4f17668caf8", - "fastqc_sequence_counts_plot-pct.png:md5,0022d7f5ac78b6eff157de24e37c5ab0", - "fastqc_sequence_duplication_levels_plot.png:md5,fcd3b1ec2b95fe4bcd607dc28179a754", - "multiqc_report.html", - "cutadapt_filtered_reads_plot-cnt.pdf", - "cutadapt_filtered_reads_plot-pct.pdf", - "cutadapt_trimmed_sequences_plot_3_Counts.pdf", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf", - "fastqc-status-check-heatmap.pdf", - "fastqc_overrepresented_sequences_plot.pdf", - "fastqc_per_base_n_content_plot.pdf", - "fastqc_per_base_sequence_quality_plot.pdf", - "fastqc_per_sequence_gc_content_plot_Counts.pdf", - "fastqc_per_sequence_gc_content_plot_Percentages.pdf", - "fastqc_per_sequence_quality_scores_plot.pdf", - "fastqc_sequence_counts_plot-cnt.pdf", - "fastqc_sequence_counts_plot-pct.pdf", - "fastqc_sequence_duplication_levels_plot.pdf", - "fastqc_sequence_length_distribution_plot.pdf", - "fastqc_top_overrepresented_sequences_table.pdf", - "general_stats_table.pdf", - "salmon_plot.pdf", - "fastqc_per_base_n_content_plot.png", - "fastqc_per_base_sequence_quality_plot.png", - "fastqc_sequence_length_distribution_plot.png", - "fastqc_top_overrepresented_sequences_table.png", - "general_stats_table.png", - "salmon_plot.png", - "cutadapt_filtered_reads_plot-cnt.svg", - "cutadapt_filtered_reads_plot-pct.svg", - "cutadapt_trimmed_sequences_plot_3_Counts.svg", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg", - "fastqc-status-check-heatmap.svg", - "fastqc_overrepresented_sequences_plot.svg", - "fastqc_per_base_n_content_plot.svg", - "fastqc_per_base_sequence_quality_plot.svg", - "fastqc_per_sequence_gc_content_plot_Counts.svg", - "fastqc_per_sequence_gc_content_plot_Percentages.svg", - "fastqc_per_sequence_quality_scores_plot.svg", - "fastqc_sequence_counts_plot-cnt.svg", - "fastqc_sequence_counts_plot-pct.svg", - "fastqc_sequence_duplication_levels_plot.svg", - "fastqc_sequence_length_distribution_plot.svg", - "fastqc_top_overrepresented_sequences_table.svg", - "general_stats_table.svg", - "salmon_plot.svg" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T10:25:09.724424" - }, - "bbsplit": { - "content": [ - "RAP1_IAA_30M_REP1.stats.txt", - "RAP1_UNINDUCED_REP1.stats.txt", - "RAP1_UNINDUCED_REP2.stats.txt", - "WT_REP1.stats.txt", - "WT_REP2.stats.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T10:25:09.665867" - }, - "salmon_quant": { - "content": [ - "ambig_info.tsv:md5,de973a4b22a4457217ae3dc04caf9401", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,1215f0c20f87d3aef8553ef119e1e74c", - "lib_format_counts.json:md5,c24ffe28d70476b5ccdd8bc2d22c0ac1", - "ambig_info.tsv:md5,45f252b4f0e11e6730cf0c29f800fdbb", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,621c6601aade5b1f2e3d6ca2fc71f636", - "lib_format_counts.json:md5,f6d44c0221f7fd559f11a9afe04c9935", - "ambig_info.tsv:md5,6dcc2891ea572e9b8d1ba52cd434ab84", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,9bed6e4dc5428d6f6297adcea29a6326", - "lib_format_counts.json:md5,7c562bf2f70e42f3a7292687dfd328c3", - "ambig_info.tsv:md5,194f574e0586416155e3f33d42e2b167", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,c7ed0aaa5d6c7934ddbebfd29e4eb86d", - "lib_format_counts.json:md5,d46250bb3677d72feeefc435fe6395a6", - "ambig_info.tsv:md5,a26e3f936e65d7da66392603c2f91f6f", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,69ebfc2c7ca6b221a0a22fa1dc8c20ac", - "lib_format_counts.json:md5,088fd51db07022ffde47033bbd029400", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T10:25:09.758031" + "timestamp": "2024-10-02T08:10:56.056197" }, "Params: --pseudo_aligner salmon --skip_qc --skip_alignment - stub": { "content": [ - "{BBMAP_BBSPLIT={bbmap=39.01}, CAT_FASTQ={cat=8.3}, CUSTOM_CATADDITIONALFASTA={python=null}, CUSTOM_GETCHROMSIZES={getchromsizes=1.2}, GTF2BED={perl=5.26.2}, GTF_FILTER={python=3.9.5}, GUNZIP_ADDITIONAL_FASTA={gunzip=1.1}, GUNZIP_GTF={gunzip=1.1}, TRIMGALORE={trimgalore=0.6.7, cutadapt=3.4}, UNTAR_SALMON_INDEX={untar=1.34}, Workflow={nf-core/rnaseq=v3.16.0dev}}", - "genome_transcriptome.fasta", - "genome_transcriptome.gtf", - "RAP1_IAA_30M_REP1_raw.html", - "RAP1_IAA_30M_REP1_raw.zip", - "RAP1_UNINDUCED_REP1_raw.html", - "RAP1_UNINDUCED_REP1_raw.zip", - "RAP1_UNINDUCED_REP2_raw.html", - "RAP1_UNINDUCED_REP2_raw.zip", - "WT_REP1_raw.html", - "WT_REP1_raw.zip", - "WT_REP2_raw.html", - "WT_REP2_raw.zip", - "multiqc_report.html", - "RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" + 16, + { + "BBMAP_BBSPLIT": { + "bbmap": 39.01 + }, + "CAT_FASTQ": { + "cat": 8.3 + }, + "CUSTOM_CATADDITIONALFASTA": { + "python": null + }, + "CUSTOM_GETCHROMSIZES": { + "getchromsizes": 1.2 + }, + "GTF2BED": { + "perl": "5.26.2" + }, + "GTF_FILTER": { + "python": "3.9.5" + }, + "GUNZIP_ADDITIONAL_FASTA": { + "gunzip": 1.1 + }, + "GUNZIP_GTF": { + "gunzip": 1.1 + }, + "TRIMGALORE": { + "trimgalore": "0.6.7", + "cutadapt": 3.4 + }, + "UNTAR_SALMON_INDEX": { + "untar": 1.34 + }, + "Workflow": { + "nf-core/rnaseq": "v3.16.0dev" + } + }, + [ + "custom", + "custom/out", + "custom/out/genome_transcriptome.fasta", + "custom/out/genome_transcriptome.gtf", + "fastqc", + "fastqc/trim", + "multiqc", + "multiqc/multiqc_data", + "multiqc/multiqc_plots", + "multiqc/multiqc_report.html", + "pipeline_info", + "pipeline_info/nf_core_rnaseq_software_mqc_versions.yml", + "trimgalore", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" + ], + [ + "genome_transcriptome.fasta:md5,d41d8cd98f00b204e9800998ecf8427e", + "genome_transcriptome.gtf:md5,d41d8cd98f00b204e9800998ecf8427e" + ] ], "meta": { "nf-test": "0.9.0", "nextflow": "24.04.4" }, - "timestamp": "2024-08-26T10:25:58.654392" + "timestamp": "2024-10-02T08:11:32.236118" } } \ No newline at end of file diff --git a/tests/skip_qc.nf.test b/tests/skip_qc.nf.test index 8fd703462..3c03631cc 100644 --- a/tests/skip_qc.nf.test +++ b/tests/skip_qc.nf.test @@ -13,472 +13,22 @@ nextflow_pipeline { } then { + // stable_name: All files + folders in ${params.outdir}/ with a stable name + def stable_name = getAllFilesFromDir(params.outdir, true, ['pipeline_info/*.{html,json,txt}'], null) + // stable_path: All files in ${params.outdir}/ with stable content + def stable_path = getAllFilesFromDir(params.outdir, false, null, 'tests/.nftignore') assertAll( - { assert workflow.success }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/bbsplit/RAP1_IAA_30M_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/RAP1_UNINDUCED_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/RAP1_UNINDUCED_REP2.stats.txt").name, - file("${params.outdir}/bbsplit/WT_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/WT_REP2.stats.txt").name - ).match("bbsplit") }, - { assert snapshot( - path("${params.outdir}/custom/out/genome_gfp.fasta"), - path("${params.outdir}/custom/out/genome_gfp.gtf") - ).match("references") }, - { assert snapshot( - // HTMLs and ZIPs are not stable - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.zip").name - ).match("fastqc/trim") }, - { assert snapshot( - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/cutadapt_filtered_reads_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc-status-check-heatmap.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_overrepresented_sequences_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_base_n_content_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_base_sequence_quality_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Percentages.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_quality_scores_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_counts_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_duplication_levels_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_length_distribution_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_citations.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_cutadapt.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_fastqc_fastqc_trimmed.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_samtools_idxstats.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_histogram.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_histogram_1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_histogram_2.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt"), - // These files are not stable - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_top_overrepresented_sequences_table.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/junction_saturation_known.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/junction_saturation_novel.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_data.json").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_general_stats.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_picard_dups.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_samtools_flagstat.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_samtools_stats.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_software_versions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_sources.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_deduplication.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/salmon_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Percentage_of_total.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Read_counts.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-stats-dp.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools_alignment_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/star_alignment_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/star_summary_table.txt").name - ).match("multiqc_data") }, - { assert snapshot( - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/cutadapt_filtered_reads_plot-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/cutadapt_filtered_reads_plot-pct.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Counts.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Obs_Exp.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc-status-check-heatmap.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Counts.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Percentages.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-pct.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png"), - // PDFs, SVGs, some PNGs and HTML reports are not stable - file("${params.outdir}/multiqc/star_salmon/multiqc_report.html").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc-status-check-heatmap.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Percentages.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_length_distribution_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/general_stats_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/salmon_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Percentage_of_total.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Read_counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-stats-dp.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_summary_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_n_content_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_length_distribution_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/general_stats_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/salmon_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Percentage_of_total.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Read_counts.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-stats-dp.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_summary_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc-status-check-heatmap.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_n_content_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Percentages.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_length_distribution_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/general_stats_table.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/salmon_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Percentage_of_total.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Read_counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-stats-dp.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_summary_table.svg").name - ).match("multiqc_plots") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.sorted.bam.stats").name - ).match("star_salmon/samtools_stats") }, - { assert snapshot( - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/i_data.ctab"), - // These files are not stable - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP1.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP1.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP1.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP2.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP2.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP2.transcripts.gtf").name - ).match("star_salmon/stringtie") }, - { assert snapshot( - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/WT_REP1.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/WT_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/WT_REP2.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/WT_REP2.markdup.sorted.bam.bai").name - ).match("star_salmon/markdup") }, - { assert snapshot( - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/lib_format_counts.json"), - path("${params.outdir}/salmon/WT_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/WT_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/WT_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/WT_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/WT_REP1/cmd_info.json"), - path("${params.outdir}/salmon/WT_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/WT_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/WT_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/WT_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/WT_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/WT_REP2/cmd_info.json"), - path("${params.outdir}/salmon/WT_REP2/lib_format_counts.json"), - // These files are not stable - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/quant.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/quant.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/quant.sf").name, - file("${params.outdir}/salmon/WT_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/WT_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/WT_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/WT_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/WT_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/WT_REP1/quant.sf").name, - file("${params.outdir}/salmon/WT_REP2/aux_info/fld.gz").name, - file("${params.outdir}/salmon/WT_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/WT_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/WT_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/WT_REP2/quant.genes.sf").name, - file("${params.outdir}/salmon/WT_REP2/quant.sf").name - ).match("salmon_quant") }, - { assert snapshot( - path("${params.outdir}/salmon/tx2gene.tsv"), - // These files are not stable - file("${params.outdir}/salmon/salmon.merged.gene_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_length_scaled.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_scaled.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_lengths.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_tpm.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.transcript_counts.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_lengths.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_tpm.tsv").name - ).match("salmon") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/star_salmon/bigwig/RAP1_IAA_30M_REP1.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_IAA_30M_REP1.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP1.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP1.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP2.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP2.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/WT_REP1.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/WT_REP1.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/WT_REP2.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/WT_REP2.reverse.bigWig").name - ).match("star_salmon/bigwig") }, - { assert snapshot( - path("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/WT_REP1.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/WT_REP2.SJ.out.tab"), - // Logs are not stable - file("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.Log.final.out").name, - file("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.Log.out").name, - file("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.Log.final.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.Log.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.Log.final.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.Log.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/WT_REP1.Log.final.out").name, - file("${params.outdir}/star_salmon/log/WT_REP1.Log.out").name, - file("${params.outdir}/star_salmon/log/WT_REP1.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/WT_REP2.Log.final.out").name, - file("${params.outdir}/star_salmon/log/WT_REP2.Log.out").name, - file("${params.outdir}/star_salmon/log/WT_REP2.Log.progress.out").name - ).match("star_salmon/log") }, - { assert snapshot( - // Metrics are not stable - file("${params.outdir}/star_salmon/picard_metrics/RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt").name - ).match("star_salmon/picard_metrics") }, - { assert snapshot( - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/cmd_info.json"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/cmd_info.json"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/cmd_info.json"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/WT_REP1/cmd_info.json"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/WT_REP2/cmd_info.json"), - path("${params.outdir}/star_salmon/tx2gene.tsv"), - // These files are not stable - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/quant.genes.sf").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/quant.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/quant.genes.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/quant.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/quant.genes.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/quant.sf").name, - file("${params.outdir}/star_salmon/WT_REP1/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/WT_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/WT_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/WT_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/WT_REP1/quant.genes.sf").name, - file("${params.outdir}/star_salmon/WT_REP1/quant.sf").name, - file("${params.outdir}/star_salmon/WT_REP2/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/WT_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/WT_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/WT_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/WT_REP2/quant.genes.sf").name, - file("${params.outdir}/star_salmon/WT_REP2/quant.sf").name - ).match("star_salmon/salmon_quant") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/star_salmon/salmon.merged.gene_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_length_scaled.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_scaled.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_lengths.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_tpm.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_counts.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_lengths.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_tpm.tsv").name - ).match("star_salmon/salmon") }, - { assert snapshot( - UTILS.removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml") - ).match("versions") } + { assert workflow.success}, + { assert snapshot( + // Number of successful tasks + workflow.trace.succeeded().size(), + // pipeline versions.yml file for multiqc from which Nextflow version is removed because we tests pipelines on multiple Nextflow versions + removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), + // All stable path name, with a relative path + getRelativePath(stable_name, outputDir), + // All files with stable contents + stable_path + ).match() } ) } } @@ -495,31 +45,21 @@ nextflow_pipeline { } then { + // stable_name: All files + folders in ${params.outdir}/ with a stable name + def stable_name = getAllFilesFromDir(params.outdir, true, ['pipeline_info/*.{html,json,txt}'], null) + // stable_path: All files in ${params.outdir}/ with stable content + def stable_path = getAllFilesFromDir(params.outdir, false, null, 'tests/.nftignore') assertAll( - { assert workflow.success }, - { assert snapshot( - UTILS.removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), - file("${params.outdir}/custom/out/genome_transcriptome.fasta").name, - file("${params.outdir}/custom/out/genome_transcriptome.gtf").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw.zip").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report.html").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt").name + { assert workflow.success}, + { assert snapshot( + // Number of successful tasks + workflow.trace.succeeded().size(), + // pipeline versions.yml file for multiqc from which Nextflow version is removed because we tests pipelines on multiple Nextflow versions + removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), + // All stable path name, with a relative path + getRelativePath(stable_name, outputDir), + // All files with stable contents + stable_path ).match() } ) } diff --git a/tests/skip_qc.nf.test.snap b/tests/skip_qc.nf.test.snap index 7a1eaccf3..ff25d5c62 100644 --- a/tests/skip_qc.nf.test.snap +++ b/tests/skip_qc.nf.test.snap @@ -1,596 +1,809 @@ { - "star_salmon/log": { - "content": [ - "RAP1_IAA_30M_REP1.SJ.out.tab:md5,ea95e243278af55534f2c52eb5fff7ee", - "RAP1_UNINDUCED_REP1.SJ.out.tab:md5,e548d13942535dc0821f3ec6d9743ec8", - "RAP1_UNINDUCED_REP2.SJ.out.tab:md5,1f294365343a1a5e95682792fdb77033", - "WT_REP1.SJ.out.tab:md5,1350c2fa6a675bf107386c6cd3fc5204", - "WT_REP2.SJ.out.tab:md5,f6cc03643a5e3c1025a5b4754eb1be23", - "RAP1_IAA_30M_REP1.Log.final.out", - "RAP1_IAA_30M_REP1.Log.out", - "RAP1_IAA_30M_REP1.Log.progress.out", - "RAP1_UNINDUCED_REP1.Log.final.out", - "RAP1_UNINDUCED_REP1.Log.out", - "RAP1_UNINDUCED_REP1.Log.progress.out", - "RAP1_UNINDUCED_REP2.Log.final.out", - "RAP1_UNINDUCED_REP2.Log.out", - "RAP1_UNINDUCED_REP2.Log.progress.out", - "WT_REP1.Log.final.out", - "WT_REP1.Log.out", - "WT_REP1.Log.progress.out", - "WT_REP2.Log.final.out", - "WT_REP2.Log.out", - "WT_REP2.Log.progress.out" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T12:11:58.323422" - }, - "star_salmon/salmon_quant": { - "content": [ - "ambig_info.tsv:md5,f9a605d54a0a103566f7a9b8e0867a73", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,4cc2492f557e5e0a2911a0bd83a51020", - "ambig_info.tsv:md5,8f97be8af4e47cc48650c62227a40203", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,dc750c3564c63da54979c852794d58a5", - "ambig_info.tsv:md5,a044fe7a3ad445c9a91a0d54ab5015d1", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,db43ed650e6e7b42cd2c5b8101bb6748", - "ambig_info.tsv:md5,7a8ea02d74058efb801e8c62bca96fd4", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,e418b4e899623449c6babdf53e5aabde", - "ambig_info.tsv:md5,543a047a549437026a1363ea8ddf5b03", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,f234c8d322df3b59d990594c63b24eae", - "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T12:11:58.511869" - }, - "multiqc_data": { - "content": [ - "cutadapt_filtered_reads_plot.txt:md5,bf033e64e9d23bee85b6277f11c663f1", - "cutadapt_trimmed_sequences_plot_3_Counts.txt:md5,13dfa866fd91dbb072689efe9aa83b1f", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt:md5,07145dd8dd3db654859b18eb0389046c", - "fastqc-status-check-heatmap.txt:md5,22a03548736b88b23be6bc0c9ef1b4a6", - "fastqc_overrepresented_sequences_plot.txt:md5,4adfeacd3a3a6c7c808f121b24e6b247", - "fastqc_per_base_n_content_plot.txt:md5,418610c1ce119cb786ad434db75d366e", - "fastqc_per_base_sequence_quality_plot.txt:md5,bd22e06e41c096ad4f745d40fe96a1e5", - "fastqc_per_sequence_gc_content_plot_Counts.txt:md5,004c60768ceb6197765154e3eaa37b7a", - "fastqc_per_sequence_gc_content_plot_Percentages.txt:md5,95d29060b687f745288ad1ec47750037", - "fastqc_per_sequence_quality_scores_plot.txt:md5,0f9834cc19f76dd5c87cf8cba7435a7c", - "fastqc_sequence_counts_plot.txt:md5,3861354bbedfbde7ca36a72994f9425c", - "fastqc_sequence_duplication_levels_plot.txt:md5,c73407d55fc532e864fa1dc8dbc12874", - "fastqc_sequence_length_distribution_plot.txt:md5,6fe2c985606abad947bcca99b015ae33", - "multiqc_citations.txt:md5,ef51c78faebdd32bad296ba14406b41e", - "multiqc_cutadapt.txt:md5,aac9581a5670cb55edf564f3d6c1f9a7", - "multiqc_fastqc_fastqc_trimmed.txt:md5,a3238f515e01d158d875d69968753804", - "multiqc_samtools_idxstats.txt:md5,fd7d03a91f0b9e01a6939941f7f2243f", - "picard_histogram.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "picard_histogram_1.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "picard_histogram_2.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt:md5,75acd04232d1804b5f960ee4c5db4722", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt:md5,ae45731d8d4595f77e6b271004f3a070", - "fastqc_top_overrepresented_sequences_table.txt", - "junction_saturation_known.txt", - "junction_saturation_novel.txt", - "multiqc_data.json", - "multiqc_general_stats.txt", - "multiqc_picard_dups.txt", - "multiqc_salmon.txt", - "multiqc_samtools_flagstat.txt", - "multiqc_samtools_stats.txt", - "multiqc_software_versions.txt", - "multiqc_sources.txt", - "multiqc_star.txt", - "picard_deduplication.txt", - "salmon_plot.txt", - "samtools-flagstat-dp_Percentage_of_total.txt", - "samtools-flagstat-dp_Read_counts.txt", - "samtools-stats-dp.txt", - "samtools_alignment_plot.txt", - "star_alignment_plot.txt", - "star_summary_table.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T19:28:48.798947" - }, - "references": { - "content": [ - "genome_gfp.fasta:md5,e23e302af63736a199985a169fdac055", - "genome_gfp.gtf:md5,c98b12c302f15731bfc36bcf297cfe28" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T11:24:48.102924" - }, "Params: --skip_qc - stub": { "content": [ - "{BBMAP_BBSPLIT={bbmap=39.01}, CAT_FASTQ={cat=8.3}, CUSTOM_CATADDITIONALFASTA={python=null}, CUSTOM_GETCHROMSIZES={getchromsizes=1.2}, GTF2BED={perl=5.26.2}, GTF_FILTER={python=3.9.5}, GUNZIP_ADDITIONAL_FASTA={gunzip=1.1}, GUNZIP_GTF={gunzip=1.1}, STAR_GENOMEGENERATE={star=2.7.10a, samtools=1.18, gawk=5.1.0}, TRIMGALORE={trimgalore=0.6.7, cutadapt=3.4}, UNTAR_SALMON_INDEX={untar=1.34}, Workflow={nf-core/rnaseq=v3.16.0dev}}", - "genome_transcriptome.fasta", - "genome_transcriptome.gtf", - "RAP1_IAA_30M_REP1_raw.html", - "RAP1_IAA_30M_REP1_raw.zip", - "RAP1_UNINDUCED_REP1_raw.html", - "RAP1_UNINDUCED_REP1_raw.zip", - "RAP1_UNINDUCED_REP2_raw.html", - "RAP1_UNINDUCED_REP2_raw.zip", - "WT_REP1_raw.html", - "WT_REP1_raw.zip", - "WT_REP2_raw.html", - "WT_REP2_raw.zip", - "multiqc_report.html", - "RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T12:12:49.33444" - }, - "star_salmon/markdup": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.bam", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.bai", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai", - "WT_REP1.markdup.sorted.bam", - "WT_REP1.markdup.sorted.bam.bai", - "WT_REP2.markdup.sorted.bam", - "WT_REP2.markdup.sorted.bam.bai" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T12:11:58.003184" - }, - "star_salmon/samtools_stats": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.stats", - "RAP1_IAA_30M_REP1.sorted.bam.flagstat", - "RAP1_IAA_30M_REP1.sorted.bam.idxstats", - "RAP1_IAA_30M_REP1.sorted.bam.stats", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats", - "RAP1_UNINDUCED_REP1.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP1.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP1.sorted.bam.stats", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats", - "RAP1_UNINDUCED_REP2.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP2.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP2.sorted.bam.stats", - "WT_REP1.markdup.sorted.bam.flagstat", - "WT_REP1.markdup.sorted.bam.idxstats", - "WT_REP1.markdup.sorted.bam.stats", - "WT_REP1.sorted.bam.flagstat", - "WT_REP1.sorted.bam.idxstats", - "WT_REP1.sorted.bam.stats", - "WT_REP2.markdup.sorted.bam.flagstat", - "WT_REP2.markdup.sorted.bam.idxstats", - "WT_REP2.markdup.sorted.bam.stats", - "WT_REP2.sorted.bam.flagstat", - "WT_REP2.sorted.bam.idxstats", - "WT_REP2.sorted.bam.stats" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T19:28:48.898246" - }, - "salmon": { - "content": [ - "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", - "salmon.merged.gene_counts.SummarizedExperiment.rds", - "salmon.merged.gene_counts.tsv", - "salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_length_scaled.tsv", - "salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_scaled.tsv", - "salmon.merged.gene_lengths.tsv", - "salmon.merged.gene_tpm.tsv", - "salmon.merged.transcript_counts.SummarizedExperiment.rds", - "salmon.merged.transcript_counts.tsv", - "salmon.merged.transcript_lengths.tsv", - "salmon.merged.transcript_tpm.tsv" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T12:11:58.152801" - }, - "multiqc_plots": { - "content": [ - "cutadapt_filtered_reads_plot-cnt.png:md5,704cf0d91bfa3dd658dd8c9590f669a2", - "cutadapt_filtered_reads_plot-pct.png:md5,2684d8b2afca3300e5786486b80237f0", - "cutadapt_trimmed_sequences_plot_3_Counts.png:md5,bef41d894629b0c4dab4478bbf197f50", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.png:md5,1e0d01537d3797623d0b3fd8fbe42787", - "fastqc-status-check-heatmap.png:md5,2402522f8c02e12aea9af088c6595890", - "fastqc_overrepresented_sequences_plot.png:md5,40e450251b80ec0efc9364434234ec7f", - "fastqc_per_sequence_gc_content_plot_Counts.png:md5,8a806cec2142f9911502e0a253d83d13", - "fastqc_per_sequence_gc_content_plot_Percentages.png:md5,953929d50c8490029880e205e4db7959", - "fastqc_per_sequence_quality_scores_plot.png:md5,d2c29cae169f35744500c751b4a7366e", - "fastqc_sequence_counts_plot-cnt.png:md5,2874fea747c7ff46828bf4f17668caf8", - "fastqc_sequence_counts_plot-pct.png:md5,0022d7f5ac78b6eff157de24e37c5ab0", - "fastqc_sequence_duplication_levels_plot.png:md5,fcd3b1ec2b95fe4bcd607dc28179a754", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png:md5,ce6abb232fd5b5f2e66c0fe9a571d75f", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png:md5,6b44818f886ef020fb3646f152ad4af6", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png:md5,d5d8a85b7ad72a0cb93d9283ea12b23f", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png:md5,19317ad8f1448cd7eb1d319f85cc5c4d", - "multiqc_report.html", - "cutadapt_filtered_reads_plot-cnt.pdf", - "cutadapt_filtered_reads_plot-pct.pdf", - "cutadapt_trimmed_sequences_plot_3_Counts.pdf", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf", - "fastqc-status-check-heatmap.pdf", - "fastqc_overrepresented_sequences_plot.pdf", - "fastqc_per_base_n_content_plot.pdf", - "fastqc_per_base_sequence_quality_plot.pdf", - "fastqc_per_sequence_gc_content_plot_Counts.pdf", - "fastqc_per_sequence_gc_content_plot_Percentages.pdf", - "fastqc_per_sequence_quality_scores_plot.pdf", - "fastqc_sequence_counts_plot-cnt.pdf", - "fastqc_sequence_counts_plot-pct.pdf", - "fastqc_sequence_duplication_levels_plot.pdf", - "fastqc_sequence_length_distribution_plot.pdf", - "fastqc_top_overrepresented_sequences_table.pdf", - "general_stats_table.pdf", - "picard_deduplication-cnt.pdf", - "picard_deduplication-pct.pdf", - "salmon_plot.pdf", - "samtools-flagstat-dp_Percentage_of_total.pdf", - "samtools-flagstat-dp_Read_counts.pdf", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf", - "samtools-stats-dp.pdf", - "samtools_alignment_plot-cnt.pdf", - "samtools_alignment_plot-pct.pdf", - "star_alignment_plot-cnt.pdf", - "star_alignment_plot-pct.pdf", - "star_summary_table.pdf", - "fastqc_per_base_n_content_plot.png", - "fastqc_per_base_sequence_quality_plot.png", - "fastqc_sequence_length_distribution_plot.png", - "fastqc_top_overrepresented_sequences_table.png", - "general_stats_table.png", - "picard_deduplication-cnt.png", - "picard_deduplication-pct.png", - "salmon_plot.png", - "samtools-flagstat-dp_Percentage_of_total.png", - "samtools-flagstat-dp_Read_counts.png", - "samtools-stats-dp.png", - "samtools_alignment_plot-cnt.png", - "samtools_alignment_plot-pct.png", - "star_alignment_plot-cnt.png", - "star_alignment_plot-pct.png", - "star_summary_table.png", - "cutadapt_filtered_reads_plot-cnt.svg", - "cutadapt_filtered_reads_plot-pct.svg", - "cutadapt_trimmed_sequences_plot_3_Counts.svg", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg", - "fastqc-status-check-heatmap.svg", - "fastqc_overrepresented_sequences_plot.svg", - "fastqc_per_base_n_content_plot.svg", - "fastqc_per_base_sequence_quality_plot.svg", - "fastqc_per_sequence_gc_content_plot_Counts.svg", - "fastqc_per_sequence_gc_content_plot_Percentages.svg", - "fastqc_per_sequence_quality_scores_plot.svg", - "fastqc_sequence_counts_plot-cnt.svg", - "fastqc_sequence_counts_plot-pct.svg", - "fastqc_sequence_duplication_levels_plot.svg", - "fastqc_sequence_length_distribution_plot.svg", - "fastqc_top_overrepresented_sequences_table.svg", - "general_stats_table.svg", - "picard_deduplication-cnt.svg", - "picard_deduplication-pct.svg", - "salmon_plot.svg", - "samtools-flagstat-dp_Percentage_of_total.svg", - "samtools-flagstat-dp_Read_counts.svg", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg", - "samtools-stats-dp.svg", - "samtools_alignment_plot-cnt.svg", - "samtools_alignment_plot-pct.svg", - "star_alignment_plot-cnt.svg", - "star_alignment_plot-pct.svg", - "star_summary_table.svg" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T19:28:48.850602" - }, - "star_salmon/picard_metrics": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt", - "WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T12:11:58.412083" - }, - "star_salmon/salmon": { - "content": [ - "salmon.merged.gene_counts.SummarizedExperiment.rds", - "salmon.merged.gene_counts.tsv", - "salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_length_scaled.tsv", - "salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_scaled.tsv", - "salmon.merged.gene_lengths.tsv", - "salmon.merged.gene_tpm.tsv", - "salmon.merged.transcript_counts.SummarizedExperiment.rds", - "salmon.merged.transcript_counts.tsv", - "salmon.merged.transcript_lengths.tsv", - "salmon.merged.transcript_tpm.tsv" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T12:11:58.679186" - }, - "star_salmon/bigwig": { - "content": [ - "RAP1_IAA_30M_REP1.forward.bigWig", - "RAP1_IAA_30M_REP1.reverse.bigWig", - "RAP1_UNINDUCED_REP1.forward.bigWig", - "RAP1_UNINDUCED_REP1.reverse.bigWig", - "RAP1_UNINDUCED_REP2.forward.bigWig", - "RAP1_UNINDUCED_REP2.reverse.bigWig", - "WT_REP1.forward.bigWig", - "WT_REP1.reverse.bigWig", - "WT_REP2.forward.bigWig", - "WT_REP2.reverse.bigWig" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T12:11:58.232941" - }, - "star_salmon/stringtie": { - "content": [ - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,3f149502efe2a9d4bac98b1dd18c15e7", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,a052ab04070e72cc318fb7680b0764e3", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,e82329a443b9ff50a86e42aff91bd704", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,d279003d92f7feef9adb31203f84474a", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,10e2d00f93f9e74f224bd3c1bfbeb29b", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,525413b70bcf62c24c8f96182e09883e", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,9aa371befc36478d7720d3ea275e6f4d", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,907ab2e06346df131cbdb929afc005a8", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,b03f3118d1aa58fceadcb3311028e856", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,041edee3193df311f621c09f4991892b", - "t_data.ctab", - "RAP1_IAA_30M_REP1.coverage.gtf", - "RAP1_IAA_30M_REP1.gene.abundance.txt", - "RAP1_IAA_30M_REP1.transcripts.gtf", - "t_data.ctab", - "RAP1_UNINDUCED_REP1.coverage.gtf", - "RAP1_UNINDUCED_REP1.gene.abundance.txt", - "RAP1_UNINDUCED_REP1.transcripts.gtf", - "t_data.ctab", - "RAP1_UNINDUCED_REP2.coverage.gtf", - "RAP1_UNINDUCED_REP2.gene.abundance.txt", - "RAP1_UNINDUCED_REP2.transcripts.gtf", - "t_data.ctab", - "WT_REP1.coverage.gtf", - "WT_REP1.gene.abundance.txt", - "WT_REP1.transcripts.gtf", - "t_data.ctab", - "WT_REP2.coverage.gtf", - "WT_REP2.gene.abundance.txt", - "WT_REP2.transcripts.gtf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T12:11:57.943545" - }, - "versions": { - "content": [ - "{BBMAP_BBSPLIT={bbmap=39.01}, BEDTOOLS_GENOMECOV_FW={bedtools=2.31.1}, CAT_FASTQ={cat=8.3}, CUSTOM_CATADDITIONALFASTA={python=3.9.5}, CUSTOM_GETCHROMSIZES={getchromsizes=1.2}, CUSTOM_TX2GENE={python=3.9.5}, FQ_SUBSAMPLE={fq=0.9.1 (2022-02-22)}, GTF2BED={perl=5.26.2}, GTF_FILTER={python=3.9.5}, GUNZIP_ADDITIONAL_FASTA={gunzip=1.1}, GUNZIP_GTF={gunzip=1.1}, PICARD_MARKDUPLICATES={picard=3.1.1}, SALMON_QUANT={salmon=1.10.1}, SAMTOOLS_FLAGSTAT={samtools=1.2}, SAMTOOLS_IDXSTATS={samtools=1.2}, SAMTOOLS_INDEX={samtools=1.2}, SAMTOOLS_SORT={samtools=1.2}, SAMTOOLS_STATS={samtools=1.2}, SE_GENE={bioconductor-summarizedexperiment=1.32.0}, STAR_ALIGN={star=2.7.10a, samtools=1.18, gawk=5.1.0}, STAR_GENOMEGENERATE={star=2.7.10a, samtools=1.18, gawk=5.1.0}, STRINGTIE_STRINGTIE={stringtie=2.2.1}, TRIMGALORE={trimgalore=0.6.7, cutadapt=3.4}, TXIMETA_TXIMPORT={bioconductor-tximeta=1.20.1}, UCSC_BEDCLIP={ucsc=377}, UCSC_BEDGRAPHTOBIGWIG={ucsc=445}, UNTAR_SALMON_INDEX={untar=1.34}, Workflow={nf-core/rnaseq=v3.16.0dev}}" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T12:11:59.164489" - }, - "fastqc/trim": { - "content": [ - "RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html", - "RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip", - "RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html", - "RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip", - "RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html", - "RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip", - "RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html", - "RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip", - "WT_REP1_trimmed_1_val_1_fastqc.html", - "WT_REP1_trimmed_1_val_1_fastqc.zip", - "WT_REP1_trimmed_2_val_2_fastqc.html", - "WT_REP1_trimmed_2_val_2_fastqc.zip", - "WT_REP2_trimmed_1_val_1_fastqc.html", - "WT_REP2_trimmed_1_val_1_fastqc.zip", - "WT_REP2_trimmed_2_val_2_fastqc.html", - "WT_REP2_trimmed_2_val_2_fastqc.zip" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T11:24:48.114664" - }, - "bbsplit": { - "content": [ - "RAP1_IAA_30M_REP1.stats.txt", - "RAP1_UNINDUCED_REP1.stats.txt", - "RAP1_UNINDUCED_REP2.stats.txt", - "WT_REP1.stats.txt", - "WT_REP2.stats.txt" + 17, + { + "BBMAP_BBSPLIT": { + "bbmap": 39.01 + }, + "CAT_FASTQ": { + "cat": 8.3 + }, + "CUSTOM_CATADDITIONALFASTA": { + "python": null + }, + "CUSTOM_GETCHROMSIZES": { + "getchromsizes": 1.2 + }, + "GTF2BED": { + "perl": "5.26.2" + }, + "GTF_FILTER": { + "python": "3.9.5" + }, + "GUNZIP_ADDITIONAL_FASTA": { + "gunzip": 1.1 + }, + "GUNZIP_GTF": { + "gunzip": 1.1 + }, + "STAR_GENOMEGENERATE": { + "star": "2.7.10a", + "samtools": 1.18, + "gawk": "5.1.0" + }, + "TRIMGALORE": { + "trimgalore": "0.6.7", + "cutadapt": 3.4 + }, + "UNTAR_SALMON_INDEX": { + "untar": 1.34 + }, + "Workflow": { + "nf-core/rnaseq": "v3.16.0dev" + } + }, + [ + "custom", + "custom/out", + "custom/out/genome_transcriptome.fasta", + "custom/out/genome_transcriptome.gtf", + "fastqc", + "fastqc/trim", + "multiqc", + "multiqc/star_salmon", + "multiqc/star_salmon/multiqc_data", + "multiqc/star_salmon/multiqc_plots", + "multiqc/star_salmon/multiqc_report.html", + "pipeline_info", + "pipeline_info/nf_core_rnaseq_software_mqc_versions.yml", + "trimgalore", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" + ], + [ + "genome_transcriptome.fasta:md5,d41d8cd98f00b204e9800998ecf8427e", + "genome_transcriptome.gtf:md5,d41d8cd98f00b204e9800998ecf8427e" + ] ], "meta": { "nf-test": "0.9.0", "nextflow": "24.04.4" }, - "timestamp": "2024-08-26T11:24:48.0918" + "timestamp": "2024-10-02T08:17:45.954114" }, - "salmon_quant": { + "Params: --skip_qc": { "content": [ - "ambig_info.tsv:md5,de973a4b22a4457217ae3dc04caf9401", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,1215f0c20f87d3aef8553ef119e1e74c", - "lib_format_counts.json:md5,c24ffe28d70476b5ccdd8bc2d22c0ac1", - "ambig_info.tsv:md5,45f252b4f0e11e6730cf0c29f800fdbb", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,621c6601aade5b1f2e3d6ca2fc71f636", - "lib_format_counts.json:md5,f6d44c0221f7fd559f11a9afe04c9935", - "ambig_info.tsv:md5,6dcc2891ea572e9b8d1ba52cd434ab84", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,9bed6e4dc5428d6f6297adcea29a6326", - "lib_format_counts.json:md5,7c562bf2f70e42f3a7292687dfd328c3", - "ambig_info.tsv:md5,194f574e0586416155e3f33d42e2b167", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,c7ed0aaa5d6c7934ddbebfd29e4eb86d", - "lib_format_counts.json:md5,d46250bb3677d72feeefc435fe6395a6", - "ambig_info.tsv:md5,a26e3f936e65d7da66392603c2f91f6f", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,69ebfc2c7ca6b221a0a22fa1dc8c20ac", - "lib_format_counts.json:md5,088fd51db07022ffde47033bbd029400", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf" + 136, + { + "BBMAP_BBSPLIT": { + "bbmap": 39.01 + }, + "BEDTOOLS_GENOMECOV_FW": { + "bedtools": "2.31.1" + }, + "CAT_FASTQ": { + "cat": 8.3 + }, + "CUSTOM_CATADDITIONALFASTA": { + "python": "3.9.5" + }, + "CUSTOM_GETCHROMSIZES": { + "getchromsizes": 1.2 + }, + "CUSTOM_TX2GENE": { + "python": "3.9.5" + }, + "FQ_SUBSAMPLE": { + "fq": "0.9.1 (2022-02-22)" + }, + "GTF2BED": { + "perl": "5.26.2" + }, + "GTF_FILTER": { + "python": "3.9.5" + }, + "GUNZIP_ADDITIONAL_FASTA": { + "gunzip": 1.1 + }, + "GUNZIP_GTF": { + "gunzip": 1.1 + }, + "PICARD_MARKDUPLICATES": { + "picard": "3.1.1" + }, + "SALMON_QUANT": { + "salmon": "1.10.1" + }, + "SAMTOOLS_FLAGSTAT": { + "samtools": 1.2 + }, + "SAMTOOLS_IDXSTATS": { + "samtools": 1.2 + }, + "SAMTOOLS_INDEX": { + "samtools": 1.2 + }, + "SAMTOOLS_SORT": { + "samtools": 1.2 + }, + "SAMTOOLS_STATS": { + "samtools": 1.2 + }, + "SE_GENE": { + "bioconductor-summarizedexperiment": "1.32.0" + }, + "STAR_ALIGN": { + "star": "2.7.10a", + "samtools": 1.18, + "gawk": "5.1.0" + }, + "STAR_GENOMEGENERATE": { + "star": "2.7.10a", + "samtools": 1.18, + "gawk": "5.1.0" + }, + "STRINGTIE_STRINGTIE": { + "stringtie": "2.2.1" + }, + "TRIMGALORE": { + "trimgalore": "0.6.7", + "cutadapt": 3.4 + }, + "TXIMETA_TXIMPORT": { + "bioconductor-tximeta": "1.20.1" + }, + "UCSC_BEDCLIP": { + "ucsc": 377 + }, + "UCSC_BEDGRAPHTOBIGWIG": { + "ucsc": 445 + }, + "UNTAR_SALMON_INDEX": { + "untar": 1.34 + }, + "Workflow": { + "nf-core/rnaseq": "v3.16.0dev" + } + }, + [ + "bbsplit", + "bbsplit/RAP1_IAA_30M_REP1.stats.txt", + "bbsplit/RAP1_UNINDUCED_REP1.stats.txt", + "bbsplit/RAP1_UNINDUCED_REP2.stats.txt", + "bbsplit/WT_REP1.stats.txt", + "bbsplit/WT_REP2.stats.txt", + "custom", + "custom/out", + "custom/out/genome_gfp.fasta", + "custom/out/genome_gfp.gtf", + "fastqc", + "fastqc/trim", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip", + "fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html", + "fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip", + "fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html", + "fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip", + "fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.html", + "fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.html", + "fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.zip", + "fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.html", + "fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.html", + "fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.zip", + "multiqc", + "multiqc/star_salmon", + "multiqc/star_salmon/multiqc_report.html", + "multiqc/star_salmon/multiqc_report_data", + "multiqc/star_salmon/multiqc_report_data/cutadapt_filtered_reads_plot.txt", + "multiqc/star_salmon/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc-status-check-heatmap.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_overrepresented_sequences_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_base_n_content_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_base_sequence_quality_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Percentages.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_quality_scores_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_counts_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_duplication_levels_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_length_distribution_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_top_overrepresented_sequences_table.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_citations.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_cutadapt.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_data.json", + "multiqc/star_salmon/multiqc_report_data/multiqc_fastqc_fastqc_trimmed.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_general_stats.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_picard_dups.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_samtools_flagstat.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_samtools_idxstats.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_samtools_stats.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_software_versions.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_sources.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star.txt", + "multiqc/star_salmon/multiqc_report_data/picard_deduplication.txt", + "multiqc/star_salmon/multiqc_report_data/picard_histogram.txt", + "multiqc/star_salmon/multiqc_report_data/picard_histogram_1.txt", + "multiqc/star_salmon/multiqc_report_data/picard_histogram_2.txt", + "multiqc/star_salmon/multiqc_report_data/salmon_plot.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Percentage_of_total.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Read_counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Raw_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-stats-dp.txt", + "multiqc/star_salmon/multiqc_report_data/samtools_alignment_plot.txt", + "multiqc/star_salmon/multiqc_report_data/star_alignment_plot.txt", + "multiqc/star_salmon/multiqc_report_data/star_summary_table.txt", + "multiqc/star_salmon/multiqc_report_plots", + "multiqc/star_salmon/multiqc_report_plots/pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc-status-check-heatmap.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Percentages.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_length_distribution_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/general_stats_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/salmon_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Percentage_of_total.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Read_counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-stats-dp.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_summary_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/png", + "multiqc/star_salmon/multiqc_report_plots/png/cutadapt_filtered_reads_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/cutadapt_filtered_reads_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Obs_Exp.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc-status-check-heatmap.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_n_content_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Percentages.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_length_distribution_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table.png", + "multiqc/star_salmon/multiqc_report_plots/png/general_stats_table.png", + "multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/salmon_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Percentage_of_total.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Read_counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-stats-dp.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_summary_table.png", + "multiqc/star_salmon/multiqc_report_plots/svg", + "multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc-status-check-heatmap.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_n_content_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Percentages.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_length_distribution_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/general_stats_table.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/salmon_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Percentage_of_total.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Read_counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-stats-dp.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_summary_table.svg", + "pipeline_info", + "pipeline_info/nf_core_rnaseq_software_mqc_versions.yml", + "salmon", + "salmon/RAP1_IAA_30M_REP1", + "salmon/RAP1_IAA_30M_REP1/aux_info", + "salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv", + "salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json", + "salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz", + "salmon/RAP1_IAA_30M_REP1/cmd_info.json", + "salmon/RAP1_IAA_30M_REP1/libParams", + "salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt", + "salmon/RAP1_IAA_30M_REP1/lib_format_counts.json", + "salmon/RAP1_IAA_30M_REP1/logs", + "salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log", + "salmon/RAP1_IAA_30M_REP1/quant.genes.sf", + "salmon/RAP1_IAA_30M_REP1/quant.sf", + "salmon/RAP1_UNINDUCED_REP1", + "salmon/RAP1_UNINDUCED_REP1/aux_info", + "salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv", + "salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json", + "salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz", + "salmon/RAP1_UNINDUCED_REP1/cmd_info.json", + "salmon/RAP1_UNINDUCED_REP1/libParams", + "salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt", + "salmon/RAP1_UNINDUCED_REP1/lib_format_counts.json", + "salmon/RAP1_UNINDUCED_REP1/logs", + "salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log", + "salmon/RAP1_UNINDUCED_REP1/quant.genes.sf", + "salmon/RAP1_UNINDUCED_REP1/quant.sf", + "salmon/RAP1_UNINDUCED_REP2", + "salmon/RAP1_UNINDUCED_REP2/aux_info", + "salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv", + "salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json", + "salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz", + "salmon/RAP1_UNINDUCED_REP2/cmd_info.json", + "salmon/RAP1_UNINDUCED_REP2/libParams", + "salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt", + "salmon/RAP1_UNINDUCED_REP2/lib_format_counts.json", + "salmon/RAP1_UNINDUCED_REP2/logs", + "salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log", + "salmon/RAP1_UNINDUCED_REP2/quant.genes.sf", + "salmon/RAP1_UNINDUCED_REP2/quant.sf", + "salmon/WT_REP1", + "salmon/WT_REP1/aux_info", + "salmon/WT_REP1/aux_info/ambig_info.tsv", + "salmon/WT_REP1/aux_info/expected_bias.gz", + "salmon/WT_REP1/aux_info/fld.gz", + "salmon/WT_REP1/aux_info/meta_info.json", + "salmon/WT_REP1/aux_info/observed_bias.gz", + "salmon/WT_REP1/aux_info/observed_bias_3p.gz", + "salmon/WT_REP1/cmd_info.json", + "salmon/WT_REP1/libParams", + "salmon/WT_REP1/libParams/flenDist.txt", + "salmon/WT_REP1/lib_format_counts.json", + "salmon/WT_REP1/logs", + "salmon/WT_REP1/logs/salmon_quant.log", + "salmon/WT_REP1/quant.genes.sf", + "salmon/WT_REP1/quant.sf", + "salmon/WT_REP2", + "salmon/WT_REP2/aux_info", + "salmon/WT_REP2/aux_info/ambig_info.tsv", + "salmon/WT_REP2/aux_info/expected_bias.gz", + "salmon/WT_REP2/aux_info/fld.gz", + "salmon/WT_REP2/aux_info/meta_info.json", + "salmon/WT_REP2/aux_info/observed_bias.gz", + "salmon/WT_REP2/aux_info/observed_bias_3p.gz", + "salmon/WT_REP2/cmd_info.json", + "salmon/WT_REP2/libParams", + "salmon/WT_REP2/libParams/flenDist.txt", + "salmon/WT_REP2/lib_format_counts.json", + "salmon/WT_REP2/logs", + "salmon/WT_REP2/logs/salmon_quant.log", + "salmon/WT_REP2/quant.genes.sf", + "salmon/WT_REP2/quant.sf", + "salmon/salmon.merged.gene_counts.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts.tsv", + "salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts_length_scaled.tsv", + "salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts_scaled.tsv", + "salmon/salmon.merged.gene_lengths.tsv", + "salmon/salmon.merged.gene_tpm.tsv", + "salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds", + "salmon/salmon.merged.transcript_counts.tsv", + "salmon/salmon.merged.transcript_lengths.tsv", + "salmon/salmon.merged.transcript_tpm.tsv", + "salmon/tx2gene.tsv", + "star_salmon", + "star_salmon/RAP1_IAA_30M_REP1", + "star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam", + "star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam.bai", + "star_salmon/RAP1_IAA_30M_REP1/aux_info", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz", + "star_salmon/RAP1_IAA_30M_REP1/cmd_info.json", + "star_salmon/RAP1_IAA_30M_REP1/libParams", + "star_salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt", + "star_salmon/RAP1_IAA_30M_REP1/logs", + "star_salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log", + "star_salmon/RAP1_IAA_30M_REP1/quant.genes.sf", + "star_salmon/RAP1_IAA_30M_REP1/quant.sf", + "star_salmon/RAP1_UNINDUCED_REP1", + "star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam", + "star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz", + "star_salmon/RAP1_UNINDUCED_REP1/cmd_info.json", + "star_salmon/RAP1_UNINDUCED_REP1/libParams", + "star_salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt", + "star_salmon/RAP1_UNINDUCED_REP1/logs", + "star_salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log", + "star_salmon/RAP1_UNINDUCED_REP1/quant.genes.sf", + "star_salmon/RAP1_UNINDUCED_REP1/quant.sf", + "star_salmon/RAP1_UNINDUCED_REP2", + "star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam", + "star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz", + "star_salmon/RAP1_UNINDUCED_REP2/cmd_info.json", + "star_salmon/RAP1_UNINDUCED_REP2/libParams", + "star_salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt", + "star_salmon/RAP1_UNINDUCED_REP2/logs", + "star_salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log", + "star_salmon/RAP1_UNINDUCED_REP2/quant.genes.sf", + "star_salmon/RAP1_UNINDUCED_REP2/quant.sf", + "star_salmon/WT_REP1", + "star_salmon/WT_REP1.markdup.sorted.bam", + "star_salmon/WT_REP1.markdup.sorted.bam.bai", + "star_salmon/WT_REP1/aux_info", + "star_salmon/WT_REP1/aux_info/ambig_info.tsv", + "star_salmon/WT_REP1/aux_info/expected_bias.gz", + "star_salmon/WT_REP1/aux_info/fld.gz", + "star_salmon/WT_REP1/aux_info/meta_info.json", + "star_salmon/WT_REP1/aux_info/observed_bias.gz", + "star_salmon/WT_REP1/aux_info/observed_bias_3p.gz", + "star_salmon/WT_REP1/cmd_info.json", + "star_salmon/WT_REP1/libParams", + "star_salmon/WT_REP1/libParams/flenDist.txt", + "star_salmon/WT_REP1/logs", + "star_salmon/WT_REP1/logs/salmon_quant.log", + "star_salmon/WT_REP1/quant.genes.sf", + "star_salmon/WT_REP1/quant.sf", + "star_salmon/WT_REP2", + "star_salmon/WT_REP2.markdup.sorted.bam", + "star_salmon/WT_REP2.markdup.sorted.bam.bai", + "star_salmon/WT_REP2/aux_info", + "star_salmon/WT_REP2/aux_info/ambig_info.tsv", + "star_salmon/WT_REP2/aux_info/expected_bias.gz", + "star_salmon/WT_REP2/aux_info/fld.gz", + "star_salmon/WT_REP2/aux_info/meta_info.json", + "star_salmon/WT_REP2/aux_info/observed_bias.gz", + "star_salmon/WT_REP2/aux_info/observed_bias_3p.gz", + "star_salmon/WT_REP2/cmd_info.json", + "star_salmon/WT_REP2/libParams", + "star_salmon/WT_REP2/libParams/flenDist.txt", + "star_salmon/WT_REP2/logs", + "star_salmon/WT_REP2/logs/salmon_quant.log", + "star_salmon/WT_REP2/quant.genes.sf", + "star_salmon/WT_REP2/quant.sf", + "star_salmon/bigwig", + "star_salmon/bigwig/RAP1_IAA_30M_REP1.forward.bigWig", + "star_salmon/bigwig/RAP1_IAA_30M_REP1.reverse.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP1.forward.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP1.reverse.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP2.forward.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP2.reverse.bigWig", + "star_salmon/bigwig/WT_REP1.forward.bigWig", + "star_salmon/bigwig/WT_REP1.reverse.bigWig", + "star_salmon/bigwig/WT_REP2.forward.bigWig", + "star_salmon/bigwig/WT_REP2.reverse.bigWig", + "star_salmon/log", + "star_salmon/log/RAP1_IAA_30M_REP1.Log.final.out", + "star_salmon/log/RAP1_IAA_30M_REP1.Log.out", + "star_salmon/log/RAP1_IAA_30M_REP1.Log.progress.out", + "star_salmon/log/RAP1_IAA_30M_REP1.SJ.out.tab", + "star_salmon/log/RAP1_UNINDUCED_REP1.Log.final.out", + "star_salmon/log/RAP1_UNINDUCED_REP1.Log.out", + "star_salmon/log/RAP1_UNINDUCED_REP1.Log.progress.out", + "star_salmon/log/RAP1_UNINDUCED_REP1.SJ.out.tab", + "star_salmon/log/RAP1_UNINDUCED_REP2.Log.final.out", + "star_salmon/log/RAP1_UNINDUCED_REP2.Log.out", + "star_salmon/log/RAP1_UNINDUCED_REP2.Log.progress.out", + "star_salmon/log/RAP1_UNINDUCED_REP2.SJ.out.tab", + "star_salmon/log/WT_REP1.Log.final.out", + "star_salmon/log/WT_REP1.Log.out", + "star_salmon/log/WT_REP1.Log.progress.out", + "star_salmon/log/WT_REP1.SJ.out.tab", + "star_salmon/log/WT_REP2.Log.final.out", + "star_salmon/log/WT_REP2.Log.out", + "star_salmon/log/WT_REP2.Log.progress.out", + "star_salmon/log/WT_REP2.SJ.out.tab", + "star_salmon/picard_metrics", + "star_salmon/picard_metrics/RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/salmon.merged.gene_counts.SummarizedExperiment.rds", + "star_salmon/salmon.merged.gene_counts.tsv", + "star_salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", + "star_salmon/salmon.merged.gene_counts_length_scaled.tsv", + "star_salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", + "star_salmon/salmon.merged.gene_counts_scaled.tsv", + "star_salmon/salmon.merged.gene_lengths.tsv", + "star_salmon/salmon.merged.gene_tpm.tsv", + "star_salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds", + "star_salmon/salmon.merged.transcript_counts.tsv", + "star_salmon/salmon.merged.transcript_lengths.tsv", + "star_salmon/salmon.merged.transcript_tpm.tsv", + "star_salmon/samtools_stats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP1.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP1.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP1.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP2.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP2.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP2.sorted.bam.stats", + "star_salmon/stringtie", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e2t.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e_data.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i2t.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i_data.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/t_data.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.coverage.gtf", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.gene.abundance.txt", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.transcripts.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/t_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.coverage.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.gene.abundance.txt", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.transcripts.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/t_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.coverage.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.gene.abundance.txt", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.transcripts.gtf", + "star_salmon/stringtie/WT_REP1.ballgown", + "star_salmon/stringtie/WT_REP1.ballgown/e2t.ctab", + "star_salmon/stringtie/WT_REP1.ballgown/e_data.ctab", + "star_salmon/stringtie/WT_REP1.ballgown/i2t.ctab", + "star_salmon/stringtie/WT_REP1.ballgown/i_data.ctab", + "star_salmon/stringtie/WT_REP1.ballgown/t_data.ctab", + "star_salmon/stringtie/WT_REP1.coverage.gtf", + "star_salmon/stringtie/WT_REP1.gene.abundance.txt", + "star_salmon/stringtie/WT_REP1.transcripts.gtf", + "star_salmon/stringtie/WT_REP2.ballgown", + "star_salmon/stringtie/WT_REP2.ballgown/e2t.ctab", + "star_salmon/stringtie/WT_REP2.ballgown/e_data.ctab", + "star_salmon/stringtie/WT_REP2.ballgown/i2t.ctab", + "star_salmon/stringtie/WT_REP2.ballgown/i_data.ctab", + "star_salmon/stringtie/WT_REP2.ballgown/t_data.ctab", + "star_salmon/stringtie/WT_REP2.coverage.gtf", + "star_salmon/stringtie/WT_REP2.gene.abundance.txt", + "star_salmon/stringtie/WT_REP2.transcripts.gtf", + "star_salmon/tx2gene.tsv", + "trimgalore", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" + ], + [ + "genome_gfp.fasta:md5,e23e302af63736a199985a169fdac055", + "genome_gfp.gtf:md5,c98b12c302f15731bfc36bcf297cfe28", + "cutadapt_filtered_reads_plot.txt:md5,bf033e64e9d23bee85b6277f11c663f1", + "cutadapt_trimmed_sequences_plot_3_Counts.txt:md5,13dfa866fd91dbb072689efe9aa83b1f", + "cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt:md5,07145dd8dd3db654859b18eb0389046c", + "fastqc-status-check-heatmap.txt:md5,22a03548736b88b23be6bc0c9ef1b4a6", + "fastqc_overrepresented_sequences_plot.txt:md5,4adfeacd3a3a6c7c808f121b24e6b247", + "fastqc_per_base_n_content_plot.txt:md5,418610c1ce119cb786ad434db75d366e", + "fastqc_per_base_sequence_quality_plot.txt:md5,bd22e06e41c096ad4f745d40fe96a1e5", + "fastqc_per_sequence_gc_content_plot_Counts.txt:md5,004c60768ceb6197765154e3eaa37b7a", + "fastqc_per_sequence_gc_content_plot_Percentages.txt:md5,95d29060b687f745288ad1ec47750037", + "fastqc_per_sequence_quality_scores_plot.txt:md5,0f9834cc19f76dd5c87cf8cba7435a7c", + "fastqc_sequence_counts_plot.txt:md5,3861354bbedfbde7ca36a72994f9425c", + "fastqc_sequence_duplication_levels_plot.txt:md5,c73407d55fc532e864fa1dc8dbc12874", + "fastqc_sequence_length_distribution_plot.txt:md5,6fe2c985606abad947bcca99b015ae33", + "multiqc_citations.txt:md5,ef51c78faebdd32bad296ba14406b41e", + "multiqc_cutadapt.txt:md5,aac9581a5670cb55edf564f3d6c1f9a7", + "multiqc_fastqc_fastqc_trimmed.txt:md5,a3238f515e01d158d875d69968753804", + "multiqc_samtools_idxstats.txt:md5,fd7d03a91f0b9e01a6939941f7f2243f", + "picard_histogram.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "picard_histogram_1.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "picard_histogram_2.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt:md5,75acd04232d1804b5f960ee4c5db4722", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt:md5,ae45731d8d4595f77e6b271004f3a070", + "samtools-idxstats-mapped-reads-plot_Raw_Counts.txt:md5,01637c600d3840500851eb4118564cc6", + "cutadapt_filtered_reads_plot-cnt.png:md5,704cf0d91bfa3dd658dd8c9590f669a2", + "cutadapt_filtered_reads_plot-pct.png:md5,2684d8b2afca3300e5786486b80237f0", + "cutadapt_trimmed_sequences_plot_3_Counts.png:md5,bef41d894629b0c4dab4478bbf197f50", + "cutadapt_trimmed_sequences_plot_3_Obs_Exp.png:md5,1e0d01537d3797623d0b3fd8fbe42787", + "fastqc-status-check-heatmap.png:md5,2402522f8c02e12aea9af088c6595890", + "fastqc_overrepresented_sequences_plot.png:md5,40e450251b80ec0efc9364434234ec7f", + "fastqc_per_sequence_gc_content_plot_Counts.png:md5,8a806cec2142f9911502e0a253d83d13", + "fastqc_per_sequence_gc_content_plot_Percentages.png:md5,953929d50c8490029880e205e4db7959", + "fastqc_per_sequence_quality_scores_plot.png:md5,d2c29cae169f35744500c751b4a7366e", + "fastqc_sequence_counts_plot-cnt.png:md5,2874fea747c7ff46828bf4f17668caf8", + "fastqc_sequence_counts_plot-pct.png:md5,0022d7f5ac78b6eff157de24e37c5ab0", + "fastqc_sequence_duplication_levels_plot.png:md5,fcd3b1ec2b95fe4bcd607dc28179a754", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png:md5,ce6abb232fd5b5f2e66c0fe9a571d75f", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png:md5,6b44818f886ef020fb3646f152ad4af6", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png:md5,d5d8a85b7ad72a0cb93d9283ea12b23f", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png:md5,19317ad8f1448cd7eb1d319f85cc5c4d", + "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png:md5,a6849cd92ae738441212b681a411614d", + "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png:md5,4c06988372df63a1fb5f8be93f73ae8f", + "ambig_info.tsv:md5,de973a4b22a4457217ae3dc04caf9401", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,1215f0c20f87d3aef8553ef119e1e74c", + "lib_format_counts.json:md5,c24ffe28d70476b5ccdd8bc2d22c0ac1", + "ambig_info.tsv:md5,45f252b4f0e11e6730cf0c29f800fdbb", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,621c6601aade5b1f2e3d6ca2fc71f636", + "lib_format_counts.json:md5,f6d44c0221f7fd559f11a9afe04c9935", + "ambig_info.tsv:md5,6dcc2891ea572e9b8d1ba52cd434ab84", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,9bed6e4dc5428d6f6297adcea29a6326", + "lib_format_counts.json:md5,7c562bf2f70e42f3a7292687dfd328c3", + "ambig_info.tsv:md5,194f574e0586416155e3f33d42e2b167", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,c7ed0aaa5d6c7934ddbebfd29e4eb86d", + "lib_format_counts.json:md5,d46250bb3677d72feeefc435fe6395a6", + "ambig_info.tsv:md5,a26e3f936e65d7da66392603c2f91f6f", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,69ebfc2c7ca6b221a0a22fa1dc8c20ac", + "lib_format_counts.json:md5,088fd51db07022ffde47033bbd029400", + "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", + "ambig_info.tsv:md5,f9a605d54a0a103566f7a9b8e0867a73", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,4cc2492f557e5e0a2911a0bd83a51020", + "ambig_info.tsv:md5,8f97be8af4e47cc48650c62227a40203", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,dc750c3564c63da54979c852794d58a5", + "ambig_info.tsv:md5,a044fe7a3ad445c9a91a0d54ab5015d1", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,db43ed650e6e7b42cd2c5b8101bb6748", + "ambig_info.tsv:md5,7a8ea02d74058efb801e8c62bca96fd4", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,e418b4e899623449c6babdf53e5aabde", + "ambig_info.tsv:md5,543a047a549437026a1363ea8ddf5b03", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,f234c8d322df3b59d990594c63b24eae", + "RAP1_IAA_30M_REP1.SJ.out.tab:md5,ea95e243278af55534f2c52eb5fff7ee", + "RAP1_UNINDUCED_REP1.SJ.out.tab:md5,e548d13942535dc0821f3ec6d9743ec8", + "RAP1_UNINDUCED_REP2.SJ.out.tab:md5,1f294365343a1a5e95682792fdb77033", + "WT_REP1.SJ.out.tab:md5,1350c2fa6a675bf107386c6cd3fc5204", + "WT_REP2.SJ.out.tab:md5,f6cc03643a5e3c1025a5b4754eb1be23", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,3f149502efe2a9d4bac98b1dd18c15e7", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,a052ab04070e72cc318fb7680b0764e3", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,e82329a443b9ff50a86e42aff91bd704", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,d279003d92f7feef9adb31203f84474a", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,10e2d00f93f9e74f224bd3c1bfbeb29b", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,525413b70bcf62c24c8f96182e09883e", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,9aa371befc36478d7720d3ea275e6f4d", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,907ab2e06346df131cbdb929afc005a8", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,b03f3118d1aa58fceadcb3311028e856", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,041edee3193df311f621c09f4991892b", + "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe" + ] ], "meta": { "nf-test": "0.9.0", "nextflow": "24.04.4" }, - "timestamp": "2024-08-26T12:11:58.071145" + "timestamp": "2024-10-02T08:17:03.577873" } } \ No newline at end of file diff --git a/tests/skip_trimming.nf.test b/tests/skip_trimming.nf.test index e5b3aa080..5053e103f 100644 --- a/tests/skip_trimming.nf.test +++ b/tests/skip_trimming.nf.test @@ -13,818 +13,24 @@ nextflow_pipeline { } then { + // stable_name: All files + folders in ${params.outdir}/ with a stable name + def stable_name = getAllFilesFromDir(params.outdir, true, ['pipeline_info/*.{html,json,txt}'], null) + // stable_path: All files in ${params.outdir}/ with stable content + def stable_path = getAllFilesFromDir(params.outdir, false, null, 'tests/.nftignore') assertAll( - { assert workflow.success }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/bbsplit/RAP1_IAA_30M_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/RAP1_UNINDUCED_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/RAP1_UNINDUCED_REP2.stats.txt").name, - file("${params.outdir}/bbsplit/WT_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/WT_REP2.stats.txt").name - ).match("bbsplit") }, - { assert snapshot( - path("${params.outdir}/custom/out/genome_gfp.fasta"), - path("${params.outdir}/custom/out/genome_gfp.gtf") - ).match("references") }, - { assert snapshot( - // HTMLs and ZIPs are not stable - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_2_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_2_fastqc.zip").name - ).match("fastqc/raw") }, - { assert snapshot( - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc-status-check-heatmap.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_adapter_content_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_overrepresented_sequences_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_base_n_content_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_base_sequence_quality_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Percentages.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_quality_scores_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_counts_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_sequence_duplication_levels_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_citations.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_fastqc_fastqc_raw.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_featurecounts_biotype_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_samtools_idxstats.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_histogram.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_histogram_1.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_histogram_2.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_gene_coverage_profile_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_gene_coverage_profile_Normalised.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_rnaseq_cov_hist.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_infer_experiment_plot.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Raw_Counts.txt"), - // These files are not stable - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/fastqc_top_overrepresented_sequences_table.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/junction_saturation_known.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/junction_saturation_novel.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_data.json").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_dupradar-section-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_fail_strand_check_table.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_general_stats.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_picard_dups.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_bam_stat.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_infer_experiment.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_junction_annotation.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_read_distribution.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_1.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_2.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_3.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_4.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_pca-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_samtools_flagstat.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_samtools_stats.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_software_versions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_sources.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_1.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_2.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_3.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_4.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_pca-plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/picard_deduplication.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_genomic_origin.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/qualimap_rnaseq_genome_results.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_bam_stat.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance_plot_Counts.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance_plot_Percentages.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Events.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Junctions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_all.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_All_Junctions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_Known_Junctions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_Novel_Junctions.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_read_distribution_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_read_dups.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/rseqc_read_dups_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/salmon_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Percentage_of_total.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Read_counts.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools-stats-dp.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/samtools_alignment_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/star_alignment_plot.txt").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_data/star_summary_table.txt").name - ).match("multiqc_data") }, - { assert snapshot( - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/dupradar-section-plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc-status-check-heatmap.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Counts.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Percentages.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-pct.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/featurecounts_biotype_plot-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/featurecounts_biotype_plot-pct.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/qualimap_gene_coverage_profile_Counts.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/qualimap_gene_coverage_profile_Normalised.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_infer_experiment_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_dups_plot.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png"), - path("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png"), - // PDFs, SVGs, some PNGs and HTML reports are not stable - file("${params.outdir}/multiqc/star_salmon/multiqc_report.html").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/dupradar-section-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fail_strand_check_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc-status-check-heatmap.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_adapter_content_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Percentages.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/featurecounts_biotype_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/featurecounts_biotype_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/general_stats_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Normalised.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_genomic_origin-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_genomic_origin-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_bam_stat.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_infer_experiment_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Percentages.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_All_Junctions.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Known_Junctions.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Novel_Junctions.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_distribution_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_distribution_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_dups_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/salmon_deseq2_clustering-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/salmon_deseq2_pca-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/salmon_plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Percentage_of_total.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Read_counts.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools-stats-dp.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_salmon_deseq2_clustering-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_salmon_deseq2_pca-plot.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/pdf/star_summary_table.pdf").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fail_strand_check_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_adapter_content_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_n_content_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/general_stats_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/qualimap_genomic_origin-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/qualimap_genomic_origin-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_bam_stat.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_inner_distance_plot_Counts.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_inner_distance_plot_Percentages.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_All_Junctions.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_Known_Junctions.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_Novel_Junctions.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_distribution_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_distribution_plot-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/salmon_deseq2_clustering-plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/salmon_deseq2_pca-plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/salmon_plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Percentage_of_total.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Read_counts.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools-stats-dp.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-pct.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_salmon_deseq2_clustering-plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_salmon_deseq2_pca-plot.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/png/star_summary_table.png").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/dupradar-section-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fail_strand_check_table.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc-status-check-heatmap.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_adapter_content_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_n_content_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Percentages.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/featurecounts_biotype_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/featurecounts_biotype_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/general_stats_table.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Normalised.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/qualimap_genomic_origin-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/qualimap_genomic_origin-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_bam_stat.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_infer_experiment_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_inner_distance_plot_Counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_inner_distance_plot_Percentages.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_All_Junctions.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Known_Junctions.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Novel_Junctions.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_distribution_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_distribution_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_dups_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/salmon_deseq2_clustering-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/salmon_deseq2_pca-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/salmon_plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Percentage_of_total.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Read_counts.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools-stats-dp.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_salmon_deseq2_clustering-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_salmon_deseq2_pca-plot.svg").name, - file("${params.outdir}/multiqc/star_salmon/multiqc_report_plots/svg/star_summary_table.svg").name - ).match("multiqc_plots") }, - { assert snapshot( - path("${params.outdir}/salmon/deseq2_qc/R_sessionInfo.log"), - // These files are not stable - file("${params.outdir}/salmon/deseq2_qc/deseq2.dds.RData").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.pca.vals.txt").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.plots.pdf").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.sample.dists.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/WT_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/WT_REP2.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/deseq2.size_factors.RData").name - ).match("salmon/deseq2_qc") }, - { assert snapshot( - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/lib_format_counts.json"), - path("${params.outdir}/salmon/WT_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/WT_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/WT_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/WT_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/WT_REP1/cmd_info.json"), - path("${params.outdir}/salmon/WT_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/WT_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/WT_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/WT_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/WT_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/WT_REP2/cmd_info.json"), - path("${params.outdir}/salmon/WT_REP2/lib_format_counts.json"), - // These files are not stable - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/quant.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/quant.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/quant.sf").name, - file("${params.outdir}/salmon/WT_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/WT_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/WT_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/WT_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/WT_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/WT_REP1/quant.sf").name, - file("${params.outdir}/salmon/WT_REP2/aux_info/fld.gz").name, - file("${params.outdir}/salmon/WT_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/WT_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/WT_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/WT_REP2/quant.genes.sf").name, - file("${params.outdir}/salmon/WT_REP2/quant.sf").name - ).match("salmon_quant") }, - { assert snapshot( - path("${params.outdir}/salmon/tx2gene.tsv"), - // These files are not stable - file("${params.outdir}/salmon/salmon.merged.gene_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_length_scaled.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_scaled.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_lengths.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_tpm.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.transcript_counts.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_lengths.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_tpm.tsv").name - ).match("salmon") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/star_salmon/bigwig/RAP1_IAA_30M_REP1.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_IAA_30M_REP1.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP1.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP1.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP2.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/RAP1_UNINDUCED_REP2.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/WT_REP1.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/WT_REP1.reverse.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/WT_REP2.forward.bigWig").name, - file("${params.outdir}/star_salmon/bigwig/WT_REP2.reverse.bigWig").name - ).match("star_salmon/bigwig") }, - { assert snapshot( - path("${params.outdir}/star_salmon/deseq2_qc/R_sessionInfo.log"), - // These files are not stable - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/WT_REP1.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/WT_REP2.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/size_factors/deseq2.size_factors.RData").name, - file("${params.outdir}/star_salmon/deseq2_qc/deseq2.dds.RData").name, - file("${params.outdir}/star_salmon/deseq2_qc/deseq2.pca.vals.txt").name, - file("${params.outdir}/star_salmon/deseq2_qc/deseq2.plots.pdf").name, - file("${params.outdir}/star_salmon/deseq2_qc/deseq2.sample.dists.txt").name - ).match("star_salmon/deseq2_qc") }, - { assert snapshot( - path("${params.outdir}/star_salmon/dupradar/gene_data/RAP1_IAA_30M_REP1_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/gene_data/RAP1_UNINDUCED_REP1_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/gene_data/RAP1_UNINDUCED_REP2_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/gene_data/WT_REP1_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/gene_data/WT_REP2_dupMatrix.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/RAP1_IAA_30M_REP1_intercept_slope.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/RAP1_UNINDUCED_REP1_intercept_slope.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/RAP1_UNINDUCED_REP2_intercept_slope.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/WT_REP1_intercept_slope.txt"), - path("${params.outdir}/star_salmon/dupradar/intercepts_slope/WT_REP2_intercept_slope.txt"), - // PDFs are not stable - file("${params.outdir}/star_salmon/dupradar/box_plot/RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/box_plot/RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/box_plot/RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/box_plot/WT_REP1_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/box_plot/WT_REP2_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/RAP1_IAA_30M_REP1_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/RAP1_UNINDUCED_REP1_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/RAP1_UNINDUCED_REP2_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/WT_REP1_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/histogram/WT_REP2_expressionHist.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/RAP1_IAA_30M_REP1_duprateExpDens.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/RAP1_UNINDUCED_REP1_duprateExpDens.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/RAP1_UNINDUCED_REP2_duprateExpDens.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/WT_REP1_duprateExpDens.pdf").name, - file("${params.outdir}/star_salmon/dupradar/scatter_plot/WT_REP2_duprateExpDens.pdf").name - ).match("star_salmon/dupradar") }, - { assert snapshot( - path("${params.outdir}/star_salmon/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt"), - path("${params.outdir}/star_salmon/featurecounts/WT_REP1.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/WT_REP1.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/WT_REP1.featureCounts.txt"), - path("${params.outdir}/star_salmon/featurecounts/WT_REP2.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/WT_REP2.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_salmon/featurecounts/WT_REP2.featureCounts.txt"), - // These files are unstable - file("${params.outdir}/star_salmon/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt.summary").name, - file("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt.summary").name, - file("${params.outdir}/star_salmon/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt.summary").name, - file("${params.outdir}/star_salmon/featurecounts/WT_REP1.featureCounts.txt.summary").name, - file("${params.outdir}/star_salmon/featurecounts/WT_REP2.featureCounts.txt.summary").name - ).match("star_salmon/featurecounts") }, - { assert snapshot( - path("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/WT_REP1.SJ.out.tab"), - path("${params.outdir}/star_salmon/log/WT_REP2.SJ.out.tab"), - // Logs are not stable - file("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.Log.final.out").name, - file("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.Log.out").name, - file("${params.outdir}/star_salmon/log/RAP1_IAA_30M_REP1.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.Log.final.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.Log.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP1.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.Log.final.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.Log.out").name, - file("${params.outdir}/star_salmon/log/RAP1_UNINDUCED_REP2.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/WT_REP1.Log.final.out").name, - file("${params.outdir}/star_salmon/log/WT_REP1.Log.out").name, - file("${params.outdir}/star_salmon/log/WT_REP1.Log.progress.out").name, - file("${params.outdir}/star_salmon/log/WT_REP2.Log.final.out").name, - file("${params.outdir}/star_salmon/log/WT_REP2.Log.out").name, - file("${params.outdir}/star_salmon/log/WT_REP2.Log.progress.out").name - ).match("star_salmon/log") }, - { assert snapshot( - // Metrics are not stable - file("${params.outdir}/star_salmon/picard_metrics/RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_salmon/picard_metrics/WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt").name - ).match("star_salmon/picard_metrics") }, - { assert snapshot( - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - // HTML reports and these files are not stable - file("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_IAA_30M_REP1/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP1/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/RAP1_UNINDUCED_REP2/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP1/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP1/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP1/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP2/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP2/qualimapReport.html").name, - file("${params.outdir}/star_salmon/qualimap/WT_REP2/rnaseq_qc_results.txt").name - ).match("star_salmon/qualimap") }, - { assert snapshot( - path("${params.outdir}/star_salmon/rseqc/infer_experiment/RAP1_IAA_30M_REP1.infer_experiment.txt"), - path("${params.outdir}/star_salmon/rseqc/infer_experiment/RAP1_UNINDUCED_REP1.infer_experiment.txt"), - path("${params.outdir}/star_salmon/rseqc/infer_experiment/RAP1_UNINDUCED_REP2.infer_experiment.txt"), - path("${params.outdir}/star_salmon/rseqc/infer_experiment/WT_REP1.infer_experiment.txt"), - path("${params.outdir}/star_salmon/rseqc/infer_experiment/WT_REP2.infer_experiment.txt"), - // PDFs, R scripts and all these files are not stable - file("${params.outdir}/star_salmon/rseqc/bam_stat/RAP1_IAA_30M_REP1.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/bam_stat/RAP1_UNINDUCED_REP1.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/bam_stat/RAP1_UNINDUCED_REP2.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/bam_stat/WT_REP1.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/bam_stat/WT_REP2.bam_stat.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/pdf/RAP1_IAA_30M_REP1.inner_distance_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/pdf/WT_REP1.inner_distance_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/pdf/WT_REP2.inner_distance_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/rscript/RAP1_IAA_30M_REP1.inner_distance_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/rscript/WT_REP1.inner_distance_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/rscript/WT_REP2.inner_distance_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_freq.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_mean.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance_freq.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance_mean.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance_freq.txt").name, - file("${params.outdir}/star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance_mean.txt").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/WT_REP1.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/WT_REP1.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/WT_REP2.junction.Interact.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/bed/WT_REP2.junction.bed").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/RAP1_IAA_30M_REP1.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP1.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP2.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/WT_REP1.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/log/WT_REP2.junction_annotation.log").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/WT_REP1.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/WT_REP1.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/WT_REP2.splice_events.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/pdf/WT_REP2.splice_junction.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/RAP1_IAA_30M_REP1.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP1.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP2.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/WT_REP1.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/rscript/WT_REP2.junction_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/RAP1_IAA_30M_REP1.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP1.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP2.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/WT_REP1.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_annotation/xls/WT_REP2.junction.xls").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/WT_REP1.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/pdf/WT_REP2.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/RAP1_IAA_30M_REP1.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP1.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP2.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/WT_REP1.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/junction_saturation/rscript/WT_REP2.junctionSaturation_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/RAP1_IAA_30M_REP1.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/RAP1_UNINDUCED_REP1.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/RAP1_UNINDUCED_REP2.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/WT_REP1.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_distribution/WT_REP2.read_distribution.txt").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/RAP1_IAA_30M_REP1.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP1.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP2.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/WT_REP1.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/pdf/WT_REP2.DupRate_plot.pdf").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/RAP1_IAA_30M_REP1.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP1.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP2.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/WT_REP1.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/rscript/WT_REP2.DupRate_plot.r").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.seq.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.seq.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.seq.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/WT_REP1.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/WT_REP1.seq.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/WT_REP2.pos.DupRate.xls").name, - file("${params.outdir}/star_salmon/rseqc/read_duplication/xls/WT_REP2.seq.DupRate.xls").name - ).match("star_salmon/rseqc") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/star_salmon/salmon.merged.gene_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_length_scaled.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_counts_scaled.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_lengths.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.gene_tpm.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_counts.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_lengths.tsv").name, - file("${params.outdir}/star_salmon/salmon.merged.transcript_tpm.tsv").name - ).match("star_salmon/salmon") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.sorted.bam.flagstat").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.sorted.bam.idxstats").name, - file("${params.outdir}/star_salmon/samtools_stats/WT_REP2.sorted.bam.stats").name - ).match("star_salmon/samtools_stats") }, - { assert snapshot( - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/e2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/e_data.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/i2t.ctab"), - path("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/i_data.ctab"), - // These files are not stable - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_IAA_30M_REP1.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP1.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/RAP1_UNINDUCED_REP2.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP1.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP1.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP1.transcripts.gtf").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP2.ballgown/t_data.ctab").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP2.coverage.gtf").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP2.gene.abundance.txt").name, - file("${params.outdir}/star_salmon/stringtie/WT_REP2.transcripts.gtf").name - ).match("star_salmon/stringtie") }, - { assert snapshot( - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/WT_REP1.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/WT_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_salmon/WT_REP2.markdup.sorted.bam").name, - file("${params.outdir}/star_salmon/WT_REP2.markdup.sorted.bam.bai").name - ).match("star_salmon/markdup") }, - { assert snapshot( - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/cmd_info.json"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/cmd_info.json"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/cmd_info.json"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/WT_REP1/cmd_info.json"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/star_salmon/WT_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/star_salmon/WT_REP2/cmd_info.json"), - path("${params.outdir}/star_salmon/tx2gene.tsv"), - // These files are not stable - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/quant.genes.sf").name, - file("${params.outdir}/star_salmon/RAP1_IAA_30M_REP1/quant.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/quant.genes.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP1/quant.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/quant.genes.sf").name, - file("${params.outdir}/star_salmon/RAP1_UNINDUCED_REP2/quant.sf").name, - file("${params.outdir}/star_salmon/WT_REP1/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/WT_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/WT_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/WT_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/WT_REP1/quant.genes.sf").name, - file("${params.outdir}/star_salmon/WT_REP1/quant.sf").name, - file("${params.outdir}/star_salmon/WT_REP2/aux_info/fld.gz").name, - file("${params.outdir}/star_salmon/WT_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/star_salmon/WT_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/star_salmon/WT_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/star_salmon/WT_REP2/quant.genes.sf").name, - file("${params.outdir}/star_salmon/WT_REP2/quant.sf").name - ).match("star_salmon/salmon_quant") }, - { assert snapshot( - UTILS.removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml") - ).match("versions") } + { assert workflow.success}, + { assert snapshot( + // Number of successful tasks + workflow.trace.succeeded().size(), + // pipeline versions.yml file for multiqc from which Nextflow version is removed because we tests pipelines on multiple Nextflow versions + removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), + // All stable path name, with a relative path + getRelativePath(stable_name, outputDir), + // All files with stable contents + stable_path + ).match() } ) } } - // STUB ARE CURRENTLY NOT POSSIBLE - } diff --git a/tests/skip_trimming.nf.test.snap b/tests/skip_trimming.nf.test.snap index 0cced5ad5..bbdcc5a51 100644 --- a/tests/skip_trimming.nf.test.snap +++ b/tests/skip_trimming.nf.test.snap @@ -1,943 +1,1384 @@ { - "star_salmon/log": { + "Params: --skip_trimming": { "content": [ - "RAP1_IAA_30M_REP1.SJ.out.tab:md5,20c790387ef68e041bc4ffdcd032a22f", - "RAP1_UNINDUCED_REP1.SJ.out.tab:md5,ba2636236fa1d26aa72f7aff73bd41f8", - "RAP1_UNINDUCED_REP2.SJ.out.tab:md5,1c0458f66e4af56a56f4409c120434b3", - "WT_REP1.SJ.out.tab:md5,299a948b1aaf329152224ba573402a51", - "WT_REP2.SJ.out.tab:md5,073498a8fb5fb4da664c9129a6777c42", - "RAP1_IAA_30M_REP1.Log.final.out", - "RAP1_IAA_30M_REP1.Log.out", - "RAP1_IAA_30M_REP1.Log.progress.out", - "RAP1_UNINDUCED_REP1.Log.final.out", - "RAP1_UNINDUCED_REP1.Log.out", - "RAP1_UNINDUCED_REP1.Log.progress.out", - "RAP1_UNINDUCED_REP2.Log.final.out", - "RAP1_UNINDUCED_REP2.Log.out", - "RAP1_UNINDUCED_REP2.Log.progress.out", - "WT_REP1.Log.final.out", - "WT_REP1.Log.out", - "WT_REP1.Log.progress.out", - "WT_REP2.Log.final.out", - "WT_REP2.Log.out", - "WT_REP2.Log.progress.out" + 193, + { + "BBMAP_BBSPLIT": { + "bbmap": 39.01 + }, + "BEDTOOLS_GENOMECOV_FW": { + "bedtools": "2.31.1" + }, + "CAT_FASTQ": { + "cat": 8.3 + }, + "CUSTOM_CATADDITIONALFASTA": { + "python": "3.9.5" + }, + "CUSTOM_GETCHROMSIZES": { + "getchromsizes": 1.2 + }, + "CUSTOM_TX2GENE": { + "python": "3.9.5" + }, + "DESEQ2_QC_PSEUDO": { + "r-base": "4.0.3", + "bioconductor-deseq2": "1.28.0" + }, + "DESEQ2_QC_STAR_SALMON": { + "r-base": "4.0.3", + "bioconductor-deseq2": "1.28.0" + }, + "DUPRADAR": { + "bioconductor-dupradar": "1.32.0" + }, + "FASTQC": { + "fastqc": "0.12.1" + }, + "FQ_SUBSAMPLE": { + "fq": "0.9.1 (2022-02-22)" + }, + "GTF2BED": { + "perl": "5.26.2" + }, + "GTF_FILTER": { + "python": "3.9.5" + }, + "GUNZIP_ADDITIONAL_FASTA": { + "gunzip": 1.1 + }, + "GUNZIP_GTF": { + "gunzip": 1.1 + }, + "MULTIQC_CUSTOM_BIOTYPE": { + "python": "3.9.5" + }, + "PICARD_MARKDUPLICATES": { + "picard": "3.1.1" + }, + "QUALIMAP_RNASEQ": { + "qualimap": 2.3 + }, + "RSEQC_BAMSTAT": { + "rseqc": "5.0.2" + }, + "RSEQC_INFEREXPERIMENT": { + "rseqc": "5.0.2" + }, + "RSEQC_INNERDISTANCE": { + "rseqc": "5.0.2" + }, + "RSEQC_JUNCTIONANNOTATION": { + "rseqc": "5.0.2" + }, + "RSEQC_JUNCTIONSATURATION": { + "rseqc": "5.0.2" + }, + "RSEQC_READDISTRIBUTION": { + "rseqc": "5.0.2" + }, + "RSEQC_READDUPLICATION": { + "rseqc": "5.0.2" + }, + "SALMON_QUANT": { + "salmon": "1.10.1" + }, + "SAMTOOLS_FLAGSTAT": { + "samtools": 1.2 + }, + "SAMTOOLS_IDXSTATS": { + "samtools": 1.2 + }, + "SAMTOOLS_INDEX": { + "samtools": 1.2 + }, + "SAMTOOLS_SORT": { + "samtools": 1.2 + }, + "SAMTOOLS_STATS": { + "samtools": 1.2 + }, + "SE_GENE": { + "bioconductor-summarizedexperiment": "1.32.0" + }, + "STAR_ALIGN": { + "star": "2.7.10a", + "samtools": 1.18, + "gawk": "5.1.0" + }, + "STAR_GENOMEGENERATE": { + "star": "2.7.10a", + "samtools": 1.18, + "gawk": "5.1.0" + }, + "STRINGTIE_STRINGTIE": { + "stringtie": "2.2.1" + }, + "SUBREAD_FEATURECOUNTS": { + "subread": "2.0.1" + }, + "TXIMETA_TXIMPORT": { + "bioconductor-tximeta": "1.20.1" + }, + "UCSC_BEDCLIP": { + "ucsc": 377 + }, + "UCSC_BEDGRAPHTOBIGWIG": { + "ucsc": 445 + }, + "UNTAR_SALMON_INDEX": { + "untar": 1.34 + }, + "Workflow": { + "nf-core/rnaseq": "v3.16.0dev" + } + }, + [ + "bbsplit", + "bbsplit/RAP1_IAA_30M_REP1.stats.txt", + "bbsplit/RAP1_UNINDUCED_REP1.stats.txt", + "bbsplit/RAP1_UNINDUCED_REP2.stats.txt", + "bbsplit/WT_REP1.stats.txt", + "bbsplit/WT_REP2.stats.txt", + "custom", + "custom/out", + "custom/out/genome_gfp.fasta", + "custom/out/genome_gfp.gtf", + "fastqc", + "fastqc/raw", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.html", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.zip", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.html", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.zip", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.html", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.zip", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.html", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.zip", + "fastqc/raw/WT_REP1_raw_1_fastqc.html", + "fastqc/raw/WT_REP1_raw_1_fastqc.zip", + "fastqc/raw/WT_REP1_raw_2_fastqc.html", + "fastqc/raw/WT_REP1_raw_2_fastqc.zip", + "fastqc/raw/WT_REP2_raw_1_fastqc.html", + "fastqc/raw/WT_REP2_raw_1_fastqc.zip", + "fastqc/raw/WT_REP2_raw_2_fastqc.html", + "fastqc/raw/WT_REP2_raw_2_fastqc.zip", + "multiqc", + "multiqc/star_salmon", + "multiqc/star_salmon/multiqc_report.html", + "multiqc/star_salmon/multiqc_report_data", + "multiqc/star_salmon/multiqc_report_data/fastqc-status-check-heatmap.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_adapter_content_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_overrepresented_sequences_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_base_n_content_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_base_sequence_quality_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Percentages.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_per_sequence_quality_scores_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_counts_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_sequence_duplication_levels_plot.txt", + "multiqc/star_salmon/multiqc_report_data/fastqc_top_overrepresented_sequences_table.txt", + "multiqc/star_salmon/multiqc_report_data/junction_saturation_known.txt", + "multiqc/star_salmon/multiqc_report_data/junction_saturation_novel.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_citations.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_data.json", + "multiqc/star_salmon/multiqc_report_data/multiqc_dupradar-section-plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_fail_strand_check_table.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_fastqc_fastqc_raw.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_featurecounts_biotype_plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_general_stats.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_picard_dups.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_bam_stat.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_infer_experiment.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_junction_annotation.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_rseqc_read_distribution.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_1.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_2.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_3.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_4.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_salmon_deseq2_pca-plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_samtools_flagstat.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_samtools_idxstats.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_samtools_stats.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_software_versions.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_sources.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_1.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_2.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_3.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_clustering-plot_4.txt", + "multiqc/star_salmon/multiqc_report_data/multiqc_star_salmon_deseq2_pca-plot.txt", + "multiqc/star_salmon/multiqc_report_data/picard_deduplication.txt", + "multiqc/star_salmon/multiqc_report_data/picard_histogram.txt", + "multiqc/star_salmon/multiqc_report_data/picard_histogram_1.txt", + "multiqc/star_salmon/multiqc_report_data/picard_histogram_2.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_gene_coverage_profile_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_gene_coverage_profile_Normalised.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_genomic_origin.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_rnaseq_cov_hist.txt", + "multiqc/star_salmon/multiqc_report_data/qualimap_rnaseq_genome_results.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_bam_stat.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_infer_experiment_plot.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance_plot_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_inner_distance_plot_Percentages.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Events.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Junctions.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_all.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_All_Junctions.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_Known_Junctions.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_junction_saturation_plot_Novel_Junctions.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_read_distribution_plot.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_read_dups.txt", + "multiqc/star_salmon/multiqc_report_data/rseqc_read_dups_plot.txt", + "multiqc/star_salmon/multiqc_report_data/salmon_plot.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Percentage_of_total.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-flagstat-dp_Read_counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Raw_Counts.txt", + "multiqc/star_salmon/multiqc_report_data/samtools-stats-dp.txt", + "multiqc/star_salmon/multiqc_report_data/samtools_alignment_plot.txt", + "multiqc/star_salmon/multiqc_report_data/star_alignment_plot.txt", + "multiqc/star_salmon/multiqc_report_data/star_summary_table.txt", + "multiqc/star_salmon/multiqc_report_plots", + "multiqc/star_salmon/multiqc_report_plots/pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/dupradar-section-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fail_strand_check_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc-status-check-heatmap.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_adapter_content_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Percentages.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/featurecounts_biotype_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/featurecounts_biotype_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/general_stats_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/picard_deduplication-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Normalised.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_genomic_origin-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/qualimap_genomic_origin-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_bam_stat.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_infer_experiment_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Percentages.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_All_Junctions.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Known_Junctions.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Novel_Junctions.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_distribution_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_distribution_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/rseqc_read_dups_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/salmon_deseq2_clustering-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/salmon_deseq2_pca-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/salmon_plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Percentage_of_total.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-flagstat-dp_Read_counts.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools-stats-dp.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/samtools_alignment_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-cnt.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_alignment_plot-pct.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_salmon_deseq2_clustering-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_salmon_deseq2_pca-plot.pdf", + "multiqc/star_salmon/multiqc_report_plots/pdf/star_summary_table.pdf", + "multiqc/star_salmon/multiqc_report_plots/png", + "multiqc/star_salmon/multiqc_report_plots/png/dupradar-section-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fail_strand_check_table.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc-status-check-heatmap.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_adapter_content_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_n_content_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Percentages.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_counts_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table.png", + "multiqc/star_salmon/multiqc_report_plots/png/featurecounts_biotype_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/featurecounts_biotype_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/general_stats_table.png", + "multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/picard_deduplication-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/qualimap_gene_coverage_profile_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/qualimap_gene_coverage_profile_Normalised.png", + "multiqc/star_salmon/multiqc_report_plots/png/qualimap_genomic_origin-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/qualimap_genomic_origin-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_bam_stat.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_infer_experiment_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_inner_distance_plot_Counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_inner_distance_plot_Percentages.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_All_Junctions.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_Known_Junctions.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_junction_saturation_plot_Novel_Junctions.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_distribution_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_distribution_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/rseqc_read_dups_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/salmon_deseq2_clustering-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/salmon_deseq2_pca-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/salmon_plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Percentage_of_total.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-flagstat-dp_Read_counts.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools-stats-dp.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/samtools_alignment_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-cnt.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_alignment_plot-pct.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_salmon_deseq2_clustering-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_salmon_deseq2_pca-plot.png", + "multiqc/star_salmon/multiqc_report_plots/png/star_summary_table.png", + "multiqc/star_salmon/multiqc_report_plots/svg", + "multiqc/star_salmon/multiqc_report_plots/svg/dupradar-section-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fail_strand_check_table.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc-status-check-heatmap.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_adapter_content_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_n_content_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Percentages.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_counts_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/featurecounts_biotype_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/featurecounts_biotype_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/general_stats_table.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/picard_deduplication-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Normalised.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/qualimap_genomic_origin-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/qualimap_genomic_origin-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_bam_stat.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_infer_experiment_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_inner_distance_plot_Counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_inner_distance_plot_Percentages.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_All_Junctions.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Known_Junctions.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Novel_Junctions.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_distribution_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_distribution_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/rseqc_read_dups_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/salmon_deseq2_clustering-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/salmon_deseq2_pca-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/salmon_plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Percentage_of_total.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-flagstat-dp_Read_counts.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools-stats-dp.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/samtools_alignment_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-cnt.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_alignment_plot-pct.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_salmon_deseq2_clustering-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_salmon_deseq2_pca-plot.svg", + "multiqc/star_salmon/multiqc_report_plots/svg/star_summary_table.svg", + "pipeline_info", + "pipeline_info/nf_core_rnaseq_software_mqc_versions.yml", + "salmon", + "salmon/RAP1_IAA_30M_REP1", + "salmon/RAP1_IAA_30M_REP1/aux_info", + "salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv", + "salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json", + "salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz", + "salmon/RAP1_IAA_30M_REP1/cmd_info.json", + "salmon/RAP1_IAA_30M_REP1/libParams", + "salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt", + "salmon/RAP1_IAA_30M_REP1/lib_format_counts.json", + "salmon/RAP1_IAA_30M_REP1/logs", + "salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log", + "salmon/RAP1_IAA_30M_REP1/quant.genes.sf", + "salmon/RAP1_IAA_30M_REP1/quant.sf", + "salmon/RAP1_UNINDUCED_REP1", + "salmon/RAP1_UNINDUCED_REP1/aux_info", + "salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv", + "salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json", + "salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz", + "salmon/RAP1_UNINDUCED_REP1/cmd_info.json", + "salmon/RAP1_UNINDUCED_REP1/libParams", + "salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt", + "salmon/RAP1_UNINDUCED_REP1/lib_format_counts.json", + "salmon/RAP1_UNINDUCED_REP1/logs", + "salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log", + "salmon/RAP1_UNINDUCED_REP1/quant.genes.sf", + "salmon/RAP1_UNINDUCED_REP1/quant.sf", + "salmon/RAP1_UNINDUCED_REP2", + "salmon/RAP1_UNINDUCED_REP2/aux_info", + "salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv", + "salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json", + "salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz", + "salmon/RAP1_UNINDUCED_REP2/cmd_info.json", + "salmon/RAP1_UNINDUCED_REP2/libParams", + "salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt", + "salmon/RAP1_UNINDUCED_REP2/lib_format_counts.json", + "salmon/RAP1_UNINDUCED_REP2/logs", + "salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log", + "salmon/RAP1_UNINDUCED_REP2/quant.genes.sf", + "salmon/RAP1_UNINDUCED_REP2/quant.sf", + "salmon/WT_REP1", + "salmon/WT_REP1/aux_info", + "salmon/WT_REP1/aux_info/ambig_info.tsv", + "salmon/WT_REP1/aux_info/expected_bias.gz", + "salmon/WT_REP1/aux_info/fld.gz", + "salmon/WT_REP1/aux_info/meta_info.json", + "salmon/WT_REP1/aux_info/observed_bias.gz", + "salmon/WT_REP1/aux_info/observed_bias_3p.gz", + "salmon/WT_REP1/cmd_info.json", + "salmon/WT_REP1/libParams", + "salmon/WT_REP1/libParams/flenDist.txt", + "salmon/WT_REP1/lib_format_counts.json", + "salmon/WT_REP1/logs", + "salmon/WT_REP1/logs/salmon_quant.log", + "salmon/WT_REP1/quant.genes.sf", + "salmon/WT_REP1/quant.sf", + "salmon/WT_REP2", + "salmon/WT_REP2/aux_info", + "salmon/WT_REP2/aux_info/ambig_info.tsv", + "salmon/WT_REP2/aux_info/expected_bias.gz", + "salmon/WT_REP2/aux_info/fld.gz", + "salmon/WT_REP2/aux_info/meta_info.json", + "salmon/WT_REP2/aux_info/observed_bias.gz", + "salmon/WT_REP2/aux_info/observed_bias_3p.gz", + "salmon/WT_REP2/cmd_info.json", + "salmon/WT_REP2/libParams", + "salmon/WT_REP2/libParams/flenDist.txt", + "salmon/WT_REP2/lib_format_counts.json", + "salmon/WT_REP2/logs", + "salmon/WT_REP2/logs/salmon_quant.log", + "salmon/WT_REP2/quant.genes.sf", + "salmon/WT_REP2/quant.sf", + "salmon/deseq2_qc", + "salmon/deseq2_qc/R_sessionInfo.log", + "salmon/deseq2_qc/deseq2.dds.RData", + "salmon/deseq2_qc/deseq2.pca.vals.txt", + "salmon/deseq2_qc/deseq2.plots.pdf", + "salmon/deseq2_qc/deseq2.sample.dists.txt", + "salmon/deseq2_qc/size_factors", + "salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt", + "salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt", + "salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt", + "salmon/deseq2_qc/size_factors/WT_REP1.txt", + "salmon/deseq2_qc/size_factors/WT_REP2.txt", + "salmon/deseq2_qc/size_factors/deseq2.size_factors.RData", + "salmon/salmon.merged.gene_counts.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts.tsv", + "salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts_length_scaled.tsv", + "salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts_scaled.tsv", + "salmon/salmon.merged.gene_lengths.tsv", + "salmon/salmon.merged.gene_tpm.tsv", + "salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds", + "salmon/salmon.merged.transcript_counts.tsv", + "salmon/salmon.merged.transcript_lengths.tsv", + "salmon/salmon.merged.transcript_tpm.tsv", + "salmon/tx2gene.tsv", + "star_salmon", + "star_salmon/RAP1_IAA_30M_REP1", + "star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam", + "star_salmon/RAP1_IAA_30M_REP1.markdup.sorted.bam.bai", + "star_salmon/RAP1_IAA_30M_REP1/aux_info", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz", + "star_salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz", + "star_salmon/RAP1_IAA_30M_REP1/cmd_info.json", + "star_salmon/RAP1_IAA_30M_REP1/libParams", + "star_salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt", + "star_salmon/RAP1_IAA_30M_REP1/logs", + "star_salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log", + "star_salmon/RAP1_IAA_30M_REP1/quant.genes.sf", + "star_salmon/RAP1_IAA_30M_REP1/quant.sf", + "star_salmon/RAP1_UNINDUCED_REP1", + "star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam", + "star_salmon/RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz", + "star_salmon/RAP1_UNINDUCED_REP1/cmd_info.json", + "star_salmon/RAP1_UNINDUCED_REP1/libParams", + "star_salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt", + "star_salmon/RAP1_UNINDUCED_REP1/logs", + "star_salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log", + "star_salmon/RAP1_UNINDUCED_REP1/quant.genes.sf", + "star_salmon/RAP1_UNINDUCED_REP1/quant.sf", + "star_salmon/RAP1_UNINDUCED_REP2", + "star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam", + "star_salmon/RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz", + "star_salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz", + "star_salmon/RAP1_UNINDUCED_REP2/cmd_info.json", + "star_salmon/RAP1_UNINDUCED_REP2/libParams", + "star_salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt", + "star_salmon/RAP1_UNINDUCED_REP2/logs", + "star_salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log", + "star_salmon/RAP1_UNINDUCED_REP2/quant.genes.sf", + "star_salmon/RAP1_UNINDUCED_REP2/quant.sf", + "star_salmon/WT_REP1", + "star_salmon/WT_REP1.markdup.sorted.bam", + "star_salmon/WT_REP1.markdup.sorted.bam.bai", + "star_salmon/WT_REP1/aux_info", + "star_salmon/WT_REP1/aux_info/ambig_info.tsv", + "star_salmon/WT_REP1/aux_info/expected_bias.gz", + "star_salmon/WT_REP1/aux_info/fld.gz", + "star_salmon/WT_REP1/aux_info/meta_info.json", + "star_salmon/WT_REP1/aux_info/observed_bias.gz", + "star_salmon/WT_REP1/aux_info/observed_bias_3p.gz", + "star_salmon/WT_REP1/cmd_info.json", + "star_salmon/WT_REP1/libParams", + "star_salmon/WT_REP1/libParams/flenDist.txt", + "star_salmon/WT_REP1/logs", + "star_salmon/WT_REP1/logs/salmon_quant.log", + "star_salmon/WT_REP1/quant.genes.sf", + "star_salmon/WT_REP1/quant.sf", + "star_salmon/WT_REP2", + "star_salmon/WT_REP2.markdup.sorted.bam", + "star_salmon/WT_REP2.markdup.sorted.bam.bai", + "star_salmon/WT_REP2/aux_info", + "star_salmon/WT_REP2/aux_info/ambig_info.tsv", + "star_salmon/WT_REP2/aux_info/expected_bias.gz", + "star_salmon/WT_REP2/aux_info/fld.gz", + "star_salmon/WT_REP2/aux_info/meta_info.json", + "star_salmon/WT_REP2/aux_info/observed_bias.gz", + "star_salmon/WT_REP2/aux_info/observed_bias_3p.gz", + "star_salmon/WT_REP2/cmd_info.json", + "star_salmon/WT_REP2/libParams", + "star_salmon/WT_REP2/libParams/flenDist.txt", + "star_salmon/WT_REP2/logs", + "star_salmon/WT_REP2/logs/salmon_quant.log", + "star_salmon/WT_REP2/quant.genes.sf", + "star_salmon/WT_REP2/quant.sf", + "star_salmon/bigwig", + "star_salmon/bigwig/RAP1_IAA_30M_REP1.forward.bigWig", + "star_salmon/bigwig/RAP1_IAA_30M_REP1.reverse.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP1.forward.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP1.reverse.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP2.forward.bigWig", + "star_salmon/bigwig/RAP1_UNINDUCED_REP2.reverse.bigWig", + "star_salmon/bigwig/WT_REP1.forward.bigWig", + "star_salmon/bigwig/WT_REP1.reverse.bigWig", + "star_salmon/bigwig/WT_REP2.forward.bigWig", + "star_salmon/bigwig/WT_REP2.reverse.bigWig", + "star_salmon/deseq2_qc", + "star_salmon/deseq2_qc/R_sessionInfo.log", + "star_salmon/deseq2_qc/deseq2.dds.RData", + "star_salmon/deseq2_qc/deseq2.pca.vals.txt", + "star_salmon/deseq2_qc/deseq2.plots.pdf", + "star_salmon/deseq2_qc/deseq2.sample.dists.txt", + "star_salmon/deseq2_qc/size_factors", + "star_salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt", + "star_salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt", + "star_salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt", + "star_salmon/deseq2_qc/size_factors/WT_REP1.txt", + "star_salmon/deseq2_qc/size_factors/WT_REP2.txt", + "star_salmon/deseq2_qc/size_factors/deseq2.size_factors.RData", + "star_salmon/dupradar", + "star_salmon/dupradar/box_plot", + "star_salmon/dupradar/box_plot/RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf", + "star_salmon/dupradar/box_plot/RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf", + "star_salmon/dupradar/box_plot/RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf", + "star_salmon/dupradar/box_plot/WT_REP1_duprateExpBoxplot.pdf", + "star_salmon/dupradar/box_plot/WT_REP2_duprateExpBoxplot.pdf", + "star_salmon/dupradar/gene_data", + "star_salmon/dupradar/gene_data/RAP1_IAA_30M_REP1_dupMatrix.txt", + "star_salmon/dupradar/gene_data/RAP1_UNINDUCED_REP1_dupMatrix.txt", + "star_salmon/dupradar/gene_data/RAP1_UNINDUCED_REP2_dupMatrix.txt", + "star_salmon/dupradar/gene_data/WT_REP1_dupMatrix.txt", + "star_salmon/dupradar/gene_data/WT_REP2_dupMatrix.txt", + "star_salmon/dupradar/histogram", + "star_salmon/dupradar/histogram/RAP1_IAA_30M_REP1_expressionHist.pdf", + "star_salmon/dupradar/histogram/RAP1_UNINDUCED_REP1_expressionHist.pdf", + "star_salmon/dupradar/histogram/RAP1_UNINDUCED_REP2_expressionHist.pdf", + "star_salmon/dupradar/histogram/WT_REP1_expressionHist.pdf", + "star_salmon/dupradar/histogram/WT_REP2_expressionHist.pdf", + "star_salmon/dupradar/intercepts_slope", + "star_salmon/dupradar/intercepts_slope/RAP1_IAA_30M_REP1_intercept_slope.txt", + "star_salmon/dupradar/intercepts_slope/RAP1_UNINDUCED_REP1_intercept_slope.txt", + "star_salmon/dupradar/intercepts_slope/RAP1_UNINDUCED_REP2_intercept_slope.txt", + "star_salmon/dupradar/intercepts_slope/WT_REP1_intercept_slope.txt", + "star_salmon/dupradar/intercepts_slope/WT_REP2_intercept_slope.txt", + "star_salmon/dupradar/scatter_plot", + "star_salmon/dupradar/scatter_plot/RAP1_IAA_30M_REP1_duprateExpDens.pdf", + "star_salmon/dupradar/scatter_plot/RAP1_UNINDUCED_REP1_duprateExpDens.pdf", + "star_salmon/dupradar/scatter_plot/RAP1_UNINDUCED_REP2_duprateExpDens.pdf", + "star_salmon/dupradar/scatter_plot/WT_REP1_duprateExpDens.pdf", + "star_salmon/dupradar/scatter_plot/WT_REP2_duprateExpDens.pdf", + "star_salmon/featurecounts", + "star_salmon/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv", + "star_salmon/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv", + "star_salmon/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt", + "star_salmon/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt.summary", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt.summary", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt", + "star_salmon/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt.summary", + "star_salmon/featurecounts/WT_REP1.biotype_counts_mqc.tsv", + "star_salmon/featurecounts/WT_REP1.biotype_counts_rrna_mqc.tsv", + "star_salmon/featurecounts/WT_REP1.featureCounts.txt", + "star_salmon/featurecounts/WT_REP1.featureCounts.txt.summary", + "star_salmon/featurecounts/WT_REP2.biotype_counts_mqc.tsv", + "star_salmon/featurecounts/WT_REP2.biotype_counts_rrna_mqc.tsv", + "star_salmon/featurecounts/WT_REP2.featureCounts.txt", + "star_salmon/featurecounts/WT_REP2.featureCounts.txt.summary", + "star_salmon/log", + "star_salmon/log/RAP1_IAA_30M_REP1.Log.final.out", + "star_salmon/log/RAP1_IAA_30M_REP1.Log.out", + "star_salmon/log/RAP1_IAA_30M_REP1.Log.progress.out", + "star_salmon/log/RAP1_IAA_30M_REP1.SJ.out.tab", + "star_salmon/log/RAP1_UNINDUCED_REP1.Log.final.out", + "star_salmon/log/RAP1_UNINDUCED_REP1.Log.out", + "star_salmon/log/RAP1_UNINDUCED_REP1.Log.progress.out", + "star_salmon/log/RAP1_UNINDUCED_REP1.SJ.out.tab", + "star_salmon/log/RAP1_UNINDUCED_REP2.Log.final.out", + "star_salmon/log/RAP1_UNINDUCED_REP2.Log.out", + "star_salmon/log/RAP1_UNINDUCED_REP2.Log.progress.out", + "star_salmon/log/RAP1_UNINDUCED_REP2.SJ.out.tab", + "star_salmon/log/WT_REP1.Log.final.out", + "star_salmon/log/WT_REP1.Log.out", + "star_salmon/log/WT_REP1.Log.progress.out", + "star_salmon/log/WT_REP1.SJ.out.tab", + "star_salmon/log/WT_REP2.Log.final.out", + "star_salmon/log/WT_REP2.Log.out", + "star_salmon/log/WT_REP2.Log.progress.out", + "star_salmon/log/WT_REP2.SJ.out.tab", + "star_salmon/picard_metrics", + "star_salmon/picard_metrics/RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/picard_metrics/WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt", + "star_salmon/qualimap", + "star_salmon/qualimap/RAP1_IAA_30M_REP1", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/agogo.css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/ajax-loader.gif", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/basic.css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/bgfooter.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/bgtop.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/comment-bright.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/comment-close.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/comment.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/doctools.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/down-pressed.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/down.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/file.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/jquery.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/minus.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/plus.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/pygments.css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/qualimap_logo_small.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/report.css", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/searchtools.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/underscore.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/up-pressed.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/up.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/css/websupport.js", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/qualimapReport.html", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/RAP1_IAA_30M_REP1/rnaseq_qc_results.txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/agogo.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/ajax-loader.gif", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/basic.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/bgfooter.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/bgtop.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/comment-bright.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/comment-close.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/comment.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/doctools.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/down-pressed.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/down.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/file.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/jquery.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/minus.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/plus.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/pygments.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/qualimap_logo_small.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/report.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/searchtools.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/underscore.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/up-pressed.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/up.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/css/websupport.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/qualimapReport.html", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP1/rnaseq_qc_results.txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/agogo.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/ajax-loader.gif", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/basic.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/bgfooter.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/bgtop.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/comment-bright.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/comment-close.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/comment.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/doctools.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/down-pressed.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/down.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/file.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/jquery.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/minus.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/plus.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/pygments.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/qualimap_logo_small.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/report.css", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/searchtools.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/underscore.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/up-pressed.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/up.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/css/websupport.js", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/qualimapReport.html", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/RAP1_UNINDUCED_REP2/rnaseq_qc_results.txt", + "star_salmon/qualimap/WT_REP1", + "star_salmon/qualimap/WT_REP1/css", + "star_salmon/qualimap/WT_REP1/css/agogo.css", + "star_salmon/qualimap/WT_REP1/css/ajax-loader.gif", + "star_salmon/qualimap/WT_REP1/css/basic.css", + "star_salmon/qualimap/WT_REP1/css/bgfooter.png", + "star_salmon/qualimap/WT_REP1/css/bgtop.png", + "star_salmon/qualimap/WT_REP1/css/comment-bright.png", + "star_salmon/qualimap/WT_REP1/css/comment-close.png", + "star_salmon/qualimap/WT_REP1/css/comment.png", + "star_salmon/qualimap/WT_REP1/css/doctools.js", + "star_salmon/qualimap/WT_REP1/css/down-pressed.png", + "star_salmon/qualimap/WT_REP1/css/down.png", + "star_salmon/qualimap/WT_REP1/css/file.png", + "star_salmon/qualimap/WT_REP1/css/jquery.js", + "star_salmon/qualimap/WT_REP1/css/minus.png", + "star_salmon/qualimap/WT_REP1/css/plus.png", + "star_salmon/qualimap/WT_REP1/css/pygments.css", + "star_salmon/qualimap/WT_REP1/css/qualimap_logo_small.png", + "star_salmon/qualimap/WT_REP1/css/report.css", + "star_salmon/qualimap/WT_REP1/css/searchtools.js", + "star_salmon/qualimap/WT_REP1/css/underscore.js", + "star_salmon/qualimap/WT_REP1/css/up-pressed.png", + "star_salmon/qualimap/WT_REP1/css/up.png", + "star_salmon/qualimap/WT_REP1/css/websupport.js", + "star_salmon/qualimap/WT_REP1/images_qualimapReport", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/WT_REP1/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/WT_REP1/qualimapReport.html", + "star_salmon/qualimap/WT_REP1/raw_data_qualimapReport", + "star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/WT_REP1/rnaseq_qc_results.txt", + "star_salmon/qualimap/WT_REP2", + "star_salmon/qualimap/WT_REP2/css", + "star_salmon/qualimap/WT_REP2/css/agogo.css", + "star_salmon/qualimap/WT_REP2/css/ajax-loader.gif", + "star_salmon/qualimap/WT_REP2/css/basic.css", + "star_salmon/qualimap/WT_REP2/css/bgfooter.png", + "star_salmon/qualimap/WT_REP2/css/bgtop.png", + "star_salmon/qualimap/WT_REP2/css/comment-bright.png", + "star_salmon/qualimap/WT_REP2/css/comment-close.png", + "star_salmon/qualimap/WT_REP2/css/comment.png", + "star_salmon/qualimap/WT_REP2/css/doctools.js", + "star_salmon/qualimap/WT_REP2/css/down-pressed.png", + "star_salmon/qualimap/WT_REP2/css/down.png", + "star_salmon/qualimap/WT_REP2/css/file.png", + "star_salmon/qualimap/WT_REP2/css/jquery.js", + "star_salmon/qualimap/WT_REP2/css/minus.png", + "star_salmon/qualimap/WT_REP2/css/plus.png", + "star_salmon/qualimap/WT_REP2/css/pygments.css", + "star_salmon/qualimap/WT_REP2/css/qualimap_logo_small.png", + "star_salmon/qualimap/WT_REP2/css/report.css", + "star_salmon/qualimap/WT_REP2/css/searchtools.js", + "star_salmon/qualimap/WT_REP2/css/underscore.js", + "star_salmon/qualimap/WT_REP2/css/up-pressed.png", + "star_salmon/qualimap/WT_REP2/css/up.png", + "star_salmon/qualimap/WT_REP2/css/websupport.js", + "star_salmon/qualimap/WT_REP2/images_qualimapReport", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Junction Analysis.png", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Reads Genomic Origin.png", + "star_salmon/qualimap/WT_REP2/images_qualimapReport/Transcript coverage histogram.png", + "star_salmon/qualimap/WT_REP2/qualimapReport.html", + "star_salmon/qualimap/WT_REP2/raw_data_qualimapReport", + "star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_salmon/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_salmon/qualimap/WT_REP2/rnaseq_qc_results.txt", + "star_salmon/rseqc", + "star_salmon/rseqc/bam_stat", + "star_salmon/rseqc/bam_stat/RAP1_IAA_30M_REP1.bam_stat.txt", + "star_salmon/rseqc/bam_stat/RAP1_UNINDUCED_REP1.bam_stat.txt", + "star_salmon/rseqc/bam_stat/RAP1_UNINDUCED_REP2.bam_stat.txt", + "star_salmon/rseqc/bam_stat/WT_REP1.bam_stat.txt", + "star_salmon/rseqc/bam_stat/WT_REP2.bam_stat.txt", + "star_salmon/rseqc/infer_experiment", + "star_salmon/rseqc/infer_experiment/RAP1_IAA_30M_REP1.infer_experiment.txt", + "star_salmon/rseqc/infer_experiment/RAP1_UNINDUCED_REP1.infer_experiment.txt", + "star_salmon/rseqc/infer_experiment/RAP1_UNINDUCED_REP2.infer_experiment.txt", + "star_salmon/rseqc/infer_experiment/WT_REP1.infer_experiment.txt", + "star_salmon/rseqc/infer_experiment/WT_REP2.infer_experiment.txt", + "star_salmon/rseqc/inner_distance", + "star_salmon/rseqc/inner_distance/pdf", + "star_salmon/rseqc/inner_distance/pdf/RAP1_IAA_30M_REP1.inner_distance_plot.pdf", + "star_salmon/rseqc/inner_distance/pdf/WT_REP1.inner_distance_plot.pdf", + "star_salmon/rseqc/inner_distance/pdf/WT_REP2.inner_distance_plot.pdf", + "star_salmon/rseqc/inner_distance/rscript", + "star_salmon/rseqc/inner_distance/rscript/RAP1_IAA_30M_REP1.inner_distance_plot.r", + "star_salmon/rseqc/inner_distance/rscript/WT_REP1.inner_distance_plot.r", + "star_salmon/rseqc/inner_distance/rscript/WT_REP2.inner_distance_plot.r", + "star_salmon/rseqc/inner_distance/txt", + "star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance.txt", + "star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_freq.txt", + "star_salmon/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_mean.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance_freq.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP1.inner_distance_mean.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance_freq.txt", + "star_salmon/rseqc/inner_distance/txt/WT_REP2.inner_distance_mean.txt", + "star_salmon/rseqc/junction_annotation", + "star_salmon/rseqc/junction_annotation/bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.bed", + "star_salmon/rseqc/junction_annotation/bed/WT_REP1.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/WT_REP1.junction.bed", + "star_salmon/rseqc/junction_annotation/bed/WT_REP2.junction.Interact.bed", + "star_salmon/rseqc/junction_annotation/bed/WT_REP2.junction.bed", + "star_salmon/rseqc/junction_annotation/log", + "star_salmon/rseqc/junction_annotation/log/RAP1_IAA_30M_REP1.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP1.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP2.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/log/WT_REP1.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/log/WT_REP2.junction_annotation.log", + "star_salmon/rseqc/junction_annotation/pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/pdf/WT_REP1.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/WT_REP1.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/pdf/WT_REP2.splice_events.pdf", + "star_salmon/rseqc/junction_annotation/pdf/WT_REP2.splice_junction.pdf", + "star_salmon/rseqc/junction_annotation/rscript", + "star_salmon/rseqc/junction_annotation/rscript/RAP1_IAA_30M_REP1.junction_plot.r", + "star_salmon/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP1.junction_plot.r", + "star_salmon/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP2.junction_plot.r", + "star_salmon/rseqc/junction_annotation/rscript/WT_REP1.junction_plot.r", + "star_salmon/rseqc/junction_annotation/rscript/WT_REP2.junction_plot.r", + "star_salmon/rseqc/junction_annotation/xls", + "star_salmon/rseqc/junction_annotation/xls/RAP1_IAA_30M_REP1.junction.xls", + "star_salmon/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP1.junction.xls", + "star_salmon/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP2.junction.xls", + "star_salmon/rseqc/junction_annotation/xls/WT_REP1.junction.xls", + "star_salmon/rseqc/junction_annotation/xls/WT_REP2.junction.xls", + "star_salmon/rseqc/junction_saturation", + "star_salmon/rseqc/junction_saturation/pdf", + "star_salmon/rseqc/junction_saturation/pdf/RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/pdf/WT_REP1.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/pdf/WT_REP2.junctionSaturation_plot.pdf", + "star_salmon/rseqc/junction_saturation/rscript", + "star_salmon/rseqc/junction_saturation/rscript/RAP1_IAA_30M_REP1.junctionSaturation_plot.r", + "star_salmon/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP1.junctionSaturation_plot.r", + "star_salmon/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP2.junctionSaturation_plot.r", + "star_salmon/rseqc/junction_saturation/rscript/WT_REP1.junctionSaturation_plot.r", + "star_salmon/rseqc/junction_saturation/rscript/WT_REP2.junctionSaturation_plot.r", + "star_salmon/rseqc/read_distribution", + "star_salmon/rseqc/read_distribution/RAP1_IAA_30M_REP1.read_distribution.txt", + "star_salmon/rseqc/read_distribution/RAP1_UNINDUCED_REP1.read_distribution.txt", + "star_salmon/rseqc/read_distribution/RAP1_UNINDUCED_REP2.read_distribution.txt", + "star_salmon/rseqc/read_distribution/WT_REP1.read_distribution.txt", + "star_salmon/rseqc/read_distribution/WT_REP2.read_distribution.txt", + "star_salmon/rseqc/read_duplication", + "star_salmon/rseqc/read_duplication/pdf", + "star_salmon/rseqc/read_duplication/pdf/RAP1_IAA_30M_REP1.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP1.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP2.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/pdf/WT_REP1.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/pdf/WT_REP2.DupRate_plot.pdf", + "star_salmon/rseqc/read_duplication/rscript", + "star_salmon/rseqc/read_duplication/rscript/RAP1_IAA_30M_REP1.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP1.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP2.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/rscript/WT_REP1.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/rscript/WT_REP2.DupRate_plot.r", + "star_salmon/rseqc/read_duplication/xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.seq.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.seq.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.seq.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/WT_REP1.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/WT_REP1.seq.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/WT_REP2.pos.DupRate.xls", + "star_salmon/rseqc/read_duplication/xls/WT_REP2.seq.DupRate.xls", + "star_salmon/salmon.merged.gene_counts.SummarizedExperiment.rds", + "star_salmon/salmon.merged.gene_counts.tsv", + "star_salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", + "star_salmon/salmon.merged.gene_counts_length_scaled.tsv", + "star_salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", + "star_salmon/salmon.merged.gene_counts_scaled.tsv", + "star_salmon/salmon.merged.gene_lengths.tsv", + "star_salmon/salmon.merged.gene_tpm.tsv", + "star_salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds", + "star_salmon/salmon.merged.transcript_counts.tsv", + "star_salmon/salmon.merged.transcript_lengths.tsv", + "star_salmon/salmon.merged.transcript_tpm.tsv", + "star_salmon/samtools_stats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.flagstat", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.idxstats", + "star_salmon/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP1.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP1.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP1.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP1.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP2.markdup.sorted.bam.stats", + "star_salmon/samtools_stats/WT_REP2.sorted.bam.flagstat", + "star_salmon/samtools_stats/WT_REP2.sorted.bam.idxstats", + "star_salmon/samtools_stats/WT_REP2.sorted.bam.stats", + "star_salmon/stringtie", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e2t.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/e_data.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i2t.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/i_data.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.ballgown/t_data.ctab", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.coverage.gtf", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.gene.abundance.txt", + "star_salmon/stringtie/RAP1_IAA_30M_REP1.transcripts.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/e_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/i_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.ballgown/t_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.coverage.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.gene.abundance.txt", + "star_salmon/stringtie/RAP1_UNINDUCED_REP1.transcripts.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/e_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i2t.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/i_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.ballgown/t_data.ctab", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.coverage.gtf", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.gene.abundance.txt", + "star_salmon/stringtie/RAP1_UNINDUCED_REP2.transcripts.gtf", + "star_salmon/stringtie/WT_REP1.ballgown", + "star_salmon/stringtie/WT_REP1.ballgown/e2t.ctab", + "star_salmon/stringtie/WT_REP1.ballgown/e_data.ctab", + "star_salmon/stringtie/WT_REP1.ballgown/i2t.ctab", + "star_salmon/stringtie/WT_REP1.ballgown/i_data.ctab", + "star_salmon/stringtie/WT_REP1.ballgown/t_data.ctab", + "star_salmon/stringtie/WT_REP1.coverage.gtf", + "star_salmon/stringtie/WT_REP1.gene.abundance.txt", + "star_salmon/stringtie/WT_REP1.transcripts.gtf", + "star_salmon/stringtie/WT_REP2.ballgown", + "star_salmon/stringtie/WT_REP2.ballgown/e2t.ctab", + "star_salmon/stringtie/WT_REP2.ballgown/e_data.ctab", + "star_salmon/stringtie/WT_REP2.ballgown/i2t.ctab", + "star_salmon/stringtie/WT_REP2.ballgown/i_data.ctab", + "star_salmon/stringtie/WT_REP2.ballgown/t_data.ctab", + "star_salmon/stringtie/WT_REP2.coverage.gtf", + "star_salmon/stringtie/WT_REP2.gene.abundance.txt", + "star_salmon/stringtie/WT_REP2.transcripts.gtf", + "star_salmon/tx2gene.tsv" + ], + [ + "genome_gfp.fasta:md5,e23e302af63736a199985a169fdac055", + "genome_gfp.gtf:md5,c98b12c302f15731bfc36bcf297cfe28", + "fastqc-status-check-heatmap.txt:md5,5a89b0d8d162f6b1dbdaf39457bbc03b", + "fastqc_adapter_content_plot.txt:md5,da0389be84cfdd189b1d045212eb2974", + "fastqc_overrepresented_sequences_plot.txt:md5,25d88ea8a72f55e8a374ae802bc7f0b1", + "fastqc_per_base_n_content_plot.txt:md5,d368d7e36ca2f73dcde61f2b486d8213", + "fastqc_per_base_sequence_quality_plot.txt:md5,5c3065b549129702b185ea1b817da420", + "fastqc_per_sequence_gc_content_plot_Counts.txt:md5,9ddaa50167117d3c9188ccf015427704", + "fastqc_per_sequence_gc_content_plot_Percentages.txt:md5,f10ee2881b61308af35f304aa3d810a3", + "fastqc_per_sequence_quality_scores_plot.txt:md5,b5f9a02933e3065952237afd2ec9ce82", + "fastqc_sequence_counts_plot.txt:md5,d385a3e2c2573a0902c66e8c93876d3c", + "fastqc_sequence_duplication_levels_plot.txt:md5,8812cee16f6ca65e2c33635754de1772", + "multiqc_citations.txt:md5,1f80cefb6f0103d9a316c396a9441a90", + "multiqc_fastqc_fastqc_raw.txt:md5,81c3c1a2575a1891a7f2a9637a0f2cc0", + "multiqc_featurecounts_biotype_plot.txt:md5,567475905baa63091cfd0560fb297e10", + "multiqc_samtools_idxstats.txt:md5,adf5f32fa1485ad0f4dacdfedc7b4bbc", + "picard_histogram.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "picard_histogram_1.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "picard_histogram_2.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "qualimap_gene_coverage_profile_Counts.txt:md5,b16bc0437cb340aaf6fa1472888b6930", + "qualimap_gene_coverage_profile_Normalised.txt:md5,209b0020fcd4c3c497e3abbd1f8cd593", + "qualimap_rnaseq_cov_hist.txt:md5,3be7bc41531ce84b42092a742bfeb0ab", + "rseqc_infer_experiment_plot.txt:md5,382397ae264336395e2a3b03af8d7023", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt:md5,75acd04232d1804b5f960ee4c5db4722", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt:md5,ae45731d8d4595f77e6b271004f3a070", + "samtools-idxstats-mapped-reads-plot_Raw_Counts.txt:md5,a557130553131c893398532377d3b525", + "dupradar-section-plot.png:md5,5e5487f0e1f1521264462d5cb9ee9089", + "fastqc-status-check-heatmap.png:md5,fe8b5b4ab4480d46a12a9005932a9b84", + "fastqc_overrepresented_sequences_plot.png:md5,6f5ffbdf1bf61fabe5e028c8bc85de14", + "fastqc_per_sequence_gc_content_plot_Counts.png:md5,01f124545af788fd5cc7bbf41b005e16", + "fastqc_per_sequence_gc_content_plot_Percentages.png:md5,eba3abf8bedb2cb20bad90c54e9c8881", + "fastqc_per_sequence_quality_scores_plot.png:md5,42fd7369a8aca78f620164a9e887c3cb", + "fastqc_sequence_counts_plot-cnt.png:md5,3890d5555f2a39b46b9f6efb14cb91f2", + "fastqc_sequence_counts_plot-pct.png:md5,55fa5838c8b2db978fcfa5cb83f6b054", + "fastqc_sequence_duplication_levels_plot.png:md5,747431f0f38f8e4c41a11a072fa18780", + "featurecounts_biotype_plot-cnt.png:md5,dcb37b4ce2fff5ca2e22767b172e55a8", + "featurecounts_biotype_plot-pct.png:md5,b15370ba2c056815939251f820d9e2af", + "qualimap_gene_coverage_profile_Counts.png:md5,8312f777db61509caa66d1f53a4b6b07", + "qualimap_gene_coverage_profile_Normalised.png:md5,66acb12427130766801a8376f95ed88b", + "rseqc_infer_experiment_plot.png:md5,c3108e35020ee93a77a62ea0167613b2", + "rseqc_read_dups_plot.png:md5,1e43ad78c4a87f7736b552ad71d25c16", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png:md5,ce6abb232fd5b5f2e66c0fe9a571d75f", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png:md5,6b44818f886ef020fb3646f152ad4af6", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png:md5,d5d8a85b7ad72a0cb93d9283ea12b23f", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png:md5,19317ad8f1448cd7eb1d319f85cc5c4d", + "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png:md5,64f2501f91db6dd0edd5e49c0b9ca8b7", + "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png:md5,52f30fc3448f43735ce9eca54b306c8e", + "ambig_info.tsv:md5,e099a9ec06de792219139248712f7f40", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,1215f0c20f87d3aef8553ef119e1e74c", + "lib_format_counts.json:md5,406e1457f0f0506bd8e605a217477436", + "ambig_info.tsv:md5,0e0895adb376929bec8e0dd0677bf7d8", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,621c6601aade5b1f2e3d6ca2fc71f636", + "lib_format_counts.json:md5,afd2a0ddf0fd0ec4f99be898608a59db", + "ambig_info.tsv:md5,6ed1b46c69917d6af3f093f9503bb962", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,9bed6e4dc5428d6f6297adcea29a6326", + "lib_format_counts.json:md5,f7b7048fd2ac63fd792e71b85e4ed6d1", + "ambig_info.tsv:md5,2f4c6a5953e41252a89851a9a7c36d9b", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,c7ed0aaa5d6c7934ddbebfd29e4eb86d", + "lib_format_counts.json:md5,03f0b70a4bb428fab96c29f04f895b6f", + "ambig_info.tsv:md5,5fff63493bf3c223707ac90b9bb3a8f3", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,69ebfc2c7ca6b221a0a22fa1dc8c20ac", + "lib_format_counts.json:md5,4bf135c93c37f90c493f761f2709a28b", + "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", + "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", + "ambig_info.tsv:md5,d1d3bd2a5617220b29a9063cb29f0578", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,4cc2492f557e5e0a2911a0bd83a51020", + "ambig_info.tsv:md5,452bbc83465339d2467663b061400b95", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,dc750c3564c63da54979c852794d58a5", + "ambig_info.tsv:md5,f2aed38ba5251664024392bc89ae3f01", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,db43ed650e6e7b42cd2c5b8101bb6748", + "ambig_info.tsv:md5,8d2b5ec0c441d9e078610480d179d116", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,e418b4e899623449c6babdf53e5aabde", + "ambig_info.tsv:md5,44dad5d05b3c0c2ccb5a19a3a80333b3", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,f234c8d322df3b59d990594c63b24eae", + "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", + "RAP1_IAA_30M_REP1_dupMatrix.txt:md5,fdeebc4f056cbb52fee53e82c2e0096f", + "RAP1_UNINDUCED_REP1_dupMatrix.txt:md5,aa94a148bdbebec4e82cd18a00316506", + "RAP1_UNINDUCED_REP2_dupMatrix.txt:md5,bf065e266566c3fb96dc9319a3ed12cf", + "WT_REP1_dupMatrix.txt:md5,04512c8be70c1898d0262935ed5ec5bd", + "WT_REP2_dupMatrix.txt:md5,5052efd01f5086d394499b9c4626deb1", + "RAP1_IAA_30M_REP1_intercept_slope.txt:md5,7962ee6ba989f9af6465aaf1101ba13b", + "RAP1_UNINDUCED_REP1_intercept_slope.txt:md5,6c69ccc819c14847eef319b7fa8ccb4f", + "RAP1_UNINDUCED_REP2_intercept_slope.txt:md5,147b051de3f1e5c75821176851d13612", + "WT_REP1_intercept_slope.txt:md5,395cde13da1a90cf4378be2597c4f297", + "WT_REP2_intercept_slope.txt:md5,7ddae43baa3c4e499fbc319b95627c41", + "RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv:md5,27087a1c2e3cc2a0826818a04fe2647f", + "RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv:md5,dde2de0cb90e10d0195c726f768e9941", + "RAP1_IAA_30M_REP1.featureCounts.txt:md5,e8ec41e6e79f378e2f301e245a4f8e73", + "RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv:md5,2e1d531352e9ad5935308e588dbaffe7", + "RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv:md5,845ff9059c72bc6722a8de69776e22bb", + "RAP1_UNINDUCED_REP1.featureCounts.txt:md5,3afe2b0bcf265526c247016c32482314", + "RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv:md5,6fedc1d11bc8d558f61c4c4a6060040f", + "RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv:md5,6d3fa4c88c7fe61f638e4624ad5e22f0", + "RAP1_UNINDUCED_REP2.featureCounts.txt:md5,6fed16d5ab57aa762891fde0c3720160", + "WT_REP1.biotype_counts_mqc.tsv:md5,ddcf909eacd91a49cc4fd3beed0b74f4", + "WT_REP1.biotype_counts_rrna_mqc.tsv:md5,8ef76d717492ca23764938aee8ea33a9", + "WT_REP1.featureCounts.txt:md5,5155de67cf7537016c9ded607797f5c5", + "WT_REP2.biotype_counts_mqc.tsv:md5,d5d731cea7c5083a54069c1820101ba3", + "WT_REP2.biotype_counts_rrna_mqc.tsv:md5,12294618fe44df1e7f39348372dcb481", + "WT_REP2.featureCounts.txt:md5,94d2ccd74ec4338ddc8ad7bdbf297826", + "RAP1_IAA_30M_REP1.SJ.out.tab:md5,20c790387ef68e041bc4ffdcd032a22f", + "RAP1_UNINDUCED_REP1.SJ.out.tab:md5,ba2636236fa1d26aa72f7aff73bd41f8", + "RAP1_UNINDUCED_REP2.SJ.out.tab:md5,1c0458f66e4af56a56f4409c120434b3", + "WT_REP1.SJ.out.tab:md5,299a948b1aaf329152224ba573402a51", + "WT_REP2.SJ.out.tab:md5,073498a8fb5fb4da664c9129a6777c42", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,3a6e83a9a2e0e983b1191a622bfc8ef1", + "Coverage Profile Along Genes (Low).png:md5,1f075e71d4c281be2ecad16cf13f52bc", + "Coverage Profile Along Genes (Total).png:md5,f32d6ff38cfe4d01c6cbc917cb6e21c1", + "Transcript coverage histogram.png:md5,4e4a8d520a3018a888e5840936e9f4e0", + "coverage_profile_along_genes_(high).txt:md5,59a01cd5d9bc7b6096490d7f3d6d6877", + "coverage_profile_along_genes_(low).txt:md5,8a5255e6f9f142bbd22c636296f41d72", + "coverage_profile_along_genes_(total).txt:md5,8a5255e6f9f142bbd22c636296f41d72", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,a0efd6fc7c7c803a3b51e7fc4600ed98", + "Coverage Profile Along Genes (Low).png:md5,212d68ca87f5bc4c60ed04a33df126af", + "Coverage Profile Along Genes (Total).png:md5,a72b6252a3ece3fb911da724274eabae", + "Transcript coverage histogram.png:md5,1daabf214a2d2c32748834188c8bea5d", + "coverage_profile_along_genes_(high).txt:md5,61683a2fcf35174fe72a648be63d45ac", + "coverage_profile_along_genes_(low).txt:md5,031046ef33de379e0463fddc0b924ecd", + "coverage_profile_along_genes_(total).txt:md5,031046ef33de379e0463fddc0b924ecd", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,75dbf9d2b8bde265fdda486c050d5ff5", + "Coverage Profile Along Genes (Low).png:md5,8e792e6037158381a50e3668c54b7254", + "Coverage Profile Along Genes (Total).png:md5,beaf835a8aaf95df20815032a5f92622", + "Transcript coverage histogram.png:md5,6428ffa766e3c59ca42a9fb5e011d866", + "coverage_profile_along_genes_(high).txt:md5,2745780cc56258bbe587f9b6db03e9e4", + "coverage_profile_along_genes_(low).txt:md5,85154785601b18118ae2e6a19d0a1c0a", + "coverage_profile_along_genes_(total).txt:md5,85154785601b18118ae2e6a19d0a1c0a", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,6491fbf74a1444b98fdfe495b8c26a7f", + "Coverage Profile Along Genes (Low).png:md5,ee6b911d01b1cfbcebb5864a1f6f5fda", + "Coverage Profile Along Genes (Total).png:md5,f286514f978d5bcb9508a908068ff6c7", + "Transcript coverage histogram.png:md5,e925b300e71d23188aa45907e0754536", + "coverage_profile_along_genes_(high).txt:md5,6afb5ffc9ddad52f69c518e32118ac61", + "coverage_profile_along_genes_(low).txt:md5,248345fdf0f8de2a8d7d329edd0a5c42", + "coverage_profile_along_genes_(total).txt:md5,248345fdf0f8de2a8d7d329edd0a5c42", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,f9f0caee3156d32588c12daab8895a0f", + "Coverage Profile Along Genes (Low).png:md5,35ac4785ed0ffb80aaeec1fb26825f4b", + "Coverage Profile Along Genes (Total).png:md5,781cc1b68e9f7afc30a84b7e45b06f85", + "Transcript coverage histogram.png:md5,a4a300dc782deea67f18e516e0c50b3b", + "coverage_profile_along_genes_(high).txt:md5,f7c11dace9fc4f446fc29e5db7b3ee24", + "coverage_profile_along_genes_(low).txt:md5,f53cfe3e30c560e3261818c2e6df3d5d", + "coverage_profile_along_genes_(total).txt:md5,f53cfe3e30c560e3261818c2e6df3d5d", + "RAP1_IAA_30M_REP1.infer_experiment.txt:md5,e1de3aba230cf3d40f04d682dfe4e803", + "RAP1_UNINDUCED_REP1.infer_experiment.txt:md5,0bc268f09da1676522f8adda63509f14", + "RAP1_UNINDUCED_REP2.infer_experiment.txt:md5,be4b322faffa736ab6ac39ff39c7aa9d", + "WT_REP1.infer_experiment.txt:md5,7e8c79fa27780693523ad7acd8f109c4", + "WT_REP2.infer_experiment.txt:md5,c895dbd41b5a075ad4032e2732145b6a", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,9225250f729f9688c50718ad82989f4c", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,319f3eaf67c02b6198a4d746f8b11a44", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,1c69593079c7bff8b3e36b9d9aa616f9", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,db2e9c245b5db90551b83c799194113c", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,9628d551f88776248ace242ba43978e3", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,50d273bef261ddb395260dc74eff1a8b", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,9c0bf54804f5624b567481de8f5a5ae4", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,d92fcfde4016a15c3f54340e8637e554", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,3bddb4b7381a62a0104b7004e5b71f20", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,cd4c62717bb0a0db1a17e9c6d8788599", + "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe" + ] ], "meta": { "nf-test": "0.9.0", "nextflow": "24.04.4" }, - "timestamp": "2024-08-26T15:27:29.632524" - }, - "star_salmon/salmon_quant": { - "content": [ - "ambig_info.tsv:md5,d1d3bd2a5617220b29a9063cb29f0578", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,4cc2492f557e5e0a2911a0bd83a51020", - "ambig_info.tsv:md5,452bbc83465339d2467663b061400b95", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,dc750c3564c63da54979c852794d58a5", - "ambig_info.tsv:md5,f2aed38ba5251664024392bc89ae3f01", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,db43ed650e6e7b42cd2c5b8101bb6748", - "ambig_info.tsv:md5,8d2b5ec0c441d9e078610480d179d116", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,e418b4e899623449c6babdf53e5aabde", - "ambig_info.tsv:md5,44dad5d05b3c0c2ccb5a19a3a80333b3", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,f234c8d322df3b59d990594c63b24eae", - "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T15:27:31.038414" - }, - "multiqc_data": { - "content": [ - "fastqc-status-check-heatmap.txt:md5,5a89b0d8d162f6b1dbdaf39457bbc03b", - "fastqc_adapter_content_plot.txt:md5,da0389be84cfdd189b1d045212eb2974", - "fastqc_overrepresented_sequences_plot.txt:md5,25d88ea8a72f55e8a374ae802bc7f0b1", - "fastqc_per_base_n_content_plot.txt:md5,d368d7e36ca2f73dcde61f2b486d8213", - "fastqc_per_base_sequence_quality_plot.txt:md5,5c3065b549129702b185ea1b817da420", - "fastqc_per_sequence_gc_content_plot_Counts.txt:md5,9ddaa50167117d3c9188ccf015427704", - "fastqc_per_sequence_gc_content_plot_Percentages.txt:md5,f10ee2881b61308af35f304aa3d810a3", - "fastqc_per_sequence_quality_scores_plot.txt:md5,b5f9a02933e3065952237afd2ec9ce82", - "fastqc_sequence_counts_plot.txt:md5,d385a3e2c2573a0902c66e8c93876d3c", - "fastqc_sequence_duplication_levels_plot.txt:md5,8812cee16f6ca65e2c33635754de1772", - "multiqc_citations.txt:md5,1f80cefb6f0103d9a316c396a9441a90", - "multiqc_fastqc_fastqc_raw.txt:md5,81c3c1a2575a1891a7f2a9637a0f2cc0", - "multiqc_featurecounts_biotype_plot.txt:md5,567475905baa63091cfd0560fb297e10", - "multiqc_samtools_idxstats.txt:md5,adf5f32fa1485ad0f4dacdfedc7b4bbc", - "picard_histogram.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "picard_histogram_1.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "picard_histogram_2.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "qualimap_gene_coverage_profile_Counts.txt:md5,b16bc0437cb340aaf6fa1472888b6930", - "qualimap_gene_coverage_profile_Normalised.txt:md5,209b0020fcd4c3c497e3abbd1f8cd593", - "qualimap_rnaseq_cov_hist.txt:md5,3be7bc41531ce84b42092a742bfeb0ab", - "rseqc_infer_experiment_plot.txt:md5,382397ae264336395e2a3b03af8d7023", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt:md5,75acd04232d1804b5f960ee4c5db4722", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt:md5,ae45731d8d4595f77e6b271004f3a070", - "samtools-idxstats-mapped-reads-plot_Raw_Counts.txt:md5,a557130553131c893398532377d3b525", - "fastqc_top_overrepresented_sequences_table.txt", - "junction_saturation_known.txt", - "junction_saturation_novel.txt", - "multiqc_data.json", - "multiqc_dupradar-section-plot.txt", - "multiqc_fail_strand_check_table.txt", - "multiqc_general_stats.txt", - "multiqc_picard_dups.txt", - "multiqc_rseqc_bam_stat.txt", - "multiqc_rseqc_infer_experiment.txt", - "multiqc_rseqc_junction_annotation.txt", - "multiqc_rseqc_read_distribution.txt", - "multiqc_salmon.txt", - "multiqc_salmon_deseq2_clustering-plot.txt", - "multiqc_salmon_deseq2_clustering-plot_1.txt", - "multiqc_salmon_deseq2_clustering-plot_2.txt", - "multiqc_salmon_deseq2_clustering-plot_3.txt", - "multiqc_salmon_deseq2_clustering-plot_4.txt", - "multiqc_salmon_deseq2_pca-plot.txt", - "multiqc_samtools_flagstat.txt", - "multiqc_samtools_stats.txt", - "multiqc_software_versions.txt", - "multiqc_sources.txt", - "multiqc_star.txt", - "multiqc_star_salmon_deseq2_clustering-plot.txt", - "multiqc_star_salmon_deseq2_clustering-plot_1.txt", - "multiqc_star_salmon_deseq2_clustering-plot_2.txt", - "multiqc_star_salmon_deseq2_clustering-plot_3.txt", - "multiqc_star_salmon_deseq2_clustering-plot_4.txt", - "multiqc_star_salmon_deseq2_pca-plot.txt", - "picard_deduplication.txt", - "qualimap_genomic_origin.txt", - "qualimap_rnaseq_genome_results.txt", - "rseqc_bam_stat.txt", - "rseqc_inner_distance.txt", - "rseqc_inner_distance_plot_Counts.txt", - "rseqc_inner_distance_plot_Percentages.txt", - "rseqc_junction_annotation_junctions_plot_Events.txt", - "rseqc_junction_annotation_junctions_plot_Junctions.txt", - "rseqc_junction_saturation_all.txt", - "rseqc_junction_saturation_plot_All_Junctions.txt", - "rseqc_junction_saturation_plot_Known_Junctions.txt", - "rseqc_junction_saturation_plot_Novel_Junctions.txt", - "rseqc_read_distribution_plot.txt", - "rseqc_read_dups.txt", - "rseqc_read_dups_plot.txt", - "salmon_plot.txt", - "samtools-flagstat-dp_Percentage_of_total.txt", - "samtools-flagstat-dp_Read_counts.txt", - "samtools-stats-dp.txt", - "samtools_alignment_plot.txt", - "star_alignment_plot.txt", - "star_summary_table.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T19:36:32.752543" - }, - "star_salmon/rseqc": { - "content": [ - "RAP1_IAA_30M_REP1.infer_experiment.txt:md5,e1de3aba230cf3d40f04d682dfe4e803", - "RAP1_UNINDUCED_REP1.infer_experiment.txt:md5,0bc268f09da1676522f8adda63509f14", - "RAP1_UNINDUCED_REP2.infer_experiment.txt:md5,be4b322faffa736ab6ac39ff39c7aa9d", - "WT_REP1.infer_experiment.txt:md5,7e8c79fa27780693523ad7acd8f109c4", - "WT_REP2.infer_experiment.txt:md5,c895dbd41b5a075ad4032e2732145b6a", - "RAP1_IAA_30M_REP1.bam_stat.txt", - "RAP1_UNINDUCED_REP1.bam_stat.txt", - "RAP1_UNINDUCED_REP2.bam_stat.txt", - "WT_REP1.bam_stat.txt", - "WT_REP2.bam_stat.txt", - "RAP1_IAA_30M_REP1.inner_distance_plot.pdf", - "WT_REP1.inner_distance_plot.pdf", - "WT_REP2.inner_distance_plot.pdf", - "RAP1_IAA_30M_REP1.inner_distance_plot.r", - "WT_REP1.inner_distance_plot.r", - "WT_REP2.inner_distance_plot.r", - "RAP1_IAA_30M_REP1.inner_distance.txt", - "RAP1_IAA_30M_REP1.inner_distance_freq.txt", - "RAP1_IAA_30M_REP1.inner_distance_mean.txt", - "WT_REP1.inner_distance.txt", - "WT_REP1.inner_distance_freq.txt", - "WT_REP1.inner_distance_mean.txt", - "WT_REP2.inner_distance.txt", - "WT_REP2.inner_distance_freq.txt", - "WT_REP2.inner_distance_mean.txt", - "RAP1_IAA_30M_REP1.junction.Interact.bed", - "RAP1_IAA_30M_REP1.junction.bed", - "RAP1_UNINDUCED_REP1.junction.Interact.bed", - "RAP1_UNINDUCED_REP1.junction.bed", - "RAP1_UNINDUCED_REP2.junction.Interact.bed", - "RAP1_UNINDUCED_REP2.junction.bed", - "WT_REP1.junction.Interact.bed", - "WT_REP1.junction.bed", - "WT_REP2.junction.Interact.bed", - "WT_REP2.junction.bed", - "RAP1_IAA_30M_REP1.junction_annotation.log", - "RAP1_UNINDUCED_REP1.junction_annotation.log", - "RAP1_UNINDUCED_REP2.junction_annotation.log", - "WT_REP1.junction_annotation.log", - "WT_REP2.junction_annotation.log", - "RAP1_IAA_30M_REP1.splice_events.pdf", - "RAP1_IAA_30M_REP1.splice_junction.pdf", - "RAP1_UNINDUCED_REP1.splice_events.pdf", - "RAP1_UNINDUCED_REP1.splice_junction.pdf", - "RAP1_UNINDUCED_REP2.splice_events.pdf", - "RAP1_UNINDUCED_REP2.splice_junction.pdf", - "WT_REP1.splice_events.pdf", - "WT_REP1.splice_junction.pdf", - "WT_REP2.splice_events.pdf", - "WT_REP2.splice_junction.pdf", - "RAP1_IAA_30M_REP1.junction_plot.r", - "RAP1_UNINDUCED_REP1.junction_plot.r", - "RAP1_UNINDUCED_REP2.junction_plot.r", - "WT_REP1.junction_plot.r", - "WT_REP2.junction_plot.r", - "RAP1_IAA_30M_REP1.junction.xls", - "RAP1_UNINDUCED_REP1.junction.xls", - "RAP1_UNINDUCED_REP2.junction.xls", - "WT_REP1.junction.xls", - "WT_REP2.junction.xls", - "RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf", - "RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf", - "RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf", - "WT_REP1.junctionSaturation_plot.pdf", - "WT_REP2.junctionSaturation_plot.pdf", - "RAP1_IAA_30M_REP1.junctionSaturation_plot.r", - "RAP1_UNINDUCED_REP1.junctionSaturation_plot.r", - "RAP1_UNINDUCED_REP2.junctionSaturation_plot.r", - "WT_REP1.junctionSaturation_plot.r", - "WT_REP2.junctionSaturation_plot.r", - "RAP1_IAA_30M_REP1.read_distribution.txt", - "RAP1_UNINDUCED_REP1.read_distribution.txt", - "RAP1_UNINDUCED_REP2.read_distribution.txt", - "WT_REP1.read_distribution.txt", - "WT_REP2.read_distribution.txt", - "RAP1_IAA_30M_REP1.DupRate_plot.pdf", - "RAP1_UNINDUCED_REP1.DupRate_plot.pdf", - "RAP1_UNINDUCED_REP2.DupRate_plot.pdf", - "WT_REP1.DupRate_plot.pdf", - "WT_REP2.DupRate_plot.pdf", - "RAP1_IAA_30M_REP1.DupRate_plot.r", - "RAP1_UNINDUCED_REP1.DupRate_plot.r", - "RAP1_UNINDUCED_REP2.DupRate_plot.r", - "WT_REP1.DupRate_plot.r", - "WT_REP2.DupRate_plot.r", - "RAP1_IAA_30M_REP1.pos.DupRate.xls", - "RAP1_IAA_30M_REP1.seq.DupRate.xls", - "RAP1_UNINDUCED_REP1.pos.DupRate.xls", - "RAP1_UNINDUCED_REP1.seq.DupRate.xls", - "RAP1_UNINDUCED_REP2.pos.DupRate.xls", - "RAP1_UNINDUCED_REP2.seq.DupRate.xls", - "WT_REP1.pos.DupRate.xls", - "WT_REP1.seq.DupRate.xls", - "WT_REP2.pos.DupRate.xls", - "WT_REP2.seq.DupRate.xls" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T15:27:30.206514" - }, - "references": { - "content": [ - "genome_gfp.fasta:md5,e23e302af63736a199985a169fdac055", - "genome_gfp.gtf:md5,c98b12c302f15731bfc36bcf297cfe28" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T14:44:49.451362" - }, - "star_salmon/deseq2_qc": { - "content": [ - "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", - "RAP1_IAA_30M_REP1.txt", - "RAP1_UNINDUCED_REP1.txt", - "RAP1_UNINDUCED_REP2.txt", - "WT_REP1.txt", - "WT_REP2.txt", - "deseq2.size_factors.RData", - "deseq2.dds.RData", - "deseq2.pca.vals.txt", - "deseq2.plots.pdf", - "deseq2.sample.dists.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T15:27:29.135111" - }, - "star_salmon/markdup": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.bam", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.bai", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai", - "WT_REP1.markdup.sorted.bam", - "WT_REP1.markdup.sorted.bam.bai", - "WT_REP2.markdup.sorted.bam", - "WT_REP2.markdup.sorted.bam.bai" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T15:27:30.89199" - }, - "star_salmon/featurecounts": { - "content": [ - "RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv:md5,27087a1c2e3cc2a0826818a04fe2647f", - "RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv:md5,dde2de0cb90e10d0195c726f768e9941", - "RAP1_IAA_30M_REP1.featureCounts.txt:md5,e8ec41e6e79f378e2f301e245a4f8e73", - "RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv:md5,2e1d531352e9ad5935308e588dbaffe7", - "RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv:md5,845ff9059c72bc6722a8de69776e22bb", - "RAP1_UNINDUCED_REP1.featureCounts.txt:md5,3afe2b0bcf265526c247016c32482314", - "RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv:md5,6fedc1d11bc8d558f61c4c4a6060040f", - "RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv:md5,6d3fa4c88c7fe61f638e4624ad5e22f0", - "RAP1_UNINDUCED_REP2.featureCounts.txt:md5,6fed16d5ab57aa762891fde0c3720160", - "WT_REP1.biotype_counts_mqc.tsv:md5,ddcf909eacd91a49cc4fd3beed0b74f4", - "WT_REP1.biotype_counts_rrna_mqc.tsv:md5,8ef76d717492ca23764938aee8ea33a9", - "WT_REP1.featureCounts.txt:md5,5155de67cf7537016c9ded607797f5c5", - "WT_REP2.biotype_counts_mqc.tsv:md5,d5d731cea7c5083a54069c1820101ba3", - "WT_REP2.biotype_counts_rrna_mqc.tsv:md5,12294618fe44df1e7f39348372dcb481", - "WT_REP2.featureCounts.txt:md5,94d2ccd74ec4338ddc8ad7bdbf297826", - "RAP1_IAA_30M_REP1.featureCounts.txt.summary", - "RAP1_UNINDUCED_REP1.featureCounts.txt.summary", - "RAP1_UNINDUCED_REP2.featureCounts.txt.summary", - "WT_REP1.featureCounts.txt.summary", - "WT_REP2.featureCounts.txt.summary" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T15:27:29.457662" - }, - "star_salmon/samtools_stats": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.stats", - "RAP1_IAA_30M_REP1.sorted.bam.flagstat", - "RAP1_IAA_30M_REP1.sorted.bam.idxstats", - "RAP1_IAA_30M_REP1.sorted.bam.stats", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats", - "RAP1_UNINDUCED_REP1.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP1.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP1.sorted.bam.stats", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats", - "RAP1_UNINDUCED_REP2.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP2.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP2.sorted.bam.stats", - "WT_REP1.markdup.sorted.bam.flagstat", - "WT_REP1.markdup.sorted.bam.idxstats", - "WT_REP1.markdup.sorted.bam.stats", - "WT_REP1.sorted.bam.flagstat", - "WT_REP1.sorted.bam.idxstats", - "WT_REP1.sorted.bam.stats", - "WT_REP2.markdup.sorted.bam.flagstat", - "WT_REP2.markdup.sorted.bam.idxstats", - "WT_REP2.markdup.sorted.bam.stats", - "WT_REP2.sorted.bam.flagstat", - "WT_REP2.sorted.bam.idxstats", - "WT_REP2.sorted.bam.stats" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T19:36:32.899658" - }, - "salmon/deseq2_qc": { - "content": [ - "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", - "deseq2.dds.RData", - "deseq2.pca.vals.txt", - "deseq2.plots.pdf", - "deseq2.sample.dists.txt", - "RAP1_IAA_30M_REP1.txt", - "RAP1_UNINDUCED_REP1.txt", - "RAP1_UNINDUCED_REP2.txt", - "WT_REP1.txt", - "WT_REP2.txt", - "deseq2.size_factors.RData" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T15:27:28.510896" - }, - "salmon": { - "content": [ - "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", - "salmon.merged.gene_counts.SummarizedExperiment.rds", - "salmon.merged.gene_counts.tsv", - "salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_length_scaled.tsv", - "salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_scaled.tsv", - "salmon.merged.gene_lengths.tsv", - "salmon.merged.gene_tpm.tsv", - "salmon.merged.transcript_counts.SummarizedExperiment.rds", - "salmon.merged.transcript_counts.tsv", - "salmon.merged.transcript_lengths.tsv", - "salmon.merged.transcript_tpm.tsv" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T15:27:28.849468" - }, - "multiqc_plots": { - "content": [ - "dupradar-section-plot.png:md5,5e5487f0e1f1521264462d5cb9ee9089", - "fastqc-status-check-heatmap.png:md5,fe8b5b4ab4480d46a12a9005932a9b84", - "fastqc_overrepresented_sequences_plot.png:md5,6f5ffbdf1bf61fabe5e028c8bc85de14", - "fastqc_per_sequence_gc_content_plot_Counts.png:md5,01f124545af788fd5cc7bbf41b005e16", - "fastqc_per_sequence_gc_content_plot_Percentages.png:md5,eba3abf8bedb2cb20bad90c54e9c8881", - "fastqc_per_sequence_quality_scores_plot.png:md5,42fd7369a8aca78f620164a9e887c3cb", - "fastqc_sequence_counts_plot-cnt.png:md5,3890d5555f2a39b46b9f6efb14cb91f2", - "fastqc_sequence_counts_plot-pct.png:md5,55fa5838c8b2db978fcfa5cb83f6b054", - "fastqc_sequence_duplication_levels_plot.png:md5,747431f0f38f8e4c41a11a072fa18780", - "featurecounts_biotype_plot-cnt.png:md5,dcb37b4ce2fff5ca2e22767b172e55a8", - "featurecounts_biotype_plot-pct.png:md5,b15370ba2c056815939251f820d9e2af", - "qualimap_gene_coverage_profile_Counts.png:md5,8312f777db61509caa66d1f53a4b6b07", - "qualimap_gene_coverage_profile_Normalised.png:md5,66acb12427130766801a8376f95ed88b", - "rseqc_infer_experiment_plot.png:md5,c3108e35020ee93a77a62ea0167613b2", - "rseqc_read_dups_plot.png:md5,1e43ad78c4a87f7736b552ad71d25c16", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png:md5,ce6abb232fd5b5f2e66c0fe9a571d75f", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png:md5,6b44818f886ef020fb3646f152ad4af6", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png:md5,d5d8a85b7ad72a0cb93d9283ea12b23f", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png:md5,19317ad8f1448cd7eb1d319f85cc5c4d", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png:md5,64f2501f91db6dd0edd5e49c0b9ca8b7", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png:md5,52f30fc3448f43735ce9eca54b306c8e", - "multiqc_report.html", - "dupradar-section-plot.pdf", - "fail_strand_check_table.pdf", - "fastqc-status-check-heatmap.pdf", - "fastqc_adapter_content_plot.pdf", - "fastqc_overrepresented_sequences_plot.pdf", - "fastqc_per_base_n_content_plot.pdf", - "fastqc_per_base_sequence_quality_plot.pdf", - "fastqc_per_sequence_gc_content_plot_Counts.pdf", - "fastqc_per_sequence_gc_content_plot_Percentages.pdf", - "fastqc_per_sequence_quality_scores_plot.pdf", - "fastqc_sequence_counts_plot-cnt.pdf", - "fastqc_sequence_counts_plot-pct.pdf", - "fastqc_sequence_duplication_levels_plot.pdf", - "fastqc_top_overrepresented_sequences_table.pdf", - "featurecounts_biotype_plot-cnt.pdf", - "featurecounts_biotype_plot-pct.pdf", - "general_stats_table.pdf", - "picard_deduplication-cnt.pdf", - "picard_deduplication-pct.pdf", - "qualimap_gene_coverage_profile_Counts.pdf", - "qualimap_gene_coverage_profile_Normalised.pdf", - "qualimap_genomic_origin-cnt.pdf", - "qualimap_genomic_origin-pct.pdf", - "rseqc_bam_stat.pdf", - "rseqc_infer_experiment_plot.pdf", - "rseqc_inner_distance_plot_Counts.pdf", - "rseqc_inner_distance_plot_Percentages.pdf", - "rseqc_junction_annotation_junctions_plot_Events-cnt.pdf", - "rseqc_junction_annotation_junctions_plot_Events-pct.pdf", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf", - "rseqc_junction_saturation_plot_All_Junctions.pdf", - "rseqc_junction_saturation_plot_Known_Junctions.pdf", - "rseqc_junction_saturation_plot_Novel_Junctions.pdf", - "rseqc_read_distribution_plot-cnt.pdf", - "rseqc_read_distribution_plot-pct.pdf", - "rseqc_read_dups_plot.pdf", - "salmon_deseq2_clustering-plot.pdf", - "salmon_deseq2_pca-plot.pdf", - "salmon_plot.pdf", - "samtools-flagstat-dp_Percentage_of_total.pdf", - "samtools-flagstat-dp_Read_counts.pdf", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf", - "samtools-stats-dp.pdf", - "samtools_alignment_plot-cnt.pdf", - "samtools_alignment_plot-pct.pdf", - "star_alignment_plot-cnt.pdf", - "star_alignment_plot-pct.pdf", - "star_salmon_deseq2_clustering-plot.pdf", - "star_salmon_deseq2_pca-plot.pdf", - "star_summary_table.pdf", - "fail_strand_check_table.png", - "fastqc_adapter_content_plot.png", - "fastqc_per_base_n_content_plot.png", - "fastqc_per_base_sequence_quality_plot.png", - "fastqc_top_overrepresented_sequences_table.png", - "general_stats_table.png", - "picard_deduplication-cnt.png", - "picard_deduplication-pct.png", - "qualimap_genomic_origin-cnt.png", - "qualimap_genomic_origin-pct.png", - "rseqc_bam_stat.png", - "rseqc_inner_distance_plot_Counts.png", - "rseqc_inner_distance_plot_Percentages.png", - "rseqc_junction_annotation_junctions_plot_Events-cnt.png", - "rseqc_junction_annotation_junctions_plot_Events-pct.png", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.png", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.png", - "rseqc_junction_saturation_plot_All_Junctions.png", - "rseqc_junction_saturation_plot_Known_Junctions.png", - "rseqc_junction_saturation_plot_Novel_Junctions.png", - "rseqc_read_distribution_plot-cnt.png", - "rseqc_read_distribution_plot-pct.png", - "salmon_deseq2_clustering-plot.png", - "salmon_deseq2_pca-plot.png", - "salmon_plot.png", - "samtools-flagstat-dp_Percentage_of_total.png", - "samtools-flagstat-dp_Read_counts.png", - "samtools-stats-dp.png", - "samtools_alignment_plot-cnt.png", - "samtools_alignment_plot-pct.png", - "star_alignment_plot-cnt.png", - "star_alignment_plot-pct.png", - "star_salmon_deseq2_clustering-plot.png", - "star_salmon_deseq2_pca-plot.png", - "star_summary_table.png", - "dupradar-section-plot.svg", - "fail_strand_check_table.svg", - "fastqc-status-check-heatmap.svg", - "fastqc_adapter_content_plot.svg", - "fastqc_overrepresented_sequences_plot.svg", - "fastqc_per_base_n_content_plot.svg", - "fastqc_per_base_sequence_quality_plot.svg", - "fastqc_per_sequence_gc_content_plot_Counts.svg", - "fastqc_per_sequence_gc_content_plot_Percentages.svg", - "fastqc_per_sequence_quality_scores_plot.svg", - "fastqc_sequence_counts_plot-cnt.svg", - "fastqc_sequence_counts_plot-pct.svg", - "fastqc_sequence_duplication_levels_plot.svg", - "fastqc_top_overrepresented_sequences_table.svg", - "featurecounts_biotype_plot-cnt.svg", - "featurecounts_biotype_plot-pct.svg", - "general_stats_table.svg", - "picard_deduplication-cnt.svg", - "picard_deduplication-pct.svg", - "qualimap_gene_coverage_profile_Counts.svg", - "qualimap_gene_coverage_profile_Normalised.svg", - "qualimap_genomic_origin-cnt.svg", - "qualimap_genomic_origin-pct.svg", - "rseqc_bam_stat.svg", - "rseqc_infer_experiment_plot.svg", - "rseqc_inner_distance_plot_Counts.svg", - "rseqc_inner_distance_plot_Percentages.svg", - "rseqc_junction_annotation_junctions_plot_Events-cnt.svg", - "rseqc_junction_annotation_junctions_plot_Events-pct.svg", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.svg", - "rseqc_junction_saturation_plot_All_Junctions.svg", - "rseqc_junction_saturation_plot_Known_Junctions.svg", - "rseqc_junction_saturation_plot_Novel_Junctions.svg", - "rseqc_read_distribution_plot-cnt.svg", - "rseqc_read_distribution_plot-pct.svg", - "rseqc_read_dups_plot.svg", - "salmon_deseq2_clustering-plot.svg", - "salmon_deseq2_pca-plot.svg", - "salmon_plot.svg", - "samtools-flagstat-dp_Percentage_of_total.svg", - "samtools-flagstat-dp_Read_counts.svg", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg", - "samtools-stats-dp.svg", - "samtools_alignment_plot-cnt.svg", - "samtools_alignment_plot-pct.svg", - "star_alignment_plot-cnt.svg", - "star_alignment_plot-pct.svg", - "star_salmon_deseq2_clustering-plot.svg", - "star_salmon_deseq2_pca-plot.svg", - "star_summary_table.svg" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T19:36:32.816392" - }, - "star_salmon/picard_metrics": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt", - "WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T15:27:29.813744" - }, - "star_salmon/salmon": { - "content": [ - "salmon.merged.gene_counts.SummarizedExperiment.rds", - "salmon.merged.gene_counts.tsv", - "salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_length_scaled.tsv", - "salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_scaled.tsv", - "salmon.merged.gene_lengths.tsv", - "salmon.merged.gene_tpm.tsv", - "salmon.merged.transcript_counts.SummarizedExperiment.rds", - "salmon.merged.transcript_counts.tsv", - "salmon.merged.transcript_lengths.tsv", - "salmon.merged.transcript_tpm.tsv" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T15:27:30.405348" - }, - "fastqc/raw": { - "content": [ - "RAP1_IAA_30M_REP1_raw_1_fastqc.html", - "RAP1_IAA_30M_REP1_raw_1_fastqc.zip", - "RAP1_IAA_30M_REP1_raw_2_fastqc.html", - "RAP1_IAA_30M_REP1_raw_2_fastqc.zip", - "RAP1_UNINDUCED_REP1_raw_fastqc.html", - "RAP1_UNINDUCED_REP1_raw_fastqc.zip", - "RAP1_UNINDUCED_REP2_raw_fastqc.html", - "RAP1_UNINDUCED_REP2_raw_fastqc.zip", - "WT_REP1_raw_1_fastqc.html", - "WT_REP1_raw_1_fastqc.zip", - "WT_REP1_raw_2_fastqc.html", - "WT_REP1_raw_2_fastqc.zip", - "WT_REP2_raw_1_fastqc.html", - "WT_REP2_raw_1_fastqc.zip", - "WT_REP2_raw_2_fastqc.html", - "WT_REP2_raw_2_fastqc.zip" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T14:44:49.461839" - }, - "star_salmon/bigwig": { - "content": [ - "RAP1_IAA_30M_REP1.forward.bigWig", - "RAP1_IAA_30M_REP1.reverse.bigWig", - "RAP1_UNINDUCED_REP1.forward.bigWig", - "RAP1_UNINDUCED_REP1.reverse.bigWig", - "RAP1_UNINDUCED_REP2.forward.bigWig", - "RAP1_UNINDUCED_REP2.reverse.bigWig", - "WT_REP1.forward.bigWig", - "WT_REP1.reverse.bigWig", - "WT_REP2.forward.bigWig", - "WT_REP2.reverse.bigWig" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T15:27:28.99559" - }, - "star_salmon/stringtie": { - "content": [ - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,9225250f729f9688c50718ad82989f4c", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,319f3eaf67c02b6198a4d746f8b11a44", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,1c69593079c7bff8b3e36b9d9aa616f9", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,db2e9c245b5db90551b83c799194113c", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,9628d551f88776248ace242ba43978e3", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,50d273bef261ddb395260dc74eff1a8b", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,9c0bf54804f5624b567481de8f5a5ae4", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,d92fcfde4016a15c3f54340e8637e554", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,3bddb4b7381a62a0104b7004e5b71f20", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,cd4c62717bb0a0db1a17e9c6d8788599", - "t_data.ctab", - "RAP1_IAA_30M_REP1.coverage.gtf", - "RAP1_IAA_30M_REP1.gene.abundance.txt", - "RAP1_IAA_30M_REP1.transcripts.gtf", - "t_data.ctab", - "RAP1_UNINDUCED_REP1.coverage.gtf", - "RAP1_UNINDUCED_REP1.gene.abundance.txt", - "RAP1_UNINDUCED_REP1.transcripts.gtf", - "t_data.ctab", - "RAP1_UNINDUCED_REP2.coverage.gtf", - "RAP1_UNINDUCED_REP2.gene.abundance.txt", - "RAP1_UNINDUCED_REP2.transcripts.gtf", - "t_data.ctab", - "WT_REP1.coverage.gtf", - "WT_REP1.gene.abundance.txt", - "WT_REP1.transcripts.gtf", - "t_data.ctab", - "WT_REP2.coverage.gtf", - "WT_REP2.gene.abundance.txt", - "WT_REP2.transcripts.gtf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T15:27:30.738255" - }, - "versions": { - "content": [ - "{BBMAP_BBSPLIT={bbmap=39.01}, BEDTOOLS_GENOMECOV_FW={bedtools=2.31.1}, CAT_FASTQ={cat=8.3}, CUSTOM_CATADDITIONALFASTA={python=3.9.5}, CUSTOM_GETCHROMSIZES={getchromsizes=1.2}, CUSTOM_TX2GENE={python=3.9.5}, DESEQ2_QC_PSEUDO={r-base=4.0.3, bioconductor-deseq2=1.28.0}, DESEQ2_QC_STAR_SALMON={r-base=4.0.3, bioconductor-deseq2=1.28.0}, DUPRADAR={bioconductor-dupradar=1.32.0}, FASTQC={fastqc=0.12.1}, FQ_SUBSAMPLE={fq=0.9.1 (2022-02-22)}, GTF2BED={perl=5.26.2}, GTF_FILTER={python=3.9.5}, GUNZIP_ADDITIONAL_FASTA={gunzip=1.1}, GUNZIP_GTF={gunzip=1.1}, MULTIQC_CUSTOM_BIOTYPE={python=3.9.5}, PICARD_MARKDUPLICATES={picard=3.1.1}, QUALIMAP_RNASEQ={qualimap=2.3}, RSEQC_BAMSTAT={rseqc=5.0.2}, RSEQC_INFEREXPERIMENT={rseqc=5.0.2}, RSEQC_INNERDISTANCE={rseqc=5.0.2}, RSEQC_JUNCTIONANNOTATION={rseqc=5.0.2}, RSEQC_JUNCTIONSATURATION={rseqc=5.0.2}, RSEQC_READDISTRIBUTION={rseqc=5.0.2}, RSEQC_READDUPLICATION={rseqc=5.0.2}, SALMON_QUANT={salmon=1.10.1}, SAMTOOLS_FLAGSTAT={samtools=1.2}, SAMTOOLS_IDXSTATS={samtools=1.2}, SAMTOOLS_INDEX={samtools=1.2}, SAMTOOLS_SORT={samtools=1.2}, SAMTOOLS_STATS={samtools=1.2}, SE_GENE={bioconductor-summarizedexperiment=1.32.0}, STAR_ALIGN={star=2.7.10a, samtools=1.18, gawk=5.1.0}, STAR_GENOMEGENERATE={star=2.7.10a, samtools=1.18, gawk=5.1.0}, STRINGTIE_STRINGTIE={stringtie=2.2.1}, SUBREAD_FEATURECOUNTS={subread=2.0.1}, TXIMETA_TXIMPORT={bioconductor-tximeta=1.20.1}, UCSC_BEDCLIP={ucsc=377}, UCSC_BEDGRAPHTOBIGWIG={ucsc=445}, UNTAR_SALMON_INDEX={untar=1.34}, Workflow={nf-core/rnaseq=v3.16.0dev}}" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T15:27:31.618005" - }, - "star_salmon/dupradar": { - "content": [ - "RAP1_IAA_30M_REP1_dupMatrix.txt:md5,fdeebc4f056cbb52fee53e82c2e0096f", - "RAP1_UNINDUCED_REP1_dupMatrix.txt:md5,aa94a148bdbebec4e82cd18a00316506", - "RAP1_UNINDUCED_REP2_dupMatrix.txt:md5,bf065e266566c3fb96dc9319a3ed12cf", - "WT_REP1_dupMatrix.txt:md5,04512c8be70c1898d0262935ed5ec5bd", - "WT_REP2_dupMatrix.txt:md5,5052efd01f5086d394499b9c4626deb1", - "RAP1_IAA_30M_REP1_intercept_slope.txt:md5,7962ee6ba989f9af6465aaf1101ba13b", - "RAP1_UNINDUCED_REP1_intercept_slope.txt:md5,6c69ccc819c14847eef319b7fa8ccb4f", - "RAP1_UNINDUCED_REP2_intercept_slope.txt:md5,147b051de3f1e5c75821176851d13612", - "WT_REP1_intercept_slope.txt:md5,395cde13da1a90cf4378be2597c4f297", - "WT_REP2_intercept_slope.txt:md5,7ddae43baa3c4e499fbc319b95627c41", - "RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf", - "RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf", - "RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf", - "WT_REP1_duprateExpBoxplot.pdf", - "WT_REP2_duprateExpBoxplot.pdf", - "RAP1_IAA_30M_REP1_expressionHist.pdf", - "RAP1_UNINDUCED_REP1_expressionHist.pdf", - "RAP1_UNINDUCED_REP2_expressionHist.pdf", - "WT_REP1_expressionHist.pdf", - "WT_REP2_expressionHist.pdf", - "RAP1_IAA_30M_REP1_duprateExpDens.pdf", - "RAP1_UNINDUCED_REP1_duprateExpDens.pdf", - "RAP1_UNINDUCED_REP2_duprateExpDens.pdf", - "WT_REP1_duprateExpDens.pdf", - "WT_REP2_duprateExpDens.pdf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T15:27:29.283253" - }, - "bbsplit": { - "content": [ - "RAP1_IAA_30M_REP1.stats.txt", - "RAP1_UNINDUCED_REP1.stats.txt", - "RAP1_UNINDUCED_REP2.stats.txt", - "WT_REP1.stats.txt", - "WT_REP2.stats.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T14:44:49.441331" - }, - "salmon_quant": { - "content": [ - "ambig_info.tsv:md5,e099a9ec06de792219139248712f7f40", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,1215f0c20f87d3aef8553ef119e1e74c", - "lib_format_counts.json:md5,406e1457f0f0506bd8e605a217477436", - "ambig_info.tsv:md5,0e0895adb376929bec8e0dd0677bf7d8", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,621c6601aade5b1f2e3d6ca2fc71f636", - "lib_format_counts.json:md5,afd2a0ddf0fd0ec4f99be898608a59db", - "ambig_info.tsv:md5,6ed1b46c69917d6af3f093f9503bb962", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,9bed6e4dc5428d6f6297adcea29a6326", - "lib_format_counts.json:md5,f7b7048fd2ac63fd792e71b85e4ed6d1", - "ambig_info.tsv:md5,2f4c6a5953e41252a89851a9a7c36d9b", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,c7ed0aaa5d6c7934ddbebfd29e4eb86d", - "lib_format_counts.json:md5,03f0b70a4bb428fab96c29f04f895b6f", - "ambig_info.tsv:md5,5fff63493bf3c223707ac90b9bb3a8f3", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,69ebfc2c7ca6b221a0a22fa1dc8c20ac", - "lib_format_counts.json:md5,4bf135c93c37f90c493f761f2709a28b", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T15:27:28.672506" - }, - "star_salmon/qualimap": { - "content": [ - "Coverage Profile Along Genes (High).png:md5,3a6e83a9a2e0e983b1191a622bfc8ef1", - "Coverage Profile Along Genes (Low).png:md5,1f075e71d4c281be2ecad16cf13f52bc", - "Coverage Profile Along Genes (Total).png:md5,f32d6ff38cfe4d01c6cbc917cb6e21c1", - "Transcript coverage histogram.png:md5,4e4a8d520a3018a888e5840936e9f4e0", - "coverage_profile_along_genes_(high).txt:md5,59a01cd5d9bc7b6096490d7f3d6d6877", - "coverage_profile_along_genes_(low).txt:md5,8a5255e6f9f142bbd22c636296f41d72", - "coverage_profile_along_genes_(total).txt:md5,8a5255e6f9f142bbd22c636296f41d72", - "Coverage Profile Along Genes (High).png:md5,a0efd6fc7c7c803a3b51e7fc4600ed98", - "Coverage Profile Along Genes (Low).png:md5,212d68ca87f5bc4c60ed04a33df126af", - "Coverage Profile Along Genes (Total).png:md5,a72b6252a3ece3fb911da724274eabae", - "Transcript coverage histogram.png:md5,1daabf214a2d2c32748834188c8bea5d", - "coverage_profile_along_genes_(high).txt:md5,61683a2fcf35174fe72a648be63d45ac", - "coverage_profile_along_genes_(low).txt:md5,031046ef33de379e0463fddc0b924ecd", - "coverage_profile_along_genes_(total).txt:md5,031046ef33de379e0463fddc0b924ecd", - "Coverage Profile Along Genes (High).png:md5,75dbf9d2b8bde265fdda486c050d5ff5", - "Coverage Profile Along Genes (Low).png:md5,8e792e6037158381a50e3668c54b7254", - "Coverage Profile Along Genes (Total).png:md5,beaf835a8aaf95df20815032a5f92622", - "Transcript coverage histogram.png:md5,6428ffa766e3c59ca42a9fb5e011d866", - "coverage_profile_along_genes_(high).txt:md5,2745780cc56258bbe587f9b6db03e9e4", - "coverage_profile_along_genes_(low).txt:md5,85154785601b18118ae2e6a19d0a1c0a", - "coverage_profile_along_genes_(total).txt:md5,85154785601b18118ae2e6a19d0a1c0a", - "Coverage Profile Along Genes (High).png:md5,6491fbf74a1444b98fdfe495b8c26a7f", - "Coverage Profile Along Genes (Low).png:md5,ee6b911d01b1cfbcebb5864a1f6f5fda", - "Coverage Profile Along Genes (Total).png:md5,f286514f978d5bcb9508a908068ff6c7", - "Transcript coverage histogram.png:md5,e925b300e71d23188aa45907e0754536", - "coverage_profile_along_genes_(high).txt:md5,6afb5ffc9ddad52f69c518e32118ac61", - "coverage_profile_along_genes_(low).txt:md5,248345fdf0f8de2a8d7d329edd0a5c42", - "coverage_profile_along_genes_(total).txt:md5,248345fdf0f8de2a8d7d329edd0a5c42", - "Coverage Profile Along Genes (High).png:md5,f9f0caee3156d32588c12daab8895a0f", - "Coverage Profile Along Genes (Low).png:md5,35ac4785ed0ffb80aaeec1fb26825f4b", - "Coverage Profile Along Genes (Total).png:md5,781cc1b68e9f7afc30a84b7e45b06f85", - "Transcript coverage histogram.png:md5,a4a300dc782deea67f18e516e0c50b3b", - "coverage_profile_along_genes_(high).txt:md5,f7c11dace9fc4f446fc29e5db7b3ee24", - "coverage_profile_along_genes_(low).txt:md5,f53cfe3e30c560e3261818c2e6df3d5d", - "coverage_profile_along_genes_(total).txt:md5,f53cfe3e30c560e3261818c2e6df3d5d", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T15:27:29.998661" + "timestamp": "2024-10-02T08:24:30.328195" } } \ No newline at end of file diff --git a/tests/star_rsem.nf.test b/tests/star_rsem.nf.test index 0f03bc6db..268a1fabb 100644 --- a/tests/star_rsem.nf.test +++ b/tests/star_rsem.nf.test @@ -13,864 +13,22 @@ nextflow_pipeline { } then { + // stable_name: All files + folders in ${params.outdir}/ with a stable name + def stable_name = getAllFilesFromDir(params.outdir, true, ['pipeline_info/*.{html,json,txt}'], null) + // stable_path: All files in ${params.outdir}/ with stable content + def stable_path = getAllFilesFromDir(params.outdir, false, null, 'tests/.nftignore') assertAll( - { assert workflow.success }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/bbsplit/RAP1_IAA_30M_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/RAP1_UNINDUCED_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/RAP1_UNINDUCED_REP2.stats.txt").name, - file("${params.outdir}/bbsplit/WT_REP1.stats.txt").name, - file("${params.outdir}/bbsplit/WT_REP2.stats.txt").name - ).match("bbsplit") }, - { assert snapshot( - path("${params.outdir}/custom/out/genome_gfp.fasta"), - path("${params.outdir}/custom/out/genome_gfp.gtf") - ).match("references") }, - { assert snapshot( - // HTMLs and ZIPs are not stable - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw_2_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_1_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_1_fastqc.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_2_fastqc.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw_2_fastqc.zip").name - ).match("fastqc/raw") }, - { assert snapshot( - // HTMLs and ZIPs are not stable - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html").name, - file("${params.outdir}/fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.zip").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.html").name, - file("${params.outdir}/fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.zip").name - ).match("fastqc/trim") }, - { assert snapshot( - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/cutadapt_filtered_reads_plot.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Counts.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc-status-check-heatmap-1.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc-status-check-heatmap.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc_adapter_content_plot.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc_overrepresented_sequences_plot-1.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc_overrepresented_sequences_plot.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc_per_base_n_content_plot-1.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc_per_base_n_content_plot.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc_per_base_sequence_quality_plot-1.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc_per_base_sequence_quality_plot.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Counts.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Percentages.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Counts.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Percentages.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc_per_sequence_quality_scores_plot-1.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc_per_sequence_quality_scores_plot.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc_sequence_counts_plot-1.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc_sequence_counts_plot.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc_sequence_duplication_levels_plot-1.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc_sequence_duplication_levels_plot.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc_sequence_length_distribution_plot.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_citations.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_cutadapt.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_fastqc_fastqc_raw.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_fastqc_fastqc_trimmed.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_featurecounts_biotype_plot.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_samtools_idxstats.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/picard_histogram.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/picard_histogram_1.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/picard_histogram_2.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/qualimap_gene_coverage_profile_Counts.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/qualimap_gene_coverage_profile_Normalised.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/qualimap_rnaseq_cov_hist.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/rseqc_infer_experiment_plot.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Raw_Counts.txt"), - // These files are not stable - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc_top_overrepresented_sequences_table-1.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/fastqc_top_overrepresented_sequences_table.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/junction_saturation_known.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/junction_saturation_novel.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_data.json").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_dupradar-section-plot.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_fail_strand_check_table.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_general_stats.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_picard_dups.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/picard_deduplication.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_rsem.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_rseqc_bam_stat.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_rseqc_infer_experiment.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_rseqc_junction_annotation.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_rseqc_read_distribution.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_salmon.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_1.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_2.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_3.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_4.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_salmon_deseq2_pca-plot.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_samtools_flagstat.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_samtools_stats.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_software_versions.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_sources.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_star.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_star_rsem_deseq2_clustering-plot.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_star_rsem_deseq2_clustering-plot_1.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_star_rsem_deseq2_clustering-plot_2.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_star_rsem_deseq2_clustering-plot_3.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_star_rsem_deseq2_clustering-plot_4.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/multiqc_star_rsem_deseq2_pca-plot.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/qualimap_genomic_origin.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/qualimap_rnaseq_genome_results.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/rsem_assignment_plot.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/rsem_multimapping_rates.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/rseqc_bam_stat.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/rseqc_inner_distance.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/rseqc_inner_distance_plot_Counts.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/rseqc_inner_distance_plot_Percentages.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Events.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Junctions.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/rseqc_junction_saturation_all.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/rseqc_junction_saturation_plot_All_Junctions.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/rseqc_junction_saturation_plot_Known_Junctions.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/rseqc_junction_saturation_plot_Novel_Junctions.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/rseqc_read_distribution_plot.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/rseqc_read_dups.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/rseqc_read_dups_plot.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/salmon_plot.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/samtools-flagstat-dp_Percentage_of_total.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/samtools-flagstat-dp_Read_counts.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/samtools-stats-dp.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/samtools_alignment_plot.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/star_alignment_plot.txt").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_data/star_summary_table.txt").name - ).match("multiqc_data") }, - { assert snapshot( - - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/cutadapt_filtered_reads_plot-cnt.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/cutadapt_filtered_reads_plot-pct.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Counts.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Obs_Exp.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/dupradar-section-plot.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc-status-check-heatmap-1.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc-status-check-heatmap.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot-1.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Counts.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Percentages.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Counts.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Percentages.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot-1.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-cnt.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-pct.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_sequence_counts_plot-cnt.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_sequence_counts_plot-pct.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot-1.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/featurecounts_biotype_plot-cnt.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/featurecounts_biotype_plot-pct.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/qualimap_gene_coverage_profile_Counts.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/qualimap_gene_coverage_profile_Normalised.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/rsem_multimapping_rates.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/rseqc_infer_experiment_plot.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/rseqc_read_dups_plot.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png"), - path("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png"), - // PDFs, SVGs, some PNGs and HTML reports are not stable - file("${params.outdir}/multiqc/star_rsem/multiqc_report.html").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Counts.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/dupradar-section-plot.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fail_strand_check_table.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc-status-check-heatmap-1.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc-status-check-heatmap.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_adapter_content_plot.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Counts.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Percentages.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Counts.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Percentages.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-cnt.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-pct.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot-1.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_sequence_length_distribution_plot.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table-1.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/featurecounts_biotype_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/featurecounts_biotype_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/general_stats_table.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/picard_deduplication-cnt.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/picard_deduplication-pct.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Counts.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Normalised.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/qualimap_genomic_origin-cnt.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/qualimap_genomic_origin-pct.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/rsem_assignment_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/rsem_assignment_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/rsem_multimapping_rates.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_bam_stat.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_infer_experiment_plot.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Counts.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Percentages.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-cnt.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-pct.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_All_Junctions.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Known_Junctions.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Novel_Junctions.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_read_distribution_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_read_distribution_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_read_dups_plot.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/salmon_deseq2_clustering-plot.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/salmon_deseq2_pca-plot.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/salmon_plot.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/samtools-flagstat-dp_Percentage_of_total.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/samtools-flagstat-dp_Read_counts.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/samtools-stats-dp.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/samtools_alignment_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/samtools_alignment_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/star_alignment_plot-cnt.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/star_alignment_plot-pct.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/star_rsem_deseq2_clustering-plot.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/star_rsem_deseq2_pca-plot.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/pdf/star_summary_table.pdf").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fail_strand_check_table.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_adapter_content_plot.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_per_base_n_content_plot-1.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_per_base_n_content_plot.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot-1.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_sequence_length_distribution_plot.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table-1.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/general_stats_table.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/picard_deduplication-cnt.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/picard_deduplication-pct.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/qualimap_genomic_origin-cnt.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/qualimap_genomic_origin-pct.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/rsem_assignment_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/rsem_assignment_plot-pct.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/rseqc_bam_stat.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/rseqc_inner_distance_plot_Counts.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/rseqc_inner_distance_plot_Percentages.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-cnt.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-pct.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-cnt.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-pct.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/rseqc_junction_saturation_plot_All_Junctions.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/rseqc_junction_saturation_plot_Known_Junctions.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/rseqc_junction_saturation_plot_Novel_Junctions.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/rseqc_read_distribution_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/rseqc_read_distribution_plot-pct.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/salmon_deseq2_clustering-plot.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/salmon_deseq2_pca-plot.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/salmon_plot.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/samtools-flagstat-dp_Percentage_of_total.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/samtools-flagstat-dp_Read_counts.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/samtools-stats-dp.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/samtools_alignment_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/samtools_alignment_plot-pct.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/star_alignment_plot-cnt.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/star_alignment_plot-pct.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/star_rsem_deseq2_clustering-plot.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/star_rsem_deseq2_pca-plot.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/png/star_summary_table.png").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Counts.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/dupradar-section-plot.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fail_strand_check_table.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc-status-check-heatmap-1.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc-status-check-heatmap.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_adapter_content_plot.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot-1.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_per_base_n_content_plot-1.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_per_base_n_content_plot.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot-1.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Counts.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Percentages.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Counts.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Percentages.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot-1.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-cnt.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-pct.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_sequence_counts_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_sequence_counts_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot-1.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_sequence_length_distribution_plot.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table-1.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/featurecounts_biotype_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/featurecounts_biotype_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/general_stats_table.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/picard_deduplication-cnt.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/picard_deduplication-pct.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Counts.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Normalised.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/qualimap_genomic_origin-cnt.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/qualimap_genomic_origin-pct.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/rsem_assignment_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/rsem_assignment_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/rsem_multimapping_rates.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/rseqc_bam_stat.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/rseqc_infer_experiment_plot.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/rseqc_inner_distance_plot_Counts.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/rseqc_inner_distance_plot_Percentages.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-cnt.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-pct.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-pct.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/rseqc_junction_saturation_plot_All_Junctions.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Known_Junctions.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Novel_Junctions.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/rseqc_read_distribution_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/rseqc_read_distribution_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/rseqc_read_dups_plot.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/salmon_deseq2_clustering-plot.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/salmon_deseq2_pca-plot.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/salmon_plot.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/samtools-flagstat-dp_Percentage_of_total.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/samtools-flagstat-dp_Read_counts.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/samtools-stats-dp.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/samtools_alignment_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/samtools_alignment_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/star_alignment_plot-cnt.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/star_alignment_plot-pct.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/star_rsem_deseq2_clustering-plot.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/star_rsem_deseq2_pca-plot.svg").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report_plots/svg/star_summary_table.svg").name - ).match("multiqc_plots") }, - { assert snapshot( - path("${params.outdir}/salmon/deseq2_qc/R_sessionInfo.log"), - // These files are not stable - file("${params.outdir}/salmon/deseq2_qc/deseq2.dds.RData").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.pca.vals.txt").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.plots.pdf").name, - file("${params.outdir}/salmon/deseq2_qc/deseq2.sample.dists.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/WT_REP1.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/WT_REP2.txt").name, - file("${params.outdir}/salmon/deseq2_qc/size_factors/deseq2.size_factors.RData").name - ).match("salmon/deseq2_qc") }, - { assert snapshot( - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_IAA_30M_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/cmd_info.json"), - path("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/lib_format_counts.json"), - path("${params.outdir}/salmon/WT_REP1/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/WT_REP1/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/WT_REP1/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/WT_REP1/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/WT_REP1/cmd_info.json"), - path("${params.outdir}/salmon/WT_REP1/lib_format_counts.json"), - path("${params.outdir}/salmon/WT_REP2/aux_info/ambig_info.tsv"), - path("${params.outdir}/salmon/WT_REP2/aux_info/expected_bias.gz"), - path("${params.outdir}/salmon/WT_REP2/aux_info/observed_bias.gz"), - path("${params.outdir}/salmon/WT_REP2/aux_info/observed_bias_3p.gz"), - path("${params.outdir}/salmon/WT_REP2/cmd_info.json"), - path("${params.outdir}/salmon/WT_REP2/lib_format_counts.json"), - // These files are not stable - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_IAA_30M_REP1/quant.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP1/quant.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/quant.genes.sf").name, - file("${params.outdir}/salmon/RAP1_UNINDUCED_REP2/quant.sf").name, - file("${params.outdir}/salmon/WT_REP1/aux_info/fld.gz").name, - file("${params.outdir}/salmon/WT_REP1/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/WT_REP1/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/WT_REP1/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/WT_REP1/quant.genes.sf").name, - file("${params.outdir}/salmon/WT_REP1/quant.sf").name, - file("${params.outdir}/salmon/WT_REP2/aux_info/fld.gz").name, - file("${params.outdir}/salmon/WT_REP2/aux_info/meta_info.json").name, - file("${params.outdir}/salmon/WT_REP2/libParams/flenDist.txt").name, - file("${params.outdir}/salmon/WT_REP2/logs/salmon_quant.log").name, - file("${params.outdir}/salmon/WT_REP2/quant.genes.sf").name, - file("${params.outdir}/salmon/WT_REP2/quant.sf").name - ).match("salmon_quant") }, - { assert snapshot( - path("${params.outdir}/salmon/tx2gene.tsv"), - // These files are not stable - file("${params.outdir}/salmon/salmon.merged.gene_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_length_scaled.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.gene_counts_scaled.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_lengths.tsv").name, - file("${params.outdir}/salmon/salmon.merged.gene_tpm.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds").name, - file("${params.outdir}/salmon/salmon.merged.transcript_counts.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_lengths.tsv").name, - file("${params.outdir}/salmon/salmon.merged.transcript_tpm.tsv").name - ).match("salmon") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/star_rsem/bigwig/RAP1_IAA_30M_REP1.forward.bigWig").name, - file("${params.outdir}/star_rsem/bigwig/RAP1_IAA_30M_REP1.reverse.bigWig").name, - file("${params.outdir}/star_rsem/bigwig/RAP1_UNINDUCED_REP1.forward.bigWig").name, - file("${params.outdir}/star_rsem/bigwig/RAP1_UNINDUCED_REP1.reverse.bigWig").name, - file("${params.outdir}/star_rsem/bigwig/RAP1_UNINDUCED_REP2.forward.bigWig").name, - file("${params.outdir}/star_rsem/bigwig/RAP1_UNINDUCED_REP2.reverse.bigWig").name, - file("${params.outdir}/star_rsem/bigwig/WT_REP1.forward.bigWig").name, - file("${params.outdir}/star_rsem/bigwig/WT_REP1.reverse.bigWig").name, - file("${params.outdir}/star_rsem/bigwig/WT_REP2.forward.bigWig").name, - file("${params.outdir}/star_rsem/bigwig/WT_REP2.reverse.bigWig").name - ).match("star_rsem/bigwig") }, - { assert snapshot( - path("${params.outdir}/star_rsem/deseq2_qc/R_sessionInfo.log"), - // These files are not stable - file("${params.outdir}/star_rsem/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt").name, - file("${params.outdir}/star_rsem/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt").name, - file("${params.outdir}/star_rsem/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt").name, - file("${params.outdir}/star_rsem/deseq2_qc/size_factors/WT_REP1.txt").name, - file("${params.outdir}/star_rsem/deseq2_qc/size_factors/WT_REP2.txt").name, - file("${params.outdir}/star_rsem/deseq2_qc/size_factors/deseq2.size_factors.RData").name, - file("${params.outdir}/star_rsem/deseq2_qc/deseq2.dds.RData").name, - file("${params.outdir}/star_rsem/deseq2_qc/deseq2.pca.vals.txt").name, - file("${params.outdir}/star_rsem/deseq2_qc/deseq2.plots.pdf").name, - file("${params.outdir}/star_rsem/deseq2_qc/deseq2.sample.dists.txt").name - ).match("star_rsem/deseq2_qc") }, - { assert snapshot( - path("${params.outdir}/star_rsem/dupradar/gene_data/RAP1_IAA_30M_REP1_dupMatrix.txt"), - path("${params.outdir}/star_rsem/dupradar/gene_data/RAP1_UNINDUCED_REP1_dupMatrix.txt"), - path("${params.outdir}/star_rsem/dupradar/gene_data/RAP1_UNINDUCED_REP2_dupMatrix.txt"), - path("${params.outdir}/star_rsem/dupradar/gene_data/WT_REP1_dupMatrix.txt"), - path("${params.outdir}/star_rsem/dupradar/gene_data/WT_REP2_dupMatrix.txt"), - path("${params.outdir}/star_rsem/dupradar/intercepts_slope/RAP1_IAA_30M_REP1_intercept_slope.txt"), - path("${params.outdir}/star_rsem/dupradar/intercepts_slope/RAP1_UNINDUCED_REP1_intercept_slope.txt"), - path("${params.outdir}/star_rsem/dupradar/intercepts_slope/RAP1_UNINDUCED_REP2_intercept_slope.txt"), - path("${params.outdir}/star_rsem/dupradar/intercepts_slope/WT_REP1_intercept_slope.txt"), - path("${params.outdir}/star_rsem/dupradar/intercepts_slope/WT_REP2_intercept_slope.txt"), - // PDFs are not stable - file("${params.outdir}/star_rsem/dupradar/box_plot/RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_rsem/dupradar/box_plot/RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_rsem/dupradar/box_plot/RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_rsem/dupradar/box_plot/WT_REP1_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_rsem/dupradar/box_plot/WT_REP2_duprateExpBoxplot.pdf").name, - file("${params.outdir}/star_rsem/dupradar/histogram/RAP1_IAA_30M_REP1_expressionHist.pdf").name, - file("${params.outdir}/star_rsem/dupradar/histogram/RAP1_UNINDUCED_REP1_expressionHist.pdf").name, - file("${params.outdir}/star_rsem/dupradar/histogram/RAP1_UNINDUCED_REP2_expressionHist.pdf").name, - file("${params.outdir}/star_rsem/dupradar/histogram/WT_REP1_expressionHist.pdf").name, - file("${params.outdir}/star_rsem/dupradar/histogram/WT_REP2_expressionHist.pdf").name, - file("${params.outdir}/star_rsem/dupradar/scatter_plot/RAP1_IAA_30M_REP1_duprateExpDens.pdf").name, - file("${params.outdir}/star_rsem/dupradar/scatter_plot/RAP1_UNINDUCED_REP1_duprateExpDens.pdf").name, - file("${params.outdir}/star_rsem/dupradar/scatter_plot/RAP1_UNINDUCED_REP2_duprateExpDens.pdf").name, - file("${params.outdir}/star_rsem/dupradar/scatter_plot/WT_REP1_duprateExpDens.pdf").name, - file("${params.outdir}/star_rsem/dupradar/scatter_plot/WT_REP2_duprateExpDens.pdf").name - ).match("star_rsem/dupradar") }, - { assert snapshot( - path("${params.outdir}/star_rsem/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_rsem/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_rsem/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt"), - path("${params.outdir}/star_rsem/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_rsem/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_rsem/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt"), - path("${params.outdir}/star_rsem/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_rsem/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_rsem/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt"), - path("${params.outdir}/star_rsem/featurecounts/WT_REP1.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_rsem/featurecounts/WT_REP1.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_rsem/featurecounts/WT_REP1.featureCounts.txt"), - path("${params.outdir}/star_rsem/featurecounts/WT_REP2.biotype_counts_mqc.tsv"), - path("${params.outdir}/star_rsem/featurecounts/WT_REP2.biotype_counts_rrna_mqc.tsv"), - path("${params.outdir}/star_rsem/featurecounts/WT_REP2.featureCounts.txt"), - // These files are unstable - file("${params.outdir}/star_rsem/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt.summary").name, - file("${params.outdir}/star_rsem/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt.summary").name, - file("${params.outdir}/star_rsem/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt.summary").name, - file("${params.outdir}/star_rsem/featurecounts/WT_REP1.featureCounts.txt.summary").name, - file("${params.outdir}/star_rsem/featurecounts/WT_REP2.featureCounts.txt.summary").name - ).match("star_rsem/featurecounts") }, - { assert snapshot( - // These files are unstable - file("${params.outdir}/star_rsem/log/RAP1_IAA_30M_REP1.log").name, - file("${params.outdir}/star_rsem/log/RAP1_UNINDUCED_REP1.log").name, - file("${params.outdir}/star_rsem/log/RAP1_UNINDUCED_REP2.log").name, - file("${params.outdir}/star_rsem/log/WT_REP1.log").name, - file("${params.outdir}/star_rsem/log/WT_REP2.log").name - ).match("star_rsem/log") }, - { assert snapshot( - // Metrics are not stable - file("${params.outdir}/star_rsem/picard_metrics/RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_rsem/picard_metrics/RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_rsem/picard_metrics/RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_rsem/picard_metrics/WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt").name, - file("${params.outdir}/star_rsem/picard_metrics/WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt").name - ).match("star_rsem/picard_metrics") }, - { assert snapshot( - path("${params.outdir}/star_rsem/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_rsem/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_rsem/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_rsem/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_rsem/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_rsem/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_rsem/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_rsem/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_rsem/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_rsem/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_rsem/qualimap/WT_REP1/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_rsem/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_rsem/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_rsem/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - path("${params.outdir}/star_rsem/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png"), - path("${params.outdir}/star_rsem/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png"), - path("${params.outdir}/star_rsem/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png"), - path("${params.outdir}/star_rsem/qualimap/WT_REP2/images_qualimapReport/Transcript coverage histogram.png"), - path("${params.outdir}/star_rsem/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt"), - path("${params.outdir}/star_rsem/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt"), - path("${params.outdir}/star_rsem/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt"), - // HTML reports and these files are not stable - file("${params.outdir}/star_rsem/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_rsem/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_rsem/qualimap/RAP1_IAA_30M_REP1/qualimapReport.html").name, - file("${params.outdir}/star_rsem/qualimap/RAP1_IAA_30M_REP1/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP1/qualimapReport.html").name, - file("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP1/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP2/qualimapReport.html").name, - file("${params.outdir}/star_rsem/qualimap/RAP1_UNINDUCED_REP2/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_rsem/qualimap/WT_REP1/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_rsem/qualimap/WT_REP1/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_rsem/qualimap/WT_REP1/qualimapReport.html").name, - file("${params.outdir}/star_rsem/qualimap/WT_REP1/rnaseq_qc_results.txt").name, - file("${params.outdir}/star_rsem/qualimap/WT_REP2/images_qualimapReport/Junction Analysis.png").name, - file("${params.outdir}/star_rsem/qualimap/WT_REP2/images_qualimapReport/Reads Genomic Origin.png").name, - file("${params.outdir}/star_rsem/qualimap/WT_REP2/qualimapReport.html").name, - file("${params.outdir}/star_rsem/qualimap/WT_REP2/rnaseq_qc_results.txt").name - ).match("star_rsem/qualimap") }, - { assert snapshot( - path("${params.outdir}/star_rsem/RAP1_IAA_30M_REP1.genes.results"), - path("${params.outdir}/star_rsem/RAP1_IAA_30M_REP1.isoforms.results"), - path("${params.outdir}/star_rsem/RAP1_UNINDUCED_REP1.genes.results"), - path("${params.outdir}/star_rsem/RAP1_UNINDUCED_REP1.isoforms.results"), - path("${params.outdir}/star_rsem/RAP1_UNINDUCED_REP2.genes.results"), - path("${params.outdir}/star_rsem/RAP1_UNINDUCED_REP2.isoforms.results"), - path("${params.outdir}/star_rsem/WT_REP1.genes.results"), - path("${params.outdir}/star_rsem/WT_REP1.isoforms.results"), - path("${params.outdir}/star_rsem/WT_REP2.genes.results"), - path("${params.outdir}/star_rsem/WT_REP2.isoforms.results"), - path("${params.outdir}/star_rsem/rsem.merged.gene_counts.tsv"), - path("${params.outdir}/star_rsem/rsem.merged.gene_tpm.tsv"), - path("${params.outdir}/star_rsem/rsem.merged.transcript_counts.tsv"), - path("${params.outdir}/star_rsem/rsem.merged.transcript_tpm.tsv"), - // These files are not stable - file("${params.outdir}/star_rsem/RAP1_IAA_30M_REP1.stat/RAP1_IAA_30M_REP1.cnt").name, - file("${params.outdir}/star_rsem/RAP1_IAA_30M_REP1.stat/RAP1_IAA_30M_REP1.model").name, - file("${params.outdir}/star_rsem/RAP1_IAA_30M_REP1.stat/RAP1_IAA_30M_REP1.theta").name, - file("${params.outdir}/star_rsem/RAP1_UNINDUCED_REP1.stat/RAP1_UNINDUCED_REP1.cnt").name, - file("${params.outdir}/star_rsem/RAP1_UNINDUCED_REP1.stat/RAP1_UNINDUCED_REP1.model").name, - file("${params.outdir}/star_rsem/RAP1_UNINDUCED_REP1.stat/RAP1_UNINDUCED_REP1.theta").name, - file("${params.outdir}/star_rsem/RAP1_UNINDUCED_REP2.stat/RAP1_UNINDUCED_REP2.cnt").name, - file("${params.outdir}/star_rsem/RAP1_UNINDUCED_REP2.stat/RAP1_UNINDUCED_REP2.model").name, - file("${params.outdir}/star_rsem/RAP1_UNINDUCED_REP2.stat/RAP1_UNINDUCED_REP2.theta").name, - file("${params.outdir}/star_rsem/WT_REP1.stat/WT_REP1.cnt").name, - file("${params.outdir}/star_rsem/WT_REP1.stat/WT_REP1.model").name, - file("${params.outdir}/star_rsem/WT_REP1.stat/WT_REP1.theta").name, - file("${params.outdir}/star_rsem/WT_REP2.stat/WT_REP2.cnt").name, - file("${params.outdir}/star_rsem/WT_REP2.stat/WT_REP2.model").name, - file("${params.outdir}/star_rsem/WT_REP2.stat/WT_REP2.theta").name - ).match("star_rsem/rsem") }, - { assert snapshot( - path("${params.outdir}/star_rsem/rseqc/infer_experiment/RAP1_IAA_30M_REP1.infer_experiment.txt"), - path("${params.outdir}/star_rsem/rseqc/infer_experiment/RAP1_UNINDUCED_REP1.infer_experiment.txt"), - path("${params.outdir}/star_rsem/rseqc/infer_experiment/RAP1_UNINDUCED_REP2.infer_experiment.txt"), - path("${params.outdir}/star_rsem/rseqc/infer_experiment/WT_REP1.infer_experiment.txt"), - path("${params.outdir}/star_rsem/rseqc/infer_experiment/WT_REP2.infer_experiment.txt"), - // PDFs, R scripts and all these files are not stable - file("${params.outdir}/star_rsem/rseqc/bam_stat/RAP1_IAA_30M_REP1.bam_stat.txt").name, - file("${params.outdir}/star_rsem/rseqc/bam_stat/RAP1_UNINDUCED_REP1.bam_stat.txt").name, - file("${params.outdir}/star_rsem/rseqc/bam_stat/RAP1_UNINDUCED_REP2.bam_stat.txt").name, - file("${params.outdir}/star_rsem/rseqc/bam_stat/WT_REP1.bam_stat.txt").name, - file("${params.outdir}/star_rsem/rseqc/bam_stat/WT_REP2.bam_stat.txt").name, - file("${params.outdir}/star_rsem/rseqc/inner_distance/pdf/RAP1_IAA_30M_REP1.inner_distance_plot.pdf").name, - file("${params.outdir}/star_rsem/rseqc/inner_distance/pdf/WT_REP1.inner_distance_plot.pdf").name, - file("${params.outdir}/star_rsem/rseqc/inner_distance/pdf/WT_REP2.inner_distance_plot.pdf").name, - file("${params.outdir}/star_rsem/rseqc/inner_distance/rscript/RAP1_IAA_30M_REP1.inner_distance_plot.r").name, - file("${params.outdir}/star_rsem/rseqc/inner_distance/rscript/WT_REP1.inner_distance_plot.r").name, - file("${params.outdir}/star_rsem/rseqc/inner_distance/rscript/WT_REP2.inner_distance_plot.r").name, - file("${params.outdir}/star_rsem/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance.txt").name, - file("${params.outdir}/star_rsem/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_freq.txt").name, - file("${params.outdir}/star_rsem/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_mean.txt").name, - file("${params.outdir}/star_rsem/rseqc/inner_distance/txt/WT_REP1.inner_distance.txt").name, - file("${params.outdir}/star_rsem/rseqc/inner_distance/txt/WT_REP1.inner_distance_freq.txt").name, - file("${params.outdir}/star_rsem/rseqc/inner_distance/txt/WT_REP1.inner_distance_mean.txt").name, - file("${params.outdir}/star_rsem/rseqc/inner_distance/txt/WT_REP2.inner_distance.txt").name, - file("${params.outdir}/star_rsem/rseqc/inner_distance/txt/WT_REP2.inner_distance_freq.txt").name, - file("${params.outdir}/star_rsem/rseqc/inner_distance/txt/WT_REP2.inner_distance_mean.txt").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.Interact.bed").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.bed").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.Interact.bed").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.bed").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.Interact.bed").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.bed").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/bed/WT_REP1.junction.Interact.bed").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/bed/WT_REP1.junction.bed").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/bed/WT_REP2.junction.Interact.bed").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/bed/WT_REP2.junction.bed").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/log/RAP1_IAA_30M_REP1.junction_annotation.log").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP1.junction_annotation.log").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP2.junction_annotation.log").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/log/WT_REP1.junction_annotation.log").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/log/WT_REP2.junction_annotation.log").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_events.pdf").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_junction.pdf").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_events.pdf").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_junction.pdf").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_events.pdf").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_junction.pdf").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/pdf/WT_REP1.splice_events.pdf").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/pdf/WT_REP1.splice_junction.pdf").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/pdf/WT_REP2.splice_events.pdf").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/pdf/WT_REP2.splice_junction.pdf").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/rscript/RAP1_IAA_30M_REP1.junction_plot.r").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP1.junction_plot.r").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP2.junction_plot.r").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/rscript/WT_REP1.junction_plot.r").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/rscript/WT_REP2.junction_plot.r").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/xls/RAP1_IAA_30M_REP1.junction.xls").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP1.junction.xls").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP2.junction.xls").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/xls/WT_REP1.junction.xls").name, - file("${params.outdir}/star_rsem/rseqc/junction_annotation/xls/WT_REP2.junction.xls").name, - file("${params.outdir}/star_rsem/rseqc/junction_saturation/pdf/RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_rsem/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_rsem/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_rsem/rseqc/junction_saturation/pdf/WT_REP1.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_rsem/rseqc/junction_saturation/pdf/WT_REP2.junctionSaturation_plot.pdf").name, - file("${params.outdir}/star_rsem/rseqc/junction_saturation/rscript/RAP1_IAA_30M_REP1.junctionSaturation_plot.r").name, - file("${params.outdir}/star_rsem/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP1.junctionSaturation_plot.r").name, - file("${params.outdir}/star_rsem/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP2.junctionSaturation_plot.r").name, - file("${params.outdir}/star_rsem/rseqc/junction_saturation/rscript/WT_REP1.junctionSaturation_plot.r").name, - file("${params.outdir}/star_rsem/rseqc/junction_saturation/rscript/WT_REP2.junctionSaturation_plot.r").name, - file("${params.outdir}/star_rsem/rseqc/read_distribution/RAP1_IAA_30M_REP1.read_distribution.txt").name, - file("${params.outdir}/star_rsem/rseqc/read_distribution/RAP1_UNINDUCED_REP1.read_distribution.txt").name, - file("${params.outdir}/star_rsem/rseqc/read_distribution/RAP1_UNINDUCED_REP2.read_distribution.txt").name, - file("${params.outdir}/star_rsem/rseqc/read_distribution/WT_REP1.read_distribution.txt").name, - file("${params.outdir}/star_rsem/rseqc/read_distribution/WT_REP2.read_distribution.txt").name, - file("${params.outdir}/star_rsem/rseqc/read_duplication/pdf/RAP1_IAA_30M_REP1.DupRate_plot.pdf").name, - file("${params.outdir}/star_rsem/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP1.DupRate_plot.pdf").name, - file("${params.outdir}/star_rsem/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP2.DupRate_plot.pdf").name, - file("${params.outdir}/star_rsem/rseqc/read_duplication/pdf/WT_REP1.DupRate_plot.pdf").name, - file("${params.outdir}/star_rsem/rseqc/read_duplication/pdf/WT_REP2.DupRate_plot.pdf").name, - file("${params.outdir}/star_rsem/rseqc/read_duplication/rscript/RAP1_IAA_30M_REP1.DupRate_plot.r").name, - file("${params.outdir}/star_rsem/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP1.DupRate_plot.r").name, - file("${params.outdir}/star_rsem/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP2.DupRate_plot.r").name, - file("${params.outdir}/star_rsem/rseqc/read_duplication/rscript/WT_REP1.DupRate_plot.r").name, - file("${params.outdir}/star_rsem/rseqc/read_duplication/rscript/WT_REP2.DupRate_plot.r").name, - file("${params.outdir}/star_rsem/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.pos.DupRate.xls").name, - file("${params.outdir}/star_rsem/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.seq.DupRate.xls").name, - file("${params.outdir}/star_rsem/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.pos.DupRate.xls").name, - file("${params.outdir}/star_rsem/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.seq.DupRate.xls").name, - file("${params.outdir}/star_rsem/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.pos.DupRate.xls").name, - file("${params.outdir}/star_rsem/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.seq.DupRate.xls").name, - file("${params.outdir}/star_rsem/rseqc/read_duplication/xls/WT_REP1.pos.DupRate.xls").name, - file("${params.outdir}/star_rsem/rseqc/read_duplication/xls/WT_REP1.seq.DupRate.xls").name, - file("${params.outdir}/star_rsem/rseqc/read_duplication/xls/WT_REP2.pos.DupRate.xls").name, - file("${params.outdir}/star_rsem/rseqc/read_duplication/xls/WT_REP2.seq.DupRate.xls").name - ).match("star_rsem/rseqc") }, - { assert snapshot( - // These files are not stable - file("${params.outdir}/star_rsem/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_rsem/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_rsem/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_rsem/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_rsem/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_rsem/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_rsem/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_rsem/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_rsem/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_rsem/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_rsem/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_rsem/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_rsem/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_rsem/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_rsem/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_rsem/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.flagstat").name, - file("${params.outdir}/star_rsem/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.idxstats").name, - file("${params.outdir}/star_rsem/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.stats").name, - file("${params.outdir}/star_rsem/samtools_stats/WT_REP1.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_rsem/samtools_stats/WT_REP1.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_rsem/samtools_stats/WT_REP1.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_rsem/samtools_stats/WT_REP1.sorted.bam.flagstat").name, - file("${params.outdir}/star_rsem/samtools_stats/WT_REP1.sorted.bam.idxstats").name, - file("${params.outdir}/star_rsem/samtools_stats/WT_REP1.sorted.bam.stats").name, - file("${params.outdir}/star_rsem/samtools_stats/WT_REP2.markdup.sorted.bam.flagstat").name, - file("${params.outdir}/star_rsem/samtools_stats/WT_REP2.markdup.sorted.bam.idxstats").name, - file("${params.outdir}/star_rsem/samtools_stats/WT_REP2.markdup.sorted.bam.stats").name, - file("${params.outdir}/star_rsem/samtools_stats/WT_REP2.sorted.bam.flagstat").name, - file("${params.outdir}/star_rsem/samtools_stats/WT_REP2.sorted.bam.idxstats").name, - file("${params.outdir}/star_rsem/samtools_stats/WT_REP2.sorted.bam.stats").name - ).match("star_rsem/samtools_stats") }, - { assert snapshot( - path("${params.outdir}/star_rsem/stringtie/RAP1_IAA_30M_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/star_rsem/stringtie/RAP1_IAA_30M_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/star_rsem/stringtie/RAP1_IAA_30M_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/star_rsem/stringtie/RAP1_IAA_30M_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/star_rsem/stringtie/RAP1_UNINDUCED_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/star_rsem/stringtie/RAP1_UNINDUCED_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/star_rsem/stringtie/RAP1_UNINDUCED_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/star_rsem/stringtie/RAP1_UNINDUCED_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/star_rsem/stringtie/RAP1_UNINDUCED_REP2.ballgown/e2t.ctab"), - path("${params.outdir}/star_rsem/stringtie/RAP1_UNINDUCED_REP2.ballgown/e_data.ctab"), - path("${params.outdir}/star_rsem/stringtie/RAP1_UNINDUCED_REP2.ballgown/i2t.ctab"), - path("${params.outdir}/star_rsem/stringtie/RAP1_UNINDUCED_REP2.ballgown/i_data.ctab"), - path("${params.outdir}/star_rsem/stringtie/WT_REP1.ballgown/e2t.ctab"), - path("${params.outdir}/star_rsem/stringtie/WT_REP1.ballgown/e_data.ctab"), - path("${params.outdir}/star_rsem/stringtie/WT_REP1.ballgown/i2t.ctab"), - path("${params.outdir}/star_rsem/stringtie/WT_REP1.ballgown/i_data.ctab"), - path("${params.outdir}/star_rsem/stringtie/WT_REP2.ballgown/e2t.ctab"), - path("${params.outdir}/star_rsem/stringtie/WT_REP2.ballgown/e_data.ctab"), - path("${params.outdir}/star_rsem/stringtie/WT_REP2.ballgown/i2t.ctab"), - path("${params.outdir}/star_rsem/stringtie/WT_REP2.ballgown/i_data.ctab"), - // These files are not stable - file("${params.outdir}/star_rsem/stringtie/RAP1_IAA_30M_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/star_rsem/stringtie/RAP1_IAA_30M_REP1.coverage.gtf").name, - file("${params.outdir}/star_rsem/stringtie/RAP1_IAA_30M_REP1.gene.abundance.txt").name, - file("${params.outdir}/star_rsem/stringtie/RAP1_IAA_30M_REP1.transcripts.gtf").name, - file("${params.outdir}/star_rsem/stringtie/RAP1_UNINDUCED_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/star_rsem/stringtie/RAP1_UNINDUCED_REP1.coverage.gtf").name, - file("${params.outdir}/star_rsem/stringtie/RAP1_UNINDUCED_REP1.gene.abundance.txt").name, - file("${params.outdir}/star_rsem/stringtie/RAP1_UNINDUCED_REP1.transcripts.gtf").name, - file("${params.outdir}/star_rsem/stringtie/RAP1_UNINDUCED_REP2.ballgown/t_data.ctab").name, - file("${params.outdir}/star_rsem/stringtie/RAP1_UNINDUCED_REP2.coverage.gtf").name, - file("${params.outdir}/star_rsem/stringtie/RAP1_UNINDUCED_REP2.gene.abundance.txt").name, - file("${params.outdir}/star_rsem/stringtie/RAP1_UNINDUCED_REP2.transcripts.gtf").name, - file("${params.outdir}/star_rsem/stringtie/WT_REP1.ballgown/t_data.ctab").name, - file("${params.outdir}/star_rsem/stringtie/WT_REP1.coverage.gtf").name, - file("${params.outdir}/star_rsem/stringtie/WT_REP1.gene.abundance.txt").name, - file("${params.outdir}/star_rsem/stringtie/WT_REP1.transcripts.gtf").name, - file("${params.outdir}/star_rsem/stringtie/WT_REP2.ballgown/t_data.ctab").name, - file("${params.outdir}/star_rsem/stringtie/WT_REP2.coverage.gtf").name, - file("${params.outdir}/star_rsem/stringtie/WT_REP2.gene.abundance.txt").name, - file("${params.outdir}/star_rsem/stringtie/WT_REP2.transcripts.gtf").name - ).match("star_rsem/stringtie") }, - { assert snapshot( - file("${params.outdir}/star_rsem/RAP1_IAA_30M_REP1.markdup.sorted.bam").name, - file("${params.outdir}/star_rsem/RAP1_IAA_30M_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_rsem/RAP1_UNINDUCED_REP1.markdup.sorted.bam").name, - file("${params.outdir}/star_rsem/RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_rsem/RAP1_UNINDUCED_REP2.markdup.sorted.bam").name, - file("${params.outdir}/star_rsem/RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_rsem/WT_REP1.markdup.sorted.bam").name, - file("${params.outdir}/star_rsem/WT_REP1.markdup.sorted.bam.bai").name, - file("${params.outdir}/star_rsem/WT_REP2.markdup.sorted.bam").name, - file("${params.outdir}/star_rsem/WT_REP2.markdup.sorted.bam.bai").name - ).match("star_rsem/markdup") }, - { assert snapshot( - // These reports are not stable - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt").name - ).match("trimgalore") }, - { assert snapshot( - UTILS.removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml") - ).match("versions") } + { assert workflow.success}, + { assert snapshot( + // Number of successful tasks + workflow.trace.succeeded().size(), + // pipeline versions.yml file for multiqc from which Nextflow version is removed because we tests pipelines on multiple Nextflow versions + removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), + // All stable path name, with a relative path + getRelativePath(stable_name, outputDir), + // All files with stable contents + stable_path + ).match() } ) } } @@ -887,31 +45,21 @@ nextflow_pipeline { } then { + // stable_name: All files + folders in ${params.outdir}/ with a stable name + def stable_name = getAllFilesFromDir(params.outdir, true, ['pipeline_info/*.{html,json,txt}'], null) + // stable_path: All files in ${params.outdir}/ with stable content + def stable_path = getAllFilesFromDir(params.outdir, false, null, 'tests/.nftignore') assertAll( - { assert workflow.success }, - { assert snapshot( - UTILS.removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), - file("${params.outdir}/custom/out/genome_transcriptome.fasta").name, - file("${params.outdir}/custom/out/genome_transcriptome.gtf").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_IAA_30M_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw.html").name, - file("${params.outdir}/fastqc/raw/RAP1_UNINDUCED_REP2_raw.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw.html").name, - file("${params.outdir}/fastqc/raw/WT_REP1_raw.zip").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw.html").name, - file("${params.outdir}/fastqc/raw/WT_REP2_raw.zip").name, - file("${params.outdir}/multiqc/star_rsem/multiqc_report.html").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt").name, - file("${params.outdir}/trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt").name + { assert workflow.success}, + { assert snapshot( + // Number of successful tasks + workflow.trace.succeeded().size(), + // pipeline versions.yml file for multiqc from which Nextflow version is removed because we tests pipelines on multiple Nextflow versions + removeNextflowVersion("$outputDir/pipeline_info/nf_core_rnaseq_software_mqc_versions.yml"), + // All stable path name, with a relative path + getRelativePath(stable_name, outputDir), + // All files with stable contents + stable_path ).match() } ) } diff --git a/tests/star_rsem.nf.test.snap b/tests/star_rsem.nf.test.snap index a6a804341..b4e4f981b 100644 --- a/tests/star_rsem.nf.test.snap +++ b/tests/star_rsem.nf.test.snap @@ -1,1029 +1,1502 @@ { - "star_rsem/bigwig": { + "Params: --aligner star_rsem": { "content": [ - "RAP1_IAA_30M_REP1.forward.bigWig", - "RAP1_IAA_30M_REP1.reverse.bigWig", - "RAP1_UNINDUCED_REP1.forward.bigWig", - "RAP1_UNINDUCED_REP1.reverse.bigWig", - "RAP1_UNINDUCED_REP2.forward.bigWig", - "RAP1_UNINDUCED_REP2.reverse.bigWig", - "WT_REP1.forward.bigWig", - "WT_REP1.reverse.bigWig", - "WT_REP2.forward.bigWig", - "WT_REP2.reverse.bigWig" + 188, + { + "BBMAP_BBSPLIT": { + "bbmap": 39.01 + }, + "BEDTOOLS_GENOMECOV_FW": { + "bedtools": "2.31.1" + }, + "CAT_FASTQ": { + "cat": 8.3 + }, + "CUSTOM_CATADDITIONALFASTA": { + "python": "3.9.5" + }, + "CUSTOM_GETCHROMSIZES": { + "getchromsizes": 1.2 + }, + "CUSTOM_TX2GENE": { + "python": "3.9.5" + }, + "DESEQ2_QC_PSEUDO": { + "r-base": "4.0.3", + "bioconductor-deseq2": "1.28.0" + }, + "DESEQ2_QC_RSEM": { + "r-base": "4.0.3", + "bioconductor-deseq2": "1.28.0" + }, + "DUPRADAR": { + "bioconductor-dupradar": "1.32.0" + }, + "FASTQC": { + "fastqc": "0.12.1" + }, + "FQ_SUBSAMPLE": { + "fq": "0.9.1 (2022-02-22)" + }, + "GTF2BED": { + "perl": "5.26.2" + }, + "GTF_FILTER": { + "python": "3.9.5" + }, + "GUNZIP_ADDITIONAL_FASTA": { + "gunzip": 1.1 + }, + "GUNZIP_GTF": { + "gunzip": 1.1 + }, + "MULTIQC_CUSTOM_BIOTYPE": { + "python": "3.9.5" + }, + "PICARD_MARKDUPLICATES": { + "picard": "3.1.1" + }, + "QUALIMAP_RNASEQ": { + "qualimap": 2.3 + }, + "RSEM_CALCULATEEXPRESSION": { + "rsem": "1.3.1", + "star": "2.7.10a" + }, + "RSEM_MERGE_COUNTS": { + "sed": 4.7 + }, + "RSEQC_BAMSTAT": { + "rseqc": "5.0.2" + }, + "RSEQC_INFEREXPERIMENT": { + "rseqc": "5.0.2" + }, + "RSEQC_INNERDISTANCE": { + "rseqc": "5.0.2" + }, + "RSEQC_JUNCTIONANNOTATION": { + "rseqc": "5.0.2" + }, + "RSEQC_JUNCTIONSATURATION": { + "rseqc": "5.0.2" + }, + "RSEQC_READDISTRIBUTION": { + "rseqc": "5.0.2" + }, + "RSEQC_READDUPLICATION": { + "rseqc": "5.0.2" + }, + "SALMON_QUANT": { + "salmon": "1.10.1" + }, + "SAMTOOLS_FLAGSTAT": { + "samtools": 1.2 + }, + "SAMTOOLS_IDXSTATS": { + "samtools": 1.2 + }, + "SAMTOOLS_INDEX": { + "samtools": 1.2 + }, + "SAMTOOLS_SORT": { + "samtools": 1.2 + }, + "SAMTOOLS_STATS": { + "samtools": 1.2 + }, + "SE_GENE": { + "bioconductor-summarizedexperiment": "1.32.0" + }, + "STRINGTIE_STRINGTIE": { + "stringtie": "2.2.1" + }, + "SUBREAD_FEATURECOUNTS": { + "subread": "2.0.1" + }, + "TRIMGALORE": { + "trimgalore": "0.6.7", + "cutadapt": 3.4 + }, + "TXIMETA_TXIMPORT": { + "bioconductor-tximeta": "1.20.1" + }, + "UCSC_BEDCLIP": { + "ucsc": 377 + }, + "UCSC_BEDGRAPHTOBIGWIG": { + "ucsc": 445 + }, + "UNTAR_RSEM_INDEX": { + "untar": 1.34 + }, + "UNTAR_SALMON_INDEX": { + "untar": 1.34 + }, + "Workflow": { + "nf-core/rnaseq": "v3.16.0dev" + } + }, + [ + "bbsplit", + "bbsplit/RAP1_IAA_30M_REP1.stats.txt", + "bbsplit/RAP1_UNINDUCED_REP1.stats.txt", + "bbsplit/RAP1_UNINDUCED_REP2.stats.txt", + "bbsplit/WT_REP1.stats.txt", + "bbsplit/WT_REP2.stats.txt", + "custom", + "custom/out", + "custom/out/genome_gfp.fasta", + "custom/out/genome_gfp.gtf", + "fastqc", + "fastqc/raw", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.html", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_1_fastqc.zip", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.html", + "fastqc/raw/RAP1_IAA_30M_REP1_raw_2_fastqc.zip", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.html", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw_fastqc.zip", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.html", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw_fastqc.zip", + "fastqc/raw/WT_REP1_raw_1_fastqc.html", + "fastqc/raw/WT_REP1_raw_1_fastqc.zip", + "fastqc/raw/WT_REP1_raw_2_fastqc.html", + "fastqc/raw/WT_REP1_raw_2_fastqc.zip", + "fastqc/raw/WT_REP2_raw_1_fastqc.html", + "fastqc/raw/WT_REP2_raw_1_fastqc.zip", + "fastqc/raw/WT_REP2_raw_2_fastqc.html", + "fastqc/raw/WT_REP2_raw_2_fastqc.zip", + "fastqc/trim", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html", + "fastqc/trim/RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip", + "fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html", + "fastqc/trim/RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip", + "fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html", + "fastqc/trim/RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip", + "fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.html", + "fastqc/trim/WT_REP1_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.html", + "fastqc/trim/WT_REP1_trimmed_2_val_2_fastqc.zip", + "fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.html", + "fastqc/trim/WT_REP2_trimmed_1_val_1_fastqc.zip", + "fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.html", + "fastqc/trim/WT_REP2_trimmed_2_val_2_fastqc.zip", + "multiqc", + "multiqc/star_rsem", + "multiqc/star_rsem/multiqc_report.html", + "multiqc/star_rsem/multiqc_report_data", + "multiqc/star_rsem/multiqc_report_data/cutadapt_filtered_reads_plot.txt", + "multiqc/star_rsem/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Counts.txt", + "multiqc/star_rsem/multiqc_report_data/cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc-status-check-heatmap-1.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc-status-check-heatmap.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc_adapter_content_plot.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc_overrepresented_sequences_plot-1.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc_overrepresented_sequences_plot.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc_per_base_n_content_plot-1.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc_per_base_n_content_plot.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc_per_base_sequence_quality_plot-1.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc_per_base_sequence_quality_plot.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Counts.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc_per_sequence_gc_content_plot-1_Percentages.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Counts.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc_per_sequence_gc_content_plot_Percentages.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc_per_sequence_quality_scores_plot-1.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc_per_sequence_quality_scores_plot.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc_sequence_counts_plot-1.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc_sequence_counts_plot.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc_sequence_duplication_levels_plot-1.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc_sequence_duplication_levels_plot.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc_sequence_length_distribution_plot.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc_top_overrepresented_sequences_table-1.txt", + "multiqc/star_rsem/multiqc_report_data/fastqc_top_overrepresented_sequences_table.txt", + "multiqc/star_rsem/multiqc_report_data/junction_saturation_known.txt", + "multiqc/star_rsem/multiqc_report_data/junction_saturation_novel.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_citations.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_cutadapt.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_data.json", + "multiqc/star_rsem/multiqc_report_data/multiqc_dupradar-section-plot.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_fail_strand_check_table.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_fastqc_fastqc_raw.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_fastqc_fastqc_trimmed.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_featurecounts_biotype_plot.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_general_stats.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_picard_dups.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_rsem.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_rseqc_bam_stat.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_rseqc_infer_experiment.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_rseqc_junction_annotation.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_rseqc_read_distribution.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_salmon.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_1.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_2.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_3.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_salmon_deseq2_clustering-plot_4.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_salmon_deseq2_pca-plot.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_samtools_flagstat.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_samtools_idxstats.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_samtools_stats.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_software_versions.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_sources.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_star_rsem_deseq2_clustering-plot.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_star_rsem_deseq2_clustering-plot_1.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_star_rsem_deseq2_clustering-plot_2.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_star_rsem_deseq2_clustering-plot_3.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_star_rsem_deseq2_clustering-plot_4.txt", + "multiqc/star_rsem/multiqc_report_data/multiqc_star_rsem_deseq2_pca-plot.txt", + "multiqc/star_rsem/multiqc_report_data/picard_deduplication.txt", + "multiqc/star_rsem/multiqc_report_data/picard_histogram.txt", + "multiqc/star_rsem/multiqc_report_data/picard_histogram_1.txt", + "multiqc/star_rsem/multiqc_report_data/picard_histogram_2.txt", + "multiqc/star_rsem/multiqc_report_data/qualimap_gene_coverage_profile_Counts.txt", + "multiqc/star_rsem/multiqc_report_data/qualimap_gene_coverage_profile_Normalised.txt", + "multiqc/star_rsem/multiqc_report_data/qualimap_genomic_origin.txt", + "multiqc/star_rsem/multiqc_report_data/qualimap_rnaseq_cov_hist.txt", + "multiqc/star_rsem/multiqc_report_data/qualimap_rnaseq_genome_results.txt", + "multiqc/star_rsem/multiqc_report_data/rsem_assignment_plot.txt", + "multiqc/star_rsem/multiqc_report_data/rsem_multimapping_rates.txt", + "multiqc/star_rsem/multiqc_report_data/rseqc_bam_stat.txt", + "multiqc/star_rsem/multiqc_report_data/rseqc_infer_experiment_plot.txt", + "multiqc/star_rsem/multiqc_report_data/rseqc_inner_distance.txt", + "multiqc/star_rsem/multiqc_report_data/rseqc_inner_distance_plot_Counts.txt", + "multiqc/star_rsem/multiqc_report_data/rseqc_inner_distance_plot_Percentages.txt", + "multiqc/star_rsem/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Events.txt", + "multiqc/star_rsem/multiqc_report_data/rseqc_junction_annotation_junctions_plot_Junctions.txt", + "multiqc/star_rsem/multiqc_report_data/rseqc_junction_saturation_all.txt", + "multiqc/star_rsem/multiqc_report_data/rseqc_junction_saturation_plot_All_Junctions.txt", + "multiqc/star_rsem/multiqc_report_data/rseqc_junction_saturation_plot_Known_Junctions.txt", + "multiqc/star_rsem/multiqc_report_data/rseqc_junction_saturation_plot_Novel_Junctions.txt", + "multiqc/star_rsem/multiqc_report_data/rseqc_read_distribution_plot.txt", + "multiqc/star_rsem/multiqc_report_data/rseqc_read_dups.txt", + "multiqc/star_rsem/multiqc_report_data/rseqc_read_dups_plot.txt", + "multiqc/star_rsem/multiqc_report_data/salmon_plot.txt", + "multiqc/star_rsem/multiqc_report_data/samtools-flagstat-dp_Percentage_of_total.txt", + "multiqc/star_rsem/multiqc_report_data/samtools-flagstat-dp_Read_counts.txt", + "multiqc/star_rsem/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt", + "multiqc/star_rsem/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt", + "multiqc/star_rsem/multiqc_report_data/samtools-idxstats-mapped-reads-plot_Raw_Counts.txt", + "multiqc/star_rsem/multiqc_report_data/samtools-stats-dp.txt", + "multiqc/star_rsem/multiqc_report_data/samtools_alignment_plot.txt", + "multiqc/star_rsem/multiqc_report_plots", + "multiqc/star_rsem/multiqc_report_plots/pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-cnt.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/cutadapt_filtered_reads_plot-pct.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Counts.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/dupradar-section-plot.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fail_strand_check_table.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc-status-check-heatmap-1.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc-status-check-heatmap.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_adapter_content_plot.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot-1.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_overrepresented_sequences_plot.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot-1.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_per_base_n_content_plot.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot-1.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_per_base_sequence_quality_plot.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Counts.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot-1_Percentages.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Counts.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_per_sequence_gc_content_plot_Percentages.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot-1.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_per_sequence_quality_scores_plot.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-cnt.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-1-pct.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-cnt.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_sequence_counts_plot-pct.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot-1.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_sequence_duplication_levels_plot.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_sequence_length_distribution_plot.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table-1.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/fastqc_top_overrepresented_sequences_table.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/featurecounts_biotype_plot-cnt.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/featurecounts_biotype_plot-pct.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/general_stats_table.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/picard_deduplication-cnt.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/picard_deduplication-pct.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Counts.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/qualimap_gene_coverage_profile_Normalised.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/qualimap_genomic_origin-cnt.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/qualimap_genomic_origin-pct.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/rsem_assignment_plot-cnt.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/rsem_assignment_plot-pct.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/rsem_multimapping_rates.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_bam_stat.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_infer_experiment_plot.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Counts.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_inner_distance_plot_Percentages.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-cnt.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Events-pct.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_All_Junctions.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Known_Junctions.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_junction_saturation_plot_Novel_Junctions.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_read_distribution_plot-cnt.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_read_distribution_plot-pct.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/rseqc_read_dups_plot.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/salmon_deseq2_clustering-plot.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/salmon_deseq2_pca-plot.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/salmon_plot.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/samtools-flagstat-dp_Percentage_of_total.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/samtools-flagstat-dp_Read_counts.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/samtools-stats-dp.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/samtools_alignment_plot-cnt.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/samtools_alignment_plot-pct.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/star_rsem_deseq2_clustering-plot.pdf", + "multiqc/star_rsem/multiqc_report_plots/pdf/star_rsem_deseq2_pca-plot.pdf", + "multiqc/star_rsem/multiqc_report_plots/png", + "multiqc/star_rsem/multiqc_report_plots/png/cutadapt_filtered_reads_plot-cnt.png", + "multiqc/star_rsem/multiqc_report_plots/png/cutadapt_filtered_reads_plot-pct.png", + "multiqc/star_rsem/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Counts.png", + "multiqc/star_rsem/multiqc_report_plots/png/cutadapt_trimmed_sequences_plot_3_Obs_Exp.png", + "multiqc/star_rsem/multiqc_report_plots/png/dupradar-section-plot.png", + "multiqc/star_rsem/multiqc_report_plots/png/fail_strand_check_table.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc-status-check-heatmap-1.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc-status-check-heatmap.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_adapter_content_plot.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot-1.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_overrepresented_sequences_plot.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_per_base_n_content_plot-1.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_per_base_n_content_plot.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot-1.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_per_base_sequence_quality_plot.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Counts.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot-1_Percentages.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Counts.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_per_sequence_gc_content_plot_Percentages.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot-1.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_per_sequence_quality_scores_plot.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-cnt.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_sequence_counts_plot-1-pct.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_sequence_counts_plot-cnt.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_sequence_counts_plot-pct.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot-1.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_sequence_duplication_levels_plot.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_sequence_length_distribution_plot.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table-1.png", + "multiqc/star_rsem/multiqc_report_plots/png/fastqc_top_overrepresented_sequences_table.png", + "multiqc/star_rsem/multiqc_report_plots/png/featurecounts_biotype_plot-cnt.png", + "multiqc/star_rsem/multiqc_report_plots/png/featurecounts_biotype_plot-pct.png", + "multiqc/star_rsem/multiqc_report_plots/png/general_stats_table.png", + "multiqc/star_rsem/multiqc_report_plots/png/picard_deduplication-cnt.png", + "multiqc/star_rsem/multiqc_report_plots/png/picard_deduplication-pct.png", + "multiqc/star_rsem/multiqc_report_plots/png/qualimap_gene_coverage_profile_Counts.png", + "multiqc/star_rsem/multiqc_report_plots/png/qualimap_gene_coverage_profile_Normalised.png", + "multiqc/star_rsem/multiqc_report_plots/png/qualimap_genomic_origin-cnt.png", + "multiqc/star_rsem/multiqc_report_plots/png/qualimap_genomic_origin-pct.png", + "multiqc/star_rsem/multiqc_report_plots/png/rsem_assignment_plot-cnt.png", + "multiqc/star_rsem/multiqc_report_plots/png/rsem_assignment_plot-pct.png", + "multiqc/star_rsem/multiqc_report_plots/png/rsem_multimapping_rates.png", + "multiqc/star_rsem/multiqc_report_plots/png/rseqc_bam_stat.png", + "multiqc/star_rsem/multiqc_report_plots/png/rseqc_infer_experiment_plot.png", + "multiqc/star_rsem/multiqc_report_plots/png/rseqc_inner_distance_plot_Counts.png", + "multiqc/star_rsem/multiqc_report_plots/png/rseqc_inner_distance_plot_Percentages.png", + "multiqc/star_rsem/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-cnt.png", + "multiqc/star_rsem/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Events-pct.png", + "multiqc/star_rsem/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-cnt.png", + "multiqc/star_rsem/multiqc_report_plots/png/rseqc_junction_annotation_junctions_plot_Junctions-pct.png", + "multiqc/star_rsem/multiqc_report_plots/png/rseqc_junction_saturation_plot_All_Junctions.png", + "multiqc/star_rsem/multiqc_report_plots/png/rseqc_junction_saturation_plot_Known_Junctions.png", + "multiqc/star_rsem/multiqc_report_plots/png/rseqc_junction_saturation_plot_Novel_Junctions.png", + "multiqc/star_rsem/multiqc_report_plots/png/rseqc_read_distribution_plot-cnt.png", + "multiqc/star_rsem/multiqc_report_plots/png/rseqc_read_distribution_plot-pct.png", + "multiqc/star_rsem/multiqc_report_plots/png/rseqc_read_dups_plot.png", + "multiqc/star_rsem/multiqc_report_plots/png/salmon_deseq2_clustering-plot.png", + "multiqc/star_rsem/multiqc_report_plots/png/salmon_deseq2_pca-plot.png", + "multiqc/star_rsem/multiqc_report_plots/png/salmon_plot.png", + "multiqc/star_rsem/multiqc_report_plots/png/samtools-flagstat-dp_Percentage_of_total.png", + "multiqc/star_rsem/multiqc_report_plots/png/samtools-flagstat-dp_Read_counts.png", + "multiqc/star_rsem/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png", + "multiqc/star_rsem/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png", + "multiqc/star_rsem/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png", + "multiqc/star_rsem/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png", + "multiqc/star_rsem/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png", + "multiqc/star_rsem/multiqc_report_plots/png/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png", + "multiqc/star_rsem/multiqc_report_plots/png/samtools-stats-dp.png", + "multiqc/star_rsem/multiqc_report_plots/png/samtools_alignment_plot-cnt.png", + "multiqc/star_rsem/multiqc_report_plots/png/samtools_alignment_plot-pct.png", + "multiqc/star_rsem/multiqc_report_plots/png/star_rsem_deseq2_clustering-plot.png", + "multiqc/star_rsem/multiqc_report_plots/png/star_rsem_deseq2_pca-plot.png", + "multiqc/star_rsem/multiqc_report_plots/svg", + "multiqc/star_rsem/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-cnt.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/cutadapt_filtered_reads_plot-pct.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Counts.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/dupradar-section-plot.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fail_strand_check_table.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc-status-check-heatmap-1.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc-status-check-heatmap.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_adapter_content_plot.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot-1.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_overrepresented_sequences_plot.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_per_base_n_content_plot-1.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_per_base_n_content_plot.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot-1.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_per_base_sequence_quality_plot.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Counts.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot-1_Percentages.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Counts.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_per_sequence_gc_content_plot_Percentages.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot-1.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_per_sequence_quality_scores_plot.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-cnt.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_sequence_counts_plot-1-pct.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_sequence_counts_plot-cnt.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_sequence_counts_plot-pct.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot-1.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_sequence_duplication_levels_plot.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_sequence_length_distribution_plot.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table-1.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/fastqc_top_overrepresented_sequences_table.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/featurecounts_biotype_plot-cnt.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/featurecounts_biotype_plot-pct.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/general_stats_table.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/picard_deduplication-cnt.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/picard_deduplication-pct.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Counts.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/qualimap_gene_coverage_profile_Normalised.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/qualimap_genomic_origin-cnt.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/qualimap_genomic_origin-pct.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/rsem_assignment_plot-cnt.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/rsem_assignment_plot-pct.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/rsem_multimapping_rates.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/rseqc_bam_stat.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/rseqc_infer_experiment_plot.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/rseqc_inner_distance_plot_Counts.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/rseqc_inner_distance_plot_Percentages.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-cnt.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Events-pct.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/rseqc_junction_annotation_junctions_plot_Junctions-pct.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/rseqc_junction_saturation_plot_All_Junctions.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Known_Junctions.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/rseqc_junction_saturation_plot_Novel_Junctions.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/rseqc_read_distribution_plot-cnt.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/rseqc_read_distribution_plot-pct.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/rseqc_read_dups_plot.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/salmon_deseq2_clustering-plot.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/salmon_deseq2_pca-plot.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/salmon_plot.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/samtools-flagstat-dp_Percentage_of_total.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/samtools-flagstat-dp_Read_counts.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/samtools-stats-dp.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/samtools_alignment_plot-cnt.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/samtools_alignment_plot-pct.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/star_rsem_deseq2_clustering-plot.svg", + "multiqc/star_rsem/multiqc_report_plots/svg/star_rsem_deseq2_pca-plot.svg", + "pipeline_info", + "pipeline_info/nf_core_rnaseq_software_mqc_versions.yml", + "salmon", + "salmon/RAP1_IAA_30M_REP1", + "salmon/RAP1_IAA_30M_REP1/aux_info", + "salmon/RAP1_IAA_30M_REP1/aux_info/ambig_info.tsv", + "salmon/RAP1_IAA_30M_REP1/aux_info/expected_bias.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/fld.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/meta_info.json", + "salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias.gz", + "salmon/RAP1_IAA_30M_REP1/aux_info/observed_bias_3p.gz", + "salmon/RAP1_IAA_30M_REP1/cmd_info.json", + "salmon/RAP1_IAA_30M_REP1/libParams", + "salmon/RAP1_IAA_30M_REP1/libParams/flenDist.txt", + "salmon/RAP1_IAA_30M_REP1/lib_format_counts.json", + "salmon/RAP1_IAA_30M_REP1/logs", + "salmon/RAP1_IAA_30M_REP1/logs/salmon_quant.log", + "salmon/RAP1_IAA_30M_REP1/quant.genes.sf", + "salmon/RAP1_IAA_30M_REP1/quant.sf", + "salmon/RAP1_UNINDUCED_REP1", + "salmon/RAP1_UNINDUCED_REP1/aux_info", + "salmon/RAP1_UNINDUCED_REP1/aux_info/ambig_info.tsv", + "salmon/RAP1_UNINDUCED_REP1/aux_info/expected_bias.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/fld.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/meta_info.json", + "salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias.gz", + "salmon/RAP1_UNINDUCED_REP1/aux_info/observed_bias_3p.gz", + "salmon/RAP1_UNINDUCED_REP1/cmd_info.json", + "salmon/RAP1_UNINDUCED_REP1/libParams", + "salmon/RAP1_UNINDUCED_REP1/libParams/flenDist.txt", + "salmon/RAP1_UNINDUCED_REP1/lib_format_counts.json", + "salmon/RAP1_UNINDUCED_REP1/logs", + "salmon/RAP1_UNINDUCED_REP1/logs/salmon_quant.log", + "salmon/RAP1_UNINDUCED_REP1/quant.genes.sf", + "salmon/RAP1_UNINDUCED_REP1/quant.sf", + "salmon/RAP1_UNINDUCED_REP2", + "salmon/RAP1_UNINDUCED_REP2/aux_info", + "salmon/RAP1_UNINDUCED_REP2/aux_info/ambig_info.tsv", + "salmon/RAP1_UNINDUCED_REP2/aux_info/expected_bias.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/fld.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/meta_info.json", + "salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias.gz", + "salmon/RAP1_UNINDUCED_REP2/aux_info/observed_bias_3p.gz", + "salmon/RAP1_UNINDUCED_REP2/cmd_info.json", + "salmon/RAP1_UNINDUCED_REP2/libParams", + "salmon/RAP1_UNINDUCED_REP2/libParams/flenDist.txt", + "salmon/RAP1_UNINDUCED_REP2/lib_format_counts.json", + "salmon/RAP1_UNINDUCED_REP2/logs", + "salmon/RAP1_UNINDUCED_REP2/logs/salmon_quant.log", + "salmon/RAP1_UNINDUCED_REP2/quant.genes.sf", + "salmon/RAP1_UNINDUCED_REP2/quant.sf", + "salmon/WT_REP1", + "salmon/WT_REP1/aux_info", + "salmon/WT_REP1/aux_info/ambig_info.tsv", + "salmon/WT_REP1/aux_info/expected_bias.gz", + "salmon/WT_REP1/aux_info/fld.gz", + "salmon/WT_REP1/aux_info/meta_info.json", + "salmon/WT_REP1/aux_info/observed_bias.gz", + "salmon/WT_REP1/aux_info/observed_bias_3p.gz", + "salmon/WT_REP1/cmd_info.json", + "salmon/WT_REP1/libParams", + "salmon/WT_REP1/libParams/flenDist.txt", + "salmon/WT_REP1/lib_format_counts.json", + "salmon/WT_REP1/logs", + "salmon/WT_REP1/logs/salmon_quant.log", + "salmon/WT_REP1/quant.genes.sf", + "salmon/WT_REP1/quant.sf", + "salmon/WT_REP2", + "salmon/WT_REP2/aux_info", + "salmon/WT_REP2/aux_info/ambig_info.tsv", + "salmon/WT_REP2/aux_info/expected_bias.gz", + "salmon/WT_REP2/aux_info/fld.gz", + "salmon/WT_REP2/aux_info/meta_info.json", + "salmon/WT_REP2/aux_info/observed_bias.gz", + "salmon/WT_REP2/aux_info/observed_bias_3p.gz", + "salmon/WT_REP2/cmd_info.json", + "salmon/WT_REP2/libParams", + "salmon/WT_REP2/libParams/flenDist.txt", + "salmon/WT_REP2/lib_format_counts.json", + "salmon/WT_REP2/logs", + "salmon/WT_REP2/logs/salmon_quant.log", + "salmon/WT_REP2/quant.genes.sf", + "salmon/WT_REP2/quant.sf", + "salmon/deseq2_qc", + "salmon/deseq2_qc/R_sessionInfo.log", + "salmon/deseq2_qc/deseq2.dds.RData", + "salmon/deseq2_qc/deseq2.pca.vals.txt", + "salmon/deseq2_qc/deseq2.plots.pdf", + "salmon/deseq2_qc/deseq2.sample.dists.txt", + "salmon/deseq2_qc/size_factors", + "salmon/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt", + "salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt", + "salmon/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt", + "salmon/deseq2_qc/size_factors/WT_REP1.txt", + "salmon/deseq2_qc/size_factors/WT_REP2.txt", + "salmon/deseq2_qc/size_factors/deseq2.size_factors.RData", + "salmon/salmon.merged.gene_counts.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts.tsv", + "salmon/salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts_length_scaled.tsv", + "salmon/salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", + "salmon/salmon.merged.gene_counts_scaled.tsv", + "salmon/salmon.merged.gene_lengths.tsv", + "salmon/salmon.merged.gene_tpm.tsv", + "salmon/salmon.merged.transcript_counts.SummarizedExperiment.rds", + "salmon/salmon.merged.transcript_counts.tsv", + "salmon/salmon.merged.transcript_lengths.tsv", + "salmon/salmon.merged.transcript_tpm.tsv", + "salmon/tx2gene.tsv", + "star_rsem", + "star_rsem/RAP1_IAA_30M_REP1.genes.results", + "star_rsem/RAP1_IAA_30M_REP1.isoforms.results", + "star_rsem/RAP1_IAA_30M_REP1.markdup.sorted.bam", + "star_rsem/RAP1_IAA_30M_REP1.markdup.sorted.bam.bai", + "star_rsem/RAP1_IAA_30M_REP1.stat", + "star_rsem/RAP1_IAA_30M_REP1.stat/RAP1_IAA_30M_REP1.cnt", + "star_rsem/RAP1_IAA_30M_REP1.stat/RAP1_IAA_30M_REP1.model", + "star_rsem/RAP1_IAA_30M_REP1.stat/RAP1_IAA_30M_REP1.theta", + "star_rsem/RAP1_UNINDUCED_REP1.genes.results", + "star_rsem/RAP1_UNINDUCED_REP1.isoforms.results", + "star_rsem/RAP1_UNINDUCED_REP1.markdup.sorted.bam", + "star_rsem/RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai", + "star_rsem/RAP1_UNINDUCED_REP1.stat", + "star_rsem/RAP1_UNINDUCED_REP1.stat/RAP1_UNINDUCED_REP1.cnt", + "star_rsem/RAP1_UNINDUCED_REP1.stat/RAP1_UNINDUCED_REP1.model", + "star_rsem/RAP1_UNINDUCED_REP1.stat/RAP1_UNINDUCED_REP1.theta", + "star_rsem/RAP1_UNINDUCED_REP2.genes.results", + "star_rsem/RAP1_UNINDUCED_REP2.isoforms.results", + "star_rsem/RAP1_UNINDUCED_REP2.markdup.sorted.bam", + "star_rsem/RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai", + "star_rsem/RAP1_UNINDUCED_REP2.stat", + "star_rsem/RAP1_UNINDUCED_REP2.stat/RAP1_UNINDUCED_REP2.cnt", + "star_rsem/RAP1_UNINDUCED_REP2.stat/RAP1_UNINDUCED_REP2.model", + "star_rsem/RAP1_UNINDUCED_REP2.stat/RAP1_UNINDUCED_REP2.theta", + "star_rsem/WT_REP1.genes.results", + "star_rsem/WT_REP1.isoforms.results", + "star_rsem/WT_REP1.markdup.sorted.bam", + "star_rsem/WT_REP1.markdup.sorted.bam.bai", + "star_rsem/WT_REP1.stat", + "star_rsem/WT_REP1.stat/WT_REP1.cnt", + "star_rsem/WT_REP1.stat/WT_REP1.model", + "star_rsem/WT_REP1.stat/WT_REP1.theta", + "star_rsem/WT_REP2.genes.results", + "star_rsem/WT_REP2.isoforms.results", + "star_rsem/WT_REP2.markdup.sorted.bam", + "star_rsem/WT_REP2.markdup.sorted.bam.bai", + "star_rsem/WT_REP2.stat", + "star_rsem/WT_REP2.stat/WT_REP2.cnt", + "star_rsem/WT_REP2.stat/WT_REP2.model", + "star_rsem/WT_REP2.stat/WT_REP2.theta", + "star_rsem/bigwig", + "star_rsem/bigwig/RAP1_IAA_30M_REP1.forward.bigWig", + "star_rsem/bigwig/RAP1_IAA_30M_REP1.reverse.bigWig", + "star_rsem/bigwig/RAP1_UNINDUCED_REP1.forward.bigWig", + "star_rsem/bigwig/RAP1_UNINDUCED_REP1.reverse.bigWig", + "star_rsem/bigwig/RAP1_UNINDUCED_REP2.forward.bigWig", + "star_rsem/bigwig/RAP1_UNINDUCED_REP2.reverse.bigWig", + "star_rsem/bigwig/WT_REP1.forward.bigWig", + "star_rsem/bigwig/WT_REP1.reverse.bigWig", + "star_rsem/bigwig/WT_REP2.forward.bigWig", + "star_rsem/bigwig/WT_REP2.reverse.bigWig", + "star_rsem/deseq2_qc", + "star_rsem/deseq2_qc/R_sessionInfo.log", + "star_rsem/deseq2_qc/deseq2.dds.RData", + "star_rsem/deseq2_qc/deseq2.pca.vals.txt", + "star_rsem/deseq2_qc/deseq2.plots.pdf", + "star_rsem/deseq2_qc/deseq2.sample.dists.txt", + "star_rsem/deseq2_qc/size_factors", + "star_rsem/deseq2_qc/size_factors/RAP1_IAA_30M_REP1.txt", + "star_rsem/deseq2_qc/size_factors/RAP1_UNINDUCED_REP1.txt", + "star_rsem/deseq2_qc/size_factors/RAP1_UNINDUCED_REP2.txt", + "star_rsem/deseq2_qc/size_factors/WT_REP1.txt", + "star_rsem/deseq2_qc/size_factors/WT_REP2.txt", + "star_rsem/deseq2_qc/size_factors/deseq2.size_factors.RData", + "star_rsem/dupradar", + "star_rsem/dupradar/box_plot", + "star_rsem/dupradar/box_plot/RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf", + "star_rsem/dupradar/box_plot/RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf", + "star_rsem/dupradar/box_plot/RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf", + "star_rsem/dupradar/box_plot/WT_REP1_duprateExpBoxplot.pdf", + "star_rsem/dupradar/box_plot/WT_REP2_duprateExpBoxplot.pdf", + "star_rsem/dupradar/gene_data", + "star_rsem/dupradar/gene_data/RAP1_IAA_30M_REP1_dupMatrix.txt", + "star_rsem/dupradar/gene_data/RAP1_UNINDUCED_REP1_dupMatrix.txt", + "star_rsem/dupradar/gene_data/RAP1_UNINDUCED_REP2_dupMatrix.txt", + "star_rsem/dupradar/gene_data/WT_REP1_dupMatrix.txt", + "star_rsem/dupradar/gene_data/WT_REP2_dupMatrix.txt", + "star_rsem/dupradar/histogram", + "star_rsem/dupradar/histogram/RAP1_IAA_30M_REP1_expressionHist.pdf", + "star_rsem/dupradar/histogram/RAP1_UNINDUCED_REP1_expressionHist.pdf", + "star_rsem/dupradar/histogram/RAP1_UNINDUCED_REP2_expressionHist.pdf", + "star_rsem/dupradar/histogram/WT_REP1_expressionHist.pdf", + "star_rsem/dupradar/histogram/WT_REP2_expressionHist.pdf", + "star_rsem/dupradar/intercepts_slope", + "star_rsem/dupradar/intercepts_slope/RAP1_IAA_30M_REP1_intercept_slope.txt", + "star_rsem/dupradar/intercepts_slope/RAP1_UNINDUCED_REP1_intercept_slope.txt", + "star_rsem/dupradar/intercepts_slope/RAP1_UNINDUCED_REP2_intercept_slope.txt", + "star_rsem/dupradar/intercepts_slope/WT_REP1_intercept_slope.txt", + "star_rsem/dupradar/intercepts_slope/WT_REP2_intercept_slope.txt", + "star_rsem/dupradar/scatter_plot", + "star_rsem/dupradar/scatter_plot/RAP1_IAA_30M_REP1_duprateExpDens.pdf", + "star_rsem/dupradar/scatter_plot/RAP1_UNINDUCED_REP1_duprateExpDens.pdf", + "star_rsem/dupradar/scatter_plot/RAP1_UNINDUCED_REP2_duprateExpDens.pdf", + "star_rsem/dupradar/scatter_plot/WT_REP1_duprateExpDens.pdf", + "star_rsem/dupradar/scatter_plot/WT_REP2_duprateExpDens.pdf", + "star_rsem/featurecounts", + "star_rsem/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv", + "star_rsem/featurecounts/RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv", + "star_rsem/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt", + "star_rsem/featurecounts/RAP1_IAA_30M_REP1.featureCounts.txt.summary", + "star_rsem/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv", + "star_rsem/featurecounts/RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv", + "star_rsem/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt", + "star_rsem/featurecounts/RAP1_UNINDUCED_REP1.featureCounts.txt.summary", + "star_rsem/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv", + "star_rsem/featurecounts/RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv", + "star_rsem/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt", + "star_rsem/featurecounts/RAP1_UNINDUCED_REP2.featureCounts.txt.summary", + "star_rsem/featurecounts/WT_REP1.biotype_counts_mqc.tsv", + "star_rsem/featurecounts/WT_REP1.biotype_counts_rrna_mqc.tsv", + "star_rsem/featurecounts/WT_REP1.featureCounts.txt", + "star_rsem/featurecounts/WT_REP1.featureCounts.txt.summary", + "star_rsem/featurecounts/WT_REP2.biotype_counts_mqc.tsv", + "star_rsem/featurecounts/WT_REP2.biotype_counts_rrna_mqc.tsv", + "star_rsem/featurecounts/WT_REP2.featureCounts.txt", + "star_rsem/featurecounts/WT_REP2.featureCounts.txt.summary", + "star_rsem/log", + "star_rsem/log/RAP1_IAA_30M_REP1.log", + "star_rsem/log/RAP1_UNINDUCED_REP1.log", + "star_rsem/log/RAP1_UNINDUCED_REP2.log", + "star_rsem/log/WT_REP1.log", + "star_rsem/log/WT_REP2.log", + "star_rsem/picard_metrics", + "star_rsem/picard_metrics/RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "star_rsem/picard_metrics/RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "star_rsem/picard_metrics/RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt", + "star_rsem/picard_metrics/WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt", + "star_rsem/picard_metrics/WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt", + "star_rsem/qualimap", + "star_rsem/qualimap/RAP1_IAA_30M_REP1", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/agogo.css", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/ajax-loader.gif", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/basic.css", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/bgfooter.png", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/bgtop.png", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/comment-bright.png", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/comment-close.png", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/comment.png", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/doctools.js", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/down-pressed.png", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/down.png", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/file.png", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/jquery.js", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/minus.png", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/plus.png", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/pygments.css", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/qualimap_logo_small.png", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/report.css", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/searchtools.js", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/underscore.js", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/up-pressed.png", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/up.png", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/css/websupport.js", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Junction Analysis.png", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Reads Genomic Origin.png", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/images_qualimapReport/Transcript coverage histogram.png", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/qualimapReport.html", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_rsem/qualimap/RAP1_IAA_30M_REP1/rnaseq_qc_results.txt", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/agogo.css", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/ajax-loader.gif", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/basic.css", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/bgfooter.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/bgtop.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/comment-bright.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/comment-close.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/comment.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/doctools.js", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/down-pressed.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/down.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/file.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/jquery.js", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/minus.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/plus.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/pygments.css", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/qualimap_logo_small.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/report.css", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/searchtools.js", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/underscore.js", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/up-pressed.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/up.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/css/websupport.js", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Junction Analysis.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Reads Genomic Origin.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/images_qualimapReport/Transcript coverage histogram.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/qualimapReport.html", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_rsem/qualimap/RAP1_UNINDUCED_REP1/rnaseq_qc_results.txt", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/agogo.css", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/ajax-loader.gif", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/basic.css", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/bgfooter.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/bgtop.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/comment-bright.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/comment-close.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/comment.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/doctools.js", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/down-pressed.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/down.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/file.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/jquery.js", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/minus.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/plus.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/pygments.css", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/qualimap_logo_small.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/report.css", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/searchtools.js", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/underscore.js", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/up-pressed.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/up.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/css/websupport.js", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Junction Analysis.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Reads Genomic Origin.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/images_qualimapReport/Transcript coverage histogram.png", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/qualimapReport.html", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_rsem/qualimap/RAP1_UNINDUCED_REP2/rnaseq_qc_results.txt", + "star_rsem/qualimap/WT_REP1", + "star_rsem/qualimap/WT_REP1/css", + "star_rsem/qualimap/WT_REP1/css/agogo.css", + "star_rsem/qualimap/WT_REP1/css/ajax-loader.gif", + "star_rsem/qualimap/WT_REP1/css/basic.css", + "star_rsem/qualimap/WT_REP1/css/bgfooter.png", + "star_rsem/qualimap/WT_REP1/css/bgtop.png", + "star_rsem/qualimap/WT_REP1/css/comment-bright.png", + "star_rsem/qualimap/WT_REP1/css/comment-close.png", + "star_rsem/qualimap/WT_REP1/css/comment.png", + "star_rsem/qualimap/WT_REP1/css/doctools.js", + "star_rsem/qualimap/WT_REP1/css/down-pressed.png", + "star_rsem/qualimap/WT_REP1/css/down.png", + "star_rsem/qualimap/WT_REP1/css/file.png", + "star_rsem/qualimap/WT_REP1/css/jquery.js", + "star_rsem/qualimap/WT_REP1/css/minus.png", + "star_rsem/qualimap/WT_REP1/css/plus.png", + "star_rsem/qualimap/WT_REP1/css/pygments.css", + "star_rsem/qualimap/WT_REP1/css/qualimap_logo_small.png", + "star_rsem/qualimap/WT_REP1/css/report.css", + "star_rsem/qualimap/WT_REP1/css/searchtools.js", + "star_rsem/qualimap/WT_REP1/css/underscore.js", + "star_rsem/qualimap/WT_REP1/css/up-pressed.png", + "star_rsem/qualimap/WT_REP1/css/up.png", + "star_rsem/qualimap/WT_REP1/css/websupport.js", + "star_rsem/qualimap/WT_REP1/images_qualimapReport", + "star_rsem/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_rsem/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_rsem/qualimap/WT_REP1/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_rsem/qualimap/WT_REP1/images_qualimapReport/Junction Analysis.png", + "star_rsem/qualimap/WT_REP1/images_qualimapReport/Reads Genomic Origin.png", + "star_rsem/qualimap/WT_REP1/images_qualimapReport/Transcript coverage histogram.png", + "star_rsem/qualimap/WT_REP1/qualimapReport.html", + "star_rsem/qualimap/WT_REP1/raw_data_qualimapReport", + "star_rsem/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_rsem/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_rsem/qualimap/WT_REP1/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_rsem/qualimap/WT_REP1/rnaseq_qc_results.txt", + "star_rsem/qualimap/WT_REP2", + "star_rsem/qualimap/WT_REP2/css", + "star_rsem/qualimap/WT_REP2/css/agogo.css", + "star_rsem/qualimap/WT_REP2/css/ajax-loader.gif", + "star_rsem/qualimap/WT_REP2/css/basic.css", + "star_rsem/qualimap/WT_REP2/css/bgfooter.png", + "star_rsem/qualimap/WT_REP2/css/bgtop.png", + "star_rsem/qualimap/WT_REP2/css/comment-bright.png", + "star_rsem/qualimap/WT_REP2/css/comment-close.png", + "star_rsem/qualimap/WT_REP2/css/comment.png", + "star_rsem/qualimap/WT_REP2/css/doctools.js", + "star_rsem/qualimap/WT_REP2/css/down-pressed.png", + "star_rsem/qualimap/WT_REP2/css/down.png", + "star_rsem/qualimap/WT_REP2/css/file.png", + "star_rsem/qualimap/WT_REP2/css/jquery.js", + "star_rsem/qualimap/WT_REP2/css/minus.png", + "star_rsem/qualimap/WT_REP2/css/plus.png", + "star_rsem/qualimap/WT_REP2/css/pygments.css", + "star_rsem/qualimap/WT_REP2/css/qualimap_logo_small.png", + "star_rsem/qualimap/WT_REP2/css/report.css", + "star_rsem/qualimap/WT_REP2/css/searchtools.js", + "star_rsem/qualimap/WT_REP2/css/underscore.js", + "star_rsem/qualimap/WT_REP2/css/up-pressed.png", + "star_rsem/qualimap/WT_REP2/css/up.png", + "star_rsem/qualimap/WT_REP2/css/websupport.js", + "star_rsem/qualimap/WT_REP2/images_qualimapReport", + "star_rsem/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (High).png", + "star_rsem/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Low).png", + "star_rsem/qualimap/WT_REP2/images_qualimapReport/Coverage Profile Along Genes (Total).png", + "star_rsem/qualimap/WT_REP2/images_qualimapReport/Junction Analysis.png", + "star_rsem/qualimap/WT_REP2/images_qualimapReport/Reads Genomic Origin.png", + "star_rsem/qualimap/WT_REP2/images_qualimapReport/Transcript coverage histogram.png", + "star_rsem/qualimap/WT_REP2/qualimapReport.html", + "star_rsem/qualimap/WT_REP2/raw_data_qualimapReport", + "star_rsem/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(high).txt", + "star_rsem/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(low).txt", + "star_rsem/qualimap/WT_REP2/raw_data_qualimapReport/coverage_profile_along_genes_(total).txt", + "star_rsem/qualimap/WT_REP2/rnaseq_qc_results.txt", + "star_rsem/rsem.merged.gene_counts.tsv", + "star_rsem/rsem.merged.gene_tpm.tsv", + "star_rsem/rsem.merged.transcript_counts.tsv", + "star_rsem/rsem.merged.transcript_tpm.tsv", + "star_rsem/rseqc", + "star_rsem/rseqc/bam_stat", + "star_rsem/rseqc/bam_stat/RAP1_IAA_30M_REP1.bam_stat.txt", + "star_rsem/rseqc/bam_stat/RAP1_UNINDUCED_REP1.bam_stat.txt", + "star_rsem/rseqc/bam_stat/RAP1_UNINDUCED_REP2.bam_stat.txt", + "star_rsem/rseqc/bam_stat/WT_REP1.bam_stat.txt", + "star_rsem/rseqc/bam_stat/WT_REP2.bam_stat.txt", + "star_rsem/rseqc/infer_experiment", + "star_rsem/rseqc/infer_experiment/RAP1_IAA_30M_REP1.infer_experiment.txt", + "star_rsem/rseqc/infer_experiment/RAP1_UNINDUCED_REP1.infer_experiment.txt", + "star_rsem/rseqc/infer_experiment/RAP1_UNINDUCED_REP2.infer_experiment.txt", + "star_rsem/rseqc/infer_experiment/WT_REP1.infer_experiment.txt", + "star_rsem/rseqc/infer_experiment/WT_REP2.infer_experiment.txt", + "star_rsem/rseqc/inner_distance", + "star_rsem/rseqc/inner_distance/pdf", + "star_rsem/rseqc/inner_distance/pdf/RAP1_IAA_30M_REP1.inner_distance_plot.pdf", + "star_rsem/rseqc/inner_distance/pdf/WT_REP1.inner_distance_plot.pdf", + "star_rsem/rseqc/inner_distance/pdf/WT_REP2.inner_distance_plot.pdf", + "star_rsem/rseqc/inner_distance/rscript", + "star_rsem/rseqc/inner_distance/rscript/RAP1_IAA_30M_REP1.inner_distance_plot.r", + "star_rsem/rseqc/inner_distance/rscript/WT_REP1.inner_distance_plot.r", + "star_rsem/rseqc/inner_distance/rscript/WT_REP2.inner_distance_plot.r", + "star_rsem/rseqc/inner_distance/txt", + "star_rsem/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance.txt", + "star_rsem/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_freq.txt", + "star_rsem/rseqc/inner_distance/txt/RAP1_IAA_30M_REP1.inner_distance_mean.txt", + "star_rsem/rseqc/inner_distance/txt/WT_REP1.inner_distance.txt", + "star_rsem/rseqc/inner_distance/txt/WT_REP1.inner_distance_freq.txt", + "star_rsem/rseqc/inner_distance/txt/WT_REP1.inner_distance_mean.txt", + "star_rsem/rseqc/inner_distance/txt/WT_REP2.inner_distance.txt", + "star_rsem/rseqc/inner_distance/txt/WT_REP2.inner_distance_freq.txt", + "star_rsem/rseqc/inner_distance/txt/WT_REP2.inner_distance_mean.txt", + "star_rsem/rseqc/junction_annotation", + "star_rsem/rseqc/junction_annotation/bed", + "star_rsem/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.Interact.bed", + "star_rsem/rseqc/junction_annotation/bed/RAP1_IAA_30M_REP1.junction.bed", + "star_rsem/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.Interact.bed", + "star_rsem/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP1.junction.bed", + "star_rsem/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.Interact.bed", + "star_rsem/rseqc/junction_annotation/bed/RAP1_UNINDUCED_REP2.junction.bed", + "star_rsem/rseqc/junction_annotation/bed/WT_REP1.junction.Interact.bed", + "star_rsem/rseqc/junction_annotation/bed/WT_REP1.junction.bed", + "star_rsem/rseqc/junction_annotation/bed/WT_REP2.junction.Interact.bed", + "star_rsem/rseqc/junction_annotation/bed/WT_REP2.junction.bed", + "star_rsem/rseqc/junction_annotation/log", + "star_rsem/rseqc/junction_annotation/log/RAP1_IAA_30M_REP1.junction_annotation.log", + "star_rsem/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP1.junction_annotation.log", + "star_rsem/rseqc/junction_annotation/log/RAP1_UNINDUCED_REP2.junction_annotation.log", + "star_rsem/rseqc/junction_annotation/log/WT_REP1.junction_annotation.log", + "star_rsem/rseqc/junction_annotation/log/WT_REP2.junction_annotation.log", + "star_rsem/rseqc/junction_annotation/pdf", + "star_rsem/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_events.pdf", + "star_rsem/rseqc/junction_annotation/pdf/RAP1_IAA_30M_REP1.splice_junction.pdf", + "star_rsem/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_events.pdf", + "star_rsem/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP1.splice_junction.pdf", + "star_rsem/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_events.pdf", + "star_rsem/rseqc/junction_annotation/pdf/RAP1_UNINDUCED_REP2.splice_junction.pdf", + "star_rsem/rseqc/junction_annotation/pdf/WT_REP1.splice_events.pdf", + "star_rsem/rseqc/junction_annotation/pdf/WT_REP1.splice_junction.pdf", + "star_rsem/rseqc/junction_annotation/pdf/WT_REP2.splice_events.pdf", + "star_rsem/rseqc/junction_annotation/pdf/WT_REP2.splice_junction.pdf", + "star_rsem/rseqc/junction_annotation/rscript", + "star_rsem/rseqc/junction_annotation/rscript/RAP1_IAA_30M_REP1.junction_plot.r", + "star_rsem/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP1.junction_plot.r", + "star_rsem/rseqc/junction_annotation/rscript/RAP1_UNINDUCED_REP2.junction_plot.r", + "star_rsem/rseqc/junction_annotation/rscript/WT_REP1.junction_plot.r", + "star_rsem/rseqc/junction_annotation/rscript/WT_REP2.junction_plot.r", + "star_rsem/rseqc/junction_annotation/xls", + "star_rsem/rseqc/junction_annotation/xls/RAP1_IAA_30M_REP1.junction.xls", + "star_rsem/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP1.junction.xls", + "star_rsem/rseqc/junction_annotation/xls/RAP1_UNINDUCED_REP2.junction.xls", + "star_rsem/rseqc/junction_annotation/xls/WT_REP1.junction.xls", + "star_rsem/rseqc/junction_annotation/xls/WT_REP2.junction.xls", + "star_rsem/rseqc/junction_saturation", + "star_rsem/rseqc/junction_saturation/pdf", + "star_rsem/rseqc/junction_saturation/pdf/RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf", + "star_rsem/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf", + "star_rsem/rseqc/junction_saturation/pdf/RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf", + "star_rsem/rseqc/junction_saturation/pdf/WT_REP1.junctionSaturation_plot.pdf", + "star_rsem/rseqc/junction_saturation/pdf/WT_REP2.junctionSaturation_plot.pdf", + "star_rsem/rseqc/junction_saturation/rscript", + "star_rsem/rseqc/junction_saturation/rscript/RAP1_IAA_30M_REP1.junctionSaturation_plot.r", + "star_rsem/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP1.junctionSaturation_plot.r", + "star_rsem/rseqc/junction_saturation/rscript/RAP1_UNINDUCED_REP2.junctionSaturation_plot.r", + "star_rsem/rseqc/junction_saturation/rscript/WT_REP1.junctionSaturation_plot.r", + "star_rsem/rseqc/junction_saturation/rscript/WT_REP2.junctionSaturation_plot.r", + "star_rsem/rseqc/read_distribution", + "star_rsem/rseqc/read_distribution/RAP1_IAA_30M_REP1.read_distribution.txt", + "star_rsem/rseqc/read_distribution/RAP1_UNINDUCED_REP1.read_distribution.txt", + "star_rsem/rseqc/read_distribution/RAP1_UNINDUCED_REP2.read_distribution.txt", + "star_rsem/rseqc/read_distribution/WT_REP1.read_distribution.txt", + "star_rsem/rseqc/read_distribution/WT_REP2.read_distribution.txt", + "star_rsem/rseqc/read_duplication", + "star_rsem/rseqc/read_duplication/pdf", + "star_rsem/rseqc/read_duplication/pdf/RAP1_IAA_30M_REP1.DupRate_plot.pdf", + "star_rsem/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP1.DupRate_plot.pdf", + "star_rsem/rseqc/read_duplication/pdf/RAP1_UNINDUCED_REP2.DupRate_plot.pdf", + "star_rsem/rseqc/read_duplication/pdf/WT_REP1.DupRate_plot.pdf", + "star_rsem/rseqc/read_duplication/pdf/WT_REP2.DupRate_plot.pdf", + "star_rsem/rseqc/read_duplication/rscript", + "star_rsem/rseqc/read_duplication/rscript/RAP1_IAA_30M_REP1.DupRate_plot.r", + "star_rsem/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP1.DupRate_plot.r", + "star_rsem/rseqc/read_duplication/rscript/RAP1_UNINDUCED_REP2.DupRate_plot.r", + "star_rsem/rseqc/read_duplication/rscript/WT_REP1.DupRate_plot.r", + "star_rsem/rseqc/read_duplication/rscript/WT_REP2.DupRate_plot.r", + "star_rsem/rseqc/read_duplication/xls", + "star_rsem/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.pos.DupRate.xls", + "star_rsem/rseqc/read_duplication/xls/RAP1_IAA_30M_REP1.seq.DupRate.xls", + "star_rsem/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.pos.DupRate.xls", + "star_rsem/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP1.seq.DupRate.xls", + "star_rsem/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.pos.DupRate.xls", + "star_rsem/rseqc/read_duplication/xls/RAP1_UNINDUCED_REP2.seq.DupRate.xls", + "star_rsem/rseqc/read_duplication/xls/WT_REP1.pos.DupRate.xls", + "star_rsem/rseqc/read_duplication/xls/WT_REP1.seq.DupRate.xls", + "star_rsem/rseqc/read_duplication/xls/WT_REP2.pos.DupRate.xls", + "star_rsem/rseqc/read_duplication/xls/WT_REP2.seq.DupRate.xls", + "star_rsem/samtools_stats", + "star_rsem/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat", + "star_rsem/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats", + "star_rsem/samtools_stats/RAP1_IAA_30M_REP1.markdup.sorted.bam.stats", + "star_rsem/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.flagstat", + "star_rsem/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.idxstats", + "star_rsem/samtools_stats/RAP1_IAA_30M_REP1.sorted.bam.stats", + "star_rsem/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat", + "star_rsem/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats", + "star_rsem/samtools_stats/RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats", + "star_rsem/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.flagstat", + "star_rsem/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.idxstats", + "star_rsem/samtools_stats/RAP1_UNINDUCED_REP1.sorted.bam.stats", + "star_rsem/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat", + "star_rsem/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats", + "star_rsem/samtools_stats/RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats", + "star_rsem/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.flagstat", + "star_rsem/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.idxstats", + "star_rsem/samtools_stats/RAP1_UNINDUCED_REP2.sorted.bam.stats", + "star_rsem/samtools_stats/WT_REP1.markdup.sorted.bam.flagstat", + "star_rsem/samtools_stats/WT_REP1.markdup.sorted.bam.idxstats", + "star_rsem/samtools_stats/WT_REP1.markdup.sorted.bam.stats", + "star_rsem/samtools_stats/WT_REP1.sorted.bam.flagstat", + "star_rsem/samtools_stats/WT_REP1.sorted.bam.idxstats", + "star_rsem/samtools_stats/WT_REP1.sorted.bam.stats", + "star_rsem/samtools_stats/WT_REP2.markdup.sorted.bam.flagstat", + "star_rsem/samtools_stats/WT_REP2.markdup.sorted.bam.idxstats", + "star_rsem/samtools_stats/WT_REP2.markdup.sorted.bam.stats", + "star_rsem/samtools_stats/WT_REP2.sorted.bam.flagstat", + "star_rsem/samtools_stats/WT_REP2.sorted.bam.idxstats", + "star_rsem/samtools_stats/WT_REP2.sorted.bam.stats", + "star_rsem/stringtie", + "star_rsem/stringtie/RAP1_IAA_30M_REP1.ballgown", + "star_rsem/stringtie/RAP1_IAA_30M_REP1.ballgown/e2t.ctab", + "star_rsem/stringtie/RAP1_IAA_30M_REP1.ballgown/e_data.ctab", + "star_rsem/stringtie/RAP1_IAA_30M_REP1.ballgown/i2t.ctab", + "star_rsem/stringtie/RAP1_IAA_30M_REP1.ballgown/i_data.ctab", + "star_rsem/stringtie/RAP1_IAA_30M_REP1.ballgown/t_data.ctab", + "star_rsem/stringtie/RAP1_IAA_30M_REP1.coverage.gtf", + "star_rsem/stringtie/RAP1_IAA_30M_REP1.gene.abundance.txt", + "star_rsem/stringtie/RAP1_IAA_30M_REP1.transcripts.gtf", + "star_rsem/stringtie/RAP1_UNINDUCED_REP1.ballgown", + "star_rsem/stringtie/RAP1_UNINDUCED_REP1.ballgown/e2t.ctab", + "star_rsem/stringtie/RAP1_UNINDUCED_REP1.ballgown/e_data.ctab", + "star_rsem/stringtie/RAP1_UNINDUCED_REP1.ballgown/i2t.ctab", + "star_rsem/stringtie/RAP1_UNINDUCED_REP1.ballgown/i_data.ctab", + "star_rsem/stringtie/RAP1_UNINDUCED_REP1.ballgown/t_data.ctab", + "star_rsem/stringtie/RAP1_UNINDUCED_REP1.coverage.gtf", + "star_rsem/stringtie/RAP1_UNINDUCED_REP1.gene.abundance.txt", + "star_rsem/stringtie/RAP1_UNINDUCED_REP1.transcripts.gtf", + "star_rsem/stringtie/RAP1_UNINDUCED_REP2.ballgown", + "star_rsem/stringtie/RAP1_UNINDUCED_REP2.ballgown/e2t.ctab", + "star_rsem/stringtie/RAP1_UNINDUCED_REP2.ballgown/e_data.ctab", + "star_rsem/stringtie/RAP1_UNINDUCED_REP2.ballgown/i2t.ctab", + "star_rsem/stringtie/RAP1_UNINDUCED_REP2.ballgown/i_data.ctab", + "star_rsem/stringtie/RAP1_UNINDUCED_REP2.ballgown/t_data.ctab", + "star_rsem/stringtie/RAP1_UNINDUCED_REP2.coverage.gtf", + "star_rsem/stringtie/RAP1_UNINDUCED_REP2.gene.abundance.txt", + "star_rsem/stringtie/RAP1_UNINDUCED_REP2.transcripts.gtf", + "star_rsem/stringtie/WT_REP1.ballgown", + "star_rsem/stringtie/WT_REP1.ballgown/e2t.ctab", + "star_rsem/stringtie/WT_REP1.ballgown/e_data.ctab", + "star_rsem/stringtie/WT_REP1.ballgown/i2t.ctab", + "star_rsem/stringtie/WT_REP1.ballgown/i_data.ctab", + "star_rsem/stringtie/WT_REP1.ballgown/t_data.ctab", + "star_rsem/stringtie/WT_REP1.coverage.gtf", + "star_rsem/stringtie/WT_REP1.gene.abundance.txt", + "star_rsem/stringtie/WT_REP1.transcripts.gtf", + "star_rsem/stringtie/WT_REP2.ballgown", + "star_rsem/stringtie/WT_REP2.ballgown/e2t.ctab", + "star_rsem/stringtie/WT_REP2.ballgown/e_data.ctab", + "star_rsem/stringtie/WT_REP2.ballgown/i2t.ctab", + "star_rsem/stringtie/WT_REP2.ballgown/i_data.ctab", + "star_rsem/stringtie/WT_REP2.ballgown/t_data.ctab", + "star_rsem/stringtie/WT_REP2.coverage.gtf", + "star_rsem/stringtie/WT_REP2.gene.abundance.txt", + "star_rsem/stringtie/WT_REP2.transcripts.gtf", + "trimgalore", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" + ], + [ + "genome_gfp.fasta:md5,e23e302af63736a199985a169fdac055", + "genome_gfp.gtf:md5,c98b12c302f15731bfc36bcf297cfe28", + "cutadapt_filtered_reads_plot.txt:md5,bf033e64e9d23bee85b6277f11c663f1", + "cutadapt_trimmed_sequences_plot_3_Counts.txt:md5,13dfa866fd91dbb072689efe9aa83b1f", + "cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt:md5,07145dd8dd3db654859b18eb0389046c", + "fastqc-status-check-heatmap-1.txt:md5,22a03548736b88b23be6bc0c9ef1b4a6", + "fastqc-status-check-heatmap.txt:md5,5a89b0d8d162f6b1dbdaf39457bbc03b", + "fastqc_adapter_content_plot.txt:md5,da0389be84cfdd189b1d045212eb2974", + "fastqc_overrepresented_sequences_plot-1.txt:md5,4adfeacd3a3a6c7c808f121b24e6b247", + "fastqc_overrepresented_sequences_plot.txt:md5,25d88ea8a72f55e8a374ae802bc7f0b1", + "fastqc_per_base_n_content_plot-1.txt:md5,418610c1ce119cb786ad434db75d366e", + "fastqc_per_base_n_content_plot.txt:md5,d368d7e36ca2f73dcde61f2b486d8213", + "fastqc_per_base_sequence_quality_plot-1.txt:md5,bd22e06e41c096ad4f745d40fe96a1e5", + "fastqc_per_base_sequence_quality_plot.txt:md5,5c3065b549129702b185ea1b817da420", + "fastqc_per_sequence_gc_content_plot-1_Counts.txt:md5,004c60768ceb6197765154e3eaa37b7a", + "fastqc_per_sequence_gc_content_plot-1_Percentages.txt:md5,95d29060b687f745288ad1ec47750037", + "fastqc_per_sequence_gc_content_plot_Counts.txt:md5,9ddaa50167117d3c9188ccf015427704", + "fastqc_per_sequence_gc_content_plot_Percentages.txt:md5,f10ee2881b61308af35f304aa3d810a3", + "fastqc_per_sequence_quality_scores_plot-1.txt:md5,0f9834cc19f76dd5c87cf8cba7435a7c", + "fastqc_per_sequence_quality_scores_plot.txt:md5,b5f9a02933e3065952237afd2ec9ce82", + "fastqc_sequence_counts_plot-1.txt:md5,3861354bbedfbde7ca36a72994f9425c", + "fastqc_sequence_counts_plot.txt:md5,d385a3e2c2573a0902c66e8c93876d3c", + "fastqc_sequence_duplication_levels_plot-1.txt:md5,c73407d55fc532e864fa1dc8dbc12874", + "fastqc_sequence_duplication_levels_plot.txt:md5,8812cee16f6ca65e2c33635754de1772", + "fastqc_sequence_length_distribution_plot.txt:md5,6fe2c985606abad947bcca99b015ae33", + "multiqc_citations.txt:md5,5a68f7972ea275b21b12acdf43447dfb", + "multiqc_cutadapt.txt:md5,aac9581a5670cb55edf564f3d6c1f9a7", + "multiqc_fastqc_fastqc_raw.txt:md5,81c3c1a2575a1891a7f2a9637a0f2cc0", + "multiqc_fastqc_fastqc_trimmed.txt:md5,a3238f515e01d158d875d69968753804", + "multiqc_featurecounts_biotype_plot.txt:md5,27bb37d346e8f0960c882a3676e219e8", + "multiqc_samtools_idxstats.txt:md5,1cbc64fc9713831a6f45effc0cfe6a39", + "multiqc_star_rsem_deseq2_pca-plot.txt:md5,7a428c83a9dec1f43ecd4fbbea664ece", + "picard_histogram.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "picard_histogram_1.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "picard_histogram_2.txt:md5,d41d8cd98f00b204e9800998ecf8427e", + "qualimap_gene_coverage_profile_Counts.txt:md5,387c07f2a93e3d13048c4cd788d1fcc3", + "qualimap_gene_coverage_profile_Normalised.txt:md5,35f0b71796622269bc51cf1e7a0650ab", + "qualimap_rnaseq_cov_hist.txt:md5,a620cb9d1878e86e10e87500e98122f1", + "rseqc_infer_experiment_plot.txt:md5,c0ddf72b026cdc54ad03e75eaa636f7e", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt:md5,75acd04232d1804b5f960ee4c5db4722", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt:md5,3e67e07b5c978fa363965e8e90356eef", + "samtools-idxstats-mapped-reads-plot_Raw_Counts.txt:md5,a83e44c5a22e014d377c41419175784c", + "cutadapt_filtered_reads_plot-cnt.png:md5,704cf0d91bfa3dd658dd8c9590f669a2", + "cutadapt_filtered_reads_plot-pct.png:md5,2684d8b2afca3300e5786486b80237f0", + "cutadapt_trimmed_sequences_plot_3_Counts.png:md5,bef41d894629b0c4dab4478bbf197f50", + "cutadapt_trimmed_sequences_plot_3_Obs_Exp.png:md5,1e0d01537d3797623d0b3fd8fbe42787", + "dupradar-section-plot.png:md5,f76a34d2eb6f2351729d79efc1434ee8", + "fastqc-status-check-heatmap-1.png:md5,2402522f8c02e12aea9af088c6595890", + "fastqc-status-check-heatmap.png:md5,fe8b5b4ab4480d46a12a9005932a9b84", + "fastqc_overrepresented_sequences_plot-1.png:md5,40e450251b80ec0efc9364434234ec7f", + "fastqc_overrepresented_sequences_plot.png:md5,6f5ffbdf1bf61fabe5e028c8bc85de14", + "fastqc_per_sequence_gc_content_plot-1_Counts.png:md5,8a806cec2142f9911502e0a253d83d13", + "fastqc_per_sequence_gc_content_plot-1_Percentages.png:md5,953929d50c8490029880e205e4db7959", + "fastqc_per_sequence_gc_content_plot_Counts.png:md5,01f124545af788fd5cc7bbf41b005e16", + "fastqc_per_sequence_gc_content_plot_Percentages.png:md5,eba3abf8bedb2cb20bad90c54e9c8881", + "fastqc_per_sequence_quality_scores_plot-1.png:md5,d2c29cae169f35744500c751b4a7366e", + "fastqc_per_sequence_quality_scores_plot.png:md5,42fd7369a8aca78f620164a9e887c3cb", + "fastqc_sequence_counts_plot-1-cnt.png:md5,2874fea747c7ff46828bf4f17668caf8", + "fastqc_sequence_counts_plot-1-pct.png:md5,0022d7f5ac78b6eff157de24e37c5ab0", + "fastqc_sequence_counts_plot-cnt.png:md5,3890d5555f2a39b46b9f6efb14cb91f2", + "fastqc_sequence_counts_plot-pct.png:md5,55fa5838c8b2db978fcfa5cb83f6b054", + "fastqc_sequence_duplication_levels_plot-1.png:md5,fcd3b1ec2b95fe4bcd607dc28179a754", + "fastqc_sequence_duplication_levels_plot.png:md5,747431f0f38f8e4c41a11a072fa18780", + "featurecounts_biotype_plot-cnt.png:md5,b033cedf28f1b3f6f48f1ed793160679", + "featurecounts_biotype_plot-pct.png:md5,1921c3931d871f8326a6a6c5c8278815", + "qualimap_gene_coverage_profile_Counts.png:md5,04a262d5af169d6d771e48555adab37e", + "qualimap_gene_coverage_profile_Normalised.png:md5,3bddc4f2a7d462996628e33daf490247", + "rsem_multimapping_rates.png:md5,e93d35b86e1be681eae9b6ad19e12350", + "rseqc_infer_experiment_plot.png:md5,1a3a792e9a6e0c0f93c082594b24e566", + "rseqc_read_dups_plot.png:md5,b79c01ce4697ebb7e0ebb4a3da5b44f7", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png:md5,ce6abb232fd5b5f2e66c0fe9a571d75f", + "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png:md5,6b44818f886ef020fb3646f152ad4af6", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png:md5,62aceda4b51ad1ae066f761de3d70d53", + "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png:md5,10d7c1023bcf922ac45e653a58ee13c8", + "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png:md5,2edc4372d981aacfceb4f16da598d63a", + "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png:md5,5d2286a4f77000c199ed22517338da4a", + "ambig_info.tsv:md5,de973a4b22a4457217ae3dc04caf9401", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,1215f0c20f87d3aef8553ef119e1e74c", + "lib_format_counts.json:md5,c24ffe28d70476b5ccdd8bc2d22c0ac1", + "ambig_info.tsv:md5,45f252b4f0e11e6730cf0c29f800fdbb", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,621c6601aade5b1f2e3d6ca2fc71f636", + "lib_format_counts.json:md5,f6d44c0221f7fd559f11a9afe04c9935", + "ambig_info.tsv:md5,6dcc2891ea572e9b8d1ba52cd434ab84", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,9bed6e4dc5428d6f6297adcea29a6326", + "lib_format_counts.json:md5,7c562bf2f70e42f3a7292687dfd328c3", + "ambig_info.tsv:md5,194f574e0586416155e3f33d42e2b167", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,c7ed0aaa5d6c7934ddbebfd29e4eb86d", + "lib_format_counts.json:md5,d46250bb3677d72feeefc435fe6395a6", + "ambig_info.tsv:md5,a26e3f936e65d7da66392603c2f91f6f", + "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", + "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", + "cmd_info.json:md5,69ebfc2c7ca6b221a0a22fa1dc8c20ac", + "lib_format_counts.json:md5,088fd51db07022ffde47033bbd029400", + "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", + "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", + "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", + "RAP1_IAA_30M_REP1_dupMatrix.txt:md5,8da31020df3c5b25167345609c6d08c5", + "RAP1_UNINDUCED_REP1_dupMatrix.txt:md5,3f269a6b2e9c8eaab66582e31d208dfc", + "RAP1_UNINDUCED_REP2_dupMatrix.txt:md5,7d96d6ddf1d12d43837b105865aeaafa", + "WT_REP1_dupMatrix.txt:md5,802dd0de10d9118943869239f8659c78", + "WT_REP2_dupMatrix.txt:md5,e97a3c8d2e606d7d4b40cd33eb0b96c4", + "RAP1_IAA_30M_REP1_intercept_slope.txt:md5,d280fe126a5e82d24121d8662fd5a161", + "RAP1_UNINDUCED_REP1_intercept_slope.txt:md5,a498640b0f9e710311ebc3eb67cedbd0", + "RAP1_UNINDUCED_REP2_intercept_slope.txt:md5,a1c5346e3bad40546c793b8914a22e7e", + "WT_REP1_intercept_slope.txt:md5,9c2e2b7890427e79c97e65827102d965", + "WT_REP2_intercept_slope.txt:md5,db7a36459f2036de6657e74d2c98a47c", + "RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv:md5,e66cd2b584d970ae3827ad2521f795ca", + "RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv:md5,dde2de0cb90e10d0195c726f768e9941", + "RAP1_IAA_30M_REP1.featureCounts.txt:md5,b3013c797d2fd38a8efa39047f5ba1b1", + "RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv:md5,548023e639f8eb76f973a2f98bcbc82c", + "RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv:md5,845ff9059c72bc6722a8de69776e22bb", + "RAP1_UNINDUCED_REP1.featureCounts.txt:md5,ff59317794fc04d5a4fd18797f0ecb0f", + "RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv:md5,2c0b5696582493f7a50259679982a6b3", + "RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv:md5,6d3fa4c88c7fe61f638e4624ad5e22f0", + "RAP1_UNINDUCED_REP2.featureCounts.txt:md5,6ee84531ba255791a11b487b6aea75ab", + "WT_REP1.biotype_counts_mqc.tsv:md5,512645a8f736eee160c4465e1940f4a5", + "WT_REP1.biotype_counts_rrna_mqc.tsv:md5,8ef76d717492ca23764938aee8ea33a9", + "WT_REP1.featureCounts.txt:md5,289cc95971a3ec550e018659279c1f59", + "WT_REP2.biotype_counts_mqc.tsv:md5,d4957c0197636b68d27fbd60d388bba1", + "WT_REP2.biotype_counts_rrna_mqc.tsv:md5,12294618fe44df1e7f39348372dcb481", + "WT_REP2.featureCounts.txt:md5,152d2f26df56a88fe4b27c742d8f7447", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,55ed67cd9df6d42446a76f49f6e9d6c0", + "Coverage Profile Along Genes (Low).png:md5,cc6887aedf7b0ce65af934849ada52f7", + "Coverage Profile Along Genes (Total).png:md5,ebb7199f5b5c179b3d0ad66b1833d5f0", + "Transcript coverage histogram.png:md5,db451ddb02fa59b2e46a3b7f936dc7e4", + "coverage_profile_along_genes_(high).txt:md5,31ab137e75752225365bd3d89143dbd2", + "coverage_profile_along_genes_(low).txt:md5,eaceda909bf652b8301fa0ed1bba9ae1", + "coverage_profile_along_genes_(total).txt:md5,eaceda909bf652b8301fa0ed1bba9ae1", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,36376d7393575a03f6e7a1c5be4f8c32", + "Coverage Profile Along Genes (Low).png:md5,24e1862606452bc53f928ccf086e3699", + "Coverage Profile Along Genes (Total).png:md5,c843e9063c3b15e4de1c0b3f680746a9", + "Transcript coverage histogram.png:md5,519b1b92340d1541d864e56b9a6956e0", + "coverage_profile_along_genes_(high).txt:md5,93822686a53dd40d3ff426ddbfc9314e", + "coverage_profile_along_genes_(low).txt:md5,bd8d58c757e4122caee4b4e8df2f4b00", + "coverage_profile_along_genes_(total).txt:md5,bd8d58c757e4122caee4b4e8df2f4b00", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,69dfa9f3eeac16a5615a4346c1d79eab", + "Coverage Profile Along Genes (Low).png:md5,84776e58e5aadee6be3b6225beccd70f", + "Coverage Profile Along Genes (Total).png:md5,2c0ddb2c5004d2f7a65e4814281a0836", + "Transcript coverage histogram.png:md5,2553413f136898302067b0a289f58241", + "coverage_profile_along_genes_(high).txt:md5,cdb2c00c43121e3beccd7f670b34e05e", + "coverage_profile_along_genes_(low).txt:md5,1a9405c8bd7c00f3be082bfebb90b6ed", + "coverage_profile_along_genes_(total).txt:md5,1a9405c8bd7c00f3be082bfebb90b6ed", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,4a4eb6c41483181ed9d67c390868026e", + "Coverage Profile Along Genes (Low).png:md5,332640c6bf816ddeec23d9e12070eede", + "Coverage Profile Along Genes (Total).png:md5,64402bed985293e66a634199b64c98f2", + "Transcript coverage histogram.png:md5,72df8608131b28ee5b23bdbc8c6e4891", + "coverage_profile_along_genes_(high).txt:md5,70c95fbc100f14911d2cc348bdff1587", + "coverage_profile_along_genes_(low).txt:md5,86e56ef794277bcf1e0d121a088b8581", + "coverage_profile_along_genes_(total).txt:md5,86e56ef794277bcf1e0d121a088b8581", + "bgfooter.png:md5,ed01bb040346e4623cc87de331ddb4e1", + "bgtop.png:md5,626a50532dc6e5adbdd968746ef318e8", + "comment-bright.png:md5,0c850bb4920b581bf5e5dba5fa493a64", + "comment-close.png:md5,2635dda49c823e8122d4d11ed385f33d", + "comment.png:md5,882e40f3d6a16c6ed35659b105251525", + "down-pressed.png:md5,ebe8979581eda700fb234a73c661a4b9", + "down.png:md5,f6f3c819cc7ca27d7fd3347e5e7ffe0f", + "file.png:md5,6587e59c55e626744eb6fc11129d99a7", + "minus.png:md5,8d572395aa95c89584a09813ada4dfa1", + "plus.png:md5,0125e6faa04e2cf0141a2d599d3bb220", + "qualimap_logo_small.png:md5,7526f145a97be4682fd59e27dda4f71b", + "up-pressed.png:md5,8ea9bd109342f87fee97943b479c6f7e", + "up.png:md5,ecc373278454cc8ecc12d6ca69e55b36", + "Coverage Profile Along Genes (High).png:md5,8ec27bae1db26eb468ca35843e5eb557", + "Coverage Profile Along Genes (Low).png:md5,5bed9f6b9e27ad01f60d188f24020c6e", + "Coverage Profile Along Genes (Total).png:md5,bb10036285f9e01ed64048597a25766f", + "Transcript coverage histogram.png:md5,e36d2e717f852cc69f2658e6a901a0ec", + "coverage_profile_along_genes_(high).txt:md5,a73462b9ecbd1d2c45d7ca84b5f7925b", + "coverage_profile_along_genes_(low).txt:md5,7adc228bc15e344abb7938ea4d35a846", + "coverage_profile_along_genes_(total).txt:md5,7adc228bc15e344abb7938ea4d35a846", + "rsem.merged.gene_counts.tsv:md5,47f272199f24af4473c959df2a9149dc", + "rsem.merged.gene_tpm.tsv:md5,a197b2d131dea75a83f9c219c23fb7a0", + "rsem.merged.transcript_counts.tsv:md5,ffc75fd409d75edf5209e8e1af8ec8fc", + "rsem.merged.transcript_tpm.tsv:md5,b836618c69d111edf635ce7244ee85e5", + "RAP1_IAA_30M_REP1.infer_experiment.txt:md5,1f31ddae1f98e779e30d846cde3834de", + "RAP1_UNINDUCED_REP1.infer_experiment.txt:md5,a2a8e31dbd0ebd0c12f3f968ffd5391b", + "RAP1_UNINDUCED_REP2.infer_experiment.txt:md5,9ec058d3a4162fd1b4c6175e2106eef4", + "WT_REP1.infer_experiment.txt:md5,d55921c0084806cdf49b9bd8653c8e09", + "WT_REP2.infer_experiment.txt:md5,fe87600c55f433ba995fe18bed5cf5f1", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,5dfd0678eefe33f2c45eea45f6262557", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,19a438db88bdb92228e64a0a8350adbd", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,a02dec82f07185700cc237e617ecc809", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,addcf0f6836e0f81184d5ddaa525895f", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,5354c397909a72a25607c550170e2874", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,389b41d0123509f18af9da9bb2e626cd", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,282685569dc501a8769c98c0c2885378", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,daedcbf428f3912587722da1c5db50d1", + "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", + "e_data.ctab:md5,49e5912dedb709344c7a14b5980c1b40", + "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", + "i_data.ctab:md5,7e81ace0a68bfe42482420b7275de195" + ] ], "meta": { "nf-test": "0.9.0", "nextflow": "24.04.4" }, - "timestamp": "2024-08-26T17:25:04.845767" - }, - "star_rsem/dupradar": { - "content": [ - "RAP1_IAA_30M_REP1_dupMatrix.txt:md5,8da31020df3c5b25167345609c6d08c5", - "RAP1_UNINDUCED_REP1_dupMatrix.txt:md5,3f269a6b2e9c8eaab66582e31d208dfc", - "RAP1_UNINDUCED_REP2_dupMatrix.txt:md5,7d96d6ddf1d12d43837b105865aeaafa", - "WT_REP1_dupMatrix.txt:md5,802dd0de10d9118943869239f8659c78", - "WT_REP2_dupMatrix.txt:md5,e97a3c8d2e606d7d4b40cd33eb0b96c4", - "RAP1_IAA_30M_REP1_intercept_slope.txt:md5,d280fe126a5e82d24121d8662fd5a161", - "RAP1_UNINDUCED_REP1_intercept_slope.txt:md5,a498640b0f9e710311ebc3eb67cedbd0", - "RAP1_UNINDUCED_REP2_intercept_slope.txt:md5,a1c5346e3bad40546c793b8914a22e7e", - "WT_REP1_intercept_slope.txt:md5,9c2e2b7890427e79c97e65827102d965", - "WT_REP2_intercept_slope.txt:md5,db7a36459f2036de6657e74d2c98a47c", - "RAP1_IAA_30M_REP1_duprateExpBoxplot.pdf", - "RAP1_UNINDUCED_REP1_duprateExpBoxplot.pdf", - "RAP1_UNINDUCED_REP2_duprateExpBoxplot.pdf", - "WT_REP1_duprateExpBoxplot.pdf", - "WT_REP2_duprateExpBoxplot.pdf", - "RAP1_IAA_30M_REP1_expressionHist.pdf", - "RAP1_UNINDUCED_REP1_expressionHist.pdf", - "RAP1_UNINDUCED_REP2_expressionHist.pdf", - "WT_REP1_expressionHist.pdf", - "WT_REP2_expressionHist.pdf", - "RAP1_IAA_30M_REP1_duprateExpDens.pdf", - "RAP1_UNINDUCED_REP1_duprateExpDens.pdf", - "RAP1_UNINDUCED_REP2_duprateExpDens.pdf", - "WT_REP1_duprateExpDens.pdf", - "WT_REP2_duprateExpDens.pdf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T17:25:05.410414" - }, - "multiqc_data": { - "content": [ - "cutadapt_filtered_reads_plot.txt:md5,bf033e64e9d23bee85b6277f11c663f1", - "cutadapt_trimmed_sequences_plot_3_Counts.txt:md5,13dfa866fd91dbb072689efe9aa83b1f", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.txt:md5,07145dd8dd3db654859b18eb0389046c", - "fastqc-status-check-heatmap-1.txt:md5,22a03548736b88b23be6bc0c9ef1b4a6", - "fastqc-status-check-heatmap.txt:md5,5a89b0d8d162f6b1dbdaf39457bbc03b", - "fastqc_adapter_content_plot.txt:md5,da0389be84cfdd189b1d045212eb2974", - "fastqc_overrepresented_sequences_plot-1.txt:md5,4adfeacd3a3a6c7c808f121b24e6b247", - "fastqc_overrepresented_sequences_plot.txt:md5,25d88ea8a72f55e8a374ae802bc7f0b1", - "fastqc_per_base_n_content_plot-1.txt:md5,418610c1ce119cb786ad434db75d366e", - "fastqc_per_base_n_content_plot.txt:md5,d368d7e36ca2f73dcde61f2b486d8213", - "fastqc_per_base_sequence_quality_plot-1.txt:md5,bd22e06e41c096ad4f745d40fe96a1e5", - "fastqc_per_base_sequence_quality_plot.txt:md5,5c3065b549129702b185ea1b817da420", - "fastqc_per_sequence_gc_content_plot-1_Counts.txt:md5,004c60768ceb6197765154e3eaa37b7a", - "fastqc_per_sequence_gc_content_plot-1_Percentages.txt:md5,95d29060b687f745288ad1ec47750037", - "fastqc_per_sequence_gc_content_plot_Counts.txt:md5,9ddaa50167117d3c9188ccf015427704", - "fastqc_per_sequence_gc_content_plot_Percentages.txt:md5,f10ee2881b61308af35f304aa3d810a3", - "fastqc_per_sequence_quality_scores_plot-1.txt:md5,0f9834cc19f76dd5c87cf8cba7435a7c", - "fastqc_per_sequence_quality_scores_plot.txt:md5,b5f9a02933e3065952237afd2ec9ce82", - "fastqc_sequence_counts_plot-1.txt:md5,3861354bbedfbde7ca36a72994f9425c", - "fastqc_sequence_counts_plot.txt:md5,d385a3e2c2573a0902c66e8c93876d3c", - "fastqc_sequence_duplication_levels_plot-1.txt:md5,c73407d55fc532e864fa1dc8dbc12874", - "fastqc_sequence_duplication_levels_plot.txt:md5,8812cee16f6ca65e2c33635754de1772", - "fastqc_sequence_length_distribution_plot.txt:md5,6fe2c985606abad947bcca99b015ae33", - "multiqc_citations.txt:md5,5a68f7972ea275b21b12acdf43447dfb", - "multiqc_cutadapt.txt:md5,aac9581a5670cb55edf564f3d6c1f9a7", - "multiqc_fastqc_fastqc_raw.txt:md5,81c3c1a2575a1891a7f2a9637a0f2cc0", - "multiqc_fastqc_fastqc_trimmed.txt:md5,a3238f515e01d158d875d69968753804", - "multiqc_featurecounts_biotype_plot.txt:md5,27bb37d346e8f0960c882a3676e219e8", - "multiqc_samtools_idxstats.txt:md5,1cbc64fc9713831a6f45effc0cfe6a39", - "picard_histogram.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "picard_histogram_1.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "picard_histogram_2.txt:md5,d41d8cd98f00b204e9800998ecf8427e", - "qualimap_gene_coverage_profile_Counts.txt:md5,387c07f2a93e3d13048c4cd788d1fcc3", - "qualimap_gene_coverage_profile_Normalised.txt:md5,35f0b71796622269bc51cf1e7a0650ab", - "qualimap_rnaseq_cov_hist.txt:md5,a620cb9d1878e86e10e87500e98122f1", - "rseqc_infer_experiment_plot.txt:md5,c0ddf72b026cdc54ad03e75eaa636f7e", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts.txt:md5,75acd04232d1804b5f960ee4c5db4722", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts.txt:md5,3e67e07b5c978fa363965e8e90356eef", - "samtools-idxstats-mapped-reads-plot_Raw_Counts.txt:md5,a83e44c5a22e014d377c41419175784c", - "fastqc_top_overrepresented_sequences_table-1.txt", - "fastqc_top_overrepresented_sequences_table.txt", - "junction_saturation_known.txt", - "junction_saturation_novel.txt", - "multiqc_data.json", - "multiqc_dupradar-section-plot.txt", - "multiqc_fail_strand_check_table.txt", - "multiqc_general_stats.txt", - "multiqc_picard_dups.txt", - "picard_deduplication.txt", - "multiqc_rsem.txt", - "multiqc_rseqc_bam_stat.txt", - "multiqc_rseqc_infer_experiment.txt", - "multiqc_rseqc_junction_annotation.txt", - "multiqc_rseqc_read_distribution.txt", - "multiqc_salmon.txt", - "multiqc_salmon_deseq2_clustering-plot.txt", - "multiqc_salmon_deseq2_clustering-plot_1.txt", - "multiqc_salmon_deseq2_clustering-plot_2.txt", - "multiqc_salmon_deseq2_clustering-plot_3.txt", - "multiqc_salmon_deseq2_clustering-plot_4.txt", - "multiqc_salmon_deseq2_pca-plot.txt", - "multiqc_samtools_flagstat.txt", - "multiqc_samtools_stats.txt", - "multiqc_software_versions.txt", - "multiqc_sources.txt", - "multiqc_star.txt", - "multiqc_star_rsem_deseq2_clustering-plot.txt", - "multiqc_star_rsem_deseq2_clustering-plot_1.txt", - "multiqc_star_rsem_deseq2_clustering-plot_2.txt", - "multiqc_star_rsem_deseq2_clustering-plot_3.txt", - "multiqc_star_rsem_deseq2_clustering-plot_4.txt", - "multiqc_star_rsem_deseq2_pca-plot.txt", - "qualimap_genomic_origin.txt", - "qualimap_rnaseq_genome_results.txt", - "rsem_assignment_plot.txt", - "rsem_multimapping_rates.txt", - "rseqc_bam_stat.txt", - "rseqc_inner_distance.txt", - "rseqc_inner_distance_plot_Counts.txt", - "rseqc_inner_distance_plot_Percentages.txt", - "rseqc_junction_annotation_junctions_plot_Events.txt", - "rseqc_junction_annotation_junctions_plot_Junctions.txt", - "rseqc_junction_saturation_all.txt", - "rseqc_junction_saturation_plot_All_Junctions.txt", - "rseqc_junction_saturation_plot_Known_Junctions.txt", - "rseqc_junction_saturation_plot_Novel_Junctions.txt", - "rseqc_read_distribution_plot.txt", - "rseqc_read_dups.txt", - "rseqc_read_dups_plot.txt", - "salmon_plot.txt", - "samtools-flagstat-dp_Percentage_of_total.txt", - "samtools-flagstat-dp_Read_counts.txt", - "samtools-stats-dp.txt", - "samtools_alignment_plot.txt", - "star_alignment_plot.txt", - "star_summary_table.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T19:43:20.562966" - }, - "star_rsem/samtools_stats": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.bam.flagstat", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.idxstats", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.stats", - "RAP1_IAA_30M_REP1.sorted.bam.flagstat", - "RAP1_IAA_30M_REP1.sorted.bam.idxstats", - "RAP1_IAA_30M_REP1.sorted.bam.stats", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.stats", - "RAP1_UNINDUCED_REP1.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP1.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP1.sorted.bam.stats", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.stats", - "RAP1_UNINDUCED_REP2.sorted.bam.flagstat", - "RAP1_UNINDUCED_REP2.sorted.bam.idxstats", - "RAP1_UNINDUCED_REP2.sorted.bam.stats", - "WT_REP1.markdup.sorted.bam.flagstat", - "WT_REP1.markdup.sorted.bam.idxstats", - "WT_REP1.markdup.sorted.bam.stats", - "WT_REP1.sorted.bam.flagstat", - "WT_REP1.sorted.bam.idxstats", - "WT_REP1.sorted.bam.stats", - "WT_REP2.markdup.sorted.bam.flagstat", - "WT_REP2.markdup.sorted.bam.idxstats", - "WT_REP2.markdup.sorted.bam.stats", - "WT_REP2.sorted.bam.flagstat", - "WT_REP2.sorted.bam.idxstats", - "WT_REP2.sorted.bam.stats" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T19:43:21.034611" - }, - "trimgalore": { - "content": [ - "RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T17:25:06.390067" - }, - "references": { - "content": [ - "genome_gfp.fasta:md5,e23e302af63736a199985a169fdac055", - "genome_gfp.gtf:md5,c98b12c302f15731bfc36bcf297cfe28" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T17:25:03.973573" - }, - "star_rsem/markdup": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.bam", - "RAP1_IAA_30M_REP1.markdup.sorted.bam.bai", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam", - "RAP1_UNINDUCED_REP1.markdup.sorted.bam.bai", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam", - "RAP1_UNINDUCED_REP2.markdup.sorted.bam.bai", - "WT_REP1.markdup.sorted.bam", - "WT_REP1.markdup.sorted.bam.bai", - "WT_REP2.markdup.sorted.bam", - "WT_REP2.markdup.sorted.bam.bai" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T17:25:06.293983" - }, - "salmon/deseq2_qc": { - "content": [ - "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", - "deseq2.dds.RData", - "deseq2.pca.vals.txt", - "deseq2.plots.pdf", - "deseq2.sample.dists.txt", - "RAP1_IAA_30M_REP1.txt", - "RAP1_UNINDUCED_REP1.txt", - "RAP1_UNINDUCED_REP2.txt", - "WT_REP1.txt", - "WT_REP2.txt", - "deseq2.size_factors.RData" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T17:25:04.305332" - }, - "salmon": { - "content": [ - "tx2gene.tsv:md5,0e2418a69d2eba45097ebffc2f700bfe", - "salmon.merged.gene_counts.SummarizedExperiment.rds", - "salmon.merged.gene_counts.tsv", - "salmon.merged.gene_counts_length_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_length_scaled.tsv", - "salmon.merged.gene_counts_scaled.SummarizedExperiment.rds", - "salmon.merged.gene_counts_scaled.tsv", - "salmon.merged.gene_lengths.tsv", - "salmon.merged.gene_tpm.tsv", - "salmon.merged.transcript_counts.SummarizedExperiment.rds", - "salmon.merged.transcript_counts.tsv", - "salmon.merged.transcript_lengths.tsv", - "salmon.merged.transcript_tpm.tsv" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T17:25:04.624383" - }, - "star_rsem/rsem": { - "content": [ - "RAP1_IAA_30M_REP1.genes.results:md5,9f76f2687983812c29b108b1faadbb92", - "RAP1_IAA_30M_REP1.isoforms.results:md5,7e8af74655cfa3533cdd8de305f101a4", - "RAP1_UNINDUCED_REP1.genes.results:md5,0ebfda99b1e92d071d3d8f12f37d25cd", - "RAP1_UNINDUCED_REP1.isoforms.results:md5,5fe29701e388c9ac813ab0e8f02e1e9b", - "RAP1_UNINDUCED_REP2.genes.results:md5,e6bed419600f1bdc30c59f2c2f0beec3", - "RAP1_UNINDUCED_REP2.isoforms.results:md5,35ede7929d359424798d92398d6d9518", - "WT_REP1.genes.results:md5,8cd8c1d87970dbae9983250530a5915d", - "WT_REP1.isoforms.results:md5,993a65e02daecd9457c529d118b6e8ac", - "WT_REP2.genes.results:md5,78387c8f57175756fda9c153790f3d37", - "WT_REP2.isoforms.results:md5,89bd225b6702ec3edbe13d9443fce40f", - "rsem.merged.gene_counts.tsv:md5,47f272199f24af4473c959df2a9149dc", - "rsem.merged.gene_tpm.tsv:md5,a197b2d131dea75a83f9c219c23fb7a0", - "rsem.merged.transcript_counts.tsv:md5,ffc75fd409d75edf5209e8e1af8ec8fc", - "rsem.merged.transcript_tpm.tsv:md5,b836618c69d111edf635ce7244ee85e5", - "RAP1_IAA_30M_REP1.cnt", - "RAP1_IAA_30M_REP1.model", - "RAP1_IAA_30M_REP1.theta", - "RAP1_UNINDUCED_REP1.cnt", - "RAP1_UNINDUCED_REP1.model", - "RAP1_UNINDUCED_REP1.theta", - "RAP1_UNINDUCED_REP2.cnt", - "RAP1_UNINDUCED_REP2.model", - "RAP1_UNINDUCED_REP2.theta", - "WT_REP1.cnt", - "WT_REP1.model", - "WT_REP1.theta", - "WT_REP2.cnt", - "WT_REP2.model", - "WT_REP2.theta" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T19:43:20.906583" - }, - "star_rsem/stringtie": { - "content": [ - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,5dfd0678eefe33f2c45eea45f6262557", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,19a438db88bdb92228e64a0a8350adbd", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,a02dec82f07185700cc237e617ecc809", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,addcf0f6836e0f81184d5ddaa525895f", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,5354c397909a72a25607c550170e2874", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,389b41d0123509f18af9da9bb2e626cd", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,282685569dc501a8769c98c0c2885378", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,daedcbf428f3912587722da1c5db50d1", - "e2t.ctab:md5,54dd6de2daa90e973f47524a738a3d69", - "e_data.ctab:md5,49e5912dedb709344c7a14b5980c1b40", - "i2t.ctab:md5,dda3d3ccd7d4184d947c654ae73efb7b", - "i_data.ctab:md5,7e81ace0a68bfe42482420b7275de195", - "t_data.ctab", - "RAP1_IAA_30M_REP1.coverage.gtf", - "RAP1_IAA_30M_REP1.gene.abundance.txt", - "RAP1_IAA_30M_REP1.transcripts.gtf", - "t_data.ctab", - "RAP1_UNINDUCED_REP1.coverage.gtf", - "RAP1_UNINDUCED_REP1.gene.abundance.txt", - "RAP1_UNINDUCED_REP1.transcripts.gtf", - "t_data.ctab", - "RAP1_UNINDUCED_REP2.coverage.gtf", - "RAP1_UNINDUCED_REP2.gene.abundance.txt", - "RAP1_UNINDUCED_REP2.transcripts.gtf", - "t_data.ctab", - "WT_REP1.coverage.gtf", - "WT_REP1.gene.abundance.txt", - "WT_REP1.transcripts.gtf", - "t_data.ctab", - "WT_REP2.coverage.gtf", - "WT_REP2.gene.abundance.txt", - "WT_REP2.transcripts.gtf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T17:25:06.2015" - }, - "multiqc_plots": { - "content": [ - "cutadapt_filtered_reads_plot-cnt.png:md5,704cf0d91bfa3dd658dd8c9590f669a2", - "cutadapt_filtered_reads_plot-pct.png:md5,2684d8b2afca3300e5786486b80237f0", - "cutadapt_trimmed_sequences_plot_3_Counts.png:md5,bef41d894629b0c4dab4478bbf197f50", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.png:md5,1e0d01537d3797623d0b3fd8fbe42787", - "dupradar-section-plot.png:md5,f76a34d2eb6f2351729d79efc1434ee8", - "fastqc-status-check-heatmap-1.png:md5,2402522f8c02e12aea9af088c6595890", - "fastqc-status-check-heatmap.png:md5,fe8b5b4ab4480d46a12a9005932a9b84", - "fastqc_overrepresented_sequences_plot-1.png:md5,40e450251b80ec0efc9364434234ec7f", - "fastqc_overrepresented_sequences_plot.png:md5,6f5ffbdf1bf61fabe5e028c8bc85de14", - "fastqc_per_sequence_gc_content_plot-1_Counts.png:md5,8a806cec2142f9911502e0a253d83d13", - "fastqc_per_sequence_gc_content_plot-1_Percentages.png:md5,953929d50c8490029880e205e4db7959", - "fastqc_per_sequence_gc_content_plot_Counts.png:md5,01f124545af788fd5cc7bbf41b005e16", - "fastqc_per_sequence_gc_content_plot_Percentages.png:md5,eba3abf8bedb2cb20bad90c54e9c8881", - "fastqc_per_sequence_quality_scores_plot-1.png:md5,d2c29cae169f35744500c751b4a7366e", - "fastqc_per_sequence_quality_scores_plot.png:md5,42fd7369a8aca78f620164a9e887c3cb", - "fastqc_sequence_counts_plot-1-cnt.png:md5,2874fea747c7ff46828bf4f17668caf8", - "fastqc_sequence_counts_plot-1-pct.png:md5,0022d7f5ac78b6eff157de24e37c5ab0", - "fastqc_sequence_counts_plot-cnt.png:md5,3890d5555f2a39b46b9f6efb14cb91f2", - "fastqc_sequence_counts_plot-pct.png:md5,55fa5838c8b2db978fcfa5cb83f6b054", - "fastqc_sequence_duplication_levels_plot-1.png:md5,fcd3b1ec2b95fe4bcd607dc28179a754", - "fastqc_sequence_duplication_levels_plot.png:md5,747431f0f38f8e4c41a11a072fa18780", - "featurecounts_biotype_plot-cnt.png:md5,b033cedf28f1b3f6f48f1ed793160679", - "featurecounts_biotype_plot-pct.png:md5,1921c3931d871f8326a6a6c5c8278815", - "qualimap_gene_coverage_profile_Counts.png:md5,04a262d5af169d6d771e48555adab37e", - "qualimap_gene_coverage_profile_Normalised.png:md5,3bddc4f2a7d462996628e33daf490247", - "rsem_multimapping_rates.png:md5,e93d35b86e1be681eae9b6ad19e12350", - "rseqc_infer_experiment_plot.png:md5,1a3a792e9a6e0c0f93c082594b24e566", - "rseqc_read_dups_plot.png:md5,b79c01ce4697ebb7e0ebb4a3da5b44f7", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.png:md5,ce6abb232fd5b5f2e66c0fe9a571d75f", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.png:md5,6b44818f886ef020fb3646f152ad4af6", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.png:md5,62aceda4b51ad1ae066f761de3d70d53", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.png:md5,10d7c1023bcf922ac45e653a58ee13c8", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.png:md5,2edc4372d981aacfceb4f16da598d63a", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.png:md5,5d2286a4f77000c199ed22517338da4a", - "multiqc_report.html", - "cutadapt_filtered_reads_plot-cnt.pdf", - "cutadapt_filtered_reads_plot-pct.pdf", - "cutadapt_trimmed_sequences_plot_3_Counts.pdf", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.pdf", - "dupradar-section-plot.pdf", - "fail_strand_check_table.pdf", - "fastqc-status-check-heatmap-1.pdf", - "fastqc-status-check-heatmap.pdf", - "fastqc_adapter_content_plot.pdf", - "fastqc_overrepresented_sequences_plot-1.pdf", - "fastqc_overrepresented_sequences_plot.pdf", - "fastqc_per_base_n_content_plot-1.pdf", - "fastqc_per_base_n_content_plot.pdf", - "fastqc_per_base_sequence_quality_plot-1.pdf", - "fastqc_per_base_sequence_quality_plot.pdf", - "fastqc_per_sequence_gc_content_plot-1_Counts.pdf", - "fastqc_per_sequence_gc_content_plot-1_Percentages.pdf", - "fastqc_per_sequence_gc_content_plot_Counts.pdf", - "fastqc_per_sequence_gc_content_plot_Percentages.pdf", - "fastqc_per_sequence_quality_scores_plot-1.pdf", - "fastqc_per_sequence_quality_scores_plot.pdf", - "fastqc_sequence_counts_plot-1-cnt.pdf", - "fastqc_sequence_counts_plot-1-pct.pdf", - "fastqc_sequence_counts_plot-cnt.pdf", - "fastqc_sequence_counts_plot-pct.pdf", - "fastqc_sequence_duplication_levels_plot-1.pdf", - "fastqc_sequence_duplication_levels_plot.pdf", - "fastqc_sequence_length_distribution_plot.pdf", - "fastqc_top_overrepresented_sequences_table-1.pdf", - "fastqc_top_overrepresented_sequences_table.pdf", - "featurecounts_biotype_plot-cnt.pdf", - "featurecounts_biotype_plot-pct.pdf", - "general_stats_table.pdf", - "picard_deduplication-cnt.pdf", - "picard_deduplication-pct.pdf", - "qualimap_gene_coverage_profile_Counts.pdf", - "qualimap_gene_coverage_profile_Normalised.pdf", - "qualimap_genomic_origin-cnt.pdf", - "qualimap_genomic_origin-pct.pdf", - "rsem_assignment_plot-cnt.pdf", - "rsem_assignment_plot-pct.pdf", - "rsem_multimapping_rates.pdf", - "rseqc_bam_stat.pdf", - "rseqc_infer_experiment_plot.pdf", - "rseqc_inner_distance_plot_Counts.pdf", - "rseqc_inner_distance_plot_Percentages.pdf", - "rseqc_junction_annotation_junctions_plot_Events-cnt.pdf", - "rseqc_junction_annotation_junctions_plot_Events-pct.pdf", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.pdf", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.pdf", - "rseqc_junction_saturation_plot_All_Junctions.pdf", - "rseqc_junction_saturation_plot_Known_Junctions.pdf", - "rseqc_junction_saturation_plot_Novel_Junctions.pdf", - "rseqc_read_distribution_plot-cnt.pdf", - "rseqc_read_distribution_plot-pct.pdf", - "rseqc_read_dups_plot.pdf", - "salmon_deseq2_clustering-plot.pdf", - "salmon_deseq2_pca-plot.pdf", - "salmon_plot.pdf", - "samtools-flagstat-dp_Percentage_of_total.pdf", - "samtools-flagstat-dp_Read_counts.pdf", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.pdf", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.pdf", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.pdf", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.pdf", - "samtools-stats-dp.pdf", - "samtools_alignment_plot-cnt.pdf", - "samtools_alignment_plot-pct.pdf", - "star_alignment_plot-cnt.pdf", - "star_alignment_plot-pct.pdf", - "star_rsem_deseq2_clustering-plot.pdf", - "star_rsem_deseq2_pca-plot.pdf", - "star_summary_table.pdf", - "fail_strand_check_table.png", - "fastqc_adapter_content_plot.png", - "fastqc_per_base_n_content_plot-1.png", - "fastqc_per_base_n_content_plot.png", - "fastqc_per_base_sequence_quality_plot-1.png", - "fastqc_per_base_sequence_quality_plot.png", - "fastqc_sequence_length_distribution_plot.png", - "fastqc_top_overrepresented_sequences_table-1.png", - "fastqc_top_overrepresented_sequences_table.png", - "general_stats_table.png", - "picard_deduplication-cnt.png", - "picard_deduplication-pct.png", - "qualimap_genomic_origin-cnt.png", - "qualimap_genomic_origin-pct.png", - "rsem_assignment_plot-cnt.png", - "rsem_assignment_plot-pct.png", - "rseqc_bam_stat.png", - "rseqc_inner_distance_plot_Counts.png", - "rseqc_inner_distance_plot_Percentages.png", - "rseqc_junction_annotation_junctions_plot_Events-cnt.png", - "rseqc_junction_annotation_junctions_plot_Events-pct.png", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.png", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.png", - "rseqc_junction_saturation_plot_All_Junctions.png", - "rseqc_junction_saturation_plot_Known_Junctions.png", - "rseqc_junction_saturation_plot_Novel_Junctions.png", - "rseqc_read_distribution_plot-cnt.png", - "rseqc_read_distribution_plot-pct.png", - "salmon_deseq2_clustering-plot.png", - "salmon_deseq2_pca-plot.png", - "salmon_plot.png", - "samtools-flagstat-dp_Percentage_of_total.png", - "samtools-flagstat-dp_Read_counts.png", - "samtools-stats-dp.png", - "samtools_alignment_plot-cnt.png", - "samtools_alignment_plot-pct.png", - "star_alignment_plot-cnt.png", - "star_alignment_plot-pct.png", - "star_rsem_deseq2_clustering-plot.png", - "star_rsem_deseq2_pca-plot.png", - "star_summary_table.png", - "cutadapt_filtered_reads_plot-cnt.svg", - "cutadapt_filtered_reads_plot-pct.svg", - "cutadapt_trimmed_sequences_plot_3_Counts.svg", - "cutadapt_trimmed_sequences_plot_3_Obs_Exp.svg", - "dupradar-section-plot.svg", - "fail_strand_check_table.svg", - "fastqc-status-check-heatmap-1.svg", - "fastqc-status-check-heatmap.svg", - "fastqc_adapter_content_plot.svg", - "fastqc_overrepresented_sequences_plot-1.svg", - "fastqc_overrepresented_sequences_plot.svg", - "fastqc_per_base_n_content_plot-1.svg", - "fastqc_per_base_n_content_plot.svg", - "fastqc_per_base_sequence_quality_plot-1.svg", - "fastqc_per_base_sequence_quality_plot.svg", - "fastqc_per_sequence_gc_content_plot-1_Counts.svg", - "fastqc_per_sequence_gc_content_plot-1_Percentages.svg", - "fastqc_per_sequence_gc_content_plot_Counts.svg", - "fastqc_per_sequence_gc_content_plot_Percentages.svg", - "fastqc_per_sequence_quality_scores_plot-1.svg", - "fastqc_per_sequence_quality_scores_plot.svg", - "fastqc_sequence_counts_plot-1-cnt.svg", - "fastqc_sequence_counts_plot-1-pct.svg", - "fastqc_sequence_counts_plot-cnt.svg", - "fastqc_sequence_counts_plot-pct.svg", - "fastqc_sequence_duplication_levels_plot-1.svg", - "fastqc_sequence_duplication_levels_plot.svg", - "fastqc_sequence_length_distribution_plot.svg", - "fastqc_top_overrepresented_sequences_table-1.svg", - "fastqc_top_overrepresented_sequences_table.svg", - "featurecounts_biotype_plot-cnt.svg", - "featurecounts_biotype_plot-pct.svg", - "general_stats_table.svg", - "picard_deduplication-cnt.svg", - "picard_deduplication-pct.svg", - "qualimap_gene_coverage_profile_Counts.svg", - "qualimap_gene_coverage_profile_Normalised.svg", - "qualimap_genomic_origin-cnt.svg", - "qualimap_genomic_origin-pct.svg", - "rsem_assignment_plot-cnt.svg", - "rsem_assignment_plot-pct.svg", - "rsem_multimapping_rates.svg", - "rseqc_bam_stat.svg", - "rseqc_infer_experiment_plot.svg", - "rseqc_inner_distance_plot_Counts.svg", - "rseqc_inner_distance_plot_Percentages.svg", - "rseqc_junction_annotation_junctions_plot_Events-cnt.svg", - "rseqc_junction_annotation_junctions_plot_Events-pct.svg", - "rseqc_junction_annotation_junctions_plot_Junctions-cnt.svg", - "rseqc_junction_annotation_junctions_plot_Junctions-pct.svg", - "rseqc_junction_saturation_plot_All_Junctions.svg", - "rseqc_junction_saturation_plot_Known_Junctions.svg", - "rseqc_junction_saturation_plot_Novel_Junctions.svg", - "rseqc_read_distribution_plot-cnt.svg", - "rseqc_read_distribution_plot-pct.svg", - "rseqc_read_dups_plot.svg", - "salmon_deseq2_clustering-plot.svg", - "salmon_deseq2_pca-plot.svg", - "salmon_plot.svg", - "samtools-flagstat-dp_Percentage_of_total.svg", - "samtools-flagstat-dp_Read_counts.svg", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Normalised_Counts-log.svg", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Observed_over_Expected_Counts-log.svg", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-cnt.svg", - "samtools-idxstats-mapped-reads-plot_Raw_Counts-log.svg", - "samtools-stats-dp.svg", - "samtools_alignment_plot-cnt.svg", - "samtools_alignment_plot-pct.svg", - "star_alignment_plot-cnt.svg", - "star_alignment_plot-pct.svg", - "star_rsem_deseq2_clustering-plot.svg", - "star_rsem_deseq2_pca-plot.svg", - "star_summary_table.svg" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T19:43:20.672077" - }, - "star_rsem/picard_metrics": { - "content": [ - "RAP1_IAA_30M_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "RAP1_UNINDUCED_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "RAP1_UNINDUCED_REP2.markdup.sorted.MarkDuplicates.metrics.txt", - "WT_REP1.markdup.sorted.MarkDuplicates.metrics.txt", - "WT_REP2.markdup.sorted.MarkDuplicates.metrics.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T17:25:05.82482" - }, - "fastqc/raw": { - "content": [ - "RAP1_IAA_30M_REP1_raw_1_fastqc.html", - "RAP1_IAA_30M_REP1_raw_1_fastqc.zip", - "RAP1_IAA_30M_REP1_raw_2_fastqc.html", - "RAP1_IAA_30M_REP1_raw_2_fastqc.zip", - "RAP1_UNINDUCED_REP1_raw_fastqc.html", - "RAP1_UNINDUCED_REP1_raw_fastqc.zip", - "RAP1_UNINDUCED_REP2_raw_fastqc.html", - "RAP1_UNINDUCED_REP2_raw_fastqc.zip", - "WT_REP1_raw_1_fastqc.html", - "WT_REP1_raw_1_fastqc.zip", - "WT_REP1_raw_2_fastqc.html", - "WT_REP1_raw_2_fastqc.zip", - "WT_REP2_raw_1_fastqc.html", - "WT_REP2_raw_1_fastqc.zip", - "WT_REP2_raw_2_fastqc.html", - "WT_REP2_raw_2_fastqc.zip" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T17:25:03.993021" - }, - "star_rsem/rseqc": { - "content": [ - "RAP1_IAA_30M_REP1.infer_experiment.txt:md5,1f31ddae1f98e779e30d846cde3834de", - "RAP1_UNINDUCED_REP1.infer_experiment.txt:md5,a2a8e31dbd0ebd0c12f3f968ffd5391b", - "RAP1_UNINDUCED_REP2.infer_experiment.txt:md5,9ec058d3a4162fd1b4c6175e2106eef4", - "WT_REP1.infer_experiment.txt:md5,d55921c0084806cdf49b9bd8653c8e09", - "WT_REP2.infer_experiment.txt:md5,fe87600c55f433ba995fe18bed5cf5f1", - "RAP1_IAA_30M_REP1.bam_stat.txt", - "RAP1_UNINDUCED_REP1.bam_stat.txt", - "RAP1_UNINDUCED_REP2.bam_stat.txt", - "WT_REP1.bam_stat.txt", - "WT_REP2.bam_stat.txt", - "RAP1_IAA_30M_REP1.inner_distance_plot.pdf", - "WT_REP1.inner_distance_plot.pdf", - "WT_REP2.inner_distance_plot.pdf", - "RAP1_IAA_30M_REP1.inner_distance_plot.r", - "WT_REP1.inner_distance_plot.r", - "WT_REP2.inner_distance_plot.r", - "RAP1_IAA_30M_REP1.inner_distance.txt", - "RAP1_IAA_30M_REP1.inner_distance_freq.txt", - "RAP1_IAA_30M_REP1.inner_distance_mean.txt", - "WT_REP1.inner_distance.txt", - "WT_REP1.inner_distance_freq.txt", - "WT_REP1.inner_distance_mean.txt", - "WT_REP2.inner_distance.txt", - "WT_REP2.inner_distance_freq.txt", - "WT_REP2.inner_distance_mean.txt", - "RAP1_IAA_30M_REP1.junction.Interact.bed", - "RAP1_IAA_30M_REP1.junction.bed", - "RAP1_UNINDUCED_REP1.junction.Interact.bed", - "RAP1_UNINDUCED_REP1.junction.bed", - "RAP1_UNINDUCED_REP2.junction.Interact.bed", - "RAP1_UNINDUCED_REP2.junction.bed", - "WT_REP1.junction.Interact.bed", - "WT_REP1.junction.bed", - "WT_REP2.junction.Interact.bed", - "WT_REP2.junction.bed", - "RAP1_IAA_30M_REP1.junction_annotation.log", - "RAP1_UNINDUCED_REP1.junction_annotation.log", - "RAP1_UNINDUCED_REP2.junction_annotation.log", - "WT_REP1.junction_annotation.log", - "WT_REP2.junction_annotation.log", - "RAP1_IAA_30M_REP1.splice_events.pdf", - "RAP1_IAA_30M_REP1.splice_junction.pdf", - "RAP1_UNINDUCED_REP1.splice_events.pdf", - "RAP1_UNINDUCED_REP1.splice_junction.pdf", - "RAP1_UNINDUCED_REP2.splice_events.pdf", - "RAP1_UNINDUCED_REP2.splice_junction.pdf", - "WT_REP1.splice_events.pdf", - "WT_REP1.splice_junction.pdf", - "WT_REP2.splice_events.pdf", - "WT_REP2.splice_junction.pdf", - "RAP1_IAA_30M_REP1.junction_plot.r", - "RAP1_UNINDUCED_REP1.junction_plot.r", - "RAP1_UNINDUCED_REP2.junction_plot.r", - "WT_REP1.junction_plot.r", - "WT_REP2.junction_plot.r", - "RAP1_IAA_30M_REP1.junction.xls", - "RAP1_UNINDUCED_REP1.junction.xls", - "RAP1_UNINDUCED_REP2.junction.xls", - "WT_REP1.junction.xls", - "WT_REP2.junction.xls", - "RAP1_IAA_30M_REP1.junctionSaturation_plot.pdf", - "RAP1_UNINDUCED_REP1.junctionSaturation_plot.pdf", - "RAP1_UNINDUCED_REP2.junctionSaturation_plot.pdf", - "WT_REP1.junctionSaturation_plot.pdf", - "WT_REP2.junctionSaturation_plot.pdf", - "RAP1_IAA_30M_REP1.junctionSaturation_plot.r", - "RAP1_UNINDUCED_REP1.junctionSaturation_plot.r", - "RAP1_UNINDUCED_REP2.junctionSaturation_plot.r", - "WT_REP1.junctionSaturation_plot.r", - "WT_REP2.junctionSaturation_plot.r", - "RAP1_IAA_30M_REP1.read_distribution.txt", - "RAP1_UNINDUCED_REP1.read_distribution.txt", - "RAP1_UNINDUCED_REP2.read_distribution.txt", - "WT_REP1.read_distribution.txt", - "WT_REP2.read_distribution.txt", - "RAP1_IAA_30M_REP1.DupRate_plot.pdf", - "RAP1_UNINDUCED_REP1.DupRate_plot.pdf", - "RAP1_UNINDUCED_REP2.DupRate_plot.pdf", - "WT_REP1.DupRate_plot.pdf", - "WT_REP2.DupRate_plot.pdf", - "RAP1_IAA_30M_REP1.DupRate_plot.r", - "RAP1_UNINDUCED_REP1.DupRate_plot.r", - "RAP1_UNINDUCED_REP2.DupRate_plot.r", - "WT_REP1.DupRate_plot.r", - "WT_REP2.DupRate_plot.r", - "RAP1_IAA_30M_REP1.pos.DupRate.xls", - "RAP1_IAA_30M_REP1.seq.DupRate.xls", - "RAP1_UNINDUCED_REP1.pos.DupRate.xls", - "RAP1_UNINDUCED_REP1.seq.DupRate.xls", - "RAP1_UNINDUCED_REP2.pos.DupRate.xls", - "RAP1_UNINDUCED_REP2.seq.DupRate.xls", - "WT_REP1.pos.DupRate.xls", - "WT_REP1.seq.DupRate.xls", - "WT_REP2.pos.DupRate.xls", - "WT_REP2.seq.DupRate.xls" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T17:25:06.004848" - }, - "star_rsem/log": { - "content": [ - "RAP1_IAA_30M_REP1.log", - "RAP1_UNINDUCED_REP1.log", - "RAP1_UNINDUCED_REP2.log", - "WT_REP1.log", - "WT_REP2.log" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T19:43:20.787774" + "timestamp": "2024-10-02T08:31:03.022387" }, "Params: --aligner star_rsem - stub": { "content": [ - "{BBMAP_BBSPLIT={bbmap=39.01}, CAT_FASTQ={cat=8.3}, CUSTOM_CATADDITIONALFASTA={python=null}, CUSTOM_GETCHROMSIZES={getchromsizes=1.2}, FASTQC={fastqc=0.12.1}, GTF2BED={perl=5.26.2}, GTF_FILTER={python=3.9.5}, GUNZIP_ADDITIONAL_FASTA={gunzip=1.1}, GUNZIP_GTF={gunzip=1.1}, TRIMGALORE={trimgalore=0.6.7, cutadapt=3.4}, UNTAR_RSEM_INDEX={untar=1.34}, UNTAR_SALMON_INDEX={untar=1.34}, Workflow={nf-core/rnaseq=v3.16.0dev}}", - "genome_transcriptome.fasta", - "genome_transcriptome.gtf", - "RAP1_IAA_30M_REP1_raw.html", - "RAP1_IAA_30M_REP1_raw.zip", - "RAP1_UNINDUCED_REP1_raw.html", - "RAP1_UNINDUCED_REP1_raw.zip", - "RAP1_UNINDUCED_REP2_raw.html", - "RAP1_UNINDUCED_REP2_raw.zip", - "WT_REP1_raw.html", - "WT_REP1_raw.zip", - "WT_REP2_raw.html", - "WT_REP2_raw.zip", - "multiqc_report.html", - "RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", - "RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", - "WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T17:26:18.851648" - }, - "versions": { - "content": [ - "{BBMAP_BBSPLIT={bbmap=39.01}, BEDTOOLS_GENOMECOV_FW={bedtools=2.31.1}, CAT_FASTQ={cat=8.3}, CUSTOM_CATADDITIONALFASTA={python=3.9.5}, CUSTOM_GETCHROMSIZES={getchromsizes=1.2}, CUSTOM_TX2GENE={python=3.9.5}, DESEQ2_QC_PSEUDO={r-base=4.0.3, bioconductor-deseq2=1.28.0}, DESEQ2_QC_RSEM={r-base=4.0.3, bioconductor-deseq2=1.28.0}, DUPRADAR={bioconductor-dupradar=1.32.0}, FASTQC={fastqc=0.12.1}, FQ_SUBSAMPLE={fq=0.9.1 (2022-02-22)}, GTF2BED={perl=5.26.2}, GTF_FILTER={python=3.9.5}, GUNZIP_ADDITIONAL_FASTA={gunzip=1.1}, GUNZIP_GTF={gunzip=1.1}, MULTIQC_CUSTOM_BIOTYPE={python=3.9.5}, PICARD_MARKDUPLICATES={picard=3.1.1}, QUALIMAP_RNASEQ={qualimap=2.3}, RSEM_CALCULATEEXPRESSION={rsem=1.3.1, star=2.7.10a}, RSEM_MERGE_COUNTS={sed=4.7}, RSEQC_BAMSTAT={rseqc=5.0.2}, RSEQC_INFEREXPERIMENT={rseqc=5.0.2}, RSEQC_INNERDISTANCE={rseqc=5.0.2}, RSEQC_JUNCTIONANNOTATION={rseqc=5.0.2}, RSEQC_JUNCTIONSATURATION={rseqc=5.0.2}, RSEQC_READDISTRIBUTION={rseqc=5.0.2}, RSEQC_READDUPLICATION={rseqc=5.0.2}, SALMON_QUANT={salmon=1.10.1}, SAMTOOLS_FLAGSTAT={samtools=1.2}, SAMTOOLS_IDXSTATS={samtools=1.2}, SAMTOOLS_INDEX={samtools=1.2}, SAMTOOLS_SORT={samtools=1.2}, SAMTOOLS_STATS={samtools=1.2}, SE_GENE={bioconductor-summarizedexperiment=1.32.0}, STRINGTIE_STRINGTIE={stringtie=2.2.1}, SUBREAD_FEATURECOUNTS={subread=2.0.1}, TRIMGALORE={trimgalore=0.6.7, cutadapt=3.4}, TXIMETA_TXIMPORT={bioconductor-tximeta=1.20.1}, UCSC_BEDCLIP={ucsc=377}, UCSC_BEDGRAPHTOBIGWIG={ucsc=445}, UNTAR_RSEM_INDEX={untar=1.34}, UNTAR_SALMON_INDEX={untar=1.34}, Workflow={nf-core/rnaseq=v3.16.0dev}}" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T17:25:06.704746" - }, - "fastqc/trim": { - "content": [ - "RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.html", - "RAP1_IAA_30M_REP1_trimmed_1_val_1_fastqc.zip", - "RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.html", - "RAP1_IAA_30M_REP1_trimmed_2_val_2_fastqc.zip", - "RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.html", - "RAP1_UNINDUCED_REP1_trimmed_trimmed_fastqc.zip", - "RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.html", - "RAP1_UNINDUCED_REP2_trimmed_trimmed_fastqc.zip", - "WT_REP1_trimmed_1_val_1_fastqc.html", - "WT_REP1_trimmed_1_val_1_fastqc.zip", - "WT_REP1_trimmed_2_val_2_fastqc.html", - "WT_REP1_trimmed_2_val_2_fastqc.zip", - "WT_REP2_trimmed_1_val_1_fastqc.html", - "WT_REP2_trimmed_1_val_1_fastqc.zip", - "WT_REP2_trimmed_2_val_2_fastqc.html", - "WT_REP2_trimmed_2_val_2_fastqc.zip" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T17:25:04.017077" - }, - "star_rsem/featurecounts": { - "content": [ - "RAP1_IAA_30M_REP1.biotype_counts_mqc.tsv:md5,e66cd2b584d970ae3827ad2521f795ca", - "RAP1_IAA_30M_REP1.biotype_counts_rrna_mqc.tsv:md5,dde2de0cb90e10d0195c726f768e9941", - "RAP1_IAA_30M_REP1.featureCounts.txt:md5,b3013c797d2fd38a8efa39047f5ba1b1", - "RAP1_UNINDUCED_REP1.biotype_counts_mqc.tsv:md5,548023e639f8eb76f973a2f98bcbc82c", - "RAP1_UNINDUCED_REP1.biotype_counts_rrna_mqc.tsv:md5,845ff9059c72bc6722a8de69776e22bb", - "RAP1_UNINDUCED_REP1.featureCounts.txt:md5,ff59317794fc04d5a4fd18797f0ecb0f", - "RAP1_UNINDUCED_REP2.biotype_counts_mqc.tsv:md5,2c0b5696582493f7a50259679982a6b3", - "RAP1_UNINDUCED_REP2.biotype_counts_rrna_mqc.tsv:md5,6d3fa4c88c7fe61f638e4624ad5e22f0", - "RAP1_UNINDUCED_REP2.featureCounts.txt:md5,6ee84531ba255791a11b487b6aea75ab", - "WT_REP1.biotype_counts_mqc.tsv:md5,512645a8f736eee160c4465e1940f4a5", - "WT_REP1.biotype_counts_rrna_mqc.tsv:md5,8ef76d717492ca23764938aee8ea33a9", - "WT_REP1.featureCounts.txt:md5,289cc95971a3ec550e018659279c1f59", - "WT_REP2.biotype_counts_mqc.tsv:md5,d4957c0197636b68d27fbd60d388bba1", - "WT_REP2.biotype_counts_rrna_mqc.tsv:md5,12294618fe44df1e7f39348372dcb481", - "WT_REP2.featureCounts.txt:md5,152d2f26df56a88fe4b27c742d8f7447", - "RAP1_IAA_30M_REP1.featureCounts.txt.summary", - "RAP1_UNINDUCED_REP1.featureCounts.txt.summary", - "RAP1_UNINDUCED_REP2.featureCounts.txt.summary", - "WT_REP1.featureCounts.txt.summary", - "WT_REP2.featureCounts.txt.summary" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T17:25:05.539329" - }, - "star_rsem/deseq2_qc": { - "content": [ - "R_sessionInfo.log:md5,fb0da0d7ad6994ed66a8e68348b19676", - "RAP1_IAA_30M_REP1.txt", - "RAP1_UNINDUCED_REP1.txt", - "RAP1_UNINDUCED_REP2.txt", - "WT_REP1.txt", - "WT_REP2.txt", - "deseq2.size_factors.RData", - "deseq2.dds.RData", - "deseq2.pca.vals.txt", - "deseq2.plots.pdf", - "deseq2.sample.dists.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T17:25:05.195993" - }, - "bbsplit": { - "content": [ - "RAP1_IAA_30M_REP1.stats.txt", - "RAP1_UNINDUCED_REP1.stats.txt", - "RAP1_UNINDUCED_REP2.stats.txt", - "WT_REP1.stats.txt", - "WT_REP2.stats.txt" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T17:25:03.953274" - }, - "salmon_quant": { - "content": [ - "ambig_info.tsv:md5,de973a4b22a4457217ae3dc04caf9401", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,1215f0c20f87d3aef8553ef119e1e74c", - "lib_format_counts.json:md5,c24ffe28d70476b5ccdd8bc2d22c0ac1", - "ambig_info.tsv:md5,45f252b4f0e11e6730cf0c29f800fdbb", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,621c6601aade5b1f2e3d6ca2fc71f636", - "lib_format_counts.json:md5,f6d44c0221f7fd559f11a9afe04c9935", - "ambig_info.tsv:md5,6dcc2891ea572e9b8d1ba52cd434ab84", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,9bed6e4dc5428d6f6297adcea29a6326", - "lib_format_counts.json:md5,7c562bf2f70e42f3a7292687dfd328c3", - "ambig_info.tsv:md5,194f574e0586416155e3f33d42e2b167", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,c7ed0aaa5d6c7934ddbebfd29e4eb86d", - "lib_format_counts.json:md5,d46250bb3677d72feeefc435fe6395a6", - "ambig_info.tsv:md5,a26e3f936e65d7da66392603c2f91f6f", - "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", - "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", - "cmd_info.json:md5,69ebfc2c7ca6b221a0a22fa1dc8c20ac", - "lib_format_counts.json:md5,088fd51db07022ffde47033bbd029400", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf", - "fld.gz", - "meta_info.json", - "flenDist.txt", - "salmon_quant.log", - "quant.genes.sf", - "quant.sf" - ], - "meta": { - "nf-test": "0.9.0", - "nextflow": "24.04.4" - }, - "timestamp": "2024-08-26T17:25:04.459744" - }, - "star_rsem/qualimap": { - "content": [ - "Coverage Profile Along Genes (High).png:md5,55ed67cd9df6d42446a76f49f6e9d6c0", - "Coverage Profile Along Genes (Low).png:md5,cc6887aedf7b0ce65af934849ada52f7", - "Coverage Profile Along Genes (Total).png:md5,ebb7199f5b5c179b3d0ad66b1833d5f0", - "Transcript coverage histogram.png:md5,db451ddb02fa59b2e46a3b7f936dc7e4", - "coverage_profile_along_genes_(high).txt:md5,31ab137e75752225365bd3d89143dbd2", - "coverage_profile_along_genes_(low).txt:md5,eaceda909bf652b8301fa0ed1bba9ae1", - "coverage_profile_along_genes_(total).txt:md5,eaceda909bf652b8301fa0ed1bba9ae1", - "Coverage Profile Along Genes (High).png:md5,36376d7393575a03f6e7a1c5be4f8c32", - "Coverage Profile Along Genes (Low).png:md5,24e1862606452bc53f928ccf086e3699", - "Coverage Profile Along Genes (Total).png:md5,c843e9063c3b15e4de1c0b3f680746a9", - "Transcript coverage histogram.png:md5,519b1b92340d1541d864e56b9a6956e0", - "coverage_profile_along_genes_(high).txt:md5,93822686a53dd40d3ff426ddbfc9314e", - "coverage_profile_along_genes_(low).txt:md5,bd8d58c757e4122caee4b4e8df2f4b00", - "coverage_profile_along_genes_(total).txt:md5,bd8d58c757e4122caee4b4e8df2f4b00", - "Coverage Profile Along Genes (High).png:md5,69dfa9f3eeac16a5615a4346c1d79eab", - "Coverage Profile Along Genes (Low).png:md5,84776e58e5aadee6be3b6225beccd70f", - "Coverage Profile Along Genes (Total).png:md5,2c0ddb2c5004d2f7a65e4814281a0836", - "Transcript coverage histogram.png:md5,2553413f136898302067b0a289f58241", - "coverage_profile_along_genes_(high).txt:md5,cdb2c00c43121e3beccd7f670b34e05e", - "coverage_profile_along_genes_(low).txt:md5,1a9405c8bd7c00f3be082bfebb90b6ed", - "coverage_profile_along_genes_(total).txt:md5,1a9405c8bd7c00f3be082bfebb90b6ed", - "Coverage Profile Along Genes (High).png:md5,4a4eb6c41483181ed9d67c390868026e", - "Coverage Profile Along Genes (Low).png:md5,332640c6bf816ddeec23d9e12070eede", - "Coverage Profile Along Genes (Total).png:md5,64402bed985293e66a634199b64c98f2", - "Transcript coverage histogram.png:md5,72df8608131b28ee5b23bdbc8c6e4891", - "coverage_profile_along_genes_(high).txt:md5,70c95fbc100f14911d2cc348bdff1587", - "coverage_profile_along_genes_(low).txt:md5,86e56ef794277bcf1e0d121a088b8581", - "coverage_profile_along_genes_(total).txt:md5,86e56ef794277bcf1e0d121a088b8581", - "Coverage Profile Along Genes (High).png:md5,8ec27bae1db26eb468ca35843e5eb557", - "Coverage Profile Along Genes (Low).png:md5,5bed9f6b9e27ad01f60d188f24020c6e", - "Coverage Profile Along Genes (Total).png:md5,bb10036285f9e01ed64048597a25766f", - "Transcript coverage histogram.png:md5,e36d2e717f852cc69f2658e6a901a0ec", - "coverage_profile_along_genes_(high).txt:md5,a73462b9ecbd1d2c45d7ca84b5f7925b", - "coverage_profile_along_genes_(low).txt:md5,7adc228bc15e344abb7938ea4d35a846", - "coverage_profile_along_genes_(total).txt:md5,7adc228bc15e344abb7938ea4d35a846", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt", - "Junction Analysis.png", - "Reads Genomic Origin.png", - "qualimapReport.html", - "rnaseq_qc_results.txt" + 22, + { + "BBMAP_BBSPLIT": { + "bbmap": 39.01 + }, + "CAT_FASTQ": { + "cat": 8.3 + }, + "CUSTOM_CATADDITIONALFASTA": { + "python": null + }, + "CUSTOM_GETCHROMSIZES": { + "getchromsizes": 1.2 + }, + "FASTQC": { + "fastqc": "0.12.1" + }, + "GTF2BED": { + "perl": "5.26.2" + }, + "GTF_FILTER": { + "python": "3.9.5" + }, + "GUNZIP_ADDITIONAL_FASTA": { + "gunzip": 1.1 + }, + "GUNZIP_GTF": { + "gunzip": 1.1 + }, + "TRIMGALORE": { + "trimgalore": "0.6.7", + "cutadapt": 3.4 + }, + "UNTAR_RSEM_INDEX": { + "untar": 1.34 + }, + "UNTAR_SALMON_INDEX": { + "untar": 1.34 + }, + "Workflow": { + "nf-core/rnaseq": "v3.16.0dev" + } + }, + [ + "custom", + "custom/out", + "custom/out/genome_transcriptome.fasta", + "custom/out/genome_transcriptome.gtf", + "fastqc", + "fastqc/raw", + "fastqc/raw/RAP1_IAA_30M_REP1_raw.html", + "fastqc/raw/RAP1_IAA_30M_REP1_raw.zip", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw.html", + "fastqc/raw/RAP1_UNINDUCED_REP1_raw.zip", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw.html", + "fastqc/raw/RAP1_UNINDUCED_REP2_raw.zip", + "fastqc/raw/WT_REP1_raw.html", + "fastqc/raw/WT_REP1_raw.zip", + "fastqc/raw/WT_REP2_raw.html", + "fastqc/raw/WT_REP2_raw.zip", + "fastqc/trim", + "multiqc", + "multiqc/star_rsem", + "multiqc/star_rsem/multiqc_data", + "multiqc/star_rsem/multiqc_plots", + "multiqc/star_rsem/multiqc_report.html", + "pipeline_info", + "pipeline_info/nf_core_rnaseq_software_mqc_versions.yml", + "trimgalore", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_IAA_30M_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP1_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/RAP1_UNINDUCED_REP2_trimmed.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP1_trimmed_2.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_1.fastq.gz_trimming_report.txt", + "trimgalore/WT_REP2_trimmed_2.fastq.gz_trimming_report.txt" + ], + [ + "genome_transcriptome.fasta:md5,d41d8cd98f00b204e9800998ecf8427e", + "genome_transcriptome.gtf:md5,d41d8cd98f00b204e9800998ecf8427e" + ] ], "meta": { "nf-test": "0.9.0", "nextflow": "24.04.4" }, - "timestamp": "2024-08-26T17:25:05.907994" + "timestamp": "2024-10-02T08:31:54.433237" } } \ No newline at end of file