[gmx-users] LINCS WARNING after good minimization and equilibration (NPT and NVT)

2011-03-07 Thread zeppelin zeppelin
Dear GROMACS users,
I only begin to work with gromacs and now have some problems with tetra
protein.
I used AMBER force field and made several changes (in ffamber.rtp,
specbond.dat, ffamber99bon.itp) to create an isopeptide bonds between
monomers.
Minimization and equilibration (NPT and NVT) were OK.
But in MD (1.2 ns) I met a problem:
__
Step 241687, time 483.374 (ps)  LINCS WARNING
relative constraint deviation after LINCS:
rms nan, max inf (between atoms 2431 and 2432)
bonds that rotated more than 30 degrees:
 atom 1 atom 2  angle  previous, current, constraint length
   2431   2432   90.00.1244  inf  0.1229
   2428   2430  113.10.1010 64418817769472.  0.1010
   2428   2429  105.70.1010 65196395593728.  0.1010
  .
t = 483.374 ps: Water molecule starting at atom 57549 can not be settled.
Check for bad contacts and/or reduce the timestep.
Wrote pdb files with previous and current coordinates
Segmentation fault

When I looked on step241686c.pdb in pymol, I found, that GLY that form one
of isopeptide bonds exploded (it's atoms were far from the water box).
I saw that a lot of people have a close problem, but usually they have it on
the first steps. Also in my case minimization and equilibration were OK. I
note some letters with the close problem, but I don't understand what to
start with in my case. I kindly ask you to give me an idea or a link to a
letter with the best solution.

Simulation is based on tutorial: Lysozyme in Water. Justin Lemkul

Thanks,
Yulian


HISTORY

   /gromacs-4.0.5/bin/pdb2gmx -f 3ALB_AMBER.pdb -o processed.gro -water
tip3p -missing -merge
   /gromacs-4.0.5/bin/editconf -f processed.gro -o newbox.gro -c -d 1.0 -bt
cubic
   /gromacs-4.0.5/bin/genbox -cp newbox.gro -cs spc216.gro -o solv.gro -p
topol.top
   /gromacs-4.0.5/bin/grompp -f ions.mdp -c solv.gro -p topol.top -o
ions.tpr
   /gromacs-4.0.5/bin/genion -s ions.tpr -o solv.gro -p topol.top -pname Na+
-np 24
   /gromacs-4.0.5/bin/grompp -f minim.mdp -c solv.gro -p topol.top -o em.tpr

   /gromacs-4.0.5/bin/mdrun -v -deffnm em
   vmd em.gro
   /gromacs-4.0.5/bin/g_energy -f em.edr -o potential.xvg
   xmgrace potential.xvg
   /gromacs-4.0.5/bin/grompp -f nvt.mdp -c em.gro -p topol.top -o nvt.tpr
   /gromacs-4.0.5/bin/mdrun -v -deffnm nvt
   /gromacs-4.0.5/bin/g_energy -f nvt.edr
   xmgrace nvt.edr
   xmgrace energy.xvg
   /gromacs-4.0.5/bin/grompp -f npt.mdp -c nvt.gro -t nvt.cpt -p topol.top
-o npt.tpr
   /gromacs-4.0.5/bin/mdrun -v -deffnm npt
   vmd npt.gro
   /gromacs-4.0.5/bin/g_energy -f npt.edr -o pressure.xvg
   xmgrace pressure.xvg
   /gromacs-4.0.5/bin/g_energy -f npt.edr -o density.xvg
   xmgrace density.xvg
   /gromacs-4.0.5/bin/grompp -f md.mdp -c npt.gro -t npt.cpt -p topol.top -o
md_2ns.tpr
   /gromacs-4.0.5/bin/mdrun -v -deffnm md_2ns


md.mdp

title= AMBER Ub_tetra48
; Run parameters
integrator= md; leap-frog integrator
nsteps= 60; 2 * 50 = 1000 ps, 1 ns
dt= 0.002; 2 fs
; Output control
nstxout= 1000; save coordinates every 2 ps
nstvout= 1000; save velocities every 2 ps
nstxtcout= 1000; xtc compressed trajectory output every 2 ps
nstenergy= 1000; save energies every 2 ps
nstlog= 1000; update log file every 2 ps
; Bond parameters
continuation= yes; Restarting after NPT
constraint_algorithm = lincs; holonomic constraints
constraints= all-bonds; all bonds (even heavy atom-H bonds)
constrained
lincs_iter= 1; accuracy of LINCS
lincs_order= 4; also related to accuracy
; Neighborsearching
ns_type= grid; search neighboring grid cells
nstlist= 5; 10 fs
rlist= 1.0; short-range neighborlist cutoff (in nm)
rcoulomb= 1.0; short-range electrostatic cutoff (in nm)
rvdw= 1.0; short-range van der Waals cutoff (in nm)
; Electrostatics
coulombtype= PME; Particle Mesh Ewald for long-range
electrostatics
pme_order= 4; cubic interpolation
fourierspacing= 0.16; grid spacing for FFT
; Temperature coupling is on
tcoupl= V-rescale; modified Berendsen thermostat
tc-grps= Protein Non-Protein; two coupling groups - more
accurate
tau_t= 0.10.1; time constant, in ps
ref_t= 300 300; reference temperature, one for each group,
in K
; Pressure coupling is on
pcoupl= Parrinello-Rahman; Pressure coupling on in NPT
pcoupltype= isotropic; uniform scaling of box vectors
tau_p= 2.0; time constant, in ps
ref_p= 1.0; reference pressure, in bar
compressibility = 4.5e-5; isothermal 

[gmx-users] isopeptide bond

2011-03-01 Thread zeppelin zeppelin
Dear GROMACS users,

I started to work with gromacs (version 4.0.5) only several weeks ago and I
need your help. Now I am trying to add a new *isopeptide bone* to connect
Lys and Gly (to make a dimer of *ubiquitin*). I use AMBER force field.

What I did:

1. Added new type of residues to ffamber.rtp

LIQ – LYN that is close enough to GLY (GLQ) to make an isopeptide bond.
Distance – 0.13

2. I added this line to specbond.dat:

LYN NZ 1 GLY C 1 0.13 LYQ GLQ

3. Added new bond type, angle type and dihedral type to ffamber99bon.itp:

For example:

[ angletypes ]

; i j k func   th0*cth*

HW OW HW 1 104.520 836.800 ; TIP3P water

HW HW OW 1 127.740 0.000 ; (found in crystallographic water with 3 bonds)

C C O 1 120.000 669.440 ; new99

.

new lines:

C CT N3 1 110.100 527.184 ; FOR UBIQ YULIANline 344

C N3 H 1 120.000 418.400 ; FOR UBIQ YULIAN

N3 C O 1 122.900 669.440 ; FOR UBIQ YULIAN

CT C N3 1 116.600 585.760 ; FOR UBIQ YULIAN

C N3 CT 1 121.900 418.400 ; FOR UBIQ YULIAN

C N3 H 1 120.000 418.400 ; FOR UBIQ YULIAN


 Here I added a new angle types just by copying a close type of angle in
simple peptide bone and changing N to N3 (for isopeptide bone)

4. But in ffamber99.atp one can found that these atoms are different (sp2
and sp3 type of hybridization):

amber99_34 14.01000 ; N sp2 nitrogen in amide groups

amber99_39 14.01000 ; N3 sp3 N for charged amino groups (Lys, etc)

5. I checked in PyMol the real value of different angles in isopeptide bond
and found, of course, that they are differ from angles in simple peptide
bond.

6. So when I change N to N3 I did not get a real isippeptide bone. And
my *question
*is: How to make a new isopeptide bone with correct value of angles and
dihedrals. I can simply change the value of angle (by measuring in pymol),
but I do not know what is *cth * in [ angletypes ] section of
ffamber99bon.itp and how to change it correctly.

P. S. After this change I have such a warning in gromacs runnings

WARNING 1 [file ffamber99bon.itp, line 344]:

Overriding Angle parameters.

old: 111.2 669.44 111.2 669.44

new: C CT N3 1 110.100 527.184

What does it really mean (during editing ffamber99bon.itp I just added
several lines and did not remove anything)?

Sincerely,

Yulian Gavrilov
-- 
gmx-users mailing listgmx-users@gromacs.org
http://lists.gromacs.org/mailman/listinfo/gmx-users
Please search the archive at 
http://www.gromacs.org/Support/Mailing_Lists/Search before posting!
Please don't post (un)subscribe requests to the list. Use the 
www interface or send it to gmx-users-requ...@gromacs.org.
Can't post? Read http://www.gromacs.org/Support/Mailing_Lists