[gmx-users] Shake constraint problem

Attila Borics aborics at bif12.creighton.edu
Wed Oct 16 21:55:39 CEST 2002


Hi!

I try simulate a 4-residue peptide with oplsaa, using tip4p, tip3p and
spc water model.
In all cases my postion-restraint dynamics stops with the following
error message: (prlog0.log)

Constraint error in algorithm Shake at step 2449
Fatal error: ci = -2147483648 should be in 0 .. 63 [FILE nsgrid.c, LINE
210]


Here's my *.mdp. Everything was working fine for this system when using
gromos96. Do I need to change something, use settle, etc.
If I need to use settle, how can I do that?


; VARIOUS PREPROCESSING OPTIONS = 
title                    = NPGQ
cpp                      = /lib/cpp
include                  = 
define                   = 

; RUN CONTROL PARAMETERS = 
integrator               = md
; start time and timestep in ps = 
tinit                    = 0.0
dt                       = 0.002
nsteps                   = 5000
; number of steps for center of mass motion removal = 
nstcomm                  = 1
comm-grps                = 

; LANGEVIN DYNAMICS OPTIONS = 
; Temperature, friction coefficient (amu/ps) and random seed = 
bd-temp                  = 300
bd-fric                  = 0
ld-seed                  = 1993

; ENERGY MINIMIZATION OPTIONS = 
; Force tolerance and initial step-size = 
emtol                    = 100
emstep                   = 0.01
; Max number of iterations in relax_shells = 
niter                    = 20
; Frequency of steepest descents steps when doing CG = 
nstcgsteep               = 1000

; OUTPUT CONTROL OPTIONS = 
; Output frequency for coords (x), velocities (v) and forces (f) = 
nstxout                  = 100
nstvout                  = 500
nstfout                  = 0
; Output frequency for energies to log file and energy file = 
nstlog                   = 100
nstenergy                = 500
; Output frequency and precision for xtc file = 
nstxtcout                = 250
xtc-precision            = 1000
; This selects the subset of atoms for the xtc file. You can = 
; select multiple groups. By default all atoms will be written. = 
xtc-grps                 = 
; Selection of energy groups = 
energygrps               = Protein  SOL

; NEIGHBORSEARCHING PARAMETERS = 
; nblist update frequency = 
nstlist                  = 10
; ns algorithm (simple or grid) = 
ns_type                  = grid
; Periodic boundary conditions: xyz or no = 
pbc                      = xyz
; nblist cut-off         = 
rlist                    = 1.0
domain-decomposition     = no

; OPTIONS FOR ELECTROSTATICS AND VDW = 
; Method for doing electrostatics = 
coulombtype              = reaction-field
rcoulomb-switch          = 0
rcoulomb                 = 1.5
; Dielectric constant (DC) for cut-off or DC of reaction field = 
epsilon_r                = 78
; Method for doing Van der Waals = 
vdwtype                  = cut-off
; cut-off lengths        = 
rvdw-switch              = 0
rvdw                     = 1.4
; Apply long range dispersion corrections for Energy and Pressure = 
DispCorr                 = No
; Spacing for the PME/PPPM FFT grid = 
fourierspacing           = 0.12
; FFT grid size, when a value is 0 fourierspacing will be used = 
fourier_nx               = 0
fourier_ny               = 0
fourier_nz               = 0
; EWALD/PME/PPPM parameters = 
pme_order                = 4
ewald_rtol               = 1e-05
epsilon_surface          = 0
optimize_fft             = no

; OPTIONS FOR WEAK COUPLING ALGORITHMS = 
; Temperature coupling   = 
Tcoupl                   = Berendsen
; Groups to couple separately = 
tc-grps                  = Protein	SOL
; Time constant (ps) and reference temperature (K) = 
tau_t                    = 0.1	0.1
ref_t                    = 300	300
; Pressure coupling      = 
Pcoupl                   = no
Pcoupltype               = Isotropic
; Time constant (ps), compressibility (1/bar) and reference P (bar) = 
tau_p                    = 0.5
compressibility          = 4.5e-5
ref_p                    = 1.0

; SIMULATED ANNEALING CONTROL = 
annealing                = no
; Time at which temperature should be zero (ps) = 
zero-temp_time           = 0

; GENERATE VELOCITIES FOR STARTUP RUN = 
gen_vel                  = yes
gen_temp                 = 300.0
gen_seed                 = 173529

; OPTIONS FOR BONDS     = 
constraints              = all-bonds
; Type of constraint algorithm = 
constraint_algorithm     = shake
; Do not constrain the start configuration = 
unconstrained_start      = yes
; Relative tolerance of shake = 
shake-tol                = 1e-04
; Highest order in the expansion of the constraint coupling matrix = 
lincs-order              = 4
; Lincs will write a warning to the stderr if in one step a bond = 
; rotates over more degrees than = 
lincs-warnangle          = 30
; Convert harmonic bonds to morse potentials = 
morse                    = no

; ENERGY GROUP EXCLUSIONS = 
; Pairs of energy groups for which all non-bonded interactions are
excluded = 
energygrp_excl           = 

; NMR refinement stuff  = 
; Distance restraints type: No, Simple or Ensemble = 
disre                    = No
; Force weighting of pairs in one distance restraint: Equal or
Conservative = 
disre-weighting          = Equal
; Use sqrt of the time averaged times the instantaneous violation = 
disre-mixed              = no
disre-fc                 = 1000
disre-tau                = 0
; Output frequency for pair distances to energy file = 
nstdisreout              = 100

; Free energy control stuff = 
free-energy              = no
init-lambda              = 0
delta-lambda             = 0
sc-alpha                 = 0
sc-sigma                 = 0.3

; Non-equilibrium MD stuff = 
acc-grps                 = 
accelerate               = 
freezegrps               = 
freezedim                = 
cos-acceleration         = 0

; Electric fields       = 
; Format is number of terms (int) and for all terms an amplitude (real)
= 
; and a phase angle (real) = 
E-x                      = 
E-xt                     = 
E-y                      = 
E-yt                     = 
E-z                      = 
E-zt                     = 

; User defined thingies = 
user1-grps               = 
user2-grps               = 
userint1                 = 0
userint2                 = 0
userint3                 = 0
userint4                 = 0
userreal1                = 0
userreal2                = 0
userreal3                = 0
userreal4                = 0


Thanks a lot!

Attila



More information about the gromacs.org_gmx-users mailing list