Explore Workflows

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

Graph Name Retrieved From View
workflow graph rnaseq-pe.cwl

RNA-Seq basic analysis workflow for paired-end experiment.

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

Path: workflows/rnaseq-pe.cwl

Branch/Commit ID: cb5e5b8563be4977e9f2babc14fe084faa234847

workflow graph THOR - differential peak calling of ChIP-seq signals with replicates

What is THOR? -------------- THOR is an HMM-based approach to detect and analyze differential peaks in two sets of ChIP-seq data from distinct biological conditions with replicates. THOR performs genomic signal processing, peak calling and p-value calculation in an integrated framework. For more information please refer to: ------------------------------------- Allhoff, M., Sere K., Freitas, J., Zenke, M., Costa, I.G. (2016), Differential Peak Calling of ChIP-seq Signals with Replicates with THOR, Nucleic Acids Research, epub gkw680.

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

Path: workflows/rgt-thor.cwl

Branch/Commit ID: 4a80f5b8f86c83af39494ecc309b789aeda77964

workflow graph Differential Methylation Workflow

A basic differential methylation analysis workflow using BismarkCov formatted bed files as input to the RnBeads tool. Analysis is conducted on region and sites levels according to the sample groups specified by user (limited to 2 conditions in this workflow implementation). See report html files for detailed descriptions of analyses and results interpretation. ### __Inputs__ *General Info:* - Experiment short name/Alias* - a unique name for the sample (e.g. what was used on tubes while processing it) - Condition 1 name - name defining condition/group 1 - Condition 2 name - name defining condition/group 2 - Bismark coverage files* for condition1 - minumum of 2 is required for analysis - Bismark coverage files* for condition2 - minumum of 2 is required for analysis - Sample genome - available options: hg19, hg38, mm9, mm10, rn5 - Genome type - indicate mismark index used for upstream samples (input for conditions 1 and 2) *Advanced:* - Number of threads for steps that support multithreading - default set to `4` *[BismarkCov formatted bed](https://www.bioinformatics.babraham.ac.uk/projects/bismark/Bismark_User_Guide.pdf): The genome-wide cytosine report (optional) is tab-delimited in the following format (1-based coords): <chromosome> <position> <strand> <count methylated> <count unmethylated> <C-context> <trinucleotide context> ### __Outputs__ Intermediate and final downloadable outputs include: - sig_dm_sites.bed ([bed for IGV](https://genome.ucsc.edu/FAQ/FAQformat.html#format1); sig diff meth sites) - sig_dm_sites_annotated.tsv (tsv for TABLE; for each site above, closest single gene annotation) - Site_id, unique indentifer per methylated site - Site_Chr, chromosome of methylated site - Site_position, 1-based position in chr of methylated site - Site_strand, strand of methylated site - Log2_Meth_Quotient, log2 of the quotient in methylation: log2((mean.g1+epsilon)/(mean.g2+epsilon)), where epsilon:=0.01. In case of paired analysis, it is the mean of the pairwise quotients. - FDR, adjusted p-values, all <0.10 assumed to be significant - Coverage_score, value between 0-1000 reflects strength of mean coverage difference between conditions and equals [1000-(1000/(meancov_g1-meancov_g2)^2](https://www.wolframalpha.com/input?i=solve+1000-%281000%2F%28x%5E2%29%29), if meancov_g1-meancov_g2==0, score=0, elif score<1==1, else score - meancov_g1, mean coverage of condition1 - meancov_g2, mean coverage of condition2 - refSeq_id, RefSeq gene id - Gene_id, gene symbol - Chr, gene chromosome - txStart, gene transcription start position - tsEnd, gene transcription end position - txStrand, gene strand - stdout and stderr log files - Packaged RnBeads reports directory (reports.tar.gz) contains: reports/ ├── configuration ├── data_import.html ├── data_import_data ├── data_import_images ├── data_import_pdfs ├── differential_methylation.html ├── differential_methylation_data ├── differential_methylation_images ├── differential_methylation_pdfs ├── preprocessing.html ├── preprocessing_data ├── preprocessing_images ├── preprocessing_pdfs ├── quality_control.html ├── quality_control_data ├── quality_control_images ├── quality_control_pdfs ├── tracks_and_tables.html ├── tracks_and_tables_data ├── tracks_and_tables_images └── tracks_and_tables_pdfs Reported methylation is in the form of regions (genes, promoters, cpg, tiling) and specific sites: - genes - Ensembl gene definitions are downloaded using the biomaRt package. - promoters - A promoter is defined as the region spanning 1,500 bases upstream and 500 bases downstream of the transcription start site of the corresponding gene - cpg - the CpG islands from the UCSC Genome Browser - tiling - a window size of 5 kilobases are defined over the whole genome - sites - all cytosines in the context of CpGs in the respective genome ### __Data Analysis Steps__ 1. generate sample sheet with associated conditions for testing in RnBeads 2. setup rnbeads analyses in R, and run differential methylation analysis 3. process output diffmeth files for regions and sites 4. find single closest gene annotations for all significantly diffmeth sites 5. package and save rnbeads report directory 6. clean up report dir for html outputs ### __References__ - https://rnbeads.org/materials/example_3/differential_methylation.html - Makambi, K. (2003) Weighted inverse chi-square method for correlated significance tests. Journal of Applied Statistics, 30(2), 225234 - https://www.ncbi.nlm.nih.gov/pmc/articles/PMC4216143/ - Assenov Y, Müller F, Lutsik P, Walter J, Lengauer T, Bock C. Comprehensive analysis of DNA methylation data with RnBeads. Nat Methods. 2014 Nov;11(11):1138-1140. doi: 10.1038/nmeth.3115. Epub 2014 Sep 28. PMID: 25262207; PMCID: PMC4216143.

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

Path: workflows/diffmeth.cwl

Branch/Commit ID: 46d3d403ddb240d5a8f4f31ab992b6d6a2686745

workflow graph Trim Galore RNA-Seq pipeline paired-end

The original [BioWardrobe's](https://biowardrobe.com) [PubMed ID:26248465](https://www.ncbi.nlm.nih.gov/pubmed/26248465) **RNA-Seq** basic analysis for a **pair-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 files 2. Use STAR to align reads from input FASTQ files according to the predefined reference indices; generate unsorted BAM file and alignment statistics file 3. Use fastx_quality_stats to analyze input FASTQ files and generate quality statistics files 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 files 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-pe.cwl

Branch/Commit ID: ce058d892d330125cd03d0a0d5fb3b321cda0be3

workflow graph revsort.cwl

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

https://github.com/common-workflow-language/cwl-v1.2.git

Path: tests/revsort.cwl

Branch/Commit ID: e62f99dd79d6cb9c157cceb458f74200da84f6e9

workflow graph Trim Galore ChIP-Seq pipeline paired-end with spike-in

A basic analysis workflow for paired-end ChIP-Seq experiments with a spike-in control. These sequencing library prep methods are chromatin mapping technologies compared to the ChIP-Seq methodology. Its primary benefits include 1) length filtering, 2) a higher signal-to-noise ratio, and 3) built-in normalization for between sample comparisons. This workflow utilizes the tool MACS2 which calls enriched regions in the target sequence data by identifying the top regions by area under a poisson distribution (of the alignment pileup). ### __Inputs__ *General Info (required\*):* - Experiment short name/Alias* - a unique name for the sample (e.g. what was used on tubes while processing it) - Cells* - sample cell type or organism name - Conditions* - experimental condition name - Catalog # - catalog number for cells from vender/supplier - Primary [genome index](https://scidap.com/tutorials/basic/genome-indices) for peak calling* - preprocessed genome index of sample organism for primary alignment and peak calling - Secondary [genome index](https://scidap.com/tutorials/basic/genome-indices) for spike-in normalization* - preprocessed genome index of spike-in organism for secondary alignment (of unaligned reads from primary alignment) and spike-in normalization, default should be E. coli K-12 - FASTQ file for R1* - read 1 file of a pair-end library - FASTQ file for R2* - read 2 file of a pair-end library *Advanced:* - - Number of bases to clip from the 3p end - used by bowtie aligner to trim <int> bases from 3' (right) end of reads - Number of bases to clip from the 5p end - used by bowtie aligner to trim <int> bases from 5' (left) end of reads - Call samtools rmdup to remove duplicates from sorted BAM file? - toggle on/off to remove duplicate reads from analysis - Fragment Length Filter will retain fragments between set base pair (bp) ranges for peak analysis - drop down menu - `default_below_1000` retains fragments <1000 bp - `histones_130_to_300` retains fragments between 130-300 bp - `TF_below_130` retains fragments <130 bp - Max distance (bp) from gene TSS (in both directions) overlapping which the peak will be assigned to the promoter region - default set to `1000` - Max distance (bp) from the promoter (only in upstream directions) overlapping which the peak will be assigned to the upstream region - default set to `20000` - Number of threads for steps that support multithreading - default set to `2` ### __Outputs__ Intermediate and final downloadable outputs include: - IGV with gene, BigWig (raw and normalized), and stringent peak tracks - quality statistics and visualizations for both R1/R2 input FASTQ files - coordinate sorted BAM file with associated BAI file for primary alignment - read pileup/coverage in BigWig format (raw and normalized) - cleaned bed files (containing fragment coordinates), and spike-in normalized peak-called BED files (also includes \"narrow\" and \"broad\" peaks). - stringent peak call bed file with nearest gene annotations per peak ### __Data Analysis Steps__ 1. Trimming the adapters with TrimGalore. - This step is particularly important when the reads are long and the fragments are short - resulting in sequencing adapters at the ends of reads. If adapter is not removed the read will not map. TrimGalore can recognize standard adapters, such as Illumina or Nextera/Tn5 adapters. 2. Generate quality control statistics of trimmed, unmapped sequence data 3. (Optional) Clipping of 5' and/or 3' end by the specified number of bases. 4. Mapping reads to primary genome index with Bowtie. - Only uniquely mapped reads with less than 3 mismatches are used in the downstream analysis. Results are then sorted and indexed. Final outputs are in bam/bai format, which are also used to extrapolate effects of additional sequencing based on library complexity. 5. (Optional) Removal of duplicates (reads/pairs of reads mapping to exactly the same location). - This step is used to remove reads overamplified during amplification of the library. Unfortunately, it may also remove \"good\" reads. We usually do not remove duplicates unless the library is heavily duplicated. 6. Mapping unaligned reads from primary alignment to secondary genome index with Bowtie. - This step is used to obtain the number of reads for normalization, used to scale the read count pileups from the primary alignment used for peak calling. After normalization, sample pileups/peak may then be appropriately compared to one another assuming an equal use of spike-in material during library preparation. 7. Formatting alignment file to account for fragments based on paired-end BAM. - Generates a filtered and normalized bed file to be used as input for peak calling. 8. Call enriched regions using MACS2. - This step called peaks (broad and narrow) using the MACS2 tool with default parameters and no normalization to a control sample. 9. Generation and formatting of output files. - This step collects read, alignment, and peak statistics, as well asgenerates BigWig coverage/pileup files for display on the browser using IGV. The coverage shows the number of fragments that cover each base in the genome both normalized and unnormalized to the calculated spike-in scaling factor.

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

Path: workflows/trim-chipseq-pe-spike.cwl

Branch/Commit ID: 46d3d403ddb240d5a8f4f31ab992b6d6a2686745

workflow graph step-valuefrom3-wf.cwl

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

Path: v1.0/v1.0/step-valuefrom3-wf.cwl

Branch/Commit ID: 17695244222b0301b37cb749fe4a8d89622cd1ad

workflow graph env-wf3.cwl

https://github.com/common-workflow-language/cwl-v1.2.git

Path: tests/env-wf3.cwl

Branch/Commit ID: ea9f8634e41824ac3f81c3dde698d5f0eef54f1b

workflow graph count-lines3-wf.cwl

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

Path: cwltool/schemas/v1.0/v1.0/count-lines3-wf.cwl

Branch/Commit ID: e9c83739a93fa0b18f8dea2f98b632a9e32725c9

workflow graph fail-unconnected.cwl

https://github.com/common-workflow-language/cwl-v1.2.git

Path: tests/fail-unconnected.cwl

Branch/Commit ID: 1f3ef888d9ef2306c828065c460c1800604f0de4