Dear All,<br><br>I am trying to equilibrate in NVT ensemble of a peptide with glycolipid (GL) molecules in a cubic box filled with TIP3P water (from Mackerell et al.). The force field for GL were converted to GROMACS format from CHARMM27 force field with additional parameters non present in the forcefield added in lipids.rtp, ffbonded.itp and ffnonboded.itp files. <br>
<br>I use the git version of GMX4.5.1 downloaded yesterday.<br><br>I can minimize successfully the system with the following em.mdp before to perform the nvt run <br><br>------- em.mdp<br><br>title                    = Glyco + peptide in water<br>
; Preprocessor - specify a full path if necessary.<br>cpp                      = cpp<br>include                  = -I../top<br>define                   = -DFLEXIBLE<br>integrator              = steep<br>;nstcgsteep              = 10000<br>
emstep                  = 0.01<br>emtol                   = 400.0<br>;dt                     = 0.002<br>pbc                     = xyz<br>nsteps                  = 10000<br>nstlist                 = 1<br>ns_type                 = grid<br>
vdw-type                = Cut-off      ; twin range cut-off’s with neighbor list<br>rlistlong               = 1.0<br>coulombtype             = PME<br>rcoulomb                = 1.0<br>rvdw                    = 1.2<br>;fourierspacing         = 0.12<br>
;pme_order              = 4<br>;ewald_rtol             = 1e-05<br>;optimize_fft           = yes<br><br><br>I obtained the final energies :<br><br>   Energies (kJ/mol)<br>           Bond          Angle            U-B    Proper Dih.  Improper Dih.<br>
    3.65918e+04    1.86096e+04    6.02333e+03    3.68911e+04    8.61501e+00<br>      CMAP Dih.          LJ-14     Coulomb-14        LJ (SR)        LJ (LR)<br>   -1.31952e+02    1.17641e+04    1.76586e+05    1.84759e+05   -1.92541e+03<br>
   Coulomb (SR)   Coul. recip.      Potential Pressure (bar)<br>   -1.26284e+06   -1.61597e+05   -9.55265e+05    0.00000e+00<br><br><br>Steepest Descents converged to Fmax &lt; 400 in 518 steps<br>Potential Energy  = -9.5526519e+05<br>
Maximum force     =  3.7991144e+02 on atom 313<br>Norm of force     =  9.2632399e+00<br><br>When I try to do the NVT equilibration step at 300 K with the following nvt.mdp, the simulation crashed quickly (app. after 20 ps of run) with several LINCS warnings for TIP3 water atoms <br>
<br>------- nvt.mdp<br>title           = Glyco + peptide in water<br>define          = -DPOSRES      ; position restrain for the peptide<br>; Run parameters<br>integrator      = md            ; leap-frog integrator<br>nsteps          = 24000         ; 2 * 50000 = 100 ps<br>
; to test <br>dt              = 0.001         ; 2 fs<br>; Output control<br>nstxout         = 1000          ; save coordinates every 0.2 ps<br>nstvout         = 10000         ; save velocities every 0.2 ps<br>nstenergy       = 10000         ; save energies every 0.2 ps<br>
nstlog          = 100           ; update log file every 0.2 ps<br>energygrps      = Protein Non-Protein<br>; Bond parameters<br>continuation    = no            ; first dynamics run<br>constraint_algorithm = lincs    ; holonomic constraints<br>
constraints     = all-bonds     ; all bonds (even heavy atom-H bonds) constrained<br>lincs_iter      = 1             ; accuracy of LINCS<br>lincs_order     = 4             ; also related to accuracy<br>; Neighborsearching<br>
ns_type         = grid          ; search neighboring grid cels<br>nstlist         = 5             ; 10 fs<br>vdw-type        = Cut-off       ; twin range cut-off’s with neighbor list<br>rlistlong       = 1.0           ; short-range neighborlist cutoff (in nm)<br>
rcoulomb        = 1.0           ; short-range electrostatic cutoff (in nm)<br>rvdw            = 1.2           ; short-range van der Waals cutoff (in nm)<br>; Electrostatics<br>coulombtype     = PME           ; Particle Mesh Ewald for long-range electrostatics<br>
pme_order       = 4             ; cubic interpolation<br>fourierspacing  = 0.12  ; grid spacing for FFT<br>; Temperature coupling is on<br>tcoupl          = V-rescale     ; modified Berendsen thermostat<br>tc-grps         = Protein Non-Protein   ; one coupling groups - more accurate<br>
tau_t           = 0.1 0.1       ; time constant, in ps<br>ref_t           = 300 300       ; reference temperature, one for each group, in K<br>; Pressure coupling is off<br>pcoupl          = no            ; no pressure coupling in NVT<br>
; Periodic boundary conditions<br>pbc             = xyz               ; 3-D PBC<br>; Dispersion correction<br>DispCorr        = EnerPres      ; account for cut-off vdW scheme<br>; Velocity generation<br>gen_vel         = yes           ; assign velocities from Maxwell distribution<br>
gen_temp        = 300           ; temperature for Maxwell distribution<br>gen_seed        = -1            ; generate a random seed<br><br>----- Here the message obtained<br><br>step 1499: Water molecule starting at atom 47947 can not be settled.<br>
Check for bad contacts and/or reduce the timestep if appropriate.<br>Wrote pdb files with previous and current coordinates<br><br>Step 1500:<br>The charge group starting at atom 36 moved than the distance allowed by the domain decomposition (1.200000) in direction Y<br>
distance out of cell -14795603.000000<br>Old coordinates:    5.159    5.115    3.453<br>New coordinates: 8325234.000 -14795599.000    3.894<br>Old cell boundaries in direction Y:    4.371    9.400<br>New cell boundaries in direction Y:    4.370    9.400<br>
<br>Step 1500:<br>The charge group starting at atom 47947 moved than the distance allowed by the domain decomposition (1.200000) in direction Y<br>distance out of cell 19727472.000000<br>Old coordinates:    5.530    4.419    2.912<br>
New coordinates: -11100299.000 19727476.000    5.506<br>Old cell boundaries in direction Y:    0.000    4.579<br>New cell boundaries in direction Y:    0.000    4.585<br><br>--------- <br><br>I aware that these errors are probably caused by a system not well equilibrated but since the Steepest Descents minimization are well converged, i am puzzled for the NVT simulation. I have checked the parameters of the force field and for me they are corrects, tried several protocols (reduce the time step (2 -&gt;1 fs, above, lower the temperature, or increase the number of minimization steps, etc.) with no success. <br>
<br>Any advices will be greatly appreciated.<br><br>Thank you for your help.<br><br>sa<br>