Explore Workflows

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

Graph Name Retrieved From View
workflow graph bacterial_kmer

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

Path: bacterial_kmer/wf_bacterial_kmer.cwl

Branch/Commit ID: 4b73bfeb967ee9f57a0410276f7c39e784f0846f

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: 708fd971bd3abe4d367e501583b964bc4c0311b9

workflow graph Functional analyis of sequences that match the 16S SSU

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

Path: workflows/16S_taxonomic_analysis.cwl

Branch/Commit ID: 30397448563d06c342b25a3603c97b6fff7ba7d3

workflow graph trimmed_fastq

Quality Control (raw data), Raw Data trimming and Quality Control (pre-processed)

https://gitlab.bsc.es/lrodrig1/structuralvariants_poc.git

Path: structuralvariants/cwl/subworkflows/trimmed_fastq.cwl

Branch/Commit ID: 32a040f94e9798bf91858da51598f0d68c35797d

workflow graph EMG pipeline v3.0 (paired end version)

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

Path: workflows/emg-pipeline-v3-paired.cwl

Branch/Commit ID: 886df9de6713e06228d2560c40f451155a196383

workflow graph Trim Galore RNA-Seq pipeline single-read strand specific

Note: should be updated The original [BioWardrobe's](https://biowardrobe.com) [PubMed ID:26248465](https://www.ncbi.nlm.nih.gov/pubmed/26248465) **RNA-Seq** basic analysis for a **single-end** experiment. A corresponded input [FASTQ](http://maq.sourceforge.net/fastq.shtml) file has to be provided. Current workflow should be used only with the single-end RNA-Seq data. It performs the following steps: 1. Trim adapters from input FASTQ file 2. Use STAR to align reads from input FASTQ file according to the predefined reference indices; generate unsorted BAM file and alignment statistics file 3. Use fastx_quality_stats to analyze input FASTQ file and generate quality statistics file 4. Use samtools sort to generate coordinate sorted BAM(+BAI) file pair from the unsorted BAM file obtained on the step 1 (after running STAR) 5. Generate BigWig file on the base of sorted BAM file 6. Map input FASTQ file to predefined rRNA reference indices using Bowtie to define the level of rRNA contamination; export resulted statistics to file 7. Calculate isoform expression level for the sorted BAM file and GTF/TAB annotation file using GEEP reads-counting utility; export results to file

https://github.com/datirium/workflows.git

Path: workflows/trim-rnaseq-se-dutp.cwl

Branch/Commit ID: b1a5dabeeeb9079b30b2871edd9c9034a1e00c1c

workflow graph WGS QC workflow

https://github.com/genome/analysis-workflows.git

Path: definitions/subworkflows/qc_wgs.cwl

Branch/Commit ID: 18600518ce6539a2e29c1707392a4c5da5687fa3

workflow graph RNA-Seq pipeline single-read strand specific

Note: should be updated The original [BioWardrobe's](https://biowardrobe.com) [PubMed ID:26248465](https://www.ncbi.nlm.nih.gov/pubmed/26248465) **RNA-Seq** basic analysis for **strand specific single-read** experiment. A corresponded input [FASTQ](http://maq.sourceforge.net/fastq.shtml) file has to be provided. Current workflow should be used only with the single-read RNA-Seq data. It performs the following steps: 1. Use STAR to align reads from input FASTQ file according to the predefined reference indices; generate unsorted BAM file and alignment statistics file 2. Use fastx_quality_stats to analyze input FASTQ file and generate quality statistics file 3. Use samtools sort to generate coordinate sorted BAM(+BAI) file pair from the unsorted BAM file obtained on the step 1 (after running STAR) 5. Generate BigWig file on the base of sorted BAM file 6. Map input FASTQ file to predefined rRNA reference indices using Bowtie to define the level of rRNA contamination; export resulted statistics to file 7. Calculate isoform expression level for the sorted BAM file and GTF/TAB annotation file using GEEP reads-counting utility; export results to file

https://github.com/datirium/workflows.git

Path: workflows/rnaseq-se-dutp.cwl

Branch/Commit ID: 480e99a4bb3046e0565113d9dca294e0895d3b0c

workflow graph picard_markduplicates

Mark duplicates

https://gitlab.bsc.es/lrodrig1/structuralvariants_poc.git

Path: structuralvariants/cwl/subworkflows/picard_markduplicates.cwl

Branch/Commit ID: 32a040f94e9798bf91858da51598f0d68c35797d

workflow graph EMG core analysis

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

Path: workflows/emg-core-analysis-v4.cwl

Branch/Commit ID: 886df9de6713e06228d2560c40f451155a196383