diff --git a/CHANGELOG.md b/CHANGELOG.md index 2e7fb21a..03b3a2cc 100644 --- a/CHANGELOG.md +++ b/CHANGELOG.md @@ -10,6 +10,7 @@ and this project adheres to [Semantic Versioning](https://semver.org/spec/v2.0.0 - [#125](https://github.com/nf-core/riboseq/pull/125) - Add rRNA removal tool selection with support for SortMeRNA (default), Bowtie2, and RiboDetector ([@pinin4fjords](https://github.com/pinin4fjords)) - [#128](https://github.com/nf-core/riboseq/pull/128) - Add DESeq2-based deltaTE analysis as an alternative to anota2seq for translational efficiency analysis ([@pinin4fjords](https://github.com/pinin4fjords)) - [#131](https://github.com/nf-core/riboseq/pull/131) - Add ribotish quality output routing to MultiQC ([@pinin4fjords](https://github.com/pinin4fjords)) +- [#134](https://github.com/nf-core/riboseq/pull/134) - Add P-site identification using plastid ([@suhrig](https://github.com/suhrig)) - [#135](https://github.com/nf-core/riboseq/pull/135) - Add optional read length equalisation to trim RNA-seq reads to match Ribo-seq lengths before quantification ([@pinin4fjords](https://github.com/pinin4fjords)) - [#138](https://github.com/nf-core/riboseq/pull/138) - Add MultiQC configuration for BBSplit, Bowtie2 rRNA removal, UMItools, and UMIcollapse ([@pinin4fjords](https://github.com/pinin4fjords)) @@ -23,22 +24,30 @@ and this project adheres to [Semantic Versioning](https://semver.org/spec/v2.0.0 ### `Parameters` -| Old parameter | New parameter | -| ------------- | ----------------------------------- | -| | `--ribo_removal_tool` | -| | `--translational_efficiency_method` | -| | `--extra_deltate_args` | -| | `--te_lfc_threshold` | -| | `--rna_lfc_threshold` | -| | `--ribo_lfc_threshold` | -| | `--equalise_read_lengths` | -| | `--equalise_read_lengths_target` | +| Old parameter | New parameter | +| ------------- | ---------------------------------------- | +| | `--ribo_removal_tool` | +| | `--translational_efficiency_method` | +| | `--extra_deltate_args` | +| | `--te_lfc_threshold` | +| | `--rna_lfc_threshold` | +| | `--ribo_lfc_threshold` | +| | `--equalise_read_lengths` | +| | `--equalise_read_lengths_target` | +| | `--skip_plastid` | +| | `--plastid_min_length` | +| | `--plastid_max_length` | +| | `--plastid_default_psite_offset` | +| | `--extra_plastid_metagene_generate_args` | +| | `--extra_plastid_psite_args` | +| | `--extra_plastid_make_wiggle_args` | ### `Dependencies` | Dependency | Old version | New version | | ---------- | ----------- | ----------- | | `MultiQC` | 1.32 | 1.33 | +| `plastid` | | 0.6.1 | ## v1.2.0 - 2025-12-03 diff --git a/README.md b/README.md index 5ae566f0..89d258fe 100644 --- a/README.md +++ b/README.md @@ -41,7 +41,7 @@ Differences occur in the downstream analysis steps. Currently these specialist s 1. Check reads distribution around annotated protein coding regions on user provided transcripts, show frame bias and estimate P-site offset for different group of reads ([`Ribo-TISH`](https://github.com/zhpn1024/ribotish)) 2. (default, optional) Predict translated open reading frames and/ or translation initiation sites _de novo_ from alignment data ([`Ribo-TISH`](https://github.com/zhpn1024/ribotish)) 3. (default, optional) Derive candidate ORFs from reference data and detect translated ORFs from that list ([`Ribotricer`](https://github.com/smithlabcode/ribotricer)) -4. (default, optional) Derive P-sites and QC from transcriptome alignments ([`riboWaltz`](https://github.com/LabTranslationalArchitectomics/riboWaltz)) +4. (default, optional) Derive P-sites and QC from transcriptome alignments ([`riboWaltz`](https://github.com/LabTranslationalArchitectomics/riboWaltz), [`plastid`](https://plastid.readthedocs.io/en/latest/index.html)) 5. (optional) Use a translational efficiency approach to study the dynamics of transcription and translation, with [anota2seq](https://bioconductor.org/packages/release/bioc/html/anota2seq.html). **requires matched RNA-seq and Ribo-seq data** ## Usage diff --git a/conf/modules.config b/conf/modules.config index a4716a76..489ccbab 100644 --- a/conf/modules.config +++ b/conf/modules.config @@ -973,6 +973,53 @@ if (!params.skip_ribowaltz) { process { withName: 'RIBOWALTZ' { ext.args = { params.extra_ribowaltz_args ?: '' } + publishDir = [ + path: { "${params.outdir}/psites/ribowaltz" }, + mode: params.publish_dir_mode, + saveAs: { filename -> filename.equals('versions.yml') ? null : filename } + ] + } + } +} + +if (!params.skip_plastid) { + process { + withName: 'PLASTID_METAGENE_GENERATE' { + ext.args = { [ + params.extra_plastid_metagene_generate_args ?: '', + '--landmark cds_start' + ].join(' ').trim() } + publishDir = [ + path: { "${params.outdir}/psites/plastid/metagene" }, + mode: params.publish_dir_mode, + saveAs: { filename -> filename.equals('versions.yml') ? null : filename } + ] + } + withName: 'PLASTID_PSITE' { + ext.args = { [ + params.extra_plastid_psite_args ?: '', + params.plastid_min_length ? "--min_length ${params.plastid_min_length}" : '', + params.plastid_max_length ? "--max_length ${params.plastid_max_length}" : '', + params.plastid_default_psite_offset ? "--default ${params.plastid_default_psite_offset}" : '', + '--require_upstream', + ].join(' ').trim() } + publishDir = [ + path: { "${params.outdir}/psites/plastid/offsets" }, + mode: params.publish_dir_mode, + saveAs: { filename -> filename.equals('versions.yml') ? null : filename } + ] + } + withName: 'PLASTID_MAKE_WIGGLE' { + ext.args = { [ + params.extra_plastid_make_wiggle_args ?: '', + params.plastid_min_length ? "--min_length ${params.plastid_min_length}" : '', + '--output_format bedgraph' + ].join(' ').trim() } + publishDir = [ + path: { "${params.outdir}/psites/plastid/tracks" }, + mode: params.publish_dir_mode, + saveAs: { filename -> filename.equals('versions.yml') ? null : filename } + ] } } } diff --git a/docs/output.md b/docs/output.md index 26d79994..74cb56c0 100644 --- a/docs/output.md +++ b/docs/output.md @@ -36,6 +36,7 @@ The pipeline is built using [Nextflow](https://www.nextflow.io/) and processes d - [Ribotricer detect-orfs](#ribotricer-detect-orfs) - [P-site identification](#p-site-identification) - [riboWaltz](#ribowaltz) + - [plastid](#plastid) - [Quantification](#quantification) - [Translational efficiency](#translational-efficiency) - [MultiQC](#multiqc) @@ -372,6 +373,19 @@ P-sites are identified by passing transcriptome-level alignment BAM files to rib +P-sites are identified by passing genome-level alignment BAM files to plastid, producing the following outputs: + +
+Output files + +- `plastid/` + - `*.filtered_rois.bed` and `*.filtered_rois.txt`: Position of CDS start for each gene in BED or TXT format; used for metagene analysis + - `*_metagene_profiles.txt`: Matrix containing the distances of the 5' read ends to the CDS start position for each read length + - `*_p_offsets.png`: Graphical illustrations of the metagene profiles + - `*_p_offsets.txt`: Selected Optimal p-site offset for each read length + +
+ ## Quantification Quantification is done by passing transcriptome-level alignment BAM files to Salmon, producing the following outputs: diff --git a/docs/usage.md b/docs/usage.md index a46da4fb..c691d703 100644 --- a/docs/usage.md +++ b/docs/usage.md @@ -298,6 +298,8 @@ The pipeline will by default run the [Ribo-TISH](https://github.com/zhpn1024/rib The pipeline will by default run [riboWaltz](https://github.com/LabTranslationalArchitectomics/riboWaltz) for P-site identification and diagnostics, unless disabled with `--skip_ribowaltz`. Additional arguments can be supplied via `--extra_ribowaltz_args` parameters. An example is: `--extra_ribowaltz_args "--length_range 27:31 --periodicity_threshold 40 --extremity 5end --start_nts 45 --stop_nts 24"`. If not provided, defaults used in the [nf-core module](https://github.com/nf-core/modules/blob/master/modules/nf-core/ribowaltz/templates/ribowaltz.r) are used. +In addition, the pipeline runs [plastid](https://plastid.readthedocs.io/en/latest/index.html) to identify P-sites and create bedGraph tracks, unless disabled with `--skip_plastid`. + ## Translational efficiency If you have paired RNA-seq and Riboseq samples, you can use this workflow to initiate a translational efficiency analysis. diff --git a/modules.json b/modules.json index 89ea4fd3..c63f0dbf 100644 --- a/modules.json +++ b/modules.json @@ -95,6 +95,21 @@ "git_sha": "9656d955b700a8707c4a67821ab056f8c1095675", "installed_by": ["modules"] }, + "plastid/make_wiggle": { + "branch": "master", + "git_sha": "8d66ebdfc2e09f449c03dcb3a08a9ee13f0412d3", + "installed_by": ["modules"] + }, + "plastid/metagene_generate": { + "branch": "master", + "git_sha": "8d66ebdfc2e09f449c03dcb3a08a9ee13f0412d3", + "installed_by": ["modules"] + }, + "plastid/psite": { + "branch": "master", + "git_sha": "8d66ebdfc2e09f449c03dcb3a08a9ee13f0412d3", + "installed_by": ["modules"] + }, "ribodetector": { "branch": "master", "git_sha": "61ce58ac3e4e4627d9c1cdc958ee6bfa742a0a75", diff --git a/modules/nf-core/plastid/make_wiggle/environment.yml b/modules/nf-core/plastid/make_wiggle/environment.yml new file mode 100644 index 00000000..86ff4ca2 --- /dev/null +++ b/modules/nf-core/plastid/make_wiggle/environment.yml @@ -0,0 +1,7 @@ +--- +# yaml-language-server: $schema=https://raw.githubusercontent.com/nf-core/modules/master/modules/environment-schema.json +channels: + - conda-forge + - bioconda +dependencies: + - plastid=0.6.1 diff --git a/modules/nf-core/plastid/make_wiggle/main.nf b/modules/nf-core/plastid/make_wiggle/main.nf new file mode 100644 index 00000000..78adce16 --- /dev/null +++ b/modules/nf-core/plastid/make_wiggle/main.nf @@ -0,0 +1,68 @@ +process PLASTID_MAKE_WIGGLE { + tag "$meta.id" + label "process_single" + + // WARN: Version information not provided by tool on CLI. Please update version string below when bumping container versions. + conda "${moduleDir}/environment.yml" + container "${ workflow.containerEngine == 'singularity' && !task.ext.singularity_pull_docker_container ? + 'https://depot.galaxyproject.org/singularity/plastid:0.6.1--py39had3e4b6_2': + 'biocontainers/plastid:0.6.1--py39had3e4b6_2' }" + + input: + tuple val(meta), path(bam), path(bam_index), path(p_offsets) + val(mapping_rule) + + output: + tuple val(meta), path("*.{wig,bedgraph}"), emit: tracks + path "versions.yml" , emit: versions + + when: + task.ext.when == null || task.ext.when + + script: + if (mapping_rule == 'fiveprime_variable' && !p_offsets) { + error "p_offsets file is required when using mapping_rule 'fiveprime_variable'" + } + def prefix = task.ext.prefix ?: "${meta.id}" + def args = task.ext.args ?: "" + def offset_arg = mapping_rule == 'fiveprime_variable' ? "--offset $p_offsets" : "" + def extension = args.contains('--output_format bedgraph') ? "bedgraph" : "wig" + def VERSION = "0.6.1" // WARN: Version information not provided by tool on CLI. Please update this string when bumping container versions. + """ + make_wiggle \\ + --count_files "$bam" \\ + $offset_arg \\ + --${mapping_rule} \\ + -o "$prefix" \\ + $args + + if [ "$extension" = "bedgraph" ]; then + for FILE in *.wig; do + mv "\$FILE" "\${FILE%.wig}.bedgraph" + done + fi + + cat <<-END_VERSIONS > versions.yml + "${task.process}": + plastid: $VERSION + END_VERSIONS + """ + + stub: + if (mapping_rule == 'fiveprime_variable' && !p_offsets) { + error "p_offsets file is required when using mapping_rule 'fiveprime_variable'" + } + def prefix = task.ext.prefix ?: "${meta.id}" + def args = task.ext.args ?: "" + def extension = args.contains('--output_format bedgraph') ? "bedgraph" : "wig" + def VERSION = "0.6.1" // WARN: Version information not provided by tool on CLI. Please update this string when bumping container versions. + """ + touch ${prefix}_fw.${extension} + touch ${prefix}_rc.${extension} + + cat <<-END_VERSIONS > versions.yml + "${task.process}": + plastid: $VERSION + END_VERSIONS + """ +} diff --git a/modules/nf-core/plastid/make_wiggle/meta.yml b/modules/nf-core/plastid/make_wiggle/meta.yml new file mode 100644 index 00000000..a78feea6 --- /dev/null +++ b/modules/nf-core/plastid/make_wiggle/meta.yml @@ -0,0 +1,77 @@ +# yaml-language-server: $schema=https://raw.githubusercontent.com/nf-core/modules/master/modules/meta-schema.json +name: "plastid_make_wiggle" +description: Create wiggle or bedGraph files from alignment files after applying + a read mapping rule (e.g. to map ribosome-protected footprints at their + P-sites), for visualization in a genome browser +keywords: + - genomics + - riboseq + - psite + - wiggle + - bedgraph +tools: + - "plastid": + description: "Nucleotide-resolution analysis of next-generation sequencing and + genomics data" + homepage: "https://github.com/joshuagryphon/plastid" + documentation: "https://plastid.readthedocs.io/en/latest/" + tool_dev_url: "https://github.com/joshuagryphon/plastid" + doi: "10.1186/s12864-016-3278-x" + licence: ["BSD-3-clause"] + identifier: biotools:plastid + +input: + - - meta: + type: map + description: | + Groovy Map containing sample information + e.g. `[ id:'sample1', single_end:false ]` + - bam: + type: file + description: Genome BAM file + pattern: "*.bam" + ontologies: + - edam: http://edamontology.org/format_2572 # BAM + - bam_index: + type: file + description: Genome BAM index file + pattern: "*.bai" + ontologies: + - edam: http://edamontology.org/format_3327 # BAI + - p_offsets: + type: file + description: | + Selected p-site offset for each read length (output from plastid_psite). + Required when mapping_rule is 'fiveprime_variable', otherwise pass empty list []. + pattern: "*_p_offsets.txt" + ontologies: [] + - mapping_rule: + type: string + description: | + Read mapping rule. Use 'fiveprime_variable' with p_offsets file to map reads to P-sites. + enum: ["fiveprime", "threeprime", "center", "fiveprime_variable"] +output: + tracks: + - - meta: + type: map + description: | + Groovy Map containing sample information + e.g. `[ id:'sample1', single_end:false ]` + - "*.{wig,bedgraph}": + type: file + description: wig/bedgraph tracks for forward and reverse strands + pattern: "*.{wig,bedgraph}" + ontologies: + - edam: http://edamontology.org/format_3005 # wig + - edam: http://edamontology.org/format_3583 # bedgraph + versions: + - versions.yml: + type: file + description: File containing software versions + pattern: "versions.yml" + ontologies: + - edam: http://edamontology.org/format_3750 # YAML +authors: + - "@suhrig" +maintainers: + - "@suhrig" diff --git a/modules/nf-core/plastid/make_wiggle/tests/main.nf.test b/modules/nf-core/plastid/make_wiggle/tests/main.nf.test new file mode 100644 index 00000000..8aa562eb --- /dev/null +++ b/modules/nf-core/plastid/make_wiggle/tests/main.nf.test @@ -0,0 +1,65 @@ +// nf-core modules test plastid +nextflow_process { + + name "Test Process PLASTID_MAKE_WIGGLE" + script "../main.nf" + process "PLASTID_MAKE_WIGGLE" + + tag "modules" + tag "modules_nfcore" + tag "plastid" + tag "plastid/make_wiggle" + + test("human chr20 bam - fiveprime_variable") { + + when { + process { + """ + input[0] = [ + [ id:'SRX11780887' ], // meta map + file(params.modules_testdata_base_path + "genomics/homo_sapiens/riboseq_expression/aligned_reads/SRX11780887_chr20.bam", checkIfExists: true), + file(params.modules_testdata_base_path + "genomics/homo_sapiens/riboseq_expression/aligned_reads/SRX11780887_chr20.bam.bai", checkIfExists: true), + file(params.modules_testdata_base_path + "genomics/homo_sapiens/riboseq_expression/plastid/SRX11780887_p_offsets.txt", checkIfExists: true) + ] + input[1] = 'fiveprime_variable' + """ + } + } + + then { + assertAll( + { assert process.success }, + { assert path(process.out.tracks.get(0).get(1).get(0)).getText().contains('track') }, + { assert snapshot(process.out.versions).match() } + ) + } + } + + test("human chr20 bam - fiveprime_variable - stub") { + + options "-stub" + + when { + process { + """ + input[0] = [ + [ id:'SRX11780887' ], // meta map + file(params.modules_testdata_base_path + "genomics/homo_sapiens/riboseq_expression/aligned_reads/SRX11780887_chr20.bam", checkIfExists: true), + file(params.modules_testdata_base_path + "genomics/homo_sapiens/riboseq_expression/aligned_reads/SRX11780887_chr20.bam.bai", checkIfExists: true), + file(params.modules_testdata_base_path + "genomics/homo_sapiens/riboseq_expression/plastid/SRX11780887_p_offsets.txt", checkIfExists: true) + ] + input[1] = 'fiveprime_variable' + """ + } + } + + then { + assertAll( + { assert process.success }, + { assert file(process.out.tracks.get(0).get(1).get(0)).exists() }, + { assert snapshot(process.out.versions).match() } + ) + } + } + +} diff --git a/modules/nf-core/plastid/make_wiggle/tests/main.nf.test.snap b/modules/nf-core/plastid/make_wiggle/tests/main.nf.test.snap new file mode 100644 index 00000000..0d2f6778 --- /dev/null +++ b/modules/nf-core/plastid/make_wiggle/tests/main.nf.test.snap @@ -0,0 +1,26 @@ +{ + "human chr20 bam - fiveprime_variable": { + "content": [ + [ + "versions.yml:md5,4ecd455575ab11a0ad86dc5e0a6c6959" + ] + ], + "meta": { + "nf-test": "0.9.2", + "nextflow": "25.10.0" + }, + "timestamp": "2025-12-10T12:36:00.352824" + }, + "human chr20 bam - fiveprime_variable - stub": { + "content": [ + [ + "versions.yml:md5,4ecd455575ab11a0ad86dc5e0a6c6959" + ] + ], + "meta": { + "nf-test": "0.9.2", + "nextflow": "25.10.0" + }, + "timestamp": "2025-12-10T12:26:10.353895" + } +} \ No newline at end of file diff --git a/modules/nf-core/plastid/metagene_generate/environment.yml b/modules/nf-core/plastid/metagene_generate/environment.yml new file mode 100644 index 00000000..86ff4ca2 --- /dev/null +++ b/modules/nf-core/plastid/metagene_generate/environment.yml @@ -0,0 +1,7 @@ +--- +# yaml-language-server: $schema=https://raw.githubusercontent.com/nf-core/modules/master/modules/environment-schema.json +channels: + - conda-forge + - bioconda +dependencies: + - plastid=0.6.1 diff --git a/modules/nf-core/plastid/metagene_generate/main.nf b/modules/nf-core/plastid/metagene_generate/main.nf new file mode 100644 index 00000000..ef3faeaa --- /dev/null +++ b/modules/nf-core/plastid/metagene_generate/main.nf @@ -0,0 +1,48 @@ +process PLASTID_METAGENE_GENERATE { + tag "$annotation" + label "process_low" + + // WARN: Version information not provided by tool on CLI. Please update version string below when bumping container versions. + conda "${moduleDir}/environment.yml" + container "${ workflow.containerEngine == 'singularity' && !task.ext.singularity_pull_docker_container ? + 'https://depot.galaxyproject.org/singularity/plastid:0.6.1--py39had3e4b6_2': + 'biocontainers/plastid:0.6.1--py39had3e4b6_2' }" + + input: + tuple val(meta), path(annotation) + + output: + tuple val(meta), path("*_rois.txt"), emit: rois_txt + tuple val(meta), path("*_rois.bed"), emit: rois_bed + path "versions.yml", emit: versions + + when: + task.ext.when == null || task.ext.when + + script: + def args = task.ext.args ?: '' + def VERSION = "0.6.1" // WARN: Version information not provided by tool on CLI. Please update this string when bumping container versions. + """ + metagene generate \\ + "${annotation.baseName}" \\ + --annotation_files "$annotation" \\ + $args + + cat <<-END_VERSIONS > versions.yml + "${task.process}": + plastid: $VERSION + END_VERSIONS + """ + + stub: + def VERSION = "0.6.1" // WARN: Version information not provided by tool on CLI. Please update this string when bumping container versions. + """ + touch ${annotation.baseName}_rois.txt + touch ${annotation.baseName}_rois.bed + + cat <<-END_VERSIONS > versions.yml + "${task.process}": + plastid: $VERSION + END_VERSIONS + """ +} diff --git a/modules/nf-core/plastid/metagene_generate/meta.yml b/modules/nf-core/plastid/metagene_generate/meta.yml new file mode 100644 index 00000000..8034234a --- /dev/null +++ b/modules/nf-core/plastid/metagene_generate/meta.yml @@ -0,0 +1,72 @@ +# yaml-language-server: $schema=https://raw.githubusercontent.com/nf-core/modules/master/modules/meta-schema.json +name: "plastid_metagene_generate" +description: Compute a metagene profile of read alignments, counts, or + quantitative data over one or more regions of interest, optionally + applying a mapping rule +keywords: + - genomics + - riboseq + - psite +tools: + - "plastid": + description: "Nucleotide-resolution analysis of next-generation sequencing and genomics data" + homepage: "https://github.com/joshuagryphon/plastid" + documentation: "https://plastid.readthedocs.io/en/latest/" + tool_dev_url: "https://github.com/joshuagryphon/plastid" + doi: "10.1186/s12864-016-3278-x" + licence: ["BSD-3-clause"] + identifier: biotools:plastid + +input: + - - meta: + type: map + description: | + Map containing reference information for the reference genome annotation file + e.g. `[ id:'Ensembl human v.111' ]` + - annotation: + type: file + description: annotation file of reference genome (BED, bigBed, GTF, GFF3) + pattern: "*.{bed,bigbed,gtf,gff3}" + ontologies: + - edam: http://edamontology.org/format_3003 # BED + - edam: http://edamontology.org/format_3004 # bigBed + - edam: http://edamontology.org/format_2306 # GTF + - edam: http://edamontology.org/format_1975 # GFF3 +output: + rois_txt: + - - meta: + type: map + description: | + Map containing reference information for the reference genome annotation file + e.g. `[ id:'Ensembl human v.111' ]` + - "*_rois.txt": + type: file + description: Tab-delimited text file describing the maximal spanning + window for each gene + pattern: "*_rois.txt" + ontologies: [] + rois_bed: + - - meta: + type: map + description: | + Map containing reference information for the reference genome annotation file + e.g. `[ id:'Ensembl human v.111' ]` + - "*_rois.bed": + type: file + description: | + Maximal spanning windows in BED format for visualization in a genome + browser. The thickly-rendered portion of a window indicates its landmark. + pattern: "*_rois.bed" + ontologies: + - edam: http://edamontology.org/format_3003 # BED + versions: + - versions.yml: + type: file + description: File containing software versions + pattern: "versions.yml" + ontologies: + - edam: http://edamontology.org/format_3750 # YAML +authors: + - "@suhrig" +maintainers: + - "@suhrig" diff --git a/modules/nf-core/plastid/metagene_generate/tests/main.nf.test b/modules/nf-core/plastid/metagene_generate/tests/main.nf.test new file mode 100644 index 00000000..2f491337 --- /dev/null +++ b/modules/nf-core/plastid/metagene_generate/tests/main.nf.test @@ -0,0 +1,55 @@ +// nf-core modules test plastid +nextflow_process { + + name "Test Process PLASTID_METAGENE_GENERATE" + script "../main.nf" + process "PLASTID_METAGENE_GENERATE" + + tag "modules" + tag "modules_nfcore" + tag "plastid" + tag "plastid/metagene_generate" + + test("human chr20 gtf") { + + when { + process { + """ + input[0] = [[id:'homo_sapiens_chr20'], file(params.modules_testdata_base_path + "genomics/homo_sapiens/riboseq_expression/Homo_sapiens.GRCh38.111_chr20.gtf", checkIfExists: true)] + """ + } + } + + then { + assertAll( + { assert process.success }, + { assert path(process.out.rois_txt.get(0).get(1)).getText().contains('ENSG') }, + { assert path(process.out.rois_bed.get(0).get(1)).getText().contains('ENSG') }, + { assert snapshot(process.out.versions).match('versions') } + ) + } + } + + test("human chr20 gtf -stub") { + + options "-stub" + + when { + process { + """ + input[0] = [[id:'homo_sapiens_chr20'], file(params.modules_testdata_base_path + "genomics/homo_sapiens/riboseq_expression/Homo_sapiens.GRCh38.111_chr20.gtf", checkIfExists: true)] + """ + } + } + + then { + assertAll( + { assert process.success }, + { assert file(process.out.rois_txt.get(0).get(1)).exists() }, + { assert file(process.out.rois_bed.get(0).get(1)).exists() }, + { assert snapshot(process.out.versions).match() } + ) + } + } + +} diff --git a/modules/nf-core/plastid/metagene_generate/tests/main.nf.test.snap b/modules/nf-core/plastid/metagene_generate/tests/main.nf.test.snap new file mode 100644 index 00000000..9fd426fb --- /dev/null +++ b/modules/nf-core/plastid/metagene_generate/tests/main.nf.test.snap @@ -0,0 +1,26 @@ +{ + "human chr20 gtf -stub": { + "content": [ + [ + "versions.yml:md5,3507c6516efe03f85ff066089c7a4b1b" + ] + ], + "meta": { + "nf-test": "0.9.2", + "nextflow": "25.10.0" + }, + "timestamp": "2025-12-10T12:45:35.749835" + }, + "versions": { + "content": [ + [ + "versions.yml:md5,3507c6516efe03f85ff066089c7a4b1b" + ] + ], + "meta": { + "nf-test": "0.9.3", + "nextflow": "25.10.0" + }, + "timestamp": "2025-12-08T10:46:58.250416821" + } +} \ No newline at end of file diff --git a/modules/nf-core/plastid/psite/environment.yml b/modules/nf-core/plastid/psite/environment.yml new file mode 100644 index 00000000..86ff4ca2 --- /dev/null +++ b/modules/nf-core/plastid/psite/environment.yml @@ -0,0 +1,7 @@ +--- +# yaml-language-server: $schema=https://raw.githubusercontent.com/nf-core/modules/master/modules/environment-schema.json +channels: + - conda-forge + - bioconda +dependencies: + - plastid=0.6.1 diff --git a/modules/nf-core/plastid/psite/main.nf b/modules/nf-core/plastid/psite/main.nf new file mode 100644 index 00000000..79389ce7 --- /dev/null +++ b/modules/nf-core/plastid/psite/main.nf @@ -0,0 +1,54 @@ +process PLASTID_PSITE { + tag "$meta.id" + label "process_single" + + // WARN: Version information not provided by tool on CLI. Please update version string below when bumping container versions. + conda "${moduleDir}/environment.yml" + container "${ workflow.containerEngine == 'singularity' && !task.ext.singularity_pull_docker_container ? + 'https://depot.galaxyproject.org/singularity/plastid:0.6.1--py39had3e4b6_2': + 'biocontainers/plastid:0.6.1--py39had3e4b6_2' }" + + input: + tuple val(meta), path(bam), path(bam_index) + tuple val(meta2), path(rois_txt) + + output: + tuple val(meta), path("*_metagene_profiles.txt"), emit: metagene_profiles + tuple val(meta), path("*_p_offsets.png") , emit: p_offsets_png + tuple val(meta), path("*_p_offsets.txt") , emit: p_offsets + path "versions.yml" , emit: versions + + when: + task.ext.when == null || task.ext.when + + script: + def prefix = task.ext.prefix ?: "${meta.id}" + def args = task.ext.args ?: "" + def VERSION = "0.6.1" // WARN: Version information not provided by tool on CLI. Please update this string when bumping container versions. + """ + psite \ + "$rois_txt" \\ + "$prefix" \\ + --count_files "$bam" \\ + $args + + cat <<-END_VERSIONS > versions.yml + "${task.process}": + plastid: $VERSION + END_VERSIONS + """ + + stub: + def prefix = task.ext.prefix ?: "${meta.id}" + def VERSION = "0.6.1" // WARN: Version information not provided by tool on CLI. Please update this string when bumping container versions. + """ + touch ${prefix}_metagene_profiles.txt + touch ${prefix}_p_offsets.png + touch ${prefix}_p_offsets.txt + + cat <<-END_VERSIONS > versions.yml + "${task.process}": + plastid: $VERSION + END_VERSIONS + """ +} diff --git a/modules/nf-core/plastid/psite/meta.yml b/modules/nf-core/plastid/psite/meta.yml new file mode 100644 index 00000000..cf0ec666 --- /dev/null +++ b/modules/nf-core/plastid/psite/meta.yml @@ -0,0 +1,94 @@ +# yaml-language-server: $schema=https://raw.githubusercontent.com/nf-core/modules/master/modules/meta-schema.json +name: "plastid_psite" +description: Estimate position of ribosomal P-site within ribosome profiling + read alignments as a function of read length +keywords: + - genomics + - riboseq + - psite +tools: + - "plastid": + description: "Nucleotide-resolution analysis of next-generation sequencing and genomics data" + homepage: "https://github.com/joshuagryphon/plastid" + documentation: "https://plastid.readthedocs.io/en/latest/" + tool_dev_url: "https://github.com/joshuagryphon/plastid" + doi: "10.1186/s12864-016-3278-x" + licence: ["BSD-3-clause"] + identifier: biotools:plastid + +input: + - - meta: + type: map + description: | + Groovy Map containing sample information + e.g. `[ id:'sample1', single_end:false ]` + - bam: + type: file + description: Genome BAM file + pattern: "*.bam" + ontologies: + - edam: http://edamontology.org/format_2572 # BAM + - bam_index: + type: file + description: Genome BAM index file + pattern: "*.bai" + ontologies: + - edam: http://edamontology.org/format_3327 # BAI + - - meta2: + type: map + description: | + Map containing reference information for the reference genome GTF file + e.g. `[ id:'Ensembl human v.111' ]` + - rois_txt: + type: file + description: | + Tab-delimited text file describing the maximal spanning + window for each gene (output from plastid_metagene_generate) + pattern: "*.txt" + ontologies: [] +output: + metagene_profiles: + - - meta: + type: map + description: | + Groovy Map containing sample information + e.g. `[ id:'sample1', single_end:false ]` + - "*_metagene_profiles.txt": + type: file + description: Matrix containing metagene profile for each read length + pattern: "*_metagene_profiles.txt" + ontologies: [] + p_offsets_png: + - - meta: + type: map + description: | + Groovy Map containing sample information + e.g. `[ id:'sample1', single_end:false ]` + - "*_p_offsets.png": + type: file + description: Graphical illustration of metagene profiles + pattern: "*_p_offsets.png" + ontologies: + - edam: http://edamontology.org/format_3603 # PNG + p_offsets: + - - meta: + type: map + description: | + Groovy Map containing sample information + e.g. `[ id:'sample1', single_end:false ]` + - "*_p_offsets.txt": + type: file + description: Selected p-site offset for each read length + pattern: "*_p_offsets.txt" + ontologies: [] + versions: + - versions.yml: + type: file + description: File containing software versions + pattern: "versions.yml" + ontologies: + - edam: http://edamontology.org/format_3750 # YAML +authors: + - "@suhrig" +maintainers: + - "@suhrig" diff --git a/modules/nf-core/plastid/psite/tests/main.nf.test b/modules/nf-core/plastid/psite/tests/main.nf.test new file mode 100644 index 00000000..a7b78ff9 --- /dev/null +++ b/modules/nf-core/plastid/psite/tests/main.nf.test @@ -0,0 +1,67 @@ +// nf-core modules test plastid +nextflow_process { + + name "Test Process PLASTID_PSITE" + script "../main.nf" + process "PLASTID_PSITE" + + tag "modules" + tag "modules_nfcore" + tag "plastid" + tag "plastid/psite" + + test("human chr20 bam") { + + when { + process { + """ + input[0] = [ + [ id:'SRX11780887' ], // meta map + file(params.modules_testdata_base_path + "genomics/homo_sapiens/riboseq_expression/aligned_reads/SRX11780887_chr20.bam", checkIfExists: true), + file(params.modules_testdata_base_path + "genomics/homo_sapiens/riboseq_expression/aligned_reads/SRX11780887_chr20.bam.bai", checkIfExists: true) + ] + input[1] = [[id:'homo_sapiens_chr20'], file(params.modules_testdata_base_path + "genomics/homo_sapiens/riboseq_expression/plastid/Homo_sapiens.GRCh38.111_chr20_rois.txt", checkIfExists: true)] + """ + } + } + + then { + assertAll( + { assert process.success }, + { assert path(process.out.metagene_profiles.get(0).get(1)).getText().contains('28-mers') }, + { assert file(process.out.p_offsets_png.get(0).get(1)).exists() }, + { assert path(process.out.p_offsets.get(0).get(1)).getText().contains("length\tp_offset") }, + { assert snapshot(process.out.versions).match() } + ) + } + } + + test("human chr20 bam -stub") { + + options "-stub" + + when { + process { + """ + input[0] = [ + [ id:'SRX11780887' ], // meta map + file(params.modules_testdata_base_path + "genomics/homo_sapiens/riboseq_expression/aligned_reads/SRX11780887_chr20.bam", checkIfExists: true), + file(params.modules_testdata_base_path + "genomics/homo_sapiens/riboseq_expression/aligned_reads/SRX11780887_chr20.bam.bai", checkIfExists: true) + ] + input[1] = [[id:'homo_sapiens_chr20'], file(params.modules_testdata_base_path + "genomics/homo_sapiens/riboseq_expression/plastid/Homo_sapiens.GRCh38.111_chr20_rois.txt", checkIfExists: true)] + """ + } + } + + then { + assertAll( + { assert process.success }, + { assert file(process.out.metagene_profiles.get(0).get(1)).exists() }, + { assert file(process.out.p_offsets_png.get(0).get(1)).exists() }, + { assert file(process.out.p_offsets.get(0).get(1)).exists() }, + { assert snapshot(process.out.versions).match() } + ) + } + } + +} diff --git a/modules/nf-core/plastid/psite/tests/main.nf.test.snap b/modules/nf-core/plastid/psite/tests/main.nf.test.snap new file mode 100644 index 00000000..c2a3532c --- /dev/null +++ b/modules/nf-core/plastid/psite/tests/main.nf.test.snap @@ -0,0 +1,26 @@ +{ + "human chr20 bam -stub": { + "content": [ + [ + "versions.yml:md5,f0a577bc6782d64582ef1c52b5b47ad7" + ] + ], + "meta": { + "nf-test": "0.9.2", + "nextflow": "25.10.0" + }, + "timestamp": "2025-12-10T12:46:13.713244" + }, + "human chr20 bam": { + "content": [ + [ + "versions.yml:md5,f0a577bc6782d64582ef1c52b5b47ad7" + ] + ], + "meta": { + "nf-test": "0.9.2", + "nextflow": "25.10.0" + }, + "timestamp": "2025-12-10T12:46:07.654842" + } +} \ No newline at end of file diff --git a/nextflow.config b/nextflow.config index eb233255..7218b21c 100644 --- a/nextflow.config +++ b/nextflow.config @@ -90,20 +90,28 @@ params { skip_multiqc = false // Riboseq module-specific options - skip_ribotish = false - extra_ribotish_quality_args = null - extra_ribotish_predict_args = null - skip_ribotricer = false - extra_ribotricer_prepareorfs_args = null - extra_ribotricer_detectorfs_args = null - skip_ribowaltz = false - extra_ribowaltz_args = null - extra_anota2seq_run_args = null - translational_efficiency_method = 'anota2seq' - extra_deltate_args = null - te_lfc_threshold = 0.2630344 // log2(1.2) - anota2seq default - rna_lfc_threshold = 0 // 0 = disabled - ribo_lfc_threshold = 0 // 0 = disabled + skip_ribotish = false + extra_ribotish_quality_args = null + extra_ribotish_predict_args = null + skip_ribotricer = false + extra_ribotricer_prepareorfs_args = null + extra_ribotricer_detectorfs_args = null + skip_ribowaltz = false + extra_ribowaltz_args = null + extra_anota2seq_run_args = null + translational_efficiency_method = 'anota2seq' + extra_deltate_args = null + te_lfc_threshold = 0.2630344 // log2(1.2) - anota2seq default + rna_lfc_threshold = 0 // 0 = disabled + ribo_lfc_threshold = 0 // 0 = disabled + skip_plastid = false + plastid_min_length = 15 + plastid_max_length = 50 + plastid_default_psite_offset = 12 + extra_plastid_metagene_generate_args = null + extra_plastid_psite_args = null + extra_plastid_make_wiggle_args = null + // Read length equalisation equalise_read_lengths = false diff --git a/nextflow_schema.json b/nextflow_schema.json index abcdd58b..c7b42112 100644 --- a/nextflow_schema.json +++ b/nextflow_schema.json @@ -488,6 +488,35 @@ "description": "Minimum absolute log2 fold change for translated mRNA (Ribo-seq) to be considered significant. Set to 0 to disable. Maps to anota2seq selDeltaP / deltaTE lfc_threshold_ribo.", "fa_icon": "fas fa-ruler-vertical" }, + "extra_plastid_metagene_generate_args": { + "type": "string", + "description": "Extra arguments to pass to plastid/metagene_generate command in addition to defaults defined by the pipeline." + }, + "extra_plastid_psite_args": { + "type": "string", + "description": "Extra arguments to pass to plastid/psite command in addition to defaults defined by the pipeline." + }, + "extra_plastid_make_wiggle_args": { + "type": "string", + "description": "Extra arguments to pass to plastid/make_wiggle command in addition to defaults defined by the pipeline." + }, + "plastid_min_length": { + "type": "integer", + "default": 15, + "fa_icon": "fas fa-ruler-horizontal", + "description": "Plastid only considers reads of at least the given length." + }, + "plastid_max_length": { + "type": "integer", + "default": 50, + "fa_icon": "fas fa-ruler-horizontal", + "description": "Plastid only considers reads of at most the given length." + }, + "plastid_default_psite_offset": { + "type": "integer", + "default": 12, + "description": "Default p-site offset to use for read lengths where the offset cannot be determined automatically from the data." + }, "equalise_read_lengths": { "type": "boolean", "default": false, @@ -641,6 +670,11 @@ "type": "boolean", "description": "Skip riboWaltz.", "fa_icon": "fas fa-fast-forward" + }, + "skip_plastid": { + "type": "boolean", + "description": "Skip plastid.", + "fa_icon": "fas fa-fast-forward" } } }, diff --git a/ro-crate-metadata.json b/ro-crate-metadata.json index e9bfb1c2..e46a3d5f 100644 --- a/ro-crate-metadata.json +++ b/ro-crate-metadata.json @@ -23,7 +23,7 @@ "@type": "Dataset", "creativeWorkStatus": "InProgress", "datePublished": "2025-12-03T16:26:32+00:00", - "description": "

\n \n \n \"nf-core/riboseq\"\n \n

\n\n[![Open in GitHub Codespaces](https://img.shields.io/badge/Open_In_GitHub_Codespaces-black?labelColor=grey&logo=github)](https://github.com/codespaces/new/nf-core/riboseq)\n[![GitHub Actions CI Status](https://github.com/nf-core/riboseq/actions/workflows/nf-test.yml/badge.svg)](https://github.com/nf-core/riboseq/actions/workflows/nf-test.yml)\n[![GitHub Actions Linting Status](https://github.com/nf-core/riboseq/actions/workflows/linting.yml/badge.svg)](https://github.com/nf-core/riboseq/actions/workflows/linting.yml)[![AWS CI](https://img.shields.io/badge/CI%20tests-full%20size-FF9900?labelColor=000000&logo=Amazon%20AWS)](https://nf-co.re/riboseq/results)[![Cite with Zenodo](http://img.shields.io/badge/DOI-10.5281/zenodo.10966364-1073c8?labelColor=000000)](https://doi.org/10.5281/zenodo.10966364)\n[![nf-test](https://img.shields.io/badge/unit_tests-nf--test-337ab7.svg)](https://www.nf-test.com)\n\n[![Nextflow](https://img.shields.io/badge/version-%E2%89%A525.04.8-green?style=flat&logo=nextflow&logoColor=white&color=%230DC09D&link=https%3A%2F%2Fnextflow.io)](https://www.nextflow.io/)\n[![nf-core template version](https://img.shields.io/badge/nf--core_template-3.5.1-green?style=flat&logo=nfcore&logoColor=white&color=%2324B064&link=https%3A%2F%2Fnf-co.re)](https://github.com/nf-core/tools/releases/tag/3.5.1)\n[![run with conda](http://img.shields.io/badge/run%20with-conda-3EB049?labelColor=000000&logo=anaconda)](https://docs.conda.io/en/latest/)\n[![run with docker](https://img.shields.io/badge/run%20with-docker-0db7ed?labelColor=000000&logo=docker)](https://www.docker.com/)\n[![run with singularity](https://img.shields.io/badge/run%20with-singularity-1d355c.svg?labelColor=000000)](https://sylabs.io/docs/)\n[![Launch on Seqera Platform](https://img.shields.io/badge/Launch%20%F0%9F%9A%80-Seqera%20Platform-%234256e7)](https://cloud.seqera.io/launch?pipeline=https://github.com/nf-core/riboseq)\n\n[![Get help on Slack](http://img.shields.io/badge/slack-nf--core%20%23riboseq-4A154B?labelColor=000000&logo=slack)](https://nfcore.slack.com/channels/riboseq)[![Follow on Bluesky](https://img.shields.io/badge/bluesky-%40nf__core-1185fe?labelColor=000000&logo=bluesky)](https://bsky.app/profile/nf-co.re)[![Follow on Mastodon](https://img.shields.io/badge/mastodon-nf__core-6364ff?labelColor=FFFFFF&logo=mastodon)](https://mstdn.science/@nf_core)[![Watch on YouTube](http://img.shields.io/badge/youtube-nf--core-FF0000?labelColor=000000&logo=youtube)](https://www.youtube.com/c/nf-core)\n\n## Introduction\n\n**nf-core/riboseq** is a bioinformatics pipeline for analysis of Ribo-seq data. It borrows heavily from nf-core/rnaseq in the preprocessing stages:\n\n![nf-core/riboseq metro map](docs/images/nf-core-riboseq_metro_map.png)\n\n1. Merge re-sequenced FastQ files ([`cat`](http://www.linfo.org/cat.html))\n2. Sub-sample FastQ files and auto-infer strandedness ([`fq`](https://github.com/stjude-rust-labs/fq), [`Salmon`](https://combine-lab.github.io/salmon/))\n3. Read QC ([`FastQC`](https://www.bioinformatics.babraham.ac.uk/projects/fastqc/))\n4. UMI extraction ([`UMI-tools`](https://github.com/CGATOxford/UMI-tools))\n5. Adapter and quality trimming ([`Trim Galore!`](https://github.com/FelixKrueger/TrimGalore))\n6. Removal of genome contaminants ([`BBSplit`](http://seqanswers.com/forums/showthread.php?t=41288))\n7. Removal of ribosomal RNA ([`SortMeRNA`](https://github.com/biocore/sortmerna))\n8. Genome alignment of reads, outputting both genome and transcriptome alignments with [`STAR`](https://github.com/alexdobin/STAR)\n9. Sort and index alignments ([`SAMtools`](https://sourceforge.net/projects/samtools/files/samtools/))\n10. UMI-based deduplication ([`UMI-tools`](https://github.com/CGATOxford/UMI-tools))\n\nDifferences occur in the downstream analysis steps. Currently these specialist steps are:\n\n1. Check reads distribution around annotated protein coding regions on user provided transcripts, show frame bias and estimate P-site offset for different group of reads ([`Ribo-TISH`](https://github.com/zhpn1024/ribotish))\n2. (default, optional) Predict translated open reading frames and/ or translation initiation sites _de novo_ from alignment data ([`Ribo-TISH`](https://github.com/zhpn1024/ribotish))\n3. (default, optional) Derive candidate ORFs from reference data and detect translated ORFs from that list ([`Ribotricer`](https://github.com/smithlabcode/ribotricer))\n4. (default, optional) Derive P-sites and QC from transcriptome alignments ([`riboWaltz`](https://github.com/LabTranslationalArchitectomics/riboWaltz))\n5. (optional) Use a translational efficiency approach to study the dynamics of transcription and translation, with [anota2seq](https://bioconductor.org/packages/release/bioc/html/anota2seq.html). **requires matched RNA-seq and Ribo-seq data**\n\n## Usage\n\n> [!NOTE]\n> If you are new to Nextflow and nf-core, please refer to [this page](https://nf-co.re/docs/usage/installation) on how to set-up Nextflow. Make sure to [test your setup](https://nf-co.re/docs/usage/introduction#how-to-run-a-pipeline) with `-profile test` before running the workflow on actual data.\n\nFirst, prepare a samplesheet with your input data that looks as follows:\n\n`samplesheet.csv`:\n\n```csv\nsample,fastq_1,fastq_2,strandedness,type\nCONTROL_REP1,AEG588A1_S1_L002_R1_001.fastq.gz,AEG588A1_S1_L002_R2_001.fastq.gz,forward,riboseq\n```\n\nEach row represents a fastq file (single-end) or a pair of fastq files (paired end). Each row should have a 'type' value of `riboseq`, `tiseq` or `rnaseq`. Future iterations of the workflow will conduct paired analysis of matched riboseq and rnaseq samples to accomplish analysis types such as 'translational efficiency, but in the current version you should set this to `riboseq` or `tiseq` for reglar Ribo-seq or TI-seq data respectively.\n\nNow, you can run the pipeline using:\n\n```bash\nnextflow run nf-core/riboseq \\\n -profile \\\n --input samplesheet.csv \\\n --outdir \n```\n\n### Including a translational efficiency analysis\n\n![anota2seq - fold change plot](docs/images/fc.png)\n\nIn the translational efficiency analysis provided by [anota2seq](https://bioconductor.org/packages/release/bioc/html/anota2seq.html), we use matched pairs of Ribo-seq and RNA-seq data to study the relationship between transcription and translation as they differ between two treatment groups. For example the test data for this workflow has a contrasts file like:\n\n```csv\nid,variable,reference,target,batch,pair\ntreated_vs_control,treatment,control,treated,,pair\n```\n\nThis describes how to compare groups of samples between treament groups, and between RNA-seq and Ribo-seq. In order the columns are:\n\n- `id`: a unique identifier to use for the contrast\n- 'variable`: which vaiable (column) of the sample sheet should be used to separate the treatment groups?\n- `reference`: which value of the variable column should be used to select samples to be used as the reference/ base group?\n- `target`: which value of the variable column should be used to select samples to be used as the target/treated group?\n- `batch`: (optional) specify a variable in the sample sheet that defines sample batches\n- `pair`: (optional) specify a variable in the sample sheet that defines sample pairing between RNA-seq and Ribo-seq samples. If not specified, it is assumed that the two types of sample are ordered the same.\n\n> [!WARNING]\n> Please provide pipeline parameters via the CLI or Nextflow `-params-file` option. Custom config files including those provided by the `-c` Nextflow option can be used to provide any configuration _**except for parameters**_; see [docs](https://nf-co.re/docs/usage/getting_started/configuration#custom-configuration-files).\n\nFor more details and further functionality, please refer to the [usage documentation](https://nf-co.re/riboseq/usage) and the [parameter documentation](https://nf-co.re/riboseq/parameters).\n\n## Pipeline output\n\nTo see the results of an example test run with a full size dataset refer to the [results](https://nf-co.re/riboseq/results) tab on the nf-core website pipeline page.\nFor more details about the output files and reports, please refer to the\n[output documentation](https://nf-co.re/riboseq/output).\n\n## Credits\n\nnf-core/riboseq was originally written by [Jonathan Manning](https://github.com/pinin4fjords) (Bioinformatics Engineer at Seqera) with support from [Altos Labs](https://www.altoslabs.com/) and in discussion with [Felix Krueger](https://github.com/FelixKrueger) and [Christel Krueger](https://github.com/ChristelKrueger). We thank the following people for their input:\n\n- Anne Bresciani (ZS)\n- [Felipe Almeida](https://github.com/fmalmeida) (ZS)\n- [Mikhail Osipovitch](https://github.com/mosi223) (ZS)\n- [Edward Wallace](https://github.com/ewallace) (University of Edinburgh)\n- [Jack Tierney](https://github.com/JackCurragh) (University College Cork)\n- [Maxime U Garcia](https://github.com/maxulysse) (Seqera)\n- [Ira A Iosub](https://github.com/iraiosub) (The Francis Crick Institute)\n\n## Contributions and Support\n\nIf you would like to contribute to this pipeline, please see the [contributing guidelines](.github/CONTRIBUTING.md).\n\nFor further information or help, don't hesitate to get in touch on the [Slack `#riboseq` channel](https://nfcore.slack.com/channels/riboseq) (you can join with [this invite](https://nf-co.re/join/slack)).\n\n## Citations\n\nIf you use nf-core/riboseq for your analysis, please cite it using the following doi: [10.5281/zenodo.10966364](https://doi.org/10.5281/zenodo.10966364)\n\nAn extensive list of references for the tools used by the pipeline can be found in the [`CITATIONS.md`](CITATIONS.md) file.\n\nYou can cite the `nf-core` publication as follows:\n\n> **The nf-core framework for community-curated bioinformatics pipelines.**\n>\n> Philip Ewels, Alexander Peltzer, Sven Fillinger, Harshil Patel, Johannes Alneberg, Andreas Wilm, Maxime Ulysse Garcia, Paolo Di Tommaso & Sven Nahnsen.\n>\n> _Nat Biotechnol._ 2020 Feb 13. doi: [10.1038/s41587-020-0439-x](https://dx.doi.org/10.1038/s41587-020-0439-x).\n", + "description": "

\n \n \n \"nf-core/riboseq\"\n \n

\n\n[![Open in GitHub Codespaces](https://img.shields.io/badge/Open_In_GitHub_Codespaces-black?labelColor=grey&logo=github)](https://github.com/codespaces/new/nf-core/riboseq)\n[![GitHub Actions CI Status](https://github.com/nf-core/riboseq/actions/workflows/nf-test.yml/badge.svg)](https://github.com/nf-core/riboseq/actions/workflows/nf-test.yml)\n[![GitHub Actions Linting Status](https://github.com/nf-core/riboseq/actions/workflows/linting.yml/badge.svg)](https://github.com/nf-core/riboseq/actions/workflows/linting.yml)[![AWS CI](https://img.shields.io/badge/CI%20tests-full%20size-FF9900?labelColor=000000&logo=Amazon%20AWS)](https://nf-co.re/riboseq/results)[![Cite with Zenodo](http://img.shields.io/badge/DOI-10.5281/zenodo.10966364-1073c8?labelColor=000000)](https://doi.org/10.5281/zenodo.10966364)\n[![nf-test](https://img.shields.io/badge/unit_tests-nf--test-337ab7.svg)](https://www.nf-test.com)\n\n[![Nextflow](https://img.shields.io/badge/version-%E2%89%A525.04.8-green?style=flat&logo=nextflow&logoColor=white&color=%230DC09D&link=https%3A%2F%2Fnextflow.io)](https://www.nextflow.io/)\n[![nf-core template version](https://img.shields.io/badge/nf--core_template-3.5.1-green?style=flat&logo=nfcore&logoColor=white&color=%2324B064&link=https%3A%2F%2Fnf-co.re)](https://github.com/nf-core/tools/releases/tag/3.5.1)\n[![run with conda](http://img.shields.io/badge/run%20with-conda-3EB049?labelColor=000000&logo=anaconda)](https://docs.conda.io/en/latest/)\n[![run with docker](https://img.shields.io/badge/run%20with-docker-0db7ed?labelColor=000000&logo=docker)](https://www.docker.com/)\n[![run with singularity](https://img.shields.io/badge/run%20with-singularity-1d355c.svg?labelColor=000000)](https://sylabs.io/docs/)\n[![Launch on Seqera Platform](https://img.shields.io/badge/Launch%20%F0%9F%9A%80-Seqera%20Platform-%234256e7)](https://cloud.seqera.io/launch?pipeline=https://github.com/nf-core/riboseq)\n\n[![Get help on Slack](http://img.shields.io/badge/slack-nf--core%20%23riboseq-4A154B?labelColor=000000&logo=slack)](https://nfcore.slack.com/channels/riboseq)[![Follow on Bluesky](https://img.shields.io/badge/bluesky-%40nf__core-1185fe?labelColor=000000&logo=bluesky)](https://bsky.app/profile/nf-co.re)[![Follow on Mastodon](https://img.shields.io/badge/mastodon-nf__core-6364ff?labelColor=FFFFFF&logo=mastodon)](https://mstdn.science/@nf_core)[![Watch on YouTube](http://img.shields.io/badge/youtube-nf--core-FF0000?labelColor=000000&logo=youtube)](https://www.youtube.com/c/nf-core)\n\n## Introduction\n\n**nf-core/riboseq** is a bioinformatics pipeline for analysis of Ribo-seq data. It borrows heavily from nf-core/rnaseq in the preprocessing stages:\n\n![nf-core/riboseq metro map](docs/images/nf-core-riboseq_metro_map.png)\n\n1. Merge re-sequenced FastQ files ([`cat`](http://www.linfo.org/cat.html))\n2. Sub-sample FastQ files and auto-infer strandedness ([`fq`](https://github.com/stjude-rust-labs/fq), [`Salmon`](https://combine-lab.github.io/salmon/))\n3. Read QC ([`FastQC`](https://www.bioinformatics.babraham.ac.uk/projects/fastqc/))\n4. UMI extraction ([`UMI-tools`](https://github.com/CGATOxford/UMI-tools))\n5. Adapter and quality trimming ([`Trim Galore!`](https://github.com/FelixKrueger/TrimGalore))\n6. Removal of genome contaminants ([`BBSplit`](http://seqanswers.com/forums/showthread.php?t=41288))\n7. Removal of ribosomal RNA ([`SortMeRNA`](https://github.com/biocore/sortmerna))\n8. Genome alignment of reads, outputting both genome and transcriptome alignments with [`STAR`](https://github.com/alexdobin/STAR)\n9. Sort and index alignments ([`SAMtools`](https://sourceforge.net/projects/samtools/files/samtools/))\n10. UMI-based deduplication ([`UMI-tools`](https://github.com/CGATOxford/UMI-tools))\n\nDifferences occur in the downstream analysis steps. Currently these specialist steps are:\n\n1. Check reads distribution around annotated protein coding regions on user provided transcripts, show frame bias and estimate P-site offset for different group of reads ([`Ribo-TISH`](https://github.com/zhpn1024/ribotish))\n2. (default, optional) Predict translated open reading frames and/ or translation initiation sites _de novo_ from alignment data ([`Ribo-TISH`](https://github.com/zhpn1024/ribotish))\n3. (default, optional) Derive candidate ORFs from reference data and detect translated ORFs from that list ([`Ribotricer`](https://github.com/smithlabcode/ribotricer))\n4. (default, optional) Derive P-sites and QC from transcriptome alignments ([`riboWaltz`](https://github.com/LabTranslationalArchitectomics/riboWaltz), [`plastid`](https://plastid.readthedocs.io/en/latest/index.html))\n5. (optional) Use a translational efficiency approach to study the dynamics of transcription and translation, with [anota2seq](https://bioconductor.org/packages/release/bioc/html/anota2seq.html). **requires matched RNA-seq and Ribo-seq data**\n\n## Usage\n\n> [!NOTE]\n> If you are new to Nextflow and nf-core, please refer to [this page](https://nf-co.re/docs/usage/installation) on how to set-up Nextflow. Make sure to [test your setup](https://nf-co.re/docs/usage/introduction#how-to-run-a-pipeline) with `-profile test` before running the workflow on actual data.\n\nFirst, prepare a samplesheet with your input data that looks as follows:\n\n`samplesheet.csv`:\n\n```csv\nsample,fastq_1,fastq_2,strandedness,type\nCONTROL_REP1,AEG588A1_S1_L002_R1_001.fastq.gz,AEG588A1_S1_L002_R2_001.fastq.gz,forward,riboseq\n```\n\nEach row represents a fastq file (single-end) or a pair of fastq files (paired end). Each row should have a 'type' value of `riboseq`, `tiseq` or `rnaseq`. Future iterations of the workflow will conduct paired analysis of matched riboseq and rnaseq samples to accomplish analysis types such as 'translational efficiency, but in the current version you should set this to `riboseq` or `tiseq` for reglar Ribo-seq or TI-seq data respectively.\n\nNow, you can run the pipeline using:\n\n```bash\nnextflow run nf-core/riboseq \\\n -profile \\\n --input samplesheet.csv \\\n --outdir \n```\n\n### Including a translational efficiency analysis\n\n![anota2seq - fold change plot](docs/images/fc.png)\n\nIn the translational efficiency analysis provided by [anota2seq](https://bioconductor.org/packages/release/bioc/html/anota2seq.html), we use matched pairs of Ribo-seq and RNA-seq data to study the relationship between transcription and translation as they differ between two treatment groups. For example the test data for this workflow has a contrasts file like:\n\n```csv\nid,variable,reference,target,batch,pair\ntreated_vs_control,treatment,control,treated,,pair\n```\n\nThis describes how to compare groups of samples between treament groups, and between RNA-seq and Ribo-seq. In order the columns are:\n\n- `id`: a unique identifier to use for the contrast\n- 'variable`: which vaiable (column) of the sample sheet should be used to separate the treatment groups?\n- `reference`: which value of the variable column should be used to select samples to be used as the reference/ base group?\n- `target`: which value of the variable column should be used to select samples to be used as the target/treated group?\n- `batch`: (optional) specify a variable in the sample sheet that defines sample batches\n- `pair`: (optional) specify a variable in the sample sheet that defines sample pairing between RNA-seq and Ribo-seq samples. If not specified, it is assumed that the two types of sample are ordered the same.\n\n> [!WARNING]\n> Please provide pipeline parameters via the CLI or Nextflow `-params-file` option. Custom config files including those provided by the `-c` Nextflow option can be used to provide any configuration _**except for parameters**_; see [docs](https://nf-co.re/docs/usage/getting_started/configuration#custom-configuration-files).\n\nFor more details and further functionality, please refer to the [usage documentation](https://nf-co.re/riboseq/usage) and the [parameter documentation](https://nf-co.re/riboseq/parameters).\n\n## Pipeline output\n\nTo see the results of an example test run with a full size dataset refer to the [results](https://nf-co.re/riboseq/results) tab on the nf-core website pipeline page.\nFor more details about the output files and reports, please refer to the\n[output documentation](https://nf-co.re/riboseq/output).\n\n## Credits\n\nnf-core/riboseq was originally written by [Jonathan Manning](https://github.com/pinin4fjords) (Bioinformatics Engineer at Seqera) with support from [Altos Labs](https://www.altoslabs.com/) and in discussion with [Felix Krueger](https://github.com/FelixKrueger) and [Christel Krueger](https://github.com/ChristelKrueger). We thank the following people for their input:\n\n- Anne Bresciani (ZS)\n- [Felipe Almeida](https://github.com/fmalmeida) (ZS)\n- [Mikhail Osipovitch](https://github.com/mosi223) (ZS)\n- [Edward Wallace](https://github.com/ewallace) (University of Edinburgh)\n- [Jack Tierney](https://github.com/JackCurragh) (University College Cork)\n- [Maxime U Garcia](https://github.com/maxulysse) (Seqera)\n- [Ira A Iosub](https://github.com/iraiosub) (The Francis Crick Institute)\n\n## Contributions and Support\n\nIf you would like to contribute to this pipeline, please see the [contributing guidelines](.github/CONTRIBUTING.md).\n\nFor further information or help, don't hesitate to get in touch on the [Slack `#riboseq` channel](https://nfcore.slack.com/channels/riboseq) (you can join with [this invite](https://nf-co.re/join/slack)).\n\n## Citations\n\nIf you use nf-core/riboseq for your analysis, please cite it using the following doi: [10.5281/zenodo.10966364](https://doi.org/10.5281/zenodo.10966364)\n\nAn extensive list of references for the tools used by the pipeline can be found in the [`CITATIONS.md`](CITATIONS.md) file.\n\nYou can cite the `nf-core` publication as follows:\n\n> **The nf-core framework for community-curated bioinformatics pipelines.**\n>\n> Philip Ewels, Alexander Peltzer, Sven Fillinger, Harshil Patel, Johannes Alneberg, Andreas Wilm, Maxime Ulysse Garcia, Paolo Di Tommaso & Sven Nahnsen.\n>\n> _Nat Biotechnol._ 2020 Feb 13. doi: [10.1038/s41587-020-0439-x](https://dx.doi.org/10.1038/s41587-020-0439-x).\n", "hasPart": [ { "@id": "main.nf" diff --git a/tests/.nftignore b/tests/.nftignore index fd65f03a..0bc2f04c 100644 --- a/tests/.nftignore +++ b/tests/.nftignore @@ -59,7 +59,8 @@ quantification/salmon_te_pseudo/*.rds quantification/salmon_te_pseudo/**/*.rds quantification/salmon_te_pseudo/salmon.merged.te_pseudo.*.tsv riboseq_qc/ribotish/*_qual.pdf -ribowaltz/**/*.pdf +psites/ribowaltz/**/*.pdf +psites/plastid/*/* translational_efficiency/anota2seq/*.{buffering,total_mRNA,translated_mRNA,translation}.anota2seq.results.tsv translational_efficiency/*/*.{jpeg,jpg,png,pdf,rds,tsv} translational_efficiency/deltate/*.{translation,translated_mRNA,total_mRNA}.deltate.results.tsv diff --git a/tests/default.nf.test.snap b/tests/default.nf.test.snap index 957a22cf..923e0f6d 100644 --- a/tests/default.nf.test.snap +++ b/tests/default.nf.test.snap @@ -27,6 +27,15 @@ "rsem": "1.3.1", "star": "2.7.10a" }, + "PLASTID_MAKE_WIGGLE": { + "plastid": "0.6.1" + }, + "PLASTID_METAGENE_GENERATE": { + "plastid": "0.6.1" + }, + "PLASTID_PSITE": { + "plastid": "0.6.1" + }, "RIBOTISH_PREDICT_ALL": { "ribotish": "0.2.7" }, @@ -674,6 +683,225 @@ "preprocessing/trimgalore/fastqc/SRX11780889_trimmed_fastqc.zip", "preprocessing/trimgalore/fastqc/SRX11780890_trimmed_fastqc.html", "preprocessing/trimgalore/fastqc/SRX11780890_trimmed_fastqc.zip", + "psites", + "psites/plastid", + "psites/plastid/metagene", + "psites/plastid/metagene/Homo_sapiens.GRCh38.dna.chromosome.20.filtered_rois.bed", + "psites/plastid/metagene/Homo_sapiens.GRCh38.dna.chromosome.20.filtered_rois.txt", + "psites/plastid/offsets", + "psites/plastid/offsets/SRX11780885_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780885_p_offsets.png", + "psites/plastid/offsets/SRX11780885_p_offsets.txt", + "psites/plastid/offsets/SRX11780886_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780886_p_offsets.png", + "psites/plastid/offsets/SRX11780886_p_offsets.txt", + "psites/plastid/offsets/SRX11780887_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780887_p_offsets.png", + "psites/plastid/offsets/SRX11780887_p_offsets.txt", + "psites/plastid/offsets/SRX11780888_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780888_p_offsets.png", + "psites/plastid/offsets/SRX11780888_p_offsets.txt", + "psites/plastid/offsets/SRX11780889_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780889_p_offsets.png", + "psites/plastid/offsets/SRX11780889_p_offsets.txt", + "psites/plastid/offsets/SRX11780890_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780890_p_offsets.png", + "psites/plastid/offsets/SRX11780890_p_offsets.txt", + "psites/plastid/tracks", + "psites/plastid/tracks/SRX11780885_fw.bedgraph", + "psites/plastid/tracks/SRX11780885_rc.bedgraph", + "psites/plastid/tracks/SRX11780886_fw.bedgraph", + "psites/plastid/tracks/SRX11780886_rc.bedgraph", + "psites/plastid/tracks/SRX11780887_fw.bedgraph", + "psites/plastid/tracks/SRX11780887_rc.bedgraph", + "psites/plastid/tracks/SRX11780888_fw.bedgraph", + "psites/plastid/tracks/SRX11780888_rc.bedgraph", + "psites/plastid/tracks/SRX11780889_fw.bedgraph", + "psites/plastid/tracks/SRX11780889_rc.bedgraph", + "psites/plastid/tracks/SRX11780890_fw.bedgraph", + "psites/plastid/tracks/SRX11780890_rc.bedgraph", + "psites/ribowaltz", + "psites/ribowaltz/SRX11780885.best_offset.txt", + "psites/ribowaltz/SRX11780885.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780885.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780885.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780885.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780885.psite.tsv.gz", + "psites/ribowaltz/SRX11780885.psite_offset.tsv.gz", + "psites/ribowaltz/SRX11780886.best_offset.txt", + "psites/ribowaltz/SRX11780886.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780886.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780886.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780886.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780886.psite.tsv.gz", + "psites/ribowaltz/SRX11780886.psite_offset.tsv.gz", + "psites/ribowaltz/SRX11780887.best_offset.txt", + "psites/ribowaltz/SRX11780887.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780887.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780887.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780887.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780887.psite.tsv.gz", + "psites/ribowaltz/SRX11780887.psite_offset.tsv.gz", + "psites/ribowaltz/SRX11780888.best_offset.txt", + "psites/ribowaltz/SRX11780888.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780888.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780888.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780888.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780888.psite.tsv.gz", + "psites/ribowaltz/SRX11780888.psite_offset.tsv.gz", + "psites/ribowaltz/SRX11780889.best_offset.txt", + "psites/ribowaltz/SRX11780889.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780889.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780889.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780889.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780889.psite.tsv.gz", + "psites/ribowaltz/SRX11780889.psite_offset.tsv.gz", + "psites/ribowaltz/SRX11780890.best_offset.txt", + "psites/ribowaltz/SRX11780890.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780890.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780890.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780890.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780890.psite.tsv.gz", + "psites/ribowaltz/SRX11780890.psite_offset.tsv.gz", + "psites/ribowaltz/offset_plot", + "psites/ribowaltz/offset_plot/SRX11780885", + "psites/ribowaltz/offset_plot/SRX11780885/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/31.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/32.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/33.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/34.pdf", + "psites/ribowaltz/offset_plot/SRX11780886", + "psites/ribowaltz/offset_plot/SRX11780886/20.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/21.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/31.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/32.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/33.pdf", + "psites/ribowaltz/offset_plot/SRX11780887", + "psites/ribowaltz/offset_plot/SRX11780887/20.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/21.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/31.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/32.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/33.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/34.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/35.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/36.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/37.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/38.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/39.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/40.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/41.pdf", + "psites/ribowaltz/offset_plot/SRX11780888", + "psites/ribowaltz/offset_plot/SRX11780888/21.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780889", + "psites/ribowaltz/offset_plot/SRX11780889/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/31.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/32.pdf", + "psites/ribowaltz/offset_plot/SRX11780890", + "psites/ribowaltz/offset_plot/SRX11780890/21.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/31.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/32.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/33.pdf", + "psites/ribowaltz/ribowaltz_qc", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.psite_region.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.psite_region.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.psite_region.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.psite_region.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.psite_region.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.psite_region.pdf", "quantification", "quantification/salmon", "quantification/salmon/SRX11780879", @@ -889,188 +1117,6 @@ "riboseq_qc/ribotish/SRX11780890.para.py", "riboseq_qc/ribotish/SRX11780890_qual.pdf", "riboseq_qc/ribotish/SRX11780890_qual.txt", - "ribowaltz", - "ribowaltz/SRX11780885.best_offset.txt", - "ribowaltz/SRX11780885.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780885.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780885.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780885.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780885.psite.tsv.gz", - "ribowaltz/SRX11780885.psite_offset.tsv.gz", - "ribowaltz/SRX11780886.best_offset.txt", - "ribowaltz/SRX11780886.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780886.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780886.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780886.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780886.psite.tsv.gz", - "ribowaltz/SRX11780886.psite_offset.tsv.gz", - "ribowaltz/SRX11780887.best_offset.txt", - "ribowaltz/SRX11780887.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780887.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780887.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780887.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780887.psite.tsv.gz", - "ribowaltz/SRX11780887.psite_offset.tsv.gz", - "ribowaltz/SRX11780888.best_offset.txt", - "ribowaltz/SRX11780888.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780888.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780888.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780888.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780888.psite.tsv.gz", - "ribowaltz/SRX11780888.psite_offset.tsv.gz", - "ribowaltz/SRX11780889.best_offset.txt", - "ribowaltz/SRX11780889.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780889.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780889.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780889.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780889.psite.tsv.gz", - "ribowaltz/SRX11780889.psite_offset.tsv.gz", - "ribowaltz/SRX11780890.best_offset.txt", - "ribowaltz/SRX11780890.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780890.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780890.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780890.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780890.psite.tsv.gz", - "ribowaltz/SRX11780890.psite_offset.tsv.gz", - "ribowaltz/offset_plot", - "ribowaltz/offset_plot/SRX11780885", - "ribowaltz/offset_plot/SRX11780885/22.pdf", - "ribowaltz/offset_plot/SRX11780885/23.pdf", - "ribowaltz/offset_plot/SRX11780885/24.pdf", - "ribowaltz/offset_plot/SRX11780885/25.pdf", - "ribowaltz/offset_plot/SRX11780885/26.pdf", - "ribowaltz/offset_plot/SRX11780885/27.pdf", - "ribowaltz/offset_plot/SRX11780885/28.pdf", - "ribowaltz/offset_plot/SRX11780885/29.pdf", - "ribowaltz/offset_plot/SRX11780885/30.pdf", - "ribowaltz/offset_plot/SRX11780885/31.pdf", - "ribowaltz/offset_plot/SRX11780885/32.pdf", - "ribowaltz/offset_plot/SRX11780885/33.pdf", - "ribowaltz/offset_plot/SRX11780885/34.pdf", - "ribowaltz/offset_plot/SRX11780886", - "ribowaltz/offset_plot/SRX11780886/20.pdf", - "ribowaltz/offset_plot/SRX11780886/21.pdf", - "ribowaltz/offset_plot/SRX11780886/22.pdf", - "ribowaltz/offset_plot/SRX11780886/23.pdf", - "ribowaltz/offset_plot/SRX11780886/24.pdf", - "ribowaltz/offset_plot/SRX11780886/25.pdf", - "ribowaltz/offset_plot/SRX11780886/26.pdf", - "ribowaltz/offset_plot/SRX11780886/27.pdf", - "ribowaltz/offset_plot/SRX11780886/28.pdf", - "ribowaltz/offset_plot/SRX11780886/29.pdf", - "ribowaltz/offset_plot/SRX11780886/30.pdf", - "ribowaltz/offset_plot/SRX11780886/31.pdf", - "ribowaltz/offset_plot/SRX11780886/32.pdf", - "ribowaltz/offset_plot/SRX11780886/33.pdf", - "ribowaltz/offset_plot/SRX11780887", - "ribowaltz/offset_plot/SRX11780887/20.pdf", - "ribowaltz/offset_plot/SRX11780887/21.pdf", - "ribowaltz/offset_plot/SRX11780887/22.pdf", - "ribowaltz/offset_plot/SRX11780887/23.pdf", - "ribowaltz/offset_plot/SRX11780887/24.pdf", - "ribowaltz/offset_plot/SRX11780887/25.pdf", - "ribowaltz/offset_plot/SRX11780887/26.pdf", - "ribowaltz/offset_plot/SRX11780887/27.pdf", - "ribowaltz/offset_plot/SRX11780887/28.pdf", - "ribowaltz/offset_plot/SRX11780887/29.pdf", - "ribowaltz/offset_plot/SRX11780887/30.pdf", - "ribowaltz/offset_plot/SRX11780887/31.pdf", - "ribowaltz/offset_plot/SRX11780887/32.pdf", - "ribowaltz/offset_plot/SRX11780887/33.pdf", - "ribowaltz/offset_plot/SRX11780887/34.pdf", - "ribowaltz/offset_plot/SRX11780887/35.pdf", - "ribowaltz/offset_plot/SRX11780887/36.pdf", - "ribowaltz/offset_plot/SRX11780887/37.pdf", - "ribowaltz/offset_plot/SRX11780887/38.pdf", - "ribowaltz/offset_plot/SRX11780887/39.pdf", - "ribowaltz/offset_plot/SRX11780887/40.pdf", - "ribowaltz/offset_plot/SRX11780887/41.pdf", - "ribowaltz/offset_plot/SRX11780888", - "ribowaltz/offset_plot/SRX11780888/21.pdf", - "ribowaltz/offset_plot/SRX11780888/22.pdf", - "ribowaltz/offset_plot/SRX11780888/23.pdf", - "ribowaltz/offset_plot/SRX11780888/24.pdf", - "ribowaltz/offset_plot/SRX11780888/25.pdf", - "ribowaltz/offset_plot/SRX11780888/26.pdf", - "ribowaltz/offset_plot/SRX11780888/27.pdf", - "ribowaltz/offset_plot/SRX11780888/28.pdf", - "ribowaltz/offset_plot/SRX11780888/29.pdf", - "ribowaltz/offset_plot/SRX11780888/30.pdf", - "ribowaltz/offset_plot/SRX11780889", - "ribowaltz/offset_plot/SRX11780889/22.pdf", - "ribowaltz/offset_plot/SRX11780889/23.pdf", - "ribowaltz/offset_plot/SRX11780889/24.pdf", - "ribowaltz/offset_plot/SRX11780889/25.pdf", - "ribowaltz/offset_plot/SRX11780889/26.pdf", - "ribowaltz/offset_plot/SRX11780889/27.pdf", - "ribowaltz/offset_plot/SRX11780889/28.pdf", - "ribowaltz/offset_plot/SRX11780889/29.pdf", - "ribowaltz/offset_plot/SRX11780889/30.pdf", - "ribowaltz/offset_plot/SRX11780889/31.pdf", - "ribowaltz/offset_plot/SRX11780889/32.pdf", - "ribowaltz/offset_plot/SRX11780890", - "ribowaltz/offset_plot/SRX11780890/21.pdf", - "ribowaltz/offset_plot/SRX11780890/22.pdf", - "ribowaltz/offset_plot/SRX11780890/23.pdf", - "ribowaltz/offset_plot/SRX11780890/24.pdf", - "ribowaltz/offset_plot/SRX11780890/25.pdf", - "ribowaltz/offset_plot/SRX11780890/26.pdf", - "ribowaltz/offset_plot/SRX11780890/27.pdf", - "ribowaltz/offset_plot/SRX11780890/28.pdf", - "ribowaltz/offset_plot/SRX11780890/29.pdf", - "ribowaltz/offset_plot/SRX11780890/30.pdf", - "ribowaltz/offset_plot/SRX11780890/31.pdf", - "ribowaltz/offset_plot/SRX11780890/32.pdf", - "ribowaltz/offset_plot/SRX11780890/33.pdf", - "ribowaltz/ribowaltz_qc", - "ribowaltz/ribowaltz_qc/SRX11780885.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.psite_region.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.psite_region.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.psite_region.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.psite_region.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.psite_region.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.psite_region.pdf", "translational_efficiency", "translational_efficiency/anota2seq", "translational_efficiency/anota2seq/treated_vs_control.Anota2seqDataSet.rds", @@ -1214,6 +1260,48 @@ "allsamples_all.txt:md5,fcdb19d5389596185db2ebce2663cd94", "allsamples_pred.txt:md5,fcdb19d5389596185db2ebce2663cd94", "allsamples_transprofile.py:md5,10add18b7c9d626042b8980ee896adb9", + "SRX11780885.best_offset.txt:md5,1e6611858fd98bf4384cb121afb6707c", + "SRX11780885.cds_coverage_psite.tsv.gz:md5,f9d49b4c82a8b3e5b521441e9df4cc86", + "SRX11780885.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,87c80db54f46aac956f46a3ae09b23bc", + "SRX11780885.codon_coverage_psite.tsv.gz:md5,8a759875e7dbbf39d3720f732713678a", + "SRX11780885.codon_coverage_rpf.tsv.gz:md5,afbf801cb1ba85f404978098e572901d", + "SRX11780885.psite.tsv.gz:md5,517cfb43200a4d77598e7cea3d654460", + "SRX11780885.psite_offset.tsv.gz:md5,8a9c12f2e2ed8ab033b0ef6094706e73", + "SRX11780886.best_offset.txt:md5,787599a080c37b7d6eda470c13cc2563", + "SRX11780886.cds_coverage_psite.tsv.gz:md5,3f9a35c6f34c0db4754e8a1662faa0b5", + "SRX11780886.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,9b15a2401a9f0e42c060526f85596d8b", + "SRX11780886.codon_coverage_psite.tsv.gz:md5,7aec8c79793692acd49c7858bce2b579", + "SRX11780886.codon_coverage_rpf.tsv.gz:md5,3e50a00b6520665c165e4c3fce19e5f1", + "SRX11780886.psite.tsv.gz:md5,78de44e6dbda8f3914d52a068acde6bd", + "SRX11780886.psite_offset.tsv.gz:md5,78798ac87401d666552fd6145abe58c7", + "SRX11780887.best_offset.txt:md5,827cbf2c4231dd868dc6f93f8b6e83b0", + "SRX11780887.cds_coverage_psite.tsv.gz:md5,d7f669652ce332ab4ebcb742a72dfcf2", + "SRX11780887.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,4fdbeb658fd750c97873f0a2d64ec3ef", + "SRX11780887.codon_coverage_psite.tsv.gz:md5,770a832bc98809a2c6ee4250dab64731", + "SRX11780887.codon_coverage_rpf.tsv.gz:md5,56e1fad3c99f046eddb6fba8d8788ce9", + "SRX11780887.psite.tsv.gz:md5,7e510dc502bdf00f58c165237683cead", + "SRX11780887.psite_offset.tsv.gz:md5,13629f9d786422375982dda7db270991", + "SRX11780888.best_offset.txt:md5,df1bd7c66c950c943d200199d072f808", + "SRX11780888.cds_coverage_psite.tsv.gz:md5,90e082f11c75a08d17bbd3eba354b6c1", + "SRX11780888.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,26fb1fddeb9db9f4b46e027537af491b", + "SRX11780888.codon_coverage_psite.tsv.gz:md5,1053bfe91da54816c224a897ac7226d2", + "SRX11780888.codon_coverage_rpf.tsv.gz:md5,bbd3e94215437a9d89bf61a3bfd5d49f", + "SRX11780888.psite.tsv.gz:md5,f47672a5ec625ad56ad0cd9f9e06003a", + "SRX11780888.psite_offset.tsv.gz:md5,6a8a86976ef7e185db81c2cb7e04014e", + "SRX11780889.best_offset.txt:md5,d01cc2839b5415179f8f02b1fe583698", + "SRX11780889.cds_coverage_psite.tsv.gz:md5,e4f51321acf53ea0610e89fe1f718759", + "SRX11780889.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,62d1ad2c5d06dcc2f5e4b38037bac919", + "SRX11780889.codon_coverage_psite.tsv.gz:md5,41ff3b1b94ed30b310bf62d110c1b671", + "SRX11780889.codon_coverage_rpf.tsv.gz:md5,0365460ff32f54ef97582566cd41803a", + "SRX11780889.psite.tsv.gz:md5,3650517af0545d8b522a4cadc7a9d380", + "SRX11780889.psite_offset.tsv.gz:md5,b8f5920532f631997588149a2b4e1e48", + "SRX11780890.best_offset.txt:md5,93ce9d385b8261eea0e90611cb1fa968", + "SRX11780890.cds_coverage_psite.tsv.gz:md5,ed927c97e107476fc1b86b6af1a10e27", + "SRX11780890.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,e51b52241818e27eb6f194af36dfc15a", + "SRX11780890.codon_coverage_psite.tsv.gz:md5,948e954e45f3f4beb19b0aa1adc384b2", + "SRX11780890.codon_coverage_rpf.tsv.gz:md5,fc28b1c4b672c3f94111a27392a0fa9c", + "SRX11780890.psite.tsv.gz:md5,163ab7bbceea7f1e55361552b295e56c", + "SRX11780890.psite_offset.tsv.gz:md5,b42eac3c4b9e4c9b0af3be1aeb87907b", "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", @@ -1277,55 +1365,13 @@ "SRX11780889_qual.txt:md5,4c567c2c47eb52bf81e514a39eb5a695", "SRX11780890.para.py:md5,5f1696c5bf20116fa63363917e131284", "SRX11780890_qual.txt:md5,0f761538ecafb2718bd781c6e1fb7dc1", - "SRX11780885.best_offset.txt:md5,1e6611858fd98bf4384cb121afb6707c", - "SRX11780885.cds_coverage_psite.tsv.gz:md5,f9d49b4c82a8b3e5b521441e9df4cc86", - "SRX11780885.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,87c80db54f46aac956f46a3ae09b23bc", - "SRX11780885.codon_coverage_psite.tsv.gz:md5,8a759875e7dbbf39d3720f732713678a", - "SRX11780885.codon_coverage_rpf.tsv.gz:md5,afbf801cb1ba85f404978098e572901d", - "SRX11780885.psite.tsv.gz:md5,517cfb43200a4d77598e7cea3d654460", - "SRX11780885.psite_offset.tsv.gz:md5,8a9c12f2e2ed8ab033b0ef6094706e73", - "SRX11780886.best_offset.txt:md5,787599a080c37b7d6eda470c13cc2563", - "SRX11780886.cds_coverage_psite.tsv.gz:md5,3f9a35c6f34c0db4754e8a1662faa0b5", - "SRX11780886.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,9b15a2401a9f0e42c060526f85596d8b", - "SRX11780886.codon_coverage_psite.tsv.gz:md5,7aec8c79793692acd49c7858bce2b579", - "SRX11780886.codon_coverage_rpf.tsv.gz:md5,3e50a00b6520665c165e4c3fce19e5f1", - "SRX11780886.psite.tsv.gz:md5,78de44e6dbda8f3914d52a068acde6bd", - "SRX11780886.psite_offset.tsv.gz:md5,78798ac87401d666552fd6145abe58c7", - "SRX11780887.best_offset.txt:md5,827cbf2c4231dd868dc6f93f8b6e83b0", - "SRX11780887.cds_coverage_psite.tsv.gz:md5,d7f669652ce332ab4ebcb742a72dfcf2", - "SRX11780887.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,4fdbeb658fd750c97873f0a2d64ec3ef", - "SRX11780887.codon_coverage_psite.tsv.gz:md5,770a832bc98809a2c6ee4250dab64731", - "SRX11780887.codon_coverage_rpf.tsv.gz:md5,56e1fad3c99f046eddb6fba8d8788ce9", - "SRX11780887.psite.tsv.gz:md5,7e510dc502bdf00f58c165237683cead", - "SRX11780887.psite_offset.tsv.gz:md5,13629f9d786422375982dda7db270991", - "SRX11780888.best_offset.txt:md5,df1bd7c66c950c943d200199d072f808", - "SRX11780888.cds_coverage_psite.tsv.gz:md5,90e082f11c75a08d17bbd3eba354b6c1", - "SRX11780888.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,26fb1fddeb9db9f4b46e027537af491b", - "SRX11780888.codon_coverage_psite.tsv.gz:md5,1053bfe91da54816c224a897ac7226d2", - "SRX11780888.codon_coverage_rpf.tsv.gz:md5,bbd3e94215437a9d89bf61a3bfd5d49f", - "SRX11780888.psite.tsv.gz:md5,f47672a5ec625ad56ad0cd9f9e06003a", - "SRX11780888.psite_offset.tsv.gz:md5,6a8a86976ef7e185db81c2cb7e04014e", - "SRX11780889.best_offset.txt:md5,d01cc2839b5415179f8f02b1fe583698", - "SRX11780889.cds_coverage_psite.tsv.gz:md5,e4f51321acf53ea0610e89fe1f718759", - "SRX11780889.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,62d1ad2c5d06dcc2f5e4b38037bac919", - "SRX11780889.codon_coverage_psite.tsv.gz:md5,41ff3b1b94ed30b310bf62d110c1b671", - "SRX11780889.codon_coverage_rpf.tsv.gz:md5,0365460ff32f54ef97582566cd41803a", - "SRX11780889.psite.tsv.gz:md5,3650517af0545d8b522a4cadc7a9d380", - "SRX11780889.psite_offset.tsv.gz:md5,b8f5920532f631997588149a2b4e1e48", - "SRX11780890.best_offset.txt:md5,93ce9d385b8261eea0e90611cb1fa968", - "SRX11780890.cds_coverage_psite.tsv.gz:md5,ed927c97e107476fc1b86b6af1a10e27", - "SRX11780890.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,e51b52241818e27eb6f194af36dfc15a", - "SRX11780890.codon_coverage_psite.tsv.gz:md5,948e954e45f3f4beb19b0aa1adc384b2", - "SRX11780890.codon_coverage_rpf.tsv.gz:md5,fc28b1c4b672c3f94111a27392a0fa9c", - "SRX11780890.psite.tsv.gz:md5,163ab7bbceea7f1e55361552b295e56c", - "SRX11780890.psite_offset.tsv.gz:md5,b42eac3c4b9e4c9b0af3be1aeb87907b", "treated_vs_control.R_sessionInfo.log:md5,3623a50b4668bfebf502bf7080800996" ] ], "meta": { "nf-test": "0.9.3", - "nextflow": "25.10.2" + "nextflow": "25.10.0" }, - "timestamp": "2026-01-09T16:40:18.929992209" + "timestamp": "2026-01-12T11:25:43.71297576" } } \ No newline at end of file diff --git a/tests/deltate.nf.test.snap b/tests/deltate.nf.test.snap index ec719c6c..028a90bd 100644 --- a/tests/deltate.nf.test.snap +++ b/tests/deltate.nf.test.snap @@ -43,6 +43,15 @@ "rsem": "1.3.1", "star": "2.7.10a" }, + "PLASTID_MAKE_WIGGLE": { + "plastid": "0.6.1" + }, + "PLASTID_METAGENE_GENERATE": { + "plastid": "0.6.1" + }, + "PLASTID_PSITE": { + "plastid": "0.6.1" + }, "RIBOTISH_PREDICT_ALL": { "ribotish": "0.2.7" }, @@ -700,6 +709,225 @@ "preprocessing/trimgalore/fastqc/SRX11780889_trimmed_fastqc.zip", "preprocessing/trimgalore/fastqc/SRX11780890_trimmed_fastqc.html", "preprocessing/trimgalore/fastqc/SRX11780890_trimmed_fastqc.zip", + "psites", + "psites/plastid", + "psites/plastid/metagene", + "psites/plastid/metagene/Homo_sapiens.GRCh38.dna.chromosome.20.filtered_rois.bed", + "psites/plastid/metagene/Homo_sapiens.GRCh38.dna.chromosome.20.filtered_rois.txt", + "psites/plastid/offsets", + "psites/plastid/offsets/SRX11780885_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780885_p_offsets.png", + "psites/plastid/offsets/SRX11780885_p_offsets.txt", + "psites/plastid/offsets/SRX11780886_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780886_p_offsets.png", + "psites/plastid/offsets/SRX11780886_p_offsets.txt", + "psites/plastid/offsets/SRX11780887_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780887_p_offsets.png", + "psites/plastid/offsets/SRX11780887_p_offsets.txt", + "psites/plastid/offsets/SRX11780888_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780888_p_offsets.png", + "psites/plastid/offsets/SRX11780888_p_offsets.txt", + "psites/plastid/offsets/SRX11780889_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780889_p_offsets.png", + "psites/plastid/offsets/SRX11780889_p_offsets.txt", + "psites/plastid/offsets/SRX11780890_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780890_p_offsets.png", + "psites/plastid/offsets/SRX11780890_p_offsets.txt", + "psites/plastid/tracks", + "psites/plastid/tracks/SRX11780885_fw.bedgraph", + "psites/plastid/tracks/SRX11780885_rc.bedgraph", + "psites/plastid/tracks/SRX11780886_fw.bedgraph", + "psites/plastid/tracks/SRX11780886_rc.bedgraph", + "psites/plastid/tracks/SRX11780887_fw.bedgraph", + "psites/plastid/tracks/SRX11780887_rc.bedgraph", + "psites/plastid/tracks/SRX11780888_fw.bedgraph", + "psites/plastid/tracks/SRX11780888_rc.bedgraph", + "psites/plastid/tracks/SRX11780889_fw.bedgraph", + "psites/plastid/tracks/SRX11780889_rc.bedgraph", + "psites/plastid/tracks/SRX11780890_fw.bedgraph", + "psites/plastid/tracks/SRX11780890_rc.bedgraph", + "psites/ribowaltz", + "psites/ribowaltz/SRX11780885.best_offset.txt", + "psites/ribowaltz/SRX11780885.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780885.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780885.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780885.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780885.psite.tsv.gz", + "psites/ribowaltz/SRX11780885.psite_offset.tsv.gz", + "psites/ribowaltz/SRX11780886.best_offset.txt", + "psites/ribowaltz/SRX11780886.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780886.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780886.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780886.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780886.psite.tsv.gz", + "psites/ribowaltz/SRX11780886.psite_offset.tsv.gz", + "psites/ribowaltz/SRX11780887.best_offset.txt", + "psites/ribowaltz/SRX11780887.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780887.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780887.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780887.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780887.psite.tsv.gz", + "psites/ribowaltz/SRX11780887.psite_offset.tsv.gz", + "psites/ribowaltz/SRX11780888.best_offset.txt", + "psites/ribowaltz/SRX11780888.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780888.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780888.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780888.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780888.psite.tsv.gz", + "psites/ribowaltz/SRX11780888.psite_offset.tsv.gz", + "psites/ribowaltz/SRX11780889.best_offset.txt", + "psites/ribowaltz/SRX11780889.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780889.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780889.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780889.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780889.psite.tsv.gz", + "psites/ribowaltz/SRX11780889.psite_offset.tsv.gz", + "psites/ribowaltz/SRX11780890.best_offset.txt", + "psites/ribowaltz/SRX11780890.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780890.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780890.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780890.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780890.psite.tsv.gz", + "psites/ribowaltz/SRX11780890.psite_offset.tsv.gz", + "psites/ribowaltz/offset_plot", + "psites/ribowaltz/offset_plot/SRX11780885", + "psites/ribowaltz/offset_plot/SRX11780885/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/31.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/32.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/33.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/34.pdf", + "psites/ribowaltz/offset_plot/SRX11780886", + "psites/ribowaltz/offset_plot/SRX11780886/20.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/21.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/31.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/32.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/33.pdf", + "psites/ribowaltz/offset_plot/SRX11780887", + "psites/ribowaltz/offset_plot/SRX11780887/20.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/21.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/31.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/32.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/33.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/34.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/35.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/36.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/37.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/38.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/39.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/40.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/41.pdf", + "psites/ribowaltz/offset_plot/SRX11780888", + "psites/ribowaltz/offset_plot/SRX11780888/21.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780889", + "psites/ribowaltz/offset_plot/SRX11780889/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/31.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/32.pdf", + "psites/ribowaltz/offset_plot/SRX11780890", + "psites/ribowaltz/offset_plot/SRX11780890/21.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/31.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/32.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/33.pdf", + "psites/ribowaltz/ribowaltz_qc", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.psite_region.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.psite_region.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.psite_region.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.psite_region.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.psite_region.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.psite_region.pdf", "quantification", "quantification/salmon", "quantification/salmon/SRX11780879", @@ -915,188 +1143,6 @@ "riboseq_qc/ribotish/SRX11780890.para.py", "riboseq_qc/ribotish/SRX11780890_qual.pdf", "riboseq_qc/ribotish/SRX11780890_qual.txt", - "ribowaltz", - "ribowaltz/SRX11780885.best_offset.txt", - "ribowaltz/SRX11780885.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780885.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780885.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780885.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780885.psite.tsv.gz", - "ribowaltz/SRX11780885.psite_offset.tsv.gz", - "ribowaltz/SRX11780886.best_offset.txt", - "ribowaltz/SRX11780886.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780886.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780886.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780886.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780886.psite.tsv.gz", - "ribowaltz/SRX11780886.psite_offset.tsv.gz", - "ribowaltz/SRX11780887.best_offset.txt", - "ribowaltz/SRX11780887.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780887.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780887.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780887.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780887.psite.tsv.gz", - "ribowaltz/SRX11780887.psite_offset.tsv.gz", - "ribowaltz/SRX11780888.best_offset.txt", - "ribowaltz/SRX11780888.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780888.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780888.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780888.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780888.psite.tsv.gz", - "ribowaltz/SRX11780888.psite_offset.tsv.gz", - "ribowaltz/SRX11780889.best_offset.txt", - "ribowaltz/SRX11780889.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780889.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780889.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780889.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780889.psite.tsv.gz", - "ribowaltz/SRX11780889.psite_offset.tsv.gz", - "ribowaltz/SRX11780890.best_offset.txt", - "ribowaltz/SRX11780890.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780890.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780890.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780890.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780890.psite.tsv.gz", - "ribowaltz/SRX11780890.psite_offset.tsv.gz", - "ribowaltz/offset_plot", - "ribowaltz/offset_plot/SRX11780885", - "ribowaltz/offset_plot/SRX11780885/22.pdf", - "ribowaltz/offset_plot/SRX11780885/23.pdf", - "ribowaltz/offset_plot/SRX11780885/24.pdf", - "ribowaltz/offset_plot/SRX11780885/25.pdf", - "ribowaltz/offset_plot/SRX11780885/26.pdf", - "ribowaltz/offset_plot/SRX11780885/27.pdf", - "ribowaltz/offset_plot/SRX11780885/28.pdf", - "ribowaltz/offset_plot/SRX11780885/29.pdf", - "ribowaltz/offset_plot/SRX11780885/30.pdf", - "ribowaltz/offset_plot/SRX11780885/31.pdf", - "ribowaltz/offset_plot/SRX11780885/32.pdf", - "ribowaltz/offset_plot/SRX11780885/33.pdf", - "ribowaltz/offset_plot/SRX11780885/34.pdf", - "ribowaltz/offset_plot/SRX11780886", - "ribowaltz/offset_plot/SRX11780886/20.pdf", - "ribowaltz/offset_plot/SRX11780886/21.pdf", - "ribowaltz/offset_plot/SRX11780886/22.pdf", - "ribowaltz/offset_plot/SRX11780886/23.pdf", - "ribowaltz/offset_plot/SRX11780886/24.pdf", - "ribowaltz/offset_plot/SRX11780886/25.pdf", - "ribowaltz/offset_plot/SRX11780886/26.pdf", - "ribowaltz/offset_plot/SRX11780886/27.pdf", - "ribowaltz/offset_plot/SRX11780886/28.pdf", - "ribowaltz/offset_plot/SRX11780886/29.pdf", - "ribowaltz/offset_plot/SRX11780886/30.pdf", - "ribowaltz/offset_plot/SRX11780886/31.pdf", - "ribowaltz/offset_plot/SRX11780886/32.pdf", - "ribowaltz/offset_plot/SRX11780886/33.pdf", - "ribowaltz/offset_plot/SRX11780887", - "ribowaltz/offset_plot/SRX11780887/20.pdf", - "ribowaltz/offset_plot/SRX11780887/21.pdf", - "ribowaltz/offset_plot/SRX11780887/22.pdf", - "ribowaltz/offset_plot/SRX11780887/23.pdf", - "ribowaltz/offset_plot/SRX11780887/24.pdf", - "ribowaltz/offset_plot/SRX11780887/25.pdf", - "ribowaltz/offset_plot/SRX11780887/26.pdf", - "ribowaltz/offset_plot/SRX11780887/27.pdf", - "ribowaltz/offset_plot/SRX11780887/28.pdf", - "ribowaltz/offset_plot/SRX11780887/29.pdf", - "ribowaltz/offset_plot/SRX11780887/30.pdf", - "ribowaltz/offset_plot/SRX11780887/31.pdf", - "ribowaltz/offset_plot/SRX11780887/32.pdf", - "ribowaltz/offset_plot/SRX11780887/33.pdf", - "ribowaltz/offset_plot/SRX11780887/34.pdf", - "ribowaltz/offset_plot/SRX11780887/35.pdf", - "ribowaltz/offset_plot/SRX11780887/36.pdf", - "ribowaltz/offset_plot/SRX11780887/37.pdf", - "ribowaltz/offset_plot/SRX11780887/38.pdf", - "ribowaltz/offset_plot/SRX11780887/39.pdf", - "ribowaltz/offset_plot/SRX11780887/40.pdf", - "ribowaltz/offset_plot/SRX11780887/41.pdf", - "ribowaltz/offset_plot/SRX11780888", - "ribowaltz/offset_plot/SRX11780888/21.pdf", - "ribowaltz/offset_plot/SRX11780888/22.pdf", - "ribowaltz/offset_plot/SRX11780888/23.pdf", - "ribowaltz/offset_plot/SRX11780888/24.pdf", - "ribowaltz/offset_plot/SRX11780888/25.pdf", - "ribowaltz/offset_plot/SRX11780888/26.pdf", - "ribowaltz/offset_plot/SRX11780888/27.pdf", - "ribowaltz/offset_plot/SRX11780888/28.pdf", - "ribowaltz/offset_plot/SRX11780888/29.pdf", - "ribowaltz/offset_plot/SRX11780888/30.pdf", - "ribowaltz/offset_plot/SRX11780889", - "ribowaltz/offset_plot/SRX11780889/22.pdf", - "ribowaltz/offset_plot/SRX11780889/23.pdf", - "ribowaltz/offset_plot/SRX11780889/24.pdf", - "ribowaltz/offset_plot/SRX11780889/25.pdf", - "ribowaltz/offset_plot/SRX11780889/26.pdf", - "ribowaltz/offset_plot/SRX11780889/27.pdf", - "ribowaltz/offset_plot/SRX11780889/28.pdf", - "ribowaltz/offset_plot/SRX11780889/29.pdf", - "ribowaltz/offset_plot/SRX11780889/30.pdf", - "ribowaltz/offset_plot/SRX11780889/31.pdf", - "ribowaltz/offset_plot/SRX11780889/32.pdf", - "ribowaltz/offset_plot/SRX11780890", - "ribowaltz/offset_plot/SRX11780890/21.pdf", - "ribowaltz/offset_plot/SRX11780890/22.pdf", - "ribowaltz/offset_plot/SRX11780890/23.pdf", - "ribowaltz/offset_plot/SRX11780890/24.pdf", - "ribowaltz/offset_plot/SRX11780890/25.pdf", - "ribowaltz/offset_plot/SRX11780890/26.pdf", - "ribowaltz/offset_plot/SRX11780890/27.pdf", - "ribowaltz/offset_plot/SRX11780890/28.pdf", - "ribowaltz/offset_plot/SRX11780890/29.pdf", - "ribowaltz/offset_plot/SRX11780890/30.pdf", - "ribowaltz/offset_plot/SRX11780890/31.pdf", - "ribowaltz/offset_plot/SRX11780890/32.pdf", - "ribowaltz/offset_plot/SRX11780890/33.pdf", - "ribowaltz/ribowaltz_qc", - "ribowaltz/ribowaltz_qc/SRX11780885.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.psite_region.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.psite_region.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.psite_region.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.psite_region.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.psite_region.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.psite_region.pdf", "translational_efficiency", "translational_efficiency/deltate", "translational_efficiency/deltate/treated_vs_control.DESeqDataSet.rds", @@ -1205,7 +1251,7 @@ "fastqc_sequence_duplication_levels_plot.txt:md5,77d6e3d36b8c93f25e2d4cdbadd018d3", "fastqc_sequence_length_distribution_plot.txt:md5,d3f33f3eda7927b061fc3cdec99e8f4e", "multiqc_bowtie2_bowtie2_rrna.txt:md5,3370acc7d4ccbfb2c7535f2c962449ed", - "multiqc_citations.txt:md5,1e71c91ad074075d489a520daf3aa183", + "multiqc_citations.txt:md5,42fe487eb19339ab63477c4c0f3734ff", "multiqc_cutadapt.txt:md5,e6031ab468a23c95b6989a6ce9e081f5", "multiqc_fastqc.txt:md5,435f987c78b50ab1dfe18640246f580b", "multiqc_fastqc_fastqc-1.txt:md5,c8ce8940114de9321e6de124b6cb4c18", @@ -1258,6 +1304,48 @@ "SRX11780888.bowtie2.log:md5,f299b3257e083e125718d1b61bc5d07a", "SRX11780889.bowtie2.log:md5,57c85c382c57184efb74779ff817382a", "SRX11780890.bowtie2.log:md5,ed7ff247afc948959b6c6e34f7da882e", + "SRX11780885.best_offset.txt:md5,1e6611858fd98bf4384cb121afb6707c", + "SRX11780885.cds_coverage_psite.tsv.gz:md5,f9d49b4c82a8b3e5b521441e9df4cc86", + "SRX11780885.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,87c80db54f46aac956f46a3ae09b23bc", + "SRX11780885.codon_coverage_psite.tsv.gz:md5,8a759875e7dbbf39d3720f732713678a", + "SRX11780885.codon_coverage_rpf.tsv.gz:md5,afbf801cb1ba85f404978098e572901d", + "SRX11780885.psite.tsv.gz:md5,8276459cd5f05ae92510e9c983f643db", + "SRX11780885.psite_offset.tsv.gz:md5,2ef8627be1603928b16f5fb561ac47b6", + "SRX11780886.best_offset.txt:md5,787599a080c37b7d6eda470c13cc2563", + "SRX11780886.cds_coverage_psite.tsv.gz:md5,3f9a35c6f34c0db4754e8a1662faa0b5", + "SRX11780886.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,9b15a2401a9f0e42c060526f85596d8b", + "SRX11780886.codon_coverage_psite.tsv.gz:md5,7aec8c79793692acd49c7858bce2b579", + "SRX11780886.codon_coverage_rpf.tsv.gz:md5,3e50a00b6520665c165e4c3fce19e5f1", + "SRX11780886.psite.tsv.gz:md5,d5776b81cdd2af8504fc3db2041da515", + "SRX11780886.psite_offset.tsv.gz:md5,583bea05a8cacd96adec469132c968f5", + "SRX11780887.best_offset.txt:md5,827cbf2c4231dd868dc6f93f8b6e83b0", + "SRX11780887.cds_coverage_psite.tsv.gz:md5,d7f669652ce332ab4ebcb742a72dfcf2", + "SRX11780887.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,4fdbeb658fd750c97873f0a2d64ec3ef", + "SRX11780887.codon_coverage_psite.tsv.gz:md5,770a832bc98809a2c6ee4250dab64731", + "SRX11780887.codon_coverage_rpf.tsv.gz:md5,56e1fad3c99f046eddb6fba8d8788ce9", + "SRX11780887.psite.tsv.gz:md5,bec9bc165cd21e17fc03a86cb87005c5", + "SRX11780887.psite_offset.tsv.gz:md5,14eebe2a609db07671c22ba4486e8d99", + "SRX11780888.best_offset.txt:md5,df1bd7c66c950c943d200199d072f808", + "SRX11780888.cds_coverage_psite.tsv.gz:md5,90e082f11c75a08d17bbd3eba354b6c1", + "SRX11780888.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,26fb1fddeb9db9f4b46e027537af491b", + "SRX11780888.codon_coverage_psite.tsv.gz:md5,1053bfe91da54816c224a897ac7226d2", + "SRX11780888.codon_coverage_rpf.tsv.gz:md5,bbd3e94215437a9d89bf61a3bfd5d49f", + "SRX11780888.psite.tsv.gz:md5,1e91a44a68e1918506962648d56a9192", + "SRX11780888.psite_offset.tsv.gz:md5,b52ce5b4cd9a95231d02fc5fed83af70", + "SRX11780889.best_offset.txt:md5,d01cc2839b5415179f8f02b1fe583698", + "SRX11780889.cds_coverage_psite.tsv.gz:md5,e4f51321acf53ea0610e89fe1f718759", + "SRX11780889.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,62d1ad2c5d06dcc2f5e4b38037bac919", + "SRX11780889.codon_coverage_psite.tsv.gz:md5,41ff3b1b94ed30b310bf62d110c1b671", + "SRX11780889.codon_coverage_rpf.tsv.gz:md5,0365460ff32f54ef97582566cd41803a", + "SRX11780889.psite.tsv.gz:md5,df4d090347750c96c3b331dab0f582a9", + "SRX11780889.psite_offset.tsv.gz:md5,e73bb4cd13df6f92efdbaa7dcf380784", + "SRX11780890.best_offset.txt:md5,93ce9d385b8261eea0e90611cb1fa968", + "SRX11780890.cds_coverage_psite.tsv.gz:md5,ed927c97e107476fc1b86b6af1a10e27", + "SRX11780890.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,e51b52241818e27eb6f194af36dfc15a", + "SRX11780890.codon_coverage_psite.tsv.gz:md5,948e954e45f3f4beb19b0aa1adc384b2", + "SRX11780890.codon_coverage_rpf.tsv.gz:md5,fc28b1c4b672c3f94111a27392a0fa9c", + "SRX11780890.psite.tsv.gz:md5,ad3e7a4abdba33a47bfe369cd7f2a725", + "SRX11780890.psite_offset.tsv.gz:md5,4c640cbe8c24465fa1758951af308534", "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", @@ -1321,55 +1409,13 @@ "SRX11780889_qual.txt:md5,4c567c2c47eb52bf81e514a39eb5a695", "SRX11780890.para.py:md5,5f1696c5bf20116fa63363917e131284", "SRX11780890_qual.txt:md5,0f761538ecafb2718bd781c6e1fb7dc1", - "SRX11780885.best_offset.txt:md5,1e6611858fd98bf4384cb121afb6707c", - "SRX11780885.cds_coverage_psite.tsv.gz:md5,f9d49b4c82a8b3e5b521441e9df4cc86", - "SRX11780885.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,87c80db54f46aac956f46a3ae09b23bc", - "SRX11780885.codon_coverage_psite.tsv.gz:md5,8a759875e7dbbf39d3720f732713678a", - "SRX11780885.codon_coverage_rpf.tsv.gz:md5,afbf801cb1ba85f404978098e572901d", - "SRX11780885.psite.tsv.gz:md5,8276459cd5f05ae92510e9c983f643db", - "SRX11780885.psite_offset.tsv.gz:md5,2ef8627be1603928b16f5fb561ac47b6", - "SRX11780886.best_offset.txt:md5,787599a080c37b7d6eda470c13cc2563", - "SRX11780886.cds_coverage_psite.tsv.gz:md5,3f9a35c6f34c0db4754e8a1662faa0b5", - "SRX11780886.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,9b15a2401a9f0e42c060526f85596d8b", - "SRX11780886.codon_coverage_psite.tsv.gz:md5,7aec8c79793692acd49c7858bce2b579", - "SRX11780886.codon_coverage_rpf.tsv.gz:md5,3e50a00b6520665c165e4c3fce19e5f1", - "SRX11780886.psite.tsv.gz:md5,d5776b81cdd2af8504fc3db2041da515", - "SRX11780886.psite_offset.tsv.gz:md5,583bea05a8cacd96adec469132c968f5", - "SRX11780887.best_offset.txt:md5,827cbf2c4231dd868dc6f93f8b6e83b0", - "SRX11780887.cds_coverage_psite.tsv.gz:md5,d7f669652ce332ab4ebcb742a72dfcf2", - "SRX11780887.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,4fdbeb658fd750c97873f0a2d64ec3ef", - "SRX11780887.codon_coverage_psite.tsv.gz:md5,770a832bc98809a2c6ee4250dab64731", - "SRX11780887.codon_coverage_rpf.tsv.gz:md5,56e1fad3c99f046eddb6fba8d8788ce9", - "SRX11780887.psite.tsv.gz:md5,bec9bc165cd21e17fc03a86cb87005c5", - "SRX11780887.psite_offset.tsv.gz:md5,14eebe2a609db07671c22ba4486e8d99", - "SRX11780888.best_offset.txt:md5,df1bd7c66c950c943d200199d072f808", - "SRX11780888.cds_coverage_psite.tsv.gz:md5,90e082f11c75a08d17bbd3eba354b6c1", - "SRX11780888.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,26fb1fddeb9db9f4b46e027537af491b", - "SRX11780888.codon_coverage_psite.tsv.gz:md5,1053bfe91da54816c224a897ac7226d2", - "SRX11780888.codon_coverage_rpf.tsv.gz:md5,bbd3e94215437a9d89bf61a3bfd5d49f", - "SRX11780888.psite.tsv.gz:md5,1e91a44a68e1918506962648d56a9192", - "SRX11780888.psite_offset.tsv.gz:md5,b52ce5b4cd9a95231d02fc5fed83af70", - "SRX11780889.best_offset.txt:md5,d01cc2839b5415179f8f02b1fe583698", - "SRX11780889.cds_coverage_psite.tsv.gz:md5,e4f51321acf53ea0610e89fe1f718759", - "SRX11780889.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,62d1ad2c5d06dcc2f5e4b38037bac919", - "SRX11780889.codon_coverage_psite.tsv.gz:md5,41ff3b1b94ed30b310bf62d110c1b671", - "SRX11780889.codon_coverage_rpf.tsv.gz:md5,0365460ff32f54ef97582566cd41803a", - "SRX11780889.psite.tsv.gz:md5,df4d090347750c96c3b331dab0f582a9", - "SRX11780889.psite_offset.tsv.gz:md5,e73bb4cd13df6f92efdbaa7dcf380784", - "SRX11780890.best_offset.txt:md5,93ce9d385b8261eea0e90611cb1fa968", - "SRX11780890.cds_coverage_psite.tsv.gz:md5,ed927c97e107476fc1b86b6af1a10e27", - "SRX11780890.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,e51b52241818e27eb6f194af36dfc15a", - "SRX11780890.codon_coverage_psite.tsv.gz:md5,948e954e45f3f4beb19b0aa1adc384b2", - "SRX11780890.codon_coverage_rpf.tsv.gz:md5,fc28b1c4b672c3f94111a27392a0fa9c", - "SRX11780890.psite.tsv.gz:md5,ad3e7a4abdba33a47bfe369cd7f2a725", - "SRX11780890.psite_offset.tsv.gz:md5,4c640cbe8c24465fa1758951af308534", "treated_vs_control.R_sessionInfo.log:md5,9388c2a7f77dfde471cd9b67687070e4" ] ], "meta": { "nf-test": "0.9.3", - "nextflow": "25.10.2" + "nextflow": "25.10.0" }, - "timestamp": "2026-01-09T16:18:41.538092342" + "timestamp": "2026-01-12T11:49:33.454689536" } } \ No newline at end of file diff --git a/tests/equalise_read_lengths.nf.test.snap b/tests/equalise_read_lengths.nf.test.snap index d35a71cd..a877e937 100644 --- a/tests/equalise_read_lengths.nf.test.snap +++ b/tests/equalise_read_lengths.nf.test.snap @@ -40,6 +40,15 @@ "rsem": "1.3.1", "star": "2.7.10a" }, + "PLASTID_MAKE_WIGGLE": { + "plastid": "0.6.1" + }, + "PLASTID_METAGENE_GENERATE": { + "plastid": "0.6.1" + }, + "PLASTID_PSITE": { + "plastid": "0.6.1" + }, "RIBOTISH_PREDICT_ALL": { "ribotish": "0.2.7" }, @@ -722,6 +731,225 @@ "preprocessing/trimgalore/fastqc/SRX11780889_trimmed_fastqc.zip", "preprocessing/trimgalore/fastqc/SRX11780890_trimmed_fastqc.html", "preprocessing/trimgalore/fastqc/SRX11780890_trimmed_fastqc.zip", + "psites", + "psites/plastid", + "psites/plastid/metagene", + "psites/plastid/metagene/Homo_sapiens.GRCh38.dna.chromosome.20.filtered_rois.bed", + "psites/plastid/metagene/Homo_sapiens.GRCh38.dna.chromosome.20.filtered_rois.txt", + "psites/plastid/offsets", + "psites/plastid/offsets/SRX11780885_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780885_p_offsets.png", + "psites/plastid/offsets/SRX11780885_p_offsets.txt", + "psites/plastid/offsets/SRX11780886_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780886_p_offsets.png", + "psites/plastid/offsets/SRX11780886_p_offsets.txt", + "psites/plastid/offsets/SRX11780887_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780887_p_offsets.png", + "psites/plastid/offsets/SRX11780887_p_offsets.txt", + "psites/plastid/offsets/SRX11780888_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780888_p_offsets.png", + "psites/plastid/offsets/SRX11780888_p_offsets.txt", + "psites/plastid/offsets/SRX11780889_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780889_p_offsets.png", + "psites/plastid/offsets/SRX11780889_p_offsets.txt", + "psites/plastid/offsets/SRX11780890_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780890_p_offsets.png", + "psites/plastid/offsets/SRX11780890_p_offsets.txt", + "psites/plastid/tracks", + "psites/plastid/tracks/SRX11780885_fw.bedgraph", + "psites/plastid/tracks/SRX11780885_rc.bedgraph", + "psites/plastid/tracks/SRX11780886_fw.bedgraph", + "psites/plastid/tracks/SRX11780886_rc.bedgraph", + "psites/plastid/tracks/SRX11780887_fw.bedgraph", + "psites/plastid/tracks/SRX11780887_rc.bedgraph", + "psites/plastid/tracks/SRX11780888_fw.bedgraph", + "psites/plastid/tracks/SRX11780888_rc.bedgraph", + "psites/plastid/tracks/SRX11780889_fw.bedgraph", + "psites/plastid/tracks/SRX11780889_rc.bedgraph", + "psites/plastid/tracks/SRX11780890_fw.bedgraph", + "psites/plastid/tracks/SRX11780890_rc.bedgraph", + "psites/ribowaltz", + "psites/ribowaltz/SRX11780885.best_offset.txt", + "psites/ribowaltz/SRX11780885.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780885.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780885.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780885.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780885.psite.tsv.gz", + "psites/ribowaltz/SRX11780885.psite_offset.tsv.gz", + "psites/ribowaltz/SRX11780886.best_offset.txt", + "psites/ribowaltz/SRX11780886.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780886.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780886.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780886.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780886.psite.tsv.gz", + "psites/ribowaltz/SRX11780886.psite_offset.tsv.gz", + "psites/ribowaltz/SRX11780887.best_offset.txt", + "psites/ribowaltz/SRX11780887.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780887.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780887.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780887.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780887.psite.tsv.gz", + "psites/ribowaltz/SRX11780887.psite_offset.tsv.gz", + "psites/ribowaltz/SRX11780888.best_offset.txt", + "psites/ribowaltz/SRX11780888.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780888.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780888.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780888.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780888.psite.tsv.gz", + "psites/ribowaltz/SRX11780888.psite_offset.tsv.gz", + "psites/ribowaltz/SRX11780889.best_offset.txt", + "psites/ribowaltz/SRX11780889.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780889.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780889.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780889.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780889.psite.tsv.gz", + "psites/ribowaltz/SRX11780889.psite_offset.tsv.gz", + "psites/ribowaltz/SRX11780890.best_offset.txt", + "psites/ribowaltz/SRX11780890.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780890.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780890.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780890.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780890.psite.tsv.gz", + "psites/ribowaltz/SRX11780890.psite_offset.tsv.gz", + "psites/ribowaltz/offset_plot", + "psites/ribowaltz/offset_plot/SRX11780885", + "psites/ribowaltz/offset_plot/SRX11780885/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/31.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/32.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/33.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/34.pdf", + "psites/ribowaltz/offset_plot/SRX11780886", + "psites/ribowaltz/offset_plot/SRX11780886/20.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/21.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/31.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/32.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/33.pdf", + "psites/ribowaltz/offset_plot/SRX11780887", + "psites/ribowaltz/offset_plot/SRX11780887/20.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/21.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/31.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/32.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/33.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/34.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/35.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/36.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/37.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/38.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/39.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/40.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/41.pdf", + "psites/ribowaltz/offset_plot/SRX11780888", + "psites/ribowaltz/offset_plot/SRX11780888/21.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780889", + "psites/ribowaltz/offset_plot/SRX11780889/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/31.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/32.pdf", + "psites/ribowaltz/offset_plot/SRX11780890", + "psites/ribowaltz/offset_plot/SRX11780890/21.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/31.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/32.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/33.pdf", + "psites/ribowaltz/ribowaltz_qc", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.psite_region.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.psite_region.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.psite_region.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.psite_region.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.psite_region.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.psite_region.pdf", "quantification", "quantification/salmon", "quantification/salmon/SRX11780879", @@ -937,188 +1165,6 @@ "riboseq_qc/ribotish/SRX11780890.para.py", "riboseq_qc/ribotish/SRX11780890_qual.pdf", "riboseq_qc/ribotish/SRX11780890_qual.txt", - "ribowaltz", - "ribowaltz/SRX11780885.best_offset.txt", - "ribowaltz/SRX11780885.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780885.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780885.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780885.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780885.psite.tsv.gz", - "ribowaltz/SRX11780885.psite_offset.tsv.gz", - "ribowaltz/SRX11780886.best_offset.txt", - "ribowaltz/SRX11780886.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780886.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780886.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780886.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780886.psite.tsv.gz", - "ribowaltz/SRX11780886.psite_offset.tsv.gz", - "ribowaltz/SRX11780887.best_offset.txt", - "ribowaltz/SRX11780887.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780887.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780887.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780887.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780887.psite.tsv.gz", - "ribowaltz/SRX11780887.psite_offset.tsv.gz", - "ribowaltz/SRX11780888.best_offset.txt", - "ribowaltz/SRX11780888.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780888.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780888.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780888.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780888.psite.tsv.gz", - "ribowaltz/SRX11780888.psite_offset.tsv.gz", - "ribowaltz/SRX11780889.best_offset.txt", - "ribowaltz/SRX11780889.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780889.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780889.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780889.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780889.psite.tsv.gz", - "ribowaltz/SRX11780889.psite_offset.tsv.gz", - "ribowaltz/SRX11780890.best_offset.txt", - "ribowaltz/SRX11780890.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780890.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780890.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780890.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780890.psite.tsv.gz", - "ribowaltz/SRX11780890.psite_offset.tsv.gz", - "ribowaltz/offset_plot", - "ribowaltz/offset_plot/SRX11780885", - "ribowaltz/offset_plot/SRX11780885/22.pdf", - "ribowaltz/offset_plot/SRX11780885/23.pdf", - "ribowaltz/offset_plot/SRX11780885/24.pdf", - "ribowaltz/offset_plot/SRX11780885/25.pdf", - "ribowaltz/offset_plot/SRX11780885/26.pdf", - "ribowaltz/offset_plot/SRX11780885/27.pdf", - "ribowaltz/offset_plot/SRX11780885/28.pdf", - "ribowaltz/offset_plot/SRX11780885/29.pdf", - "ribowaltz/offset_plot/SRX11780885/30.pdf", - "ribowaltz/offset_plot/SRX11780885/31.pdf", - "ribowaltz/offset_plot/SRX11780885/32.pdf", - "ribowaltz/offset_plot/SRX11780885/33.pdf", - "ribowaltz/offset_plot/SRX11780885/34.pdf", - "ribowaltz/offset_plot/SRX11780886", - "ribowaltz/offset_plot/SRX11780886/20.pdf", - "ribowaltz/offset_plot/SRX11780886/21.pdf", - "ribowaltz/offset_plot/SRX11780886/22.pdf", - "ribowaltz/offset_plot/SRX11780886/23.pdf", - "ribowaltz/offset_plot/SRX11780886/24.pdf", - "ribowaltz/offset_plot/SRX11780886/25.pdf", - "ribowaltz/offset_plot/SRX11780886/26.pdf", - "ribowaltz/offset_plot/SRX11780886/27.pdf", - "ribowaltz/offset_plot/SRX11780886/28.pdf", - "ribowaltz/offset_plot/SRX11780886/29.pdf", - "ribowaltz/offset_plot/SRX11780886/30.pdf", - "ribowaltz/offset_plot/SRX11780886/31.pdf", - "ribowaltz/offset_plot/SRX11780886/32.pdf", - "ribowaltz/offset_plot/SRX11780886/33.pdf", - "ribowaltz/offset_plot/SRX11780887", - "ribowaltz/offset_plot/SRX11780887/20.pdf", - "ribowaltz/offset_plot/SRX11780887/21.pdf", - "ribowaltz/offset_plot/SRX11780887/22.pdf", - "ribowaltz/offset_plot/SRX11780887/23.pdf", - "ribowaltz/offset_plot/SRX11780887/24.pdf", - "ribowaltz/offset_plot/SRX11780887/25.pdf", - "ribowaltz/offset_plot/SRX11780887/26.pdf", - "ribowaltz/offset_plot/SRX11780887/27.pdf", - "ribowaltz/offset_plot/SRX11780887/28.pdf", - "ribowaltz/offset_plot/SRX11780887/29.pdf", - "ribowaltz/offset_plot/SRX11780887/30.pdf", - "ribowaltz/offset_plot/SRX11780887/31.pdf", - "ribowaltz/offset_plot/SRX11780887/32.pdf", - "ribowaltz/offset_plot/SRX11780887/33.pdf", - "ribowaltz/offset_plot/SRX11780887/34.pdf", - "ribowaltz/offset_plot/SRX11780887/35.pdf", - "ribowaltz/offset_plot/SRX11780887/36.pdf", - "ribowaltz/offset_plot/SRX11780887/37.pdf", - "ribowaltz/offset_plot/SRX11780887/38.pdf", - "ribowaltz/offset_plot/SRX11780887/39.pdf", - "ribowaltz/offset_plot/SRX11780887/40.pdf", - "ribowaltz/offset_plot/SRX11780887/41.pdf", - "ribowaltz/offset_plot/SRX11780888", - "ribowaltz/offset_plot/SRX11780888/21.pdf", - "ribowaltz/offset_plot/SRX11780888/22.pdf", - "ribowaltz/offset_plot/SRX11780888/23.pdf", - "ribowaltz/offset_plot/SRX11780888/24.pdf", - "ribowaltz/offset_plot/SRX11780888/25.pdf", - "ribowaltz/offset_plot/SRX11780888/26.pdf", - "ribowaltz/offset_plot/SRX11780888/27.pdf", - "ribowaltz/offset_plot/SRX11780888/28.pdf", - "ribowaltz/offset_plot/SRX11780888/29.pdf", - "ribowaltz/offset_plot/SRX11780888/30.pdf", - "ribowaltz/offset_plot/SRX11780889", - "ribowaltz/offset_plot/SRX11780889/22.pdf", - "ribowaltz/offset_plot/SRX11780889/23.pdf", - "ribowaltz/offset_plot/SRX11780889/24.pdf", - "ribowaltz/offset_plot/SRX11780889/25.pdf", - "ribowaltz/offset_plot/SRX11780889/26.pdf", - "ribowaltz/offset_plot/SRX11780889/27.pdf", - "ribowaltz/offset_plot/SRX11780889/28.pdf", - "ribowaltz/offset_plot/SRX11780889/29.pdf", - "ribowaltz/offset_plot/SRX11780889/30.pdf", - "ribowaltz/offset_plot/SRX11780889/31.pdf", - "ribowaltz/offset_plot/SRX11780889/32.pdf", - "ribowaltz/offset_plot/SRX11780890", - "ribowaltz/offset_plot/SRX11780890/21.pdf", - "ribowaltz/offset_plot/SRX11780890/22.pdf", - "ribowaltz/offset_plot/SRX11780890/23.pdf", - "ribowaltz/offset_plot/SRX11780890/24.pdf", - "ribowaltz/offset_plot/SRX11780890/25.pdf", - "ribowaltz/offset_plot/SRX11780890/26.pdf", - "ribowaltz/offset_plot/SRX11780890/27.pdf", - "ribowaltz/offset_plot/SRX11780890/28.pdf", - "ribowaltz/offset_plot/SRX11780890/29.pdf", - "ribowaltz/offset_plot/SRX11780890/30.pdf", - "ribowaltz/offset_plot/SRX11780890/31.pdf", - "ribowaltz/offset_plot/SRX11780890/32.pdf", - "ribowaltz/offset_plot/SRX11780890/33.pdf", - "ribowaltz/ribowaltz_qc", - "ribowaltz/ribowaltz_qc/SRX11780885.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.psite_region.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.psite_region.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.psite_region.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.psite_region.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.psite_region.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.psite_region.pdf", "translational_efficiency", "translational_efficiency/anota2seq", "translational_efficiency/anota2seq/treated_vs_control.Anota2seqDataSet.rds", @@ -1222,7 +1268,7 @@ "fastqc_sequence_duplication_levels_plot.txt:md5,77d6e3d36b8c93f25e2d4cdbadd018d3", "fastqc_sequence_length_distribution_plot.txt:md5,d3f33f3eda7927b061fc3cdec99e8f4e", "multiqc_bowtie2_bowtie2_rrna.txt:md5,3370acc7d4ccbfb2c7535f2c962449ed", - "multiqc_citations.txt:md5,96f75160a177c9f907fc9b5365ffe449", + "multiqc_citations.txt:md5,b855e8ba279b140e3a252c5c29156b91", "multiqc_cutadapt.txt:md5,e6031ab468a23c95b6989a6ce9e081f5", "multiqc_fastqc.txt:md5,435f987c78b50ab1dfe18640246f580b", "multiqc_fastqc_fastqc-1.txt:md5,c8ce8940114de9321e6de124b6cb4c18", @@ -1284,6 +1330,48 @@ "SRX11780888.riboseq_readlength_stats.tsv:md5,3b0ded8ebbb3b6ce4dcd1ff288d40c7c", "SRX11780889.riboseq_readlength_stats.tsv:md5,44a962dafdcd8d4fdfbb8fd3c3f6a750", "SRX11780890.riboseq_readlength_stats.tsv:md5,4ad1deb0e42df674bccc620ae4e02b31", + "SRX11780885.best_offset.txt:md5,1e6611858fd98bf4384cb121afb6707c", + "SRX11780885.cds_coverage_psite.tsv.gz:md5,f9d49b4c82a8b3e5b521441e9df4cc86", + "SRX11780885.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,87c80db54f46aac956f46a3ae09b23bc", + "SRX11780885.codon_coverage_psite.tsv.gz:md5,8a759875e7dbbf39d3720f732713678a", + "SRX11780885.codon_coverage_rpf.tsv.gz:md5,afbf801cb1ba85f404978098e572901d", + "SRX11780885.psite.tsv.gz:md5,8276459cd5f05ae92510e9c983f643db", + "SRX11780885.psite_offset.tsv.gz:md5,2ef8627be1603928b16f5fb561ac47b6", + "SRX11780886.best_offset.txt:md5,787599a080c37b7d6eda470c13cc2563", + "SRX11780886.cds_coverage_psite.tsv.gz:md5,3f9a35c6f34c0db4754e8a1662faa0b5", + "SRX11780886.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,9b15a2401a9f0e42c060526f85596d8b", + "SRX11780886.codon_coverage_psite.tsv.gz:md5,7aec8c79793692acd49c7858bce2b579", + "SRX11780886.codon_coverage_rpf.tsv.gz:md5,3e50a00b6520665c165e4c3fce19e5f1", + "SRX11780886.psite.tsv.gz:md5,d5776b81cdd2af8504fc3db2041da515", + "SRX11780886.psite_offset.tsv.gz:md5,583bea05a8cacd96adec469132c968f5", + "SRX11780887.best_offset.txt:md5,827cbf2c4231dd868dc6f93f8b6e83b0", + "SRX11780887.cds_coverage_psite.tsv.gz:md5,d7f669652ce332ab4ebcb742a72dfcf2", + "SRX11780887.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,4fdbeb658fd750c97873f0a2d64ec3ef", + "SRX11780887.codon_coverage_psite.tsv.gz:md5,770a832bc98809a2c6ee4250dab64731", + "SRX11780887.codon_coverage_rpf.tsv.gz:md5,56e1fad3c99f046eddb6fba8d8788ce9", + "SRX11780887.psite.tsv.gz:md5,bec9bc165cd21e17fc03a86cb87005c5", + "SRX11780887.psite_offset.tsv.gz:md5,14eebe2a609db07671c22ba4486e8d99", + "SRX11780888.best_offset.txt:md5,df1bd7c66c950c943d200199d072f808", + "SRX11780888.cds_coverage_psite.tsv.gz:md5,90e082f11c75a08d17bbd3eba354b6c1", + "SRX11780888.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,26fb1fddeb9db9f4b46e027537af491b", + "SRX11780888.codon_coverage_psite.tsv.gz:md5,1053bfe91da54816c224a897ac7226d2", + "SRX11780888.codon_coverage_rpf.tsv.gz:md5,bbd3e94215437a9d89bf61a3bfd5d49f", + "SRX11780888.psite.tsv.gz:md5,1e91a44a68e1918506962648d56a9192", + "SRX11780888.psite_offset.tsv.gz:md5,b52ce5b4cd9a95231d02fc5fed83af70", + "SRX11780889.best_offset.txt:md5,d01cc2839b5415179f8f02b1fe583698", + "SRX11780889.cds_coverage_psite.tsv.gz:md5,e4f51321acf53ea0610e89fe1f718759", + "SRX11780889.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,62d1ad2c5d06dcc2f5e4b38037bac919", + "SRX11780889.codon_coverage_psite.tsv.gz:md5,41ff3b1b94ed30b310bf62d110c1b671", + "SRX11780889.codon_coverage_rpf.tsv.gz:md5,0365460ff32f54ef97582566cd41803a", + "SRX11780889.psite.tsv.gz:md5,df4d090347750c96c3b331dab0f582a9", + "SRX11780889.psite_offset.tsv.gz:md5,e73bb4cd13df6f92efdbaa7dcf380784", + "SRX11780890.best_offset.txt:md5,93ce9d385b8261eea0e90611cb1fa968", + "SRX11780890.cds_coverage_psite.tsv.gz:md5,ed927c97e107476fc1b86b6af1a10e27", + "SRX11780890.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,e51b52241818e27eb6f194af36dfc15a", + "SRX11780890.codon_coverage_psite.tsv.gz:md5,948e954e45f3f4beb19b0aa1adc384b2", + "SRX11780890.codon_coverage_rpf.tsv.gz:md5,fc28b1c4b672c3f94111a27392a0fa9c", + "SRX11780890.psite.tsv.gz:md5,ad3e7a4abdba33a47bfe369cd7f2a725", + "SRX11780890.psite_offset.tsv.gz:md5,4c640cbe8c24465fa1758951af308534", "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", @@ -1347,55 +1435,13 @@ "SRX11780889_qual.txt:md5,4c567c2c47eb52bf81e514a39eb5a695", "SRX11780890.para.py:md5,5f1696c5bf20116fa63363917e131284", "SRX11780890_qual.txt:md5,0f761538ecafb2718bd781c6e1fb7dc1", - "SRX11780885.best_offset.txt:md5,1e6611858fd98bf4384cb121afb6707c", - "SRX11780885.cds_coverage_psite.tsv.gz:md5,f9d49b4c82a8b3e5b521441e9df4cc86", - "SRX11780885.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,87c80db54f46aac956f46a3ae09b23bc", - "SRX11780885.codon_coverage_psite.tsv.gz:md5,8a759875e7dbbf39d3720f732713678a", - "SRX11780885.codon_coverage_rpf.tsv.gz:md5,afbf801cb1ba85f404978098e572901d", - "SRX11780885.psite.tsv.gz:md5,8276459cd5f05ae92510e9c983f643db", - "SRX11780885.psite_offset.tsv.gz:md5,2ef8627be1603928b16f5fb561ac47b6", - "SRX11780886.best_offset.txt:md5,787599a080c37b7d6eda470c13cc2563", - "SRX11780886.cds_coverage_psite.tsv.gz:md5,3f9a35c6f34c0db4754e8a1662faa0b5", - "SRX11780886.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,9b15a2401a9f0e42c060526f85596d8b", - "SRX11780886.codon_coverage_psite.tsv.gz:md5,7aec8c79793692acd49c7858bce2b579", - "SRX11780886.codon_coverage_rpf.tsv.gz:md5,3e50a00b6520665c165e4c3fce19e5f1", - "SRX11780886.psite.tsv.gz:md5,d5776b81cdd2af8504fc3db2041da515", - "SRX11780886.psite_offset.tsv.gz:md5,583bea05a8cacd96adec469132c968f5", - "SRX11780887.best_offset.txt:md5,827cbf2c4231dd868dc6f93f8b6e83b0", - "SRX11780887.cds_coverage_psite.tsv.gz:md5,d7f669652ce332ab4ebcb742a72dfcf2", - "SRX11780887.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,4fdbeb658fd750c97873f0a2d64ec3ef", - "SRX11780887.codon_coverage_psite.tsv.gz:md5,770a832bc98809a2c6ee4250dab64731", - "SRX11780887.codon_coverage_rpf.tsv.gz:md5,56e1fad3c99f046eddb6fba8d8788ce9", - "SRX11780887.psite.tsv.gz:md5,bec9bc165cd21e17fc03a86cb87005c5", - "SRX11780887.psite_offset.tsv.gz:md5,14eebe2a609db07671c22ba4486e8d99", - "SRX11780888.best_offset.txt:md5,df1bd7c66c950c943d200199d072f808", - "SRX11780888.cds_coverage_psite.tsv.gz:md5,90e082f11c75a08d17bbd3eba354b6c1", - "SRX11780888.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,26fb1fddeb9db9f4b46e027537af491b", - "SRX11780888.codon_coverage_psite.tsv.gz:md5,1053bfe91da54816c224a897ac7226d2", - "SRX11780888.codon_coverage_rpf.tsv.gz:md5,bbd3e94215437a9d89bf61a3bfd5d49f", - "SRX11780888.psite.tsv.gz:md5,1e91a44a68e1918506962648d56a9192", - "SRX11780888.psite_offset.tsv.gz:md5,b52ce5b4cd9a95231d02fc5fed83af70", - "SRX11780889.best_offset.txt:md5,d01cc2839b5415179f8f02b1fe583698", - "SRX11780889.cds_coverage_psite.tsv.gz:md5,e4f51321acf53ea0610e89fe1f718759", - "SRX11780889.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,62d1ad2c5d06dcc2f5e4b38037bac919", - "SRX11780889.codon_coverage_psite.tsv.gz:md5,41ff3b1b94ed30b310bf62d110c1b671", - "SRX11780889.codon_coverage_rpf.tsv.gz:md5,0365460ff32f54ef97582566cd41803a", - "SRX11780889.psite.tsv.gz:md5,df4d090347750c96c3b331dab0f582a9", - "SRX11780889.psite_offset.tsv.gz:md5,e73bb4cd13df6f92efdbaa7dcf380784", - "SRX11780890.best_offset.txt:md5,93ce9d385b8261eea0e90611cb1fa968", - "SRX11780890.cds_coverage_psite.tsv.gz:md5,ed927c97e107476fc1b86b6af1a10e27", - "SRX11780890.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,e51b52241818e27eb6f194af36dfc15a", - "SRX11780890.codon_coverage_psite.tsv.gz:md5,948e954e45f3f4beb19b0aa1adc384b2", - "SRX11780890.codon_coverage_rpf.tsv.gz:md5,fc28b1c4b672c3f94111a27392a0fa9c", - "SRX11780890.psite.tsv.gz:md5,ad3e7a4abdba33a47bfe369cd7f2a725", - "SRX11780890.psite_offset.tsv.gz:md5,4c640cbe8c24465fa1758951af308534", "treated_vs_control.R_sessionInfo.log:md5,3623a50b4668bfebf502bf7080800996" ] ], "meta": { "nf-test": "0.9.3", - "nextflow": "25.10.2" + "nextflow": "25.10.0" }, - "timestamp": "2026-01-09T16:28:10.662002637" + "timestamp": "2026-01-12T12:06:06.727279212" } } \ No newline at end of file diff --git a/tests/ribo_removal_bowtie2.nf.test.snap b/tests/ribo_removal_bowtie2.nf.test.snap index 94ff01d9..6d23e221 100644 --- a/tests/ribo_removal_bowtie2.nf.test.snap +++ b/tests/ribo_removal_bowtie2.nf.test.snap @@ -40,6 +40,15 @@ "rsem": "1.3.1", "star": "2.7.10a" }, + "PLASTID_MAKE_WIGGLE": { + "plastid": "0.6.1" + }, + "PLASTID_METAGENE_GENERATE": { + "plastid": "0.6.1" + }, + "PLASTID_PSITE": { + "plastid": "0.6.1" + }, "RIBOTISH_PREDICT_ALL": { "ribotish": "0.2.7" }, @@ -697,6 +706,225 @@ "preprocessing/trimgalore/fastqc/SRX11780889_trimmed_fastqc.zip", "preprocessing/trimgalore/fastqc/SRX11780890_trimmed_fastqc.html", "preprocessing/trimgalore/fastqc/SRX11780890_trimmed_fastqc.zip", + "psites", + "psites/plastid", + "psites/plastid/metagene", + "psites/plastid/metagene/Homo_sapiens.GRCh38.dna.chromosome.20.filtered_rois.bed", + "psites/plastid/metagene/Homo_sapiens.GRCh38.dna.chromosome.20.filtered_rois.txt", + "psites/plastid/offsets", + "psites/plastid/offsets/SRX11780885_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780885_p_offsets.png", + "psites/plastid/offsets/SRX11780885_p_offsets.txt", + "psites/plastid/offsets/SRX11780886_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780886_p_offsets.png", + "psites/plastid/offsets/SRX11780886_p_offsets.txt", + "psites/plastid/offsets/SRX11780887_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780887_p_offsets.png", + "psites/plastid/offsets/SRX11780887_p_offsets.txt", + "psites/plastid/offsets/SRX11780888_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780888_p_offsets.png", + "psites/plastid/offsets/SRX11780888_p_offsets.txt", + "psites/plastid/offsets/SRX11780889_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780889_p_offsets.png", + "psites/plastid/offsets/SRX11780889_p_offsets.txt", + "psites/plastid/offsets/SRX11780890_metagene_profiles.txt", + "psites/plastid/offsets/SRX11780890_p_offsets.png", + "psites/plastid/offsets/SRX11780890_p_offsets.txt", + "psites/plastid/tracks", + "psites/plastid/tracks/SRX11780885_fw.bedgraph", + "psites/plastid/tracks/SRX11780885_rc.bedgraph", + "psites/plastid/tracks/SRX11780886_fw.bedgraph", + "psites/plastid/tracks/SRX11780886_rc.bedgraph", + "psites/plastid/tracks/SRX11780887_fw.bedgraph", + "psites/plastid/tracks/SRX11780887_rc.bedgraph", + "psites/plastid/tracks/SRX11780888_fw.bedgraph", + "psites/plastid/tracks/SRX11780888_rc.bedgraph", + "psites/plastid/tracks/SRX11780889_fw.bedgraph", + "psites/plastid/tracks/SRX11780889_rc.bedgraph", + "psites/plastid/tracks/SRX11780890_fw.bedgraph", + "psites/plastid/tracks/SRX11780890_rc.bedgraph", + "psites/ribowaltz", + "psites/ribowaltz/SRX11780885.best_offset.txt", + "psites/ribowaltz/SRX11780885.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780885.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780885.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780885.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780885.psite.tsv.gz", + "psites/ribowaltz/SRX11780885.psite_offset.tsv.gz", + "psites/ribowaltz/SRX11780886.best_offset.txt", + "psites/ribowaltz/SRX11780886.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780886.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780886.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780886.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780886.psite.tsv.gz", + "psites/ribowaltz/SRX11780886.psite_offset.tsv.gz", + "psites/ribowaltz/SRX11780887.best_offset.txt", + "psites/ribowaltz/SRX11780887.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780887.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780887.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780887.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780887.psite.tsv.gz", + "psites/ribowaltz/SRX11780887.psite_offset.tsv.gz", + "psites/ribowaltz/SRX11780888.best_offset.txt", + "psites/ribowaltz/SRX11780888.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780888.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780888.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780888.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780888.psite.tsv.gz", + "psites/ribowaltz/SRX11780888.psite_offset.tsv.gz", + "psites/ribowaltz/SRX11780889.best_offset.txt", + "psites/ribowaltz/SRX11780889.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780889.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780889.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780889.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780889.psite.tsv.gz", + "psites/ribowaltz/SRX11780889.psite_offset.tsv.gz", + "psites/ribowaltz/SRX11780890.best_offset.txt", + "psites/ribowaltz/SRX11780890.cds_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780890.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780890.codon_coverage_psite.tsv.gz", + "psites/ribowaltz/SRX11780890.codon_coverage_rpf.tsv.gz", + "psites/ribowaltz/SRX11780890.psite.tsv.gz", + "psites/ribowaltz/SRX11780890.psite_offset.tsv.gz", + "psites/ribowaltz/offset_plot", + "psites/ribowaltz/offset_plot/SRX11780885", + "psites/ribowaltz/offset_plot/SRX11780885/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/31.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/32.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/33.pdf", + "psites/ribowaltz/offset_plot/SRX11780885/34.pdf", + "psites/ribowaltz/offset_plot/SRX11780886", + "psites/ribowaltz/offset_plot/SRX11780886/20.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/21.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/31.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/32.pdf", + "psites/ribowaltz/offset_plot/SRX11780886/33.pdf", + "psites/ribowaltz/offset_plot/SRX11780887", + "psites/ribowaltz/offset_plot/SRX11780887/20.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/21.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/31.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/32.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/33.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/34.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/35.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/36.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/37.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/38.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/39.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/40.pdf", + "psites/ribowaltz/offset_plot/SRX11780887/41.pdf", + "psites/ribowaltz/offset_plot/SRX11780888", + "psites/ribowaltz/offset_plot/SRX11780888/21.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780888/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780889", + "psites/ribowaltz/offset_plot/SRX11780889/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/31.pdf", + "psites/ribowaltz/offset_plot/SRX11780889/32.pdf", + "psites/ribowaltz/offset_plot/SRX11780890", + "psites/ribowaltz/offset_plot/SRX11780890/21.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/22.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/23.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/24.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/25.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/26.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/27.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/28.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/29.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/30.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/31.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/32.pdf", + "psites/ribowaltz/offset_plot/SRX11780890/33.pdf", + "psites/ribowaltz/ribowaltz_qc", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780885.psite_region.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780886.psite_region.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780887.psite_region.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780888.psite_region.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780889.psite_region.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.codon_usage.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.ends_heatmap.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.frames.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.frames_stratified.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.length_bins_for_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.length_distribution.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.metaprofile_psite.pdf", + "psites/ribowaltz/ribowaltz_qc/SRX11780890.psite_region.pdf", "quantification", "quantification/salmon", "quantification/salmon/SRX11780879", @@ -912,188 +1140,6 @@ "riboseq_qc/ribotish/SRX11780890.para.py", "riboseq_qc/ribotish/SRX11780890_qual.pdf", "riboseq_qc/ribotish/SRX11780890_qual.txt", - "ribowaltz", - "ribowaltz/SRX11780885.best_offset.txt", - "ribowaltz/SRX11780885.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780885.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780885.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780885.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780885.psite.tsv.gz", - "ribowaltz/SRX11780885.psite_offset.tsv.gz", - "ribowaltz/SRX11780886.best_offset.txt", - "ribowaltz/SRX11780886.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780886.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780886.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780886.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780886.psite.tsv.gz", - "ribowaltz/SRX11780886.psite_offset.tsv.gz", - "ribowaltz/SRX11780887.best_offset.txt", - "ribowaltz/SRX11780887.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780887.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780887.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780887.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780887.psite.tsv.gz", - "ribowaltz/SRX11780887.psite_offset.tsv.gz", - "ribowaltz/SRX11780888.best_offset.txt", - "ribowaltz/SRX11780888.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780888.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780888.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780888.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780888.psite.tsv.gz", - "ribowaltz/SRX11780888.psite_offset.tsv.gz", - "ribowaltz/SRX11780889.best_offset.txt", - "ribowaltz/SRX11780889.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780889.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780889.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780889.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780889.psite.tsv.gz", - "ribowaltz/SRX11780889.psite_offset.tsv.gz", - "ribowaltz/SRX11780890.best_offset.txt", - "ribowaltz/SRX11780890.cds_coverage_psite.tsv.gz", - "ribowaltz/SRX11780890.cds_plus42nt_minus27nt_coverage_psite.tsv.gz", - "ribowaltz/SRX11780890.codon_coverage_psite.tsv.gz", - "ribowaltz/SRX11780890.codon_coverage_rpf.tsv.gz", - "ribowaltz/SRX11780890.psite.tsv.gz", - "ribowaltz/SRX11780890.psite_offset.tsv.gz", - "ribowaltz/offset_plot", - "ribowaltz/offset_plot/SRX11780885", - "ribowaltz/offset_plot/SRX11780885/22.pdf", - "ribowaltz/offset_plot/SRX11780885/23.pdf", - "ribowaltz/offset_plot/SRX11780885/24.pdf", - "ribowaltz/offset_plot/SRX11780885/25.pdf", - "ribowaltz/offset_plot/SRX11780885/26.pdf", - "ribowaltz/offset_plot/SRX11780885/27.pdf", - "ribowaltz/offset_plot/SRX11780885/28.pdf", - "ribowaltz/offset_plot/SRX11780885/29.pdf", - "ribowaltz/offset_plot/SRX11780885/30.pdf", - "ribowaltz/offset_plot/SRX11780885/31.pdf", - "ribowaltz/offset_plot/SRX11780885/32.pdf", - "ribowaltz/offset_plot/SRX11780885/33.pdf", - "ribowaltz/offset_plot/SRX11780885/34.pdf", - "ribowaltz/offset_plot/SRX11780886", - "ribowaltz/offset_plot/SRX11780886/20.pdf", - "ribowaltz/offset_plot/SRX11780886/21.pdf", - "ribowaltz/offset_plot/SRX11780886/22.pdf", - "ribowaltz/offset_plot/SRX11780886/23.pdf", - "ribowaltz/offset_plot/SRX11780886/24.pdf", - "ribowaltz/offset_plot/SRX11780886/25.pdf", - "ribowaltz/offset_plot/SRX11780886/26.pdf", - "ribowaltz/offset_plot/SRX11780886/27.pdf", - "ribowaltz/offset_plot/SRX11780886/28.pdf", - "ribowaltz/offset_plot/SRX11780886/29.pdf", - "ribowaltz/offset_plot/SRX11780886/30.pdf", - "ribowaltz/offset_plot/SRX11780886/31.pdf", - "ribowaltz/offset_plot/SRX11780886/32.pdf", - "ribowaltz/offset_plot/SRX11780886/33.pdf", - "ribowaltz/offset_plot/SRX11780887", - "ribowaltz/offset_plot/SRX11780887/20.pdf", - "ribowaltz/offset_plot/SRX11780887/21.pdf", - "ribowaltz/offset_plot/SRX11780887/22.pdf", - "ribowaltz/offset_plot/SRX11780887/23.pdf", - "ribowaltz/offset_plot/SRX11780887/24.pdf", - "ribowaltz/offset_plot/SRX11780887/25.pdf", - "ribowaltz/offset_plot/SRX11780887/26.pdf", - "ribowaltz/offset_plot/SRX11780887/27.pdf", - "ribowaltz/offset_plot/SRX11780887/28.pdf", - "ribowaltz/offset_plot/SRX11780887/29.pdf", - "ribowaltz/offset_plot/SRX11780887/30.pdf", - "ribowaltz/offset_plot/SRX11780887/31.pdf", - "ribowaltz/offset_plot/SRX11780887/32.pdf", - "ribowaltz/offset_plot/SRX11780887/33.pdf", - "ribowaltz/offset_plot/SRX11780887/34.pdf", - "ribowaltz/offset_plot/SRX11780887/35.pdf", - "ribowaltz/offset_plot/SRX11780887/36.pdf", - "ribowaltz/offset_plot/SRX11780887/37.pdf", - "ribowaltz/offset_plot/SRX11780887/38.pdf", - "ribowaltz/offset_plot/SRX11780887/39.pdf", - "ribowaltz/offset_plot/SRX11780887/40.pdf", - "ribowaltz/offset_plot/SRX11780887/41.pdf", - "ribowaltz/offset_plot/SRX11780888", - "ribowaltz/offset_plot/SRX11780888/21.pdf", - "ribowaltz/offset_plot/SRX11780888/22.pdf", - "ribowaltz/offset_plot/SRX11780888/23.pdf", - "ribowaltz/offset_plot/SRX11780888/24.pdf", - "ribowaltz/offset_plot/SRX11780888/25.pdf", - "ribowaltz/offset_plot/SRX11780888/26.pdf", - "ribowaltz/offset_plot/SRX11780888/27.pdf", - "ribowaltz/offset_plot/SRX11780888/28.pdf", - "ribowaltz/offset_plot/SRX11780888/29.pdf", - "ribowaltz/offset_plot/SRX11780888/30.pdf", - "ribowaltz/offset_plot/SRX11780889", - "ribowaltz/offset_plot/SRX11780889/22.pdf", - "ribowaltz/offset_plot/SRX11780889/23.pdf", - "ribowaltz/offset_plot/SRX11780889/24.pdf", - "ribowaltz/offset_plot/SRX11780889/25.pdf", - "ribowaltz/offset_plot/SRX11780889/26.pdf", - "ribowaltz/offset_plot/SRX11780889/27.pdf", - "ribowaltz/offset_plot/SRX11780889/28.pdf", - "ribowaltz/offset_plot/SRX11780889/29.pdf", - "ribowaltz/offset_plot/SRX11780889/30.pdf", - "ribowaltz/offset_plot/SRX11780889/31.pdf", - "ribowaltz/offset_plot/SRX11780889/32.pdf", - "ribowaltz/offset_plot/SRX11780890", - "ribowaltz/offset_plot/SRX11780890/21.pdf", - "ribowaltz/offset_plot/SRX11780890/22.pdf", - "ribowaltz/offset_plot/SRX11780890/23.pdf", - "ribowaltz/offset_plot/SRX11780890/24.pdf", - "ribowaltz/offset_plot/SRX11780890/25.pdf", - "ribowaltz/offset_plot/SRX11780890/26.pdf", - "ribowaltz/offset_plot/SRX11780890/27.pdf", - "ribowaltz/offset_plot/SRX11780890/28.pdf", - "ribowaltz/offset_plot/SRX11780890/29.pdf", - "ribowaltz/offset_plot/SRX11780890/30.pdf", - "ribowaltz/offset_plot/SRX11780890/31.pdf", - "ribowaltz/offset_plot/SRX11780890/32.pdf", - "ribowaltz/offset_plot/SRX11780890/33.pdf", - "ribowaltz/ribowaltz_qc", - "ribowaltz/ribowaltz_qc/SRX11780885.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780885.psite_region.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780886.psite_region.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780887.psite_region.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780888.psite_region.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780889.psite_region.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.codon_usage.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.ends_heatmap.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.frames.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.frames_stratified.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.length_bins_for_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.length_distribution.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.metaprofile_psite.pdf", - "ribowaltz/ribowaltz_qc/SRX11780890.psite_region.pdf", "translational_efficiency", "translational_efficiency/anota2seq", "translational_efficiency/anota2seq/treated_vs_control.Anota2seqDataSet.rds", @@ -1197,7 +1243,7 @@ "fastqc_sequence_duplication_levels_plot.txt:md5,77d6e3d36b8c93f25e2d4cdbadd018d3", "fastqc_sequence_length_distribution_plot.txt:md5,d3f33f3eda7927b061fc3cdec99e8f4e", "multiqc_bowtie2_bowtie2_rrna.txt:md5,3370acc7d4ccbfb2c7535f2c962449ed", - "multiqc_citations.txt:md5,1e71c91ad074075d489a520daf3aa183", + "multiqc_citations.txt:md5,42fe487eb19339ab63477c4c0f3734ff", "multiqc_cutadapt.txt:md5,e6031ab468a23c95b6989a6ce9e081f5", "multiqc_fastqc.txt:md5,435f987c78b50ab1dfe18640246f580b", "multiqc_fastqc_fastqc-1.txt:md5,c8ce8940114de9321e6de124b6cb4c18", @@ -1250,6 +1296,48 @@ "SRX11780888.bowtie2.log:md5,f299b3257e083e125718d1b61bc5d07a", "SRX11780889.bowtie2.log:md5,57c85c382c57184efb74779ff817382a", "SRX11780890.bowtie2.log:md5,ed7ff247afc948959b6c6e34f7da882e", + "SRX11780885.best_offset.txt:md5,1e6611858fd98bf4384cb121afb6707c", + "SRX11780885.cds_coverage_psite.tsv.gz:md5,f9d49b4c82a8b3e5b521441e9df4cc86", + "SRX11780885.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,87c80db54f46aac956f46a3ae09b23bc", + "SRX11780885.codon_coverage_psite.tsv.gz:md5,8a759875e7dbbf39d3720f732713678a", + "SRX11780885.codon_coverage_rpf.tsv.gz:md5,afbf801cb1ba85f404978098e572901d", + "SRX11780885.psite.tsv.gz:md5,8276459cd5f05ae92510e9c983f643db", + "SRX11780885.psite_offset.tsv.gz:md5,2ef8627be1603928b16f5fb561ac47b6", + "SRX11780886.best_offset.txt:md5,787599a080c37b7d6eda470c13cc2563", + "SRX11780886.cds_coverage_psite.tsv.gz:md5,3f9a35c6f34c0db4754e8a1662faa0b5", + "SRX11780886.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,9b15a2401a9f0e42c060526f85596d8b", + "SRX11780886.codon_coverage_psite.tsv.gz:md5,7aec8c79793692acd49c7858bce2b579", + "SRX11780886.codon_coverage_rpf.tsv.gz:md5,3e50a00b6520665c165e4c3fce19e5f1", + "SRX11780886.psite.tsv.gz:md5,d5776b81cdd2af8504fc3db2041da515", + "SRX11780886.psite_offset.tsv.gz:md5,583bea05a8cacd96adec469132c968f5", + "SRX11780887.best_offset.txt:md5,827cbf2c4231dd868dc6f93f8b6e83b0", + "SRX11780887.cds_coverage_psite.tsv.gz:md5,d7f669652ce332ab4ebcb742a72dfcf2", + "SRX11780887.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,4fdbeb658fd750c97873f0a2d64ec3ef", + "SRX11780887.codon_coverage_psite.tsv.gz:md5,770a832bc98809a2c6ee4250dab64731", + "SRX11780887.codon_coverage_rpf.tsv.gz:md5,56e1fad3c99f046eddb6fba8d8788ce9", + "SRX11780887.psite.tsv.gz:md5,bec9bc165cd21e17fc03a86cb87005c5", + "SRX11780887.psite_offset.tsv.gz:md5,14eebe2a609db07671c22ba4486e8d99", + "SRX11780888.best_offset.txt:md5,df1bd7c66c950c943d200199d072f808", + "SRX11780888.cds_coverage_psite.tsv.gz:md5,90e082f11c75a08d17bbd3eba354b6c1", + "SRX11780888.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,26fb1fddeb9db9f4b46e027537af491b", + "SRX11780888.codon_coverage_psite.tsv.gz:md5,1053bfe91da54816c224a897ac7226d2", + "SRX11780888.codon_coverage_rpf.tsv.gz:md5,bbd3e94215437a9d89bf61a3bfd5d49f", + "SRX11780888.psite.tsv.gz:md5,1e91a44a68e1918506962648d56a9192", + "SRX11780888.psite_offset.tsv.gz:md5,b52ce5b4cd9a95231d02fc5fed83af70", + "SRX11780889.best_offset.txt:md5,d01cc2839b5415179f8f02b1fe583698", + "SRX11780889.cds_coverage_psite.tsv.gz:md5,e4f51321acf53ea0610e89fe1f718759", + "SRX11780889.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,62d1ad2c5d06dcc2f5e4b38037bac919", + "SRX11780889.codon_coverage_psite.tsv.gz:md5,41ff3b1b94ed30b310bf62d110c1b671", + "SRX11780889.codon_coverage_rpf.tsv.gz:md5,0365460ff32f54ef97582566cd41803a", + "SRX11780889.psite.tsv.gz:md5,df4d090347750c96c3b331dab0f582a9", + "SRX11780889.psite_offset.tsv.gz:md5,e73bb4cd13df6f92efdbaa7dcf380784", + "SRX11780890.best_offset.txt:md5,93ce9d385b8261eea0e90611cb1fa968", + "SRX11780890.cds_coverage_psite.tsv.gz:md5,ed927c97e107476fc1b86b6af1a10e27", + "SRX11780890.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,e51b52241818e27eb6f194af36dfc15a", + "SRX11780890.codon_coverage_psite.tsv.gz:md5,948e954e45f3f4beb19b0aa1adc384b2", + "SRX11780890.codon_coverage_rpf.tsv.gz:md5,fc28b1c4b672c3f94111a27392a0fa9c", + "SRX11780890.psite.tsv.gz:md5,ad3e7a4abdba33a47bfe369cd7f2a725", + "SRX11780890.psite_offset.tsv.gz:md5,4c640cbe8c24465fa1758951af308534", "expected_bias.gz:md5,3407f87245d0003e0ffbfdf6d8c04f20", "observed_bias.gz:md5,92bcd0592d22a6a58d0360fc76103e56", "observed_bias_3p.gz:md5,92bcd0592d22a6a58d0360fc76103e56", @@ -1313,55 +1401,13 @@ "SRX11780889_qual.txt:md5,4c567c2c47eb52bf81e514a39eb5a695", "SRX11780890.para.py:md5,5f1696c5bf20116fa63363917e131284", "SRX11780890_qual.txt:md5,0f761538ecafb2718bd781c6e1fb7dc1", - "SRX11780885.best_offset.txt:md5,1e6611858fd98bf4384cb121afb6707c", - "SRX11780885.cds_coverage_psite.tsv.gz:md5,f9d49b4c82a8b3e5b521441e9df4cc86", - "SRX11780885.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,87c80db54f46aac956f46a3ae09b23bc", - "SRX11780885.codon_coverage_psite.tsv.gz:md5,8a759875e7dbbf39d3720f732713678a", - "SRX11780885.codon_coverage_rpf.tsv.gz:md5,afbf801cb1ba85f404978098e572901d", - "SRX11780885.psite.tsv.gz:md5,8276459cd5f05ae92510e9c983f643db", - "SRX11780885.psite_offset.tsv.gz:md5,2ef8627be1603928b16f5fb561ac47b6", - "SRX11780886.best_offset.txt:md5,787599a080c37b7d6eda470c13cc2563", - "SRX11780886.cds_coverage_psite.tsv.gz:md5,3f9a35c6f34c0db4754e8a1662faa0b5", - "SRX11780886.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,9b15a2401a9f0e42c060526f85596d8b", - "SRX11780886.codon_coverage_psite.tsv.gz:md5,7aec8c79793692acd49c7858bce2b579", - "SRX11780886.codon_coverage_rpf.tsv.gz:md5,3e50a00b6520665c165e4c3fce19e5f1", - "SRX11780886.psite.tsv.gz:md5,d5776b81cdd2af8504fc3db2041da515", - "SRX11780886.psite_offset.tsv.gz:md5,583bea05a8cacd96adec469132c968f5", - "SRX11780887.best_offset.txt:md5,827cbf2c4231dd868dc6f93f8b6e83b0", - "SRX11780887.cds_coverage_psite.tsv.gz:md5,d7f669652ce332ab4ebcb742a72dfcf2", - "SRX11780887.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,4fdbeb658fd750c97873f0a2d64ec3ef", - "SRX11780887.codon_coverage_psite.tsv.gz:md5,770a832bc98809a2c6ee4250dab64731", - "SRX11780887.codon_coverage_rpf.tsv.gz:md5,56e1fad3c99f046eddb6fba8d8788ce9", - "SRX11780887.psite.tsv.gz:md5,bec9bc165cd21e17fc03a86cb87005c5", - "SRX11780887.psite_offset.tsv.gz:md5,14eebe2a609db07671c22ba4486e8d99", - "SRX11780888.best_offset.txt:md5,df1bd7c66c950c943d200199d072f808", - "SRX11780888.cds_coverage_psite.tsv.gz:md5,90e082f11c75a08d17bbd3eba354b6c1", - "SRX11780888.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,26fb1fddeb9db9f4b46e027537af491b", - "SRX11780888.codon_coverage_psite.tsv.gz:md5,1053bfe91da54816c224a897ac7226d2", - "SRX11780888.codon_coverage_rpf.tsv.gz:md5,bbd3e94215437a9d89bf61a3bfd5d49f", - "SRX11780888.psite.tsv.gz:md5,1e91a44a68e1918506962648d56a9192", - "SRX11780888.psite_offset.tsv.gz:md5,b52ce5b4cd9a95231d02fc5fed83af70", - "SRX11780889.best_offset.txt:md5,d01cc2839b5415179f8f02b1fe583698", - "SRX11780889.cds_coverage_psite.tsv.gz:md5,e4f51321acf53ea0610e89fe1f718759", - "SRX11780889.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,62d1ad2c5d06dcc2f5e4b38037bac919", - "SRX11780889.codon_coverage_psite.tsv.gz:md5,41ff3b1b94ed30b310bf62d110c1b671", - "SRX11780889.codon_coverage_rpf.tsv.gz:md5,0365460ff32f54ef97582566cd41803a", - "SRX11780889.psite.tsv.gz:md5,df4d090347750c96c3b331dab0f582a9", - "SRX11780889.psite_offset.tsv.gz:md5,e73bb4cd13df6f92efdbaa7dcf380784", - "SRX11780890.best_offset.txt:md5,93ce9d385b8261eea0e90611cb1fa968", - "SRX11780890.cds_coverage_psite.tsv.gz:md5,ed927c97e107476fc1b86b6af1a10e27", - "SRX11780890.cds_plus42nt_minus27nt_coverage_psite.tsv.gz:md5,e51b52241818e27eb6f194af36dfc15a", - "SRX11780890.codon_coverage_psite.tsv.gz:md5,948e954e45f3f4beb19b0aa1adc384b2", - "SRX11780890.codon_coverage_rpf.tsv.gz:md5,fc28b1c4b672c3f94111a27392a0fa9c", - "SRX11780890.psite.tsv.gz:md5,ad3e7a4abdba33a47bfe369cd7f2a725", - "SRX11780890.psite_offset.tsv.gz:md5,4c640cbe8c24465fa1758951af308534", "treated_vs_control.R_sessionInfo.log:md5,3623a50b4668bfebf502bf7080800996" ] ], "meta": { "nf-test": "0.9.3", - "nextflow": "25.10.2" + "nextflow": "25.10.0" }, - "timestamp": "2026-01-09T17:38:04.81764085" + "timestamp": "2026-01-12T12:13:40.704565835" } } \ No newline at end of file diff --git a/workflows/riboseq/main.nf b/workflows/riboseq/main.nf index c67bb4e5..96847731 100644 --- a/workflows/riboseq/main.nf +++ b/workflows/riboseq/main.nf @@ -37,6 +37,9 @@ include { DESEQ2_DELTATE } from '../../mod include { QUANTIFY_PSEUDO_ALIGNMENT as QUANTIFY_STAR_SALMON } from '../../subworkflows/nf-core/quantify_pseudo_alignment' include { QUANTIFY_PSEUDO_ALIGNMENT as QUANTIFY_PSEUDO_TE } from '../../subworkflows/nf-core/quantify_pseudo_alignment' include { RIBOWALTZ } from '../../modules/nf-core/ribowaltz/main' +include { PLASTID_METAGENE_GENERATE } from '../../modules/nf-core/plastid/metagene_generate/main' +include { PLASTID_PSITE } from '../../modules/nf-core/plastid/psite/main' +include { PLASTID_MAKE_WIGGLE } from '../../modules/nf-core/plastid/make_wiggle/main' /* ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ @@ -349,6 +352,25 @@ workflow RIBOSEQ { ch_versions = ch_versions.mix(RIBOWALTZ.out.versions) } + if (!params.skip_plastid) { + + PLASTID_METAGENE_GENERATE(ch_gtf.map { [ [:], it ] }) + ch_versions = ch_versions.mix(PLASTID_METAGENE_GENERATE.out.versions) + + PLASTID_PSITE( + ch_bams_for_analysis, + PLASTID_METAGENE_GENERATE.out.rois_txt + ) + ch_versions = ch_versions.mix(PLASTID_PSITE.out.versions) + + PLASTID_MAKE_WIGGLE( + ch_bams_for_analysis.join(PLASTID_PSITE.out.p_offsets, by: [0]), + "fiveprime_variable" + ) + ch_versions = ch_versions.mix(PLASTID_MAKE_WIGGLE.out.versions) + + } + // // SUBWORKFLOW: Count reads from BAM alignments using Salmon //