Workflow: TOPMed_RNA-seq
TOPMed RNA-seq CWL workflow. Documentation on the workflow can be found [here](https://github.com/heliumdatacommons/cwl_workflows/blob/master/topmed-workflows/TOPMed_RNAseq_pipeline/README.md). Example input files: [Dockstore.json](https://github.com/heliumdatacommons/cwl_workflows/blob/master/topmed-workflows/TOPMed_RNAseq_pipeline/input-examples/Dockstore.json) and [rnaseq_pipeline_fastq-example.yml](https://github.com/heliumdatacommons/cwl_workflows/blob/master/topmed-workflows/TOPMed_RNAseq_pipeline/input-examples/rnaseq_pipeline_fastq-example.yml). Quickstart instructions are [here](https://github.com/heliumdatacommons/cwl_workflows/blob/master/topmed-workflows/TOPMed_RNAseq_pipeline/README.md#Quick Start). [GitHub Repo](https://github.com/heliumdatacommons/cwl_workflows) Pipeline steps: 1. Align RNA-seq reads with [STAR v2.5.3a](https://github.com/alexdobin/STAR). 2. Run [Picard](https://github.com/broadinstitute/picard) [MarkDuplicates](https://broadinstitute.github.io/picard/command-line-overview.html#MarkDuplicates). 2a. Create BAM index for MarkDuplicates BAM with [Samtools 1.6](https://github.com/samtools/samtools/releases) index. 3. Transcript quantification with [RSEM 1.3.0](https://deweylab.github.io/RSEM/) 4. Gene quantification and quality control with [RNA-SeQC 1.1.9](https://github.com/francois-a/rnaseqc)
- Selected
- |
- Default Values
- Nested Workflows
- Tools
- Inputs/Outputs
Inputs
| ID | Type | Title | Doc |
|---|---|---|---|
| fastqs | File[] | ||
| genes_gtf | File | ||
| paired_end | Boolean | ||
| prefix_str | String | ||
| star_index | Directory | ||
| is_stranded | Boolean | ||
| genome_fasta | File | ||
| max_frag_len | Integer | ||
| rsem_ref_dir | Directory | ||
| estimate_rspd | Boolean | ||
| rnaseqc_flags | String[] |
Steps
| ID | Runs | Label | Doc |
|---|---|---|---|
| run_rsem |
rsem.cwl
(CommandLineTool)
|
run-rsem |
A CWL wrapper for [run_RSEM.py](https://github.com/broadinstitute/gtex-pipeline/blob/master/rnaseq/src/run_RSEM.py) |
| run_star |
star.cwl
(CommandLineTool)
|
run-star |
A CWL wrapper for [run_STAR.py](https://github.com/broadinstitute/gtex-pipeline/blob/master/rnaseq/src/run_STAR.py) |
| sort_bam |
samtools-sort.cwl
(CommandLineTool)
|
Sort alignments by leftmost coordinates, or by read name when -n is used. An appropriate @HD-SO sort order header tag will be added or an existing one updated if necessary. |
|
| index_bam |
indexbam.cwl
(CommandLineTool)
|
run-index-bam |
A wrapper for running `samtools index <bam>`. |
| run_rna-seqc |
rna_seqc.cwl
(CommandLineTool)
|
run-seqc |
A CWL wrapper for [run_rnaseqc.py](https://github.com/heliumdatacommons/cwl_workflows/blob/master/topmed-workflows/TOPMed_RNAseq_pipeline/src/run_rnaseqc.py) duplicated from [run_rnaseqc.py](https://github.com/broadinstitute/gtex-pipeline/blob/master/rnaseq/src/run_rnaseqc.py) with minor modifications. |
| run_markduplicates |
markduplicates.cwl
(CommandLineTool)
|
run-MarkDuplicates |
A CWL wrapper for [run_MarkDuplicates.py](https://github.com/broadinstitute/gtex-pipeline/blob/master/rnaseq/src/run_MarkDuplicates.py) |
| run_index_markduplicates_bam |
indexbam.cwl
(CommandLineTool)
|
run-index-bam |
A wrapper for running `samtools index <bam>`. |
Outputs
| ID | Type | Label | Doc |
|---|---|---|---|
| star_output_bam | File | ||
| star_output_logs | File[] | ||
| star_output_bam_index | File | ||
| star_output_junctions | File | ||
| star_output_read_counts | File | ||
| markduplicates_bam_index | File | ||
| rsem_output_gene_results | File | ||
| markduplicates_output_bam | File | ||
| rna-seqc_output_gene_rpkm | File | ||
| rna-seqc_output_exon_counts | File | ||
| rna-seqc_output_gene_counts | File | ||
| star_output_junctions_pass1 | File | ||
| rsem_output_isoforms_results | File | ||
| markduplicates_output_metrics | File | ||
| rna-seqc_output_count_metrics | File | ||
| rna-seqc_output_count_outputs | File | ||
| star_output_transcriptome_bam | File | ||
| star_output_chimeric_junctions | File |
https://w3id.org/cwl/view/git/018d344b12e9e1b888e21e0819096f9b337d371d/topmed-workflows/TOPMed_RNAseq_pipeline/rnaseq_pipeline_fastq.cwl
