Dear all,<div><br></div><div>Zephyr (<a href="https://simtk.org/home/zephyr">https://simtk.org/home/zephyr</a>) is released, although only for Mac and Windows so far, and it comes with examples, pretty neat.</div><div><br>

</div><div>Even though there&#39;s some apparently fixes compared to the usual release of openmm and gromacs-openmm, my molecule didn&#39;t work with it yet.</div><div><br></div><div>Nevertheless, for those with nvidia cuda and Mac or Windows, it&#39;s worth trying.</div>

<div><br></div><div>Cheers,</div><div>Alan<br><br><div class="gmail_quote">On Sat, Jul 18, 2009 at 18:31, Alan <span dir="ltr">&lt;<a href="mailto:alanwilter@gmail.com">alanwilter@gmail.com</a>&gt;</span> wrote:<br><blockquote class="gmail_quote" style="margin:0 0 0 .8ex;border-left:1px #ccc solid;padding-left:1ex;">

Thanks Justin.<br>
<br>
I could swear I tried what you said... anyway it worked now (2.5 x<br>
faster), but not with implicit solvent for mdrun-openmm... Trying with<br>
plain mdrun with the setup for implicit solvent and it seemed to work<br>
(although I don&#39;t know how to interpret this from<br>
GromacsOpenMMPreview3-Mac/Gromacs-OpenMM Readme.txt file: &quot;even though<br>
this is not available in the standard Gromacs 4&quot;)<br>
<br>
I still would like an example/tutorial that really worked for someone<br>
with gmx openmm.<br>
<br>
In the end, with mdrun-openmm and implicit solvent in the mdp file, I<br>
got a file md.gro full of &quot;nan     nan&quot;.<br>
<br>
For those interested, here are the commands I did. If you have GMX<br>
with ffamber, CUDA and GMX-openmm you may reproduce it.<br>
<br>
###############################<br>
<br>
cat &lt;&lt; EOF &gt;| em.mdp<br>
define                   = -DFLEXIBLE<br>
integrator               = cg ; steep<br>
nsteps                   = 200<br>
constraints              = none<br>
emtol                    = 1000.0<br>
nstcgsteep               = 10 ; do a steep every 10 steps of cg<br>
emstep                   = 0.01 ; used with steep<br>
nstcomm                  = 1<br>
coulombtype              = Reaction-Field<br>
ns_type                  = simple<br>
rlist                    = 1.2<br>
<div class="im">rcoulomb                 = 1.2<br>
rvdw                     = 1.2<br>
vdwtype                  = cut-off<br>
</div>Tcoupl                   = no<br>
Pcoupl                   = no<br>
gen_vel                  = no<br>
nstxout                  = 0 ; write coords every # step<br>
epsilon_rf               = 0<br>
pbc = no<br>
EOF<br>
<br>
cat &lt;&lt; EOF &gt;| md.mdp<br>
<div class="im">integrator               = md<br>
nsteps                   = 1000<br>
dt                       = 0.002<br>
constraints              = all-bonds<br>
nstcomm                  = 1<br>
ns_type                  = simple<br>
</div>rlist                    = 1.2<br>
<div class="im">rcoulomb                 = 1.2<br>
rvdw                     = 1.2<br>
vdwtype                  = cut-off<br>
coulombtype              = Reaction-Field<br>
epsilon_rf               = 0<br>
Tcoupl                   = no<br>
Pcoupl                   = no<br>
gen_vel                  = yes<br>
nstxout                  = 2 ; write coords every # step<br>
lincs-iter               = 2<br>
pbc = no<br>
</div>comm_mode = ANGULAR<br>
; uncomment below to test with implicit solvent<br>
;implicit_solvent = GBSA<br>
<div class="im">;gb_algorithm = OBC<br>
;gb_epsilon_solvent = 78.3<br>
</div>EOF<br>
<br>
wget -c &quot;<a href="http://www.pdb.org/pdb/download/downloadFile.do?fileFormat=pdb&amp;compression=NO&amp;structureId=1BVG" target="_blank">http://www.pdb.org/pdb/download/downloadFile.do?fileFormat=pdb&amp;compression=NO&amp;structureId=1BVG</a>&quot;<br>


-O 1BVG.pdb<br>
grep &#39;ATOM  &#39; 1BVG.pdb&gt;| Protein.pdb<br>
grep &#39;HETATM&#39; 1BVG.pdb&gt;| Ligand.pdb<br>
<br>
sed s/PRO\ A\ \ \ 1/NPROA\ \ \ 1/g Protein.pdb | sed s/PRO\ B\ \ \<br>
1/NPROB\ \ \ 1/g \<br>
| sed s/PHE\ A\ \ 99/CPHEA\ \ 99/g | sed s/PHE\ B\ \ 99/CPHEB\ \ 99/g \<br>
| sed s/O\ \ \ CPHE/OC1\ CPHE/g | sed s/OXT\ CPHE/OC2\ CPHE/g \<br>
| sed s/HIS\ /HID\ /g | sed s/LYS\ /LYP\ /g | sed s/CYS\ /CYN\ /g &gt;|<br>
ProteinAmber.pdb<br>
<br>
# Process with pdb2gmx and define water<br>
pdb2gmx -ff amber99sb -f ProteinAmber.pdb -o Protein2.pdb -p Protein.top -ignh<br>
<br>
grompp -f em.mdp -c Protein2.pdb -p Protein.top -o em.tpr<br>
mdrun -v -deffnm em<br>
<br>
grompp -f md.mdp -c em.gro -p Protein.top -o md.tpr<br>
mdrun -v -deffnm md<br>
<br>
vmd md.gro md.trr # OK<br>
<br>
mdrun-openmm -v -deffnm md<br>
# 3 times fater<br>
# works fine without set for implicit solvent in md.mdp<br>
# with implicit solvent, md.gro full of nan nan nan everywhere.<br>
<br>
###############################<br>
<div><div></div><div class="h5"><br>
On Sat, Jul 18, 2009 at 17:31, Alan&lt;<a href="mailto:alanwilter@gmail.com">alanwilter@gmail.com</a>&gt; wrote:<br>
&gt; Ok, I tried.<br>
&gt;<br>
&gt; Can someone tell how to have in a mdp file this combination (in order<br>
&gt; to satisfy gromacs openmm) without raising a error in grompp?<br>
&gt;<br>
&gt; ns_type = simple<br>
&gt; pbc = no<br>
&gt; coulombtype = Reaction-Field<br>
&gt;<br>
&gt; Whatever I try I get:<br>
&gt;<br>
&gt; ERROR: Twin-range neighbour searching (NS) with simple NS algorithm<br>
&gt; not implemented<br>
&gt;<br>
&gt; My full md.mdp file is:<br>
&gt; integrator               = md<br>
&gt; nsteps                   = 1000<br>
&gt; dt                       = 0.002<br>
&gt; constraints              = all-bonds<br>
&gt; nstcomm                  = 1<br>
&gt; ns_type                  = simple<br>
&gt; rlist                    = 1.0<br>
&gt; rcoulomb                 = 1.2<br>
&gt; rvdw                     = 1.2<br>
&gt; vdwtype                  = cut-off<br>
&gt; coulombtype              = Reaction-Field<br>
&gt; epsilon_rf               = 0<br>
&gt; Tcoupl                   = no<br>
&gt; Pcoupl                   = no<br>
&gt; gen_vel                  = yes<br>
&gt; nstxout                  = 2 ; write coords every # step<br>
&gt; lincs-iter               = 2<br>
&gt; pbc = no<br>
&gt; implicit_solvent = GBSA<br>
&gt; gb_algorithm = OBC<br>
&gt; gb_epsilon_solvent = 78.3<br>
&gt; comm_mode = ANGULAR<br>
&gt;<br>
&gt;<br>
&gt; Many thanks in advance,<br>
&gt;<br>
&gt; Alan<br>
&gt;<br>
&gt;<br>
&gt;<br>
&gt; On Sat, Jul 18, 2009 at 11:35, Alan&lt;<a href="mailto:alanwilter@gmail.com">alanwilter@gmail.com</a>&gt; wrote:<br>
&gt;&gt; Dear Mark,<br>
&gt;&gt;<br>
&gt;&gt; Thanks. I reread those file carefully and noticed the &quot;only implicit<br>
&gt;&gt; solvent&quot;. Sorry for that. I am building my test case here to see by<br>
&gt;&gt; myself how fast it can be.<br>
&gt;&gt;<br>
&gt;&gt; Alan<br>
&gt;&gt;<br>
&gt;&gt;<br>
&gt;&gt; On Sat, Jul 18, 2009 at 11:00, &lt;<a href="mailto:gmx-users-request@gromacs.org">gmx-users-request@gromacs.org</a>&gt; wrote:<br>
&gt;&gt;<br>
&gt;&gt;&gt; Alan wrote:<br>
&gt;&gt;&gt;&gt; Hi list, does anyone have an example (input pdb, gmx commands and<br>
&gt;&gt;&gt;&gt; md.mdp for example) to test gromacs with and without openmm?<br>
&gt;&gt;&gt;&gt;<br>
&gt;&gt;&gt;&gt; The case I use here (with explicit water) didn&#39;t show me any speed up<br>
&gt;&gt;&gt;&gt; (comparing with mpirun -c 2 mdrun_mpi...).<br>
&gt;&gt;&gt;&gt;<br>
&gt;&gt;&gt;&gt; I am using Mac Leopard 10.5.7 with Cuda drivers and gromacs 4.0.5<br>
&gt;&gt;&gt;<br>
&gt;&gt;&gt; This would be expected if you read the OpenMM README.... or see<br>
&gt;&gt;&gt; <a href="http://oldwiki.gromacs.org/index.php/OpenMM_GROMACS" target="_blank">http://oldwiki.gromacs.org/index.php/OpenMM_GROMACS</a><br>
&gt;&gt;&gt;<br>
&gt;&gt;&gt; Mark<br>
&gt;&gt; --<br>
&gt;&gt; Alan Wilter S. da Silva, D.Sc. - CCPN Research Associate<br>
&gt;&gt; Department of Biochemistry, University of Cambridge.<br>
&gt;&gt; 80 Tennis Court Road, Cambridge CB2 1GA, UK.<br>
&gt;&gt;&gt;&gt;<a href="http://www.bio.cam.ac.uk/~awd28" target="_blank">http://www.bio.cam.ac.uk/~awd28</a>&lt;&lt;<br>
&gt;&gt;<br>
&gt;<br>
&gt;<br>
&gt;<br>
&gt; --<br>
&gt; Alan Wilter S. da Silva, D.Sc. - CCPN Research Associate<br>
&gt; Department of Biochemistry, University of Cambridge.<br>
&gt; 80 Tennis Court Road, Cambridge CB2 1GA, UK.<br>
&gt;&gt;&gt;<a href="http://www.bio.cam.ac.uk/~awd28" target="_blank">http://www.bio.cam.ac.uk/~awd28</a>&lt;&lt;<br>
&gt;<br>
<br>
<br>
<br>
</div></div>--<br>
<div><div></div><div class="h5">Alan Wilter S. da Silva, D.Sc. - CCPN Research Associate<br>
Department of Biochemistry, University of Cambridge.<br>
80 Tennis Court Road, Cambridge CB2 1GA, UK.<br>
&gt;&gt;<a href="http://www.bio.cam.ac.uk/~awd28" target="_blank">http://www.bio.cam.ac.uk/~awd28</a>&lt;&lt;<br>
</div></div></blockquote></div><br><br clear="all"><br>-- <br>Alan Wilter S. da Silva, D.Sc. - CCPN Research Associate<br>Department of Biochemistry, University of Cambridge.<br>80 Tennis Court Road, Cambridge CB2 1GA, UK.<br>

&gt;&gt;<a href="http://www.bio.cam.ac.uk/~awd28">http://www.bio.cam.ac.uk/~awd28</a>&lt;&lt;<br>
</div>