<br><br>
<div class="gmail_quote">On Thu, Mar 8, 2012 at 2:18 PM, Justin A. Lemkul <span dir="ltr">&lt;<a href="mailto:jalemkul@vt.edu">jalemkul@vt.edu</a>&gt;</span> wrote:<br>
<blockquote style="BORDER-LEFT:#ccc 1px solid;MARGIN:0px 0px 0px 0.8ex;PADDING-LEFT:1ex" class="gmail_quote">
<div class="HOEnZb">
<div class="h5"><br><br>Steven Neumann wrote:<br>
<blockquote style="BORDER-LEFT:#ccc 1px solid;MARGIN:0px 0px 0px 0.8ex;PADDING-LEFT:1ex" class="gmail_quote">Dear Gmx Users, Dear Justin,<br> I pulled my ligand away from my protein. Ligand was attached to lower part of my protein, I pulled in Z coordinate it using:<br>
<br>; Run parameters<br><br>integrator = md ; leap-frog integrator<br><br>nsteps = 5000000 ; 2 * 5000000 = 10 ns<br><br>dt = 0.002 ; 2 fs<br><br>tinit = 0<br><br>nstcomm = 10<br><br>; Output control<br><br>nstxout = 50000 ; save coordinates every 100 ps<br>
<br>nstvout = 50000 ; save velocities every<br><br>nstfout = 5000<br><br>nstxtcout = 5000 ; every 10 ps<br><br>nstenergy = 5000<br><br>; Bond parameters<br><br>continuation = yes ; first dynamics run<br><br>constraint_algorithm = lincs ; holonomic constraints<br>
<br>constraints = all-bonds ; all bonds (even heavy atom-H bonds) constrained<br><br>; Neighborsearching<br><br>ns_type = grid ; search neighboring grid cells<br><br>nstlist = 5 ; 10 fs<br><br>rlist = 0.9 ; short-range neighborlist cutoff (in nm)<br>
<br>rcoulomb = 0.9 ; short-range electrostatic cutoff (in nm)<br><br>rvdw = 0.9 ; short-range van der Waals cutoff (in nm)<br><br>ewald_rtol = 1e-5 ; relative strenght of the Ewald-shifted potential rcoulomb<br><br>; Electrostatics<br>
<br>coulombtype = PME ; Particle Mesh Ewald for long-range electrostatics<br><br>pme_order = 4 ; cubic interpolation<br><br>fourierspacing = 0.12 ; grid spacing for FFT<br><br>fourier_nx = 0<br><br>fourier_ny = 0<br><br>fourier_nz = 0<br>
<br>optimize_fft = yes<br><br>; Temperature coupling is on<br><br>tcoupl = V-rescale ; modified Berendsen thermostat<br><br>tc_grps = Protein_LIG Water_and_ions ; two coupling groups - more accurate<br><br>tau_t = 0.1 0.1 ; time constant, in ps<br>
<br>ref_t = 298 298 ; reference temperature, one for each group, in K<br><br>; Pressure coupling is on<br><br>pcoupl = Parrinello-Rahman ; pressure coupling is on for NPT<br><br>pcoupltype = isotropic ; uniform scaling of box vectors<br>
<br>tau_p = 1.0 ; time constant, in ps<br><br>ref_p = 1.0 ; reference pressure, in bar<br><br>compressibility = 4.5e-5 ; isothermal compressibility of water, bar^-1<br><br>; Periodic boundary conditions<br><br>pbc = xyz ; 3-D PBC<br>
<br>; Dispersion correction<br><br>DispCorr = EnerPres ; account for cut-off vdW scheme<br><br>; Velocity generation<br><br>gen_vel = no ; assign velocities from Maxwell distribution<br><br>; These options remove COM motion of the system<br>
<br>; Pull code<br><br>pull = umbrella<br><br>pull_geometry = distance<br><br>pull_dim = N N Y<br><br>pull_start = yes<br><br>pull_ngroups = 1<br><br>pull_group0 = Protein<br><br>pull_group1 = LIG182<br><br>pull_init1 = 0<br>
<br>pull_rate1 = 0.0<br><br>pull_k1 = 200 ; kJ mol^-1 nm^-2<br><br>pull_nstxout = 1000 ; every 2 ps<br><br>pull_nstfout = 1000 ; every 2 ps<br><br>Following Justin&#39;s tutorial I used perl script to extract coordinate for each window.<br>
<br>0       2.4595039<br><br>1       2.4745028<br><br>...<br><br>500    8.74<br><br>My ligand at the begining was at such distance as it was in the lower part of the protein. Then I used 0.1 nm spacing at the begining (till 4 nm) and 0.2 nm later on.<br>
<br>And following equilibration in each window I run umbrella sampling for 10ns in app 49 windows:<br><br>Run parameters<br><br>integrator = md ; leap-frog integrator<br><br>nsteps = 5000000 ; 2 * 5000000 = 10 ns<br><br>dt = 0.002 ; 2 fs<br>
<br>tinit = 0<br><br>nstcomm = 10<br><br>; Output control<br><br>nstxout = 50000 ; save coordinates every 100 ps<br><br>nstvout = 50000 ; save velocities every<br><br>nstfout = 5000<br><br>nstxtcout = 5000 ; every 10 ps<br>
<br>nstenergy = 5000<br><br>; Bond parameters<br><br>continuation = yes ; first dynamics run<br><br>constraint_algorithm = lincs ; holonomic constraints<br><br>constraints = all-bonds ; all bonds (even heavy atom-H bonds) constrained<br>
<br>; Neighborsearching<br><br>ns_type = grid ; search neighboring grid cells<br><br>nstlist = 5 ; 10 fs<br><br>rlist = 0.9 ; short-range neighborlist cutoff (in nm)<br><br>rcoulomb = 0.9 ; short-range electrostatic cutoff (in nm)<br>
<br>rvdw = 0.9 ; short-range van der Waals cutoff (in nm)<br><br>ewald_rtol = 1e-5 ; relative strenght of the Ewald-shifted potential rcoulomb<br><br>; Electrostatics<br><br>coulombtype = PME ; Particle Mesh Ewald for long-range electrostatics<br>
<br>pme_order = 4 ; cubic interpolation<br><br>fourierspacing = 0.12 ; grid spacing for FFT<br><br>fourier_nx = 0<br><br>fourier_ny = 0<br><br>fourier_nz = 0<br><br>optimize_fft = yes<br><br>; Temperature coupling is on<br>
<br>tcoupl = V-rescale ; modified Berendsen thermostat<br><br>tc_grps = Protein_LIG Water_and_ions ; two coupling groups - more accurate<br><br>tau_t = 0.1 0.1 ; time constant, in ps<br><br>ref_t = 298 298 ; reference temperature, one for each group, in K<br>
<br>; Pressure coupling is on<br><br>pcoupl = Parrinello-Rahman ; pressure coupling is on for NPT<br><br>pcoupltype = isotropic ; uniform scaling of box vectors<br><br>tau_p = 1.0 ; time constant, in ps<br><br>ref_p = 1.0 ; reference pressure, in bar<br>
<br>compressibility = 4.5e-5 ; isothermal compressibility of water, bar^-1<br><br>; Periodic boundary conditions<br><br>pbc = xyz ; 3-D PBC<br><br>; Dispersion correction<br><br>DispCorr = EnerPres ; account for cut-off vdW scheme<br>
<br>; Velocity generation<br><br>gen_vel = no ; assign velocities from Maxwell distribution<br><br>; These options remove COM motion of the system<br><br>; Pull code<br><br>pull = umbrella<br><br>pull_geometry = distance<br>
<br>pull_dim = N N Y<br><br>pull_start = yes<br><br>pull_ngroups = 1<br><br>pull_group0 = Protein<br><br>pull_group1 = LIG182<br><br>pull_init1 = 0<br><br>pull_rate1 = 0.0<br><br>pull_k1 = 200 ; kJ mol^-1 nm^-2<br><br>pull_nstxout = 1000 ; every 2 ps<br>
<br>pull_nstfout = 1000 ; every 2 ps<br><br> <br>My PMF profile:<br><br><a href="http://speedy.sh/zerqZ/profile.JPG" target="_blank">http://speedy.sh/zerqZ/<u></u>profile.JPG</a><br><br>My histogram: <a href="http://speedy.sh/PyhnN/Histo.JPG" target="_blank">http://speedy.sh/PyhnN/Histo.<u></u>JPG</a><br>
<br>Why g_wham takes into account distances below 2.45 nm as the 1st structure was at 2.45. If I get rid of the distances below 2.45 (those weird values PMF values) I obtain beautiful profile:<br><br><a href="http://speedy.sh/TUXGC/profile1.JPG" target="_blank">http://speedy.sh/TUXGC/<u></u>profile1.JPG</a><br>
<br>Please, explain!<br><br></blockquote><br></div></div>The way you&#39;re thinking about distance is not consistent.  Again, this is a hazard of trying to map my tutorial onto your problem.  You say you have a ligand bound to the &quot;lower part&quot; of your protein, and then you&#39;re pulling in the z-direction.  The COM distance (as measured by g_dist and extracted using my script) is not equivalent to the distance along the reaction coordinate, if that reaction coordinate is only one dimension.  In the tutorial, it was.  Here, it is not, hence the massive sampling defects that you&#39;re observing and considerable redundancy in many of your windows.<br>
<br>Check the output of grompp for the actual restraint distances that mdrun will interpret.  They are printed to the screen.<br><br>-Justin<br></blockquote>
<div> </div>
<div>Thank you Justin!!!</div>
<div> </div>
<div>Steven</div>
<div> </div>
<div> </div>
<div> </div>
<blockquote style="BORDER-LEFT:#ccc 1px solid;MARGIN:0px 0px 0px 0.8ex;PADDING-LEFT:1ex" class="gmail_quote"><br>-- <br>==============================<u></u>==========<br><br>Justin A. Lemkul<br>Ph.D. Candidate<br>ICTAS Doctoral Scholar<br>
MILES-IGERT Trainee<br>Department of Biochemistry<br>Virginia Tech<br>Blacksburg, VA<br>jalemkul[at]<a href="http://vt.edu/" target="_blank">vt.edu</a> | <a href="tel:%28540%29%20231-9080" target="_blank" value="+15402319080">(540) 231-9080</a><br>
<a href="http://www.bevanlab.biochem.vt.edu/Pages/Personal/justin" target="_blank">http://www.bevanlab.biochem.<u></u>vt.edu/Pages/Personal/justin</a><br><br>==============================<u></u>==========<span class="HOEnZb"><font color="#888888"><br>
-- <br>gmx-users mailing list    <a href="mailto:gmx-users@gromacs.org" target="_blank">gmx-users@gromacs.org</a><br><a href="http://lists.gromacs.org/mailman/listinfo/gmx-users" target="_blank">http://lists.gromacs.org/<u></u>mailman/listinfo/gmx-users</a><br>
Please search the archive at <a href="http://www.gromacs.org/Support/Mailing_Lists/Search" target="_blank">http://www.gromacs.org/<u></u>Support/Mailing_Lists/Search</a> before posting!<br>Please don&#39;t post (un)subscribe requests to the list. Use the www interface or send it to <a href="mailto:gmx-users-request@gromacs.org" target="_blank">gmx-users-request@gromacs.org</a>.<br>
Can&#39;t post? Read <a href="http://www.gromacs.org/Support/Mailing_Lists" target="_blank">http://www.gromacs.org/<u></u>Support/Mailing_Lists</a><br></font></span></blockquote></div><br>