- Selected
- |
- Default Values
- Nested Workflows
- Tools
- Inputs/Outputs
This workflow is Open Source and may be reused according to the terms of:
GNU General Public License v3.0 only
Note that the tools invoked by the workflow may have separate licenses.
Inputs
| ID | Type | Title | Doc |
|---|---|---|---|
| assay | String | scRNA-seq assay | |
| img_dir | Directory (Optional) | Directory containing TIFF image data (for Visium assay) | |
| threads | Integer | Number of threads for Salmon | |
| fastq_dir | Directory[] | Directory containing FASTQ files | |
| metadata_dir | Directory (Optional) | Directory containing metadata, including gpr slide file (for Visium assay) | |
| keep_all_barcodes | Boolean (Optional) | ||
| expected_cell_count | Integer (Optional) |
Steps
| ID | Runs | Label | Doc |
|---|---|---|---|
| fastqc |
steps/fastqc.cwl
(CommandLineTool)
|
Runs fastQC on each fastq file in fastq directory | |
| scanpy_analysis |
steps/scanpy-analysis.cwl
(CommandLineTool)
|
Dimensionality reduction and clustering | |
| scvelo_analysis |
steps/scvelo-analysis.cwl
(CommandLineTool)
|
RNA velocity analysis via scVelo | |
| squidpy_analysis |
steps/squidpy-analysis.cwl
(CommandLineTool)
|
Dimensionality reduction and clustering | |
| compute_qc_results |
steps/compute-qc-metrics.cwl
(CommandLineTool)
|
Compute QC metrics | |
| salmon_quantification |
steps/salmon-quantification.cwl
(Workflow)
|
Salmon quantification, FASTQ -> H5AD count matrix |
Outputs
| ID | Type | Label | Doc |
|---|---|---|---|
| qc_report | File | Quality control report in JSON format | |
| umap_plot | File | UMAP dimensionality reduction plot | |
| fastqc_dir | Directory[] | Directory of FastQC output files, mirroring input directory structure | |
| ripley_plot | File (Optional) | ||
| spatial_plot | File (Optional) | Slide-seq bead plot, colored by Leiden cluster | |
| salmon_output | Directory | Full output of `salmon alevin` | |
| dispersion_plot | File | Gene expression dispersion plot | |
| raw_count_matrix | File (Optional) | Unfiltered count matrix from Alevin, converted to H5AD, with intronic counts as separate columns | |
| count_matrix_h5ad | File | Unfiltered count matrix from Alevin, converted to H5AD, spliced and unspliced counts | |
| genome_build_json | File | Genome build information in JSON format | |
| scanpy_qc_results | File | Quality control metrics from Scanpy | |
| umap_density_plot | File | UMAP dimensionality reduction plot, colored by cell density | |
| co_occurrence_plot | File (Optional) | ||
| filtered_data_h5ad | File | Full data set of filtered results |
Full data set of filtered results: expression matrix, coordinates in dimensionality-reduced space (PCA and UMAP), cluster assignments via the Leiden algorithm, and marker genes for one cluster vs. rest |
| squidpy_spatial_plot | File (Optional) | ||
| scvelo_annotated_h5ad | File (Optional) | scVelo-annotated h5ad file, including cell RNA velocity | |
| centrality_scores_plot | File (Optional) | ||
| squidpy_annotated_h5ad | File (Optional) | ||
| interaction_matrix_plot | File (Optional) | ||
| marker_gene_plot_logreg | File | Cluster marker genes, logreg method | |
| marker_gene_plot_t_test | File | Cluster marker genes, t-test | |
| scvelo_embedding_grid_plot | File (Optional) | scVelo velocity embedding grid plot | |
| neighborhood_enrichment_plot | File (Optional) |
Permalink:
https://w3id.org/cwl/view/git/6591870e5784be2536a1a88d661dc3dbd7459367/pipeline.cwl
