Script

Tutorial

Here is an example of a short simulation of the SH3 domain of phospholipase Cγ1. Seven successive steps are used:

  1. Topologie creation using create_top.py.

  2. Minimisation of the structure using minimize_pdb.py.

  3. Solvation of the system using solvate_ions.py.

  4. Minimisation of the system using minimize_pdb.py.

  5. Equilibration of the system using equi_3_step.py.

  6. Production run using production.py.

  7. Extension of the production run using extend.py.

# Create topologie
create_top.py -f gromacs_py/test_files/1y0m.pdb -o tmp/1y0m/top -vsite

# Minimize the protein structure
minimize_pdb.py -f tmp/1y0m/top/1y0m_pdb2gmx_box.pdb -p tmp/1y0m/top/1y0m_pdb2gmx.top -o tmp/1y0m/em/  -n em_1y0m -nt 2

# Add water and ions
solvate_ions.py -f tmp/1y0m/em/em_1y0m_compact.pdb -p tmp/1y0m/top/1y0m_pdb2gmx.top -o tmp/1y0m_water_ions/top/  -n 1y0m_water_ions

# Minimize the system
minimize_pdb.py -f tmp/1y0m_water_ions/top/1y0m_water_ions_water_ion.gro -p tmp/1y0m_water_ions/top/1y0m_water_ions_water_ion.top -o tmp/1y0m_water_ions/em/  -n em_1y0m

# Do three small equilibrations with postion contraints on heavy atoms (first), Carbon alpha (second) and low constraint on Carbon alpha (third)
equi_3_step.py -f tmp/1y0m_water_ions/em/em_1y0m_compact.pdb -p tmp/1y0m_water_ions/top/1y0m_water_ions_water_ion.top -o tmp/1y0m_water_ions/  -n 1y0m -HA_time 0.1 -dt_HA 0.002 -CA_time 0.1 -CA_LOW_time 0.1 -dt 0.004 -maxwarn 1

# Small production run of 0.1 ns
production.py -f tmp/1y0m_water_ions/02_equi_CA_LOW/equi_CA_LOW_1y0m.gro -p tmp/1y0m_water_ions/top/1y0m_water_ions_water_ion.top -o tmp/1y0m_water_ions/03_prod -n 1y0m -time 0.1 -dt 0.004 -maxwarn 1

# Extension of the simulation
extend.py -s tmp/1y0m_water_ions/03_prod/prod_1y0m.tpr -time 0.2

# Remove simulation files
rm -r ./tmp

Or simply use one command to do all previous commands:

top_em_equi_3_step_prod.py -f gromacs_py/test/input/1y0m.pdb -o tmp/1y0m -vsite -HA_time 0.1 -CA_time 0.1 -CA_LOW_time 0.1 -prod_time 0.3

Simulation:

Energy minimization

Minimize a pdb structure in 2 steps,the first step without bonds constraints and the second step with

usage: minimize_pdb.py [-h] -f F -p P -o O -n NAME [-m_steps MIN_STEPS]
                       [-box BOX] [-nt NT] [-ntmpi NTMPI] [-gpu_id GPUID]

Named Arguments

-f

Input PDB file

-p

Topologie in gromacs format .top

-o

Output Directory

-n

Output file name

-m_steps

Minimisation nsteps, default=1000

-box

Create a box, default=False

-nt

Total number of threads to start, default=0

-ntmpi

Number of thread-MPI threads to start, default=0

-gpu_id

List of GPU device id-s to use, default=””

Equilibration

Equilibrate in 3 steps a system (coor+top), (i) first equilibration with heavy atoms position restraints, (ii) second equilibration with alpha carbon position restraints and (iii) finaly equilibration with weak alpha carbon position restraints

usage: equi_3_step.py [-h] -f F -p P -o O -n NAME [-HA_time HA_TIME]
                      [-CA_time CA_TIME] [-CA_LOW_time CA_LOW_TIME]
                      [-dt_HA DT_HA] [-dt DT] [-maxwarn MAXWARN] [-nt NT]
                      [-ntmpi NTMPI] [-gpu_id GPUID]

Named Arguments

-f

Input PDB file

-p

Topologie in gromacs format .top

-o

Output Directory

-n

Output file name

-HA_time

Equilibration with HA constraint time(ns), default = 0.25ns

-CA_time

Equilibration with HA constraint time(ns), default = 1ns

-CA_LOW_time

Equilibration with HA constraint time(ns), default = 5ns

-dt_HA

Equi HA dt, default=0.002 (2 fs)

-dt

Equi CA, CA_LOW, dt, default=0.002 (2 fs)

-maxwarn

Total number of warnings allowed for the equilibration, default=0

-nt

Total number of threads to start, default=0

-ntmpi

Number of thread-MPI threads to start, default=0

-gpu_id

List of GPU device id-s to use, default=””

Production

Simulation production

usage: production.py [-h] -f F -p P -o O -n NAME [-time TIME] [-dt DT]
                     [-maxwarn MAXWARN] [-nt NT] [-ntmpi NTMPI]
                     [-gpu_id GPUID]

Named Arguments

-f

Input PDB file

-p

Topologie in gromacs format .top

-o

Output Directory

-n

Output file name

-time

Production time, default=10

-dt

Equilibration dt, default=0.002 (2 fs)

-maxwarn

Total number of warnings allowed for the equilibration, default=0

-nt

Total number of threads to start, default=0

-ntmpi

Number of thread-MPI threads to start, default=0

-gpu_id

List of GPU device id-s to use, default=””