Explore Workflows

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

Graph Name Retrieved From View
workflow graph EMG pipeline's QIIME workflow

Step 1: Set environment PYTHONPATH, QIIME_ROOT, PATH Step 2: Run QIIME script pick_closed_reference_otus.py ${python} ${qiimeDir}/bin/pick_closed_reference_otus.py -i $1 -o $2 -r ${qiimeDir}/gg_13_8_otus/rep_set/97_otus.fasta -t ${qiimeDir}/gg_13_8_otus/taxonomy/97_otu_taxonomy.txt -p ${qiimeDir}/cr_otus_parameters.txt Step 3: Convert new biom format to old biom format (json) ${qiimeDir}/bin/biom convert -i ${resultDir}/cr_otus/otu_table.biom -o ${resultDir}/cr_otus/${infileBase}_otu_table_json.biom --table-type=\"OTU table\" --to-json Step 4: Convert new biom format to a classic OTU table. ${qiimeDir}/bin/biom convert -i ${resultDir}/cr_otus/otu_table.biom -o ${resultDir}/cr_otus/${infileBase}_otu_table.txt --to-tsv --header-key taxonomy --table-type \"OTU table\" Step 5: Create otu summary ${qiimeDir}/bin/biom summarize-table -i ${resultDir}/cr_otus/otu_table.biom -o ${resultDir}/cr_otus/${infileBase}_otu_table_summary.txt Step 6: Move one of the result files mv ${resultDir}/cr_otus/otu_table.biom ${resultDir}/cr_otus/${infileBase}_otu_table_hdf5.biom Step 7: Create a list of observations awk '{print $1}' ${resultDir}/cr_otus/${infileBase}_otu_table.txt | sed '/#/d' > ${resultDir}/cr_otus/${infileBase}_otu_observations.txt Step 8: Create a phylogenetic tree by pruning GreenGenes and keeping observed otus ${python} ${qiimeDir}/bin/filter_tree.py -i ${qiimeDir}/gg_13_8_otus/trees/97_otus.tree -t ${resultDir}/cr_otus/${infileBase}_otu_observations.txt -o ${resultDir}/cr_otus/${infileBase}_pruned.tree

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

Path: workflows/qiime-workflow.cwl

Branch/Commit ID: 8e196ab

workflow graph revsort.cwl

Reverse the lines in a document, then sort those lines.

https://github.com/common-workflow-language/cwlprov.git

Path: examples/revsort-run-1/snapshot/revsort.cwl

Branch/Commit ID: main

workflow graph Whole Exome Sequencing

Whole Exome Sequence analysis using GATK best practices - Germline SNP & Indel Discovery

https://github.com/Duke-GCB/bespin-cwl.git

Path: packed/exomeseq.cwl

Branch/Commit ID: qiime2-workflow

Packed ID: main

workflow graph BD Rhapsody™ Targeted Analysis Pipeline

The BD Rhapsody™ assays are used to create sequencing libraries from single cell transcriptomes. After sequencing, the analysis pipeline takes the FASTQ files and a reference file for gene alignment. The pipeline generates molecular counts per cell, read counts per cell, metrics, and an alignment file.

https://github.com/longbow0/cwl.git

Path: v1.8/rhapsody_targeted_1.8.cwl

Branch/Commit ID: master

Packed ID: main

workflow graph ST520106.cwl

https://github.com/Marco-Salvi/cwl-test.git

Path: wf5201/ST520106.cwl

Branch/Commit ID: main

workflow graph collate_unique_rRNA_headers.cwl

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

Path: tools/collate_unique_rRNA_headers.cwl

Branch/Commit ID: ef3c7b2

workflow graph Alignment without BQSR

https://github.com/apaul7/cancer-genomics-workflow.git

Path: definitions/subworkflows/sequence_to_bqsr_nonhuman.cwl

Branch/Commit ID: low-vaf

workflow graph gathered exome alignment and somatic variant detection

https://github.com/apaul7/cancer-genomics-workflow.git

Path: definitions/pipelines/somatic_exome_gathered.cwl

Branch/Commit ID: low-vaf

workflow graph presto.cwl

https://github.com/EOSC-LOFAR/presto-cwl.git

Path: presto.cwl

Branch/Commit ID: visualise

workflow graph kfdrc_alignment_CramOnly_wf.cwl

https://github.com/cr-ste-justine/chujs-alignment-workflow.git

Path: workflows/kfdrc_alignment_CramOnly_wf.cwl

Branch/Commit ID: dev