Re: [gmx-users] removing pbc jumps from trajectory

2011-02-21 Thread XAvier Periole
You have to make sure of two things: 1- use a reference (gro or tpr) where the molecule is whole! The tpr is prefered since the molecules are defined. 2- with such a reference and the option -mol you'll get a trajectory with the protein as a whole. On that trajectory you may apply more modi

[gmx-users] Re: gmx-users Digest, Vol 82, Issue 150

2011-02-21 Thread Evelyne Deplazes
I tried a couple of things according to your suggestions, but no luck so far I used the following commands 1) trjconv -f trajout_dt2000.xtc -s topol.tpr -pbc mol -o trajout_mol.xtc 2) trjconv -f trajout_mol.xtc -s topol.tpr -pbc nojump trajout_nojump.xtc no luck...If I use command 1) only the

Re: [gmx-users] configure: error: cannot compute sizeof (off_t)

2011-02-21 Thread Carsten Kutzner
On Feb 20, 2011, at 9:30 PM, Justin Kat wrote: > Dear experts, > > I am still unable to overcome this error during the configuration: > > configure: error: cannot compute sizeof (off_t) > See `config.log' for more details. So what does config.log say about "cannot compute sizeof (off_t) ?" Car

Re: [gmx-users] Re: gmx-users Digest, Vol 82, Issue 150

2011-02-21 Thread XAvier Periole
ok this does not make sense! Did you check your tpr file? the command 1) should give you a trajectory where the molecules are whole but jumping across the boundaries ... if it does not that means that the tpr is fucky! Try to visualize your tpr in vmd ... night give you some insight on what is

Re: [gmx-users] Re: gmx-users Digest, Vol 82, Issue 150

2011-02-21 Thread Tsjerk Wassenaar
Hi Evelyne, > 1) trjconv  -f trajout_dt2000.xtc -s topol.tpr -pbc mol -o trajout_mol.xtc The option -pbc mol IIRC relates to the option for the unit cell representation (-ur). To unbreak molecules using trjconv, you need to have .tpr file and use the option -pbc whole. > 2) trjconv  -f trajout_m

Re: [gmx-users] g_covar to calculate correlation of motion

2011-02-21 Thread Tsjerk Wassenaar
Hi Bipin, The file residuetypes.dat is quite different from aminoacids.dat. You can paste the following into that file (first line is number of entries, followed by so many residue names): 49 ABU ACE AIB ALA ARG ARGN ASN ASN1 ASP ASP1 ASPH CYS CYS1 CYS2 CYSH DALA GLN GLU GLUH GLY HIS HIS1 HI

Re: [gmx-users] g_covar to calculate correlation of motion

2011-02-21 Thread bipin singh
Thanks a lot Sir. On Mon, Feb 21, 2011 at 15:26, Tsjerk Wassenaar wrote: > Hi Bipin, > > The file residuetypes.dat is quite different from aminoacids.dat. You > can paste the following into that file (first line is number of > entries, followed by so many residue names): > > 49 > ABU > ACE > AIB

[gmx-users] how many contacts has a certain atom at MD

2011-02-21 Thread Olga Ivchenko
Dear Gromacs Users, I would like to know if there is in gromacs an option how to calculate how many contacts has a certain atom i(n a molecules of interest) with water during the whole MD simulations (or at each step of MD). Please could you advice me on this? best, Olga -- gmx-users mailing lis

Re: [gmx-users] how many contacts has a certain atom at MD

2011-02-21 Thread XAvier Periole
g_dist On Feb 21, 2011, at 11:32 AM, Olga Ivchenko wrote: Dear Gromacs Users, I would like to know if there is in gromacs an option how to calculate how many contacts has a certain atom i(n a molecules of interest) with water during the whole MD simulations (or at each step of MD). Pleas

Re: [gmx-users] how many contacts has a certain atom at MD

2011-02-21 Thread Erik Marklund
Or g_hbond -contact. Undfortuntely there are still issues with g_hbond at the moment. Version 4.0.x seem to work better. XAvier Periole skrev 2011-02-21 11.37: g_dist On Feb 21, 2011, at 11:32 AM, Olga Ivchenko wrote: Dear Gromacs Users, I would like to know if there is in gromacs an option

Re: [gmx-users] how many contacts has a certain atom at MD

2011-02-21 Thread Justin A. Lemkul
g_mindist -on (with suitable index groups) should also do the trick. -Justin Erik Marklund wrote: Or g_hbond -contact. Undfortuntely there are still issues with g_hbond at the moment. Version 4.0.x seem to work better. XAvier Periole skrev 2011-02-21 11.37: g_dist On Feb 21, 2011, at 11:32

Re: [gmx-users] how many contacts has a certain atom at MD

2011-02-21 Thread Olga Ivchenko
Thank you very much. best, Olga 2011/2/21 Justin A. Lemkul > > g_mindist -on (with suitable index groups) should also do the trick. > > -Justin > > > Erik Marklund wrote: > >> Or g_hbond -contact. Undfortuntely there are still issues with g_hbond at >> the moment. Version 4.0.x seem to work bett

RE: [gmx-users] Porting Amber parmbsc0 force field to Gromacs

2011-02-21 Thread william Stebbeds
Hello, gods of gromacs, I have ported the parmbsc0 modifications to a new gromacs force field, based on the amber99sb.ff, this involves adding a new carbon atom (CI) to be used in the C5' of nucleotides. Everything is working perfectly (to my astonishment) and I am confident of all of the mo

Re: [gmx-users] how many contacts has a certain atom at MD

2011-02-21 Thread Olga Ivchenko
So I used mindist for a certain group of molecules which is surrounded by water. I got plot number of contacts versuc sumulation time. According to what I see in a distance < 0.6nm at certain frame there are on average 150 contacts. Actually how the programm calculates the number of contacts, if

Re: [gmx-users] how many contacts has a certain atom at MD

2011-02-21 Thread Justin A. Lemkul
Olga Ivchenko wrote: So I used mindist for a certain group of molecules which is surrounded by water. I got plot number of contacts versuc sumulation time. According to what I see in a distance < 0.6nm at certain frame there are on average 150 contacts. Actually how the programm calculates

Re: [gmx-users] Target implementation date for gb_saltconc?

2011-02-21 Thread Per Larsson
Skickat från min iPhone 18 feb 2011 kl. 21:10 skrev Matthew Zwier : > Dear GROMACS developers and users, > > Our research group is interested in performing GBSA simulations with > GROMACS, but we would need to perform them with a nonzero salt > concentration. I was wondering if there are plan

[gmx-users] free energy-couple-intramol options

2011-02-21 Thread Moeed
Hello, I read through the couple-intramol options (yes and no) good many times but I can not still realize what is the difference and which option I should select. I am having a hydrocarbon system (polyethylene in hexane as solvent). Can anyone help me understand these options please? (in plain en

[gmx-users] diffusion constant

2011-02-21 Thread Rebeca García Fandiño
Hello, I am trying to calculate the diffusion coefficient of a molecule in water using g_msd, and I have a doubt: I get 3 different values when I use the trajectory directly from the simulation, the trajectory using PBC conditions, and the "fitted trajectory". Which would be the correct value fo

[gmx-users] PMF from pull code, unexpected results

2011-02-21 Thread Michael Brunsteiner
Dear all, I would like to calculate the potential of mean force between two molecules in aqueous solution using the pull code. For a start i performed a number of calulations with a couple of very simple model systems with settings loosely based on the example in the gmx tutorial section (see m

Re: [gmx-users] An argument about long range electrostatics

2011-02-21 Thread Justin A. Lemkul
Hassan Shallal wrote: Dear Gromacs users, While I was using Gromos force field in simulating a protein in explicit solvent, I used the following parameters: *rcoulomb = 1, rlist =1, rvdw = 1.4* *Electrostatitcs : PME* *VDW : Twin range cutoff* The above situation will not allow the calc

[gmx-users] An argument about long range electrostatics

2011-02-21 Thread Hassan Shallal
Dear Gromacs users, While I was using Gromos force field in simulating a protein in explicit solvent, I used the following parameters: rcoulomb = 1, rlist =1, rvdw = 1.4 Electrostatitcs : PME VDW : Twin range cutoff The above situation will not allow the calculation of any long-range electr

Re: [gmx-users] Can g_wham support using different temperature for different windows?

2011-02-21 Thread Justin A. Lemkul
Jianguo Li wrote: Dear all, I want to get the PMF of my peptide across the membrane bilayer. First I pulled my peptide across the membrane and then did windowed umbrella sampling along the reaction coordinates which is the z-distance between peptide and membrane. However, I found that sampl

[gmx-users] Can g_wham support using different temperature for different windows?

2011-02-21 Thread Jianguo Li
Dear all, I want to get the PMF of my peptide across the membrane bilayer. First I pulled my peptide across the membrane and then did windowed umbrella sampling along the reaction coordinates which is the z-distance between peptide and membrane. However, I found that sampling is not sufficient

Re: [gmx-users] Can g_wham support using different temperature for different windows?

2011-02-21 Thread Justin A. Lemkul
Jianguo Li wrote: Thanks Justin. I tried your suggestions by either increase more windows and change the force constant, but it seems the samplings are still bad in some windows. When I did pulling in (0 0 1) direction and a reverse pulling in (0 0 -1) direction, I got different configuratio

[gmx-users] ffamber03 RB dihedrals and amb2gmx.pl problem!

2011-02-21 Thread gromacs564
Hello all I obtained a top file after running the "amb2gmx.pl" script,but I feel some errors in this top file. The functype of the [dihedral] is 3 in this top file,but the [pairs] part aslo presence in it. And the manual is point that "with the Ryckaert-Bellemans potential the 1-4 interactions

Re: [gmx-users] Can g_wham support using different temperature for different windows?

2011-02-21 Thread Jianguo Li
Thanks Justin. I tried your suggestions by either increase more windows and change the force constant, but it seems the samplings are still bad in some windows. When I did pulling in (0 0 1) direction and a reverse pulling in (0 0 -1) direction, I got different configurations at certain reaction

[gmx-users] PMF from pull code, unexpected results

2011-02-21 Thread chris . neale
Looking at http://www.brunsteiner.net/tbut-pmf.gif you seem to be getting exactly what I would expect. The difference is the entropy term. Note that the spherical shell increases volume as r increases for pulldim YYY but this effect is absent for pulldim NNY. This is why you can correct as

Re: [gmx-users] Can g_wham support using different temperature for different windows?

2011-02-21 Thread Jianguo Li
Thanks for your comments, Justin. Using timestep of 20 fs, in each window the simulation runs for 100 ns CG time. The pulling rate is 0.001 nm/ps. Is it too fast? My system is a little different. My peptide is highly positively charged. The NMR experiments show that the conformation of the pept

Re: [gmx-users] Can g_wham support using different temperature for different windows?

2011-02-21 Thread Justin A. Lemkul
Jianguo Li wrote: Thanks for your comments, Justin. Using timestep of 20 fs, in each window the simulation runs for 100 ns CG time. The pulling rate is 0.001 nm/ps. Is it too fast? Let me clarify things, since I'm not convinced I understand your procedure. You generate a series of configu

[gmx-users] Can g_wham support using different temperature for different windows?

2011-02-21 Thread chris . neale
Sounds like unconverged sampling. You would be astounded how long systems like this can take to converge. An all-atom simulation like this can easily require >10 us (microseconds!) per umbrella. I don't know about martini, probably a lot less. Chris. -- original message -- Thanks Justin.

[gmx-users] membrane bilayer simulation by OPLS FF

2011-02-21 Thread mircial
Dear All: I am using OPLS force field (OPLS FF) to do molecular dynamics simulations. My system contains DPPC lipid, protein and a small molecule. I have the following questions: 1, where can I get the topology files for the DPPC lipids? 2, How to prepare the topology files for the small m

[gmx-users] %exist hydrogen bond

2011-02-21 Thread leila karami
Dear Justin My simulation system contains protein, dna and water. I used your script already for obtaining %exist hydrogen bonds between protein and dna: #!/usr/bin/perl # # plot_hbmap.pl - plot the probability of finding a particular hydrogen bond # based on several input files: # 1. coordina

RE: [gmx-users] membrane bilayer simulation by OPLS FF

2011-02-21 Thread Dallas Warren
7 and 8 have nothing to do with OPLS-AA. As the text tells you, it is the Encad forcefield (http://www.sklogwiki.org/SklogWiki/index.php/ENCAD_%28force_field%29) So that then leaves you with the OPLS-AA for you to use :-) Catch ya, Dr. Dallas Warren Medicinal Chemistry and Drug Action Monash In

[gmx-users] diffusion coefficients

2011-02-21 Thread Thomas Koller
Hello, I'm investigating the diffusion coefficient of gases in liquids. Therefore, I insert some molecules with the genbox tool in an equilibrated system. After a NPT run to adjust the density, I'm running an NVT simulation to calculate the diffusion coefficient (g_msd). MSD of the liquids are

Re: [gmx-users] Can g_wham support using different temperature for different windows?

2011-02-21 Thread Jianguo Li
Thanks Justin and Chris and sorry for confusing interpretation. Let me make it more clear. My peptide is flexible Martini beads, and highly positively charged. My membrane is a mixture of negatively charged lipids (25%) and zitterionic lipids(75%). So there is strong electrostatic attraction be