GROMACS version:
GROMACS modification: Yes/No
Here post your question
I am trying to simulate a protein having 2 chains. I have used Charmm 36 forcefield and following is the em.mdp parameters that i am using for minimization.
integrator = steep
emstep = 0.001 ; Minimization step size
nsteps = 40000 ; Maximum number of (minimization) steps to perform
; Output control
nstxout = 250 ; save coordinates every 1 ps
nstvout = 250 ; save velocities every 1 ps
nstenergy = 250 ; save energies every 1 ps
nstlog = 250 ; update log file every 1 ps
; Parameters describing how to find the neighbors of each atom and how to calculate the interactions
nstlist = 1 ; Frequency to update the neighbor list and long range forces
cutoff-scheme = Verlet ; Buffered neighbor searching
ns_type = grid ; Method to determine neighbor list (simple, grid)
coulombtype = PME ; Treatment of long range electrostatic interactions
rcoulomb = 1.0 ; Short-range electrostatic cut-off
rvdw = 1.0 ; Short-range Van der Waals cut-off
pbc = xyz ; Periodic Boundary Conditions in all 3 dimensions
i am getting this error "Energy minimization has stopped, but the forces have not converged to the
requested precision Fmax < 10 (which may not be possible for your system). It
stopped because the algorithm tried to make a new step whose size was too
small, or there was no change in the energy since last step. Either way, we
regard the minimization as converged to within the available machine
precision, given your starting configuration and EM parameters.
Double precision normally gives you higher accuracy, but this is often not
needed for preparing to run molecular dynamics.
Steepest Descents converged to machine precision in 19223 steps,
but did not reach the requested Fmax < 10.
Potential Energy = -2.3072438e+06
Maximum force = 1.4922278e+02 on atom 1008
Norm of force = 2.2953074e+00
D O M A I N D E C O M P O S I T I O N S T A T I S T I C S
av. #atoms communicated per step for force: 2 x 203895.7
" . i have even tried multiple values for emsteps. have even used CG algorithm . how to resolve it? I really want the energy minimization of 40 ps.