Explore Workflows

View already parsed workflows here or click here to add your own

Graph Name Retrieved From View
workflow graph ex_wf.cwl

https://github.com/idaks/cwl_modeling.git

Path: cwl_example_user_guide/ex_wf.cwl

Branch/Commit ID: master

workflow graph Produce a list of residue-mapped structural domain instances from Pfam ids

Retrieve and process the PDB structures corresponding to the Pfam family ids resulting in a list of residue-mapped structural domain instances along with lost structural instances (requires Data/pdbmap downloaded from Pfam and uses SIFTS resource for UniProt to PDB residue Mapping)

https://gitlab.inria.fr/capsid.public_codes/CroMaSt.git

Path: Tools/resmapping_pfam_instances_subwf.cwl

Branch/Commit ID: main

workflow graph packed.cwl#workflow_mc.cwl

https://github.com/mr-c/cwltests.git

Path: cwl/packed.cwl

Branch/Commit ID: pack_test

Packed ID: workflow_mc.cwl

workflow graph collate_unique_SSU_headers.cwl

https://github.com/ProteinsWebTeam/ebi-metagenomics-cwl.git

Path: tools/collate_unique_SSU_headers.cwl

Branch/Commit ID: master

workflow graph collate_unique_SSU_headers.cwl

https://github.com/EBI-Metagenomics/ebi-metagenomics-cwl.git

Path: tools/collate_unique_SSU_headers.cwl

Branch/Commit ID: 3f85843

workflow graph analysis-workflow.cwl

https://github.com/mskcc/pluto-cwl.git

Path: cwl/analysis-workflow.cwl

Branch/Commit ID: master

workflow graph 02-peakcall.cwl

DNase-seq 02 quantification

https://github.com/alexbarrera/GGR-cwl.git

Path: v1.0/DNase-seq_pipeline/02-peakcall.cwl

Branch/Commit ID: master

workflow graph germline-gpu-v4.0.1.cwl

https://github.com/NCGM-genome/WGSpipeline.git

Path: Workflows/germline-gpu-v4.0.1.cwl

Branch/Commit ID: main

workflow graph Bacterial Annotation, structural annotation, functional annotation: ab initio GeneMark, by WP, by HMM (second pass)

https://github.com/ncbi/pgap.git

Path: bacterial_annot/wf_bacterial_annot_2nd_pass.cwl

Branch/Commit ID: master

workflow graph facets-workflow.cwl

Workflow for running Facets-suite on a set of tumor normal pairs This workflow scatters over all the pairs in the input JSON to run all samples in parallel Input JSON format ----------------- { \"pairs\": [ { \"tumor_bam\": { \"class\": \"File\", \"path\": \"/test_data/bam/Tumor1.rg.md.abra.printreads.bam\" }, \"normal_bam\": { \"class\": \"File\", \"path\": \"/test_data/bam/Normal1.rg.md.abra.printreads.bam\" }, \"pair_maf\": { \"class\": \"File\", \"path\": \"/test_data/bam/Tumor1.Normal1.maf\" }, \"pair_id\": \"Tumor1.Normal1\" }, { \"tumor_bam\": { \"class\": \"File\", \"path\": \"/test_data/bam/Tumor2.rg.md.abra.printreads.bam\" }, \"normal_bam\": { \"class\": \"File\", \"path\": \"/test_data/bam/Normal2.rg.md.abra.printreads.bam\" }, \"pair_maf\": { \"class\": \"File\", \"path\": \"/test_data/bam/Tumor2.Normal2.maf\" }, \"pair_id\": \"Tumor2.Normal2\" } ] } Output format ------------- output └── facets-suite ├── Tumor1.Normal1.arm_level.txt ├── Tumor1.Normal1.gene_level.txt ├── Tumor1.Normal1_hisens.ccf.maf ├── Tumor1.Normal1_hisens.rds ├── Tumor1.Normal1_hisens.seg ├── Tumor1.Normal1_purity.rds ├── Tumor1.Normal1_purity.seg ├── Tumor1.Normal1.qc.txt ├── Tumor1.Normal1.snp_pileup.gz ├── Tumor1.Normal1.txt ├── Tumor2.Normal2.arm_level.txt ├── Tumor2.Normal2.gene_level.txt ├── Tumor2.Normal2_hisens.ccf.maf ├── Tumor2.Normal2_hisens.rds ├── Tumor2.Normal2_hisens.seg ├── Tumor2.Normal2_purity.rds ├── Tumor2.Normal2_purity.seg ├── Tumor2.Normal2.qc.txt ├── Tumor2.Normal2.snp_pileup.gz ├── Tumor2.Normal2.txt └── logs ├── success └── failed

https://github.com/mskcc/pluto-cwl.git

Path: cwl/facets-workflow.cwl

Branch/Commit ID: master