PerMedCoE Covid19 Pilot workflow (Nextflow)

public public 1yr ago Version: Version 1 0 bookmarks

COVID-19 Multiscale Modelling of the Virus and Patients’ Tissue Workflow

Description

Uses multiscale simulations to predict patient-specific SARS‑CoV‑2 severity subtypes (moderate, severe or control), using single-cell RNA-Seq data, MaBoSS and PhysiBoSS. Boolean models are used to determine the behaviour of individual agents as a function of extracellular conditions and the concentration of different substrates, including the number of virions. Predictions of severity subtypes are based on a meta-analysis of personalised model outputs simulating cellular apoptosis regulation in epithelial cells infected by SARS‑CoV‑2.

The workflow uses the following building blocks, described in order of execution:

  1. High-throughput mutant analysis
  2. Single-cell processing
  3. Personalise patient
  4. PhysiBoSS
  5. Analysis of all simulations

Code Snippets

34
35
36
"""
sed  's/\t/,/g' $meta_tsv > "meta.csv" 
"""
46
47
48
"""
MaBoSS_BB -d --model epithelial_cell_2 --data_folder ${params.data_dir} --parallel ${task.cpus} --ko_file ko_file.txt
"""
58
59
60
61
"""
mkdir result
single_cell_processing_BB -d --p_id ${p_id} --p_group ${group} --p_file ${sample_file} --parallelize ${task.cpus} --norm_data result/norm_data.tsv --raw_data result/raw_data.tsv --scaled_data result/scaled_data.tsv --cells_metadata result/cells_metadata.tsv --outdir images
"""
71
72
73
"""
personalize_patient_BB -d --norm_data ${res_dir}/norm_data.tsv --cells ${res_dir}/cells_metadata.tsv --model_prefix ${params.model_prefix} --t ${params.cell_type} --ko $ko --model_output_dir \$PWD/model --personalized_result personal 
"""
83
84
85
"""
PhysiBoSS_BB -d --sample $p_id --repetition $rep --prefix $cfg_file.baseName --bnd_file $bnd_file --cfg_file $cfg_file --parallel ${task.cpus} --max_time ${params.max_time} --out_file physiboss.out --err_file physiboss.err --results_dir \$PWD/${p_id}_${cfg_file.baseName}_physiboss_run_${rep}
"""
101
102
103
104
105
106
107
108
109
110
111
"""

ids=(\$(ls -1 | grep epithelial_cell_2 | cut -d '_' -f1 | sort | uniq ))
for i in "\${ids[@]}"; do
    mkdir -p \$i/physiboss_results
    mv \${i}_* \$i/physiboss_results
    rename \${i}_ "" \$i/physiboss_results/*
done

meta_analysis_BB -d --meta_file $params.meta_file --out_dir \$PWD --model_prefix ${params.model_name} --ko_file $ko --reps $params.repetitions --verbose 0 --results \$PWD/meta_res
"""
ShowHide 4 more snippets with no or duplicated tags.

Login to post a comment if you would like to share your experience with this workflow.

Do you know this workflow well? If so, you can request seller status , and start supporting this workflow.

Free

Created: 1yr ago
Updated: 1yr ago
Maitainers: public
URL: https://github.com/PerMedCoE/covid-19-workflow.git
Name: permedcoe-covid19-pilot-workflow-nextflow
Version: Version 1
Badge:
workflow icon

Insert copied code into your website to add a link to this workflow.

Downloaded: 0
Copyright: Public Domain
License: None
  • Future updates

Related Workflows

cellranger-snakemake-gke
snakemake workflow to run cellranger on a given bucket using gke.
A Snakemake workflow for running cellranger on a given bucket using Google Kubernetes Engine. The usage of this workflow ...