Merge branch release-4-6
[alexxy/gromacs.git] / src / gromacs / gmxana / gmx_spol.c
1 /*
2  *
3  *                This source code is part of
4  *
5  *                 G   R   O   M   A   C   S
6  *
7  *          GROningen MAchine for Chemical Simulations
8  *
9  *                        VERSION 3.2.0
10  * Written by David van der Spoel, Erik Lindahl, Berk Hess, and others.
11  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
12  * Copyright (c) 2001-2004, The GROMACS development team,
13  * check out http://www.gromacs.org for more information.
14
15  * This program is free software; you can redistribute it and/or
16  * modify it under the terms of the GNU General Public License
17  * as published by the Free Software Foundation; either version 2
18  * of the License, or (at your option) any later version.
19  *
20  * If you want to redistribute modifications, please consider that
21  * scientific software is very special. Version control is crucial -
22  * bugs must be traceable. We will be happy to consider code for
23  * inclusion in the official distribution, but derived work must not
24  * be called official GROMACS. Details are found in the README & COPYING
25  * files - if they are missing, get the official version at www.gromacs.org.
26  *
27  * To help us fund GROMACS development, we humbly ask that you cite
28  * the papers on the package - you can find them in the top README file.
29  *
30  * For more info, check our website at http://www.gromacs.org
31  *
32  * And Hey:
33  * Green Red Orange Magenta Azure Cyan Skyblue
34  */
35 #ifdef HAVE_CONFIG_H
36 #include <config.h>
37 #endif
38
39 #include "macros.h"
40 #include "statutil.h"
41 #include "smalloc.h"
42 #include "gstat.h"
43 #include "vec.h"
44 #include "xvgr.h"
45 #include "pbc.h"
46 #include "index.h"
47 #include "tpxio.h"
48 #include "physics.h"
49 #include "gmx_ana.h"
50
51
52 static void calc_com_pbc(int nrefat, t_topology *top, rvec x[], t_pbc *pbc,
53                          atom_id index[], rvec xref, int ePBC)
54 {
55     const real tol = 1e-4;
56     gmx_bool   bChanged;
57     int        m, j, ai, iter;
58     real       mass, mtot;
59     rvec       dx, xtest;
60
61     /* First simple calculation */
62     clear_rvec(xref);
63     mtot = 0;
64     for (m = 0; (m < nrefat); m++)
65     {
66         ai   = index[m];
67         mass = top->atoms.atom[ai].m;
68         for (j = 0; (j < DIM); j++)
69         {
70             xref[j] += mass*x[ai][j];
71         }
72         mtot += mass;
73     }
74     svmul(1/mtot, xref, xref);
75     /* Now check if any atom is more than half the box from the COM */
76     if (ePBC != epbcNONE)
77     {
78         iter = 0;
79         do
80         {
81             bChanged = FALSE;
82             for (m = 0; (m < nrefat); m++)
83             {
84                 ai   = index[m];
85                 mass = top->atoms.atom[ai].m/mtot;
86                 pbc_dx(pbc, x[ai], xref, dx);
87                 rvec_add(xref, dx, xtest);
88                 for (j = 0; (j < DIM); j++)
89                 {
90                     if (fabs(xtest[j]-x[ai][j]) > tol)
91                     {
92                         /* Here we have used the wrong image for contributing to the COM */
93                         xref[j] += mass*(xtest[j]-x[ai][j]);
94                         x[ai][j] = xtest[j];
95                         bChanged = TRUE;
96                     }
97                 }
98             }
99             if (bChanged)
100             {
101                 printf("COM: %8.3f  %8.3f  %8.3f  iter = %d\n", xref[XX], xref[YY], xref[ZZ], iter);
102             }
103             iter++;
104         }
105         while (bChanged);
106     }
107 }
108
109 void spol_atom2molindex(int *n, int *index, t_block *mols)
110 {
111     int nmol, i, j, m;
112
113     nmol = 0;
114     i    = 0;
115     while (i < *n)
116     {
117         m = 0;
118         while (m < mols->nr && index[i] != mols->index[m])
119         {
120             m++;
121         }
122         if (m == mols->nr)
123         {
124             gmx_fatal(FARGS, "index[%d]=%d does not correspond to the first atom of a molecule", i+1, index[i]+1);
125         }
126         for (j = mols->index[m]; j < mols->index[m+1]; j++)
127         {
128             if (i >= *n || index[i] != j)
129             {
130                 gmx_fatal(FARGS, "The index group is not a set of whole molecules");
131             }
132             i++;
133         }
134         /* Modify the index in place */
135         index[nmol++] = m;
136     }
137     printf("There are %d molecules in the selection\n", nmol);
138
139     *n = nmol;
140 }
141
142 int gmx_spol(int argc, char *argv[])
143 {
144     t_topology  *top;
145     t_inputrec  *ir;
146     t_atom      *atom;
147     char         title[STRLEN];
148     t_trxstatus *status;
149     int          nrefat, natoms, nf, ntot;
150     real         t;
151     rvec        *xtop, *x, xref, trial, dx = {0}, dip, dir;
152     matrix       box;
153
154     FILE        *fp;
155     int         *isize, nrefgrp;
156     atom_id    **index, *molindex;
157     char       **grpname;
158     real         rmin2, rmax2, rcut, rcut2, rdx2 = 0, rtry2, qav, q, dip2, invbw;
159     int          nbin, i, m, mol, a0, a1, a, d;
160     double       sdip, sdip2, sinp, sdinp, nmol;
161     int         *hist;
162     t_pbc        pbc;
163     gmx_rmpbc_t  gpbc = NULL;
164
165
166     const char     *desc[] = {
167         "[TT]g_spol[tt] analyzes dipoles around a solute; it is especially useful",
168         "for polarizable water. A group of reference atoms, or a center",
169         "of mass reference (option [TT]-com[tt]) and a group of solvent",
170         "atoms is required. The program splits the group of solvent atoms",
171         "into molecules. For each solvent molecule the distance to the",
172         "closest atom in reference group or to the COM is determined.",
173         "A cumulative distribution of these distances is plotted.",
174         "For each distance between [TT]-rmin[tt] and [TT]-rmax[tt]",
175         "the inner product of the distance vector",
176         "and the dipole of the solvent molecule is determined.",
177         "For solvent molecules with net charge (ions), the net charge of the ion",
178         "is subtracted evenly from all atoms in the selection of each ion.",
179         "The average of these dipole components is printed.",
180         "The same is done for the polarization, where the average dipole is",
181         "subtracted from the instantaneous dipole. The magnitude of the average",
182         "dipole is set with the option [TT]-dip[tt], the direction is defined",
183         "by the vector from the first atom in the selected solvent group",
184         "to the midpoint between the second and the third atom."
185     };
186
187     output_env_t    oenv;
188     static gmx_bool bCom   = FALSE, bPBC = FALSE;
189     static int      srefat = 1;
190     static real     rmin   = 0.0, rmax = 0.32, refdip = 0, bw = 0.01;
191     t_pargs         pa[]   = {
192         { "-com",  FALSE, etBOOL,  {&bCom},
193           "Use the center of mass as the reference postion" },
194         { "-refat",  FALSE, etINT, {&srefat},
195           "The reference atom of the solvent molecule" },
196         { "-rmin",  FALSE, etREAL, {&rmin}, "Maximum distance (nm)" },
197         { "-rmax",  FALSE, etREAL, {&rmax}, "Maximum distance (nm)" },
198         { "-dip",   FALSE, etREAL, {&refdip}, "The average dipole (D)" },
199         { "-bw",    FALSE, etREAL, {&bw}, "The bin width" }
200     };
201
202     t_filenm        fnm[] = {
203         { efTRX, NULL,  NULL,  ffREAD },
204         { efTPX, NULL,  NULL,  ffREAD },
205         { efNDX, NULL,  NULL,  ffOPTRD },
206         { efXVG, NULL,  "scdist.xvg",  ffWRITE }
207     };
208 #define NFILE asize(fnm)
209
210     if (!parse_common_args(&argc, argv, PCA_CAN_TIME | PCA_CAN_VIEW | PCA_BE_NICE,
211                            NFILE, fnm, asize(pa), pa, asize(desc), desc, 0, NULL, &oenv))
212     {
213         return 0;
214     }
215
216     snew(top, 1);
217     snew(ir, 1);
218     read_tpx_top(ftp2fn(efTPX, NFILE, fnm),
219                  ir, box, &natoms, NULL, NULL, NULL, top);
220
221     /* get index groups */
222     printf("Select a group of reference particles and a solvent group:\n");
223     snew(grpname, 2);
224     snew(index, 2);
225     snew(isize, 2);
226     get_index(&top->atoms, ftp2fn_null(efNDX, NFILE, fnm), 2, isize, index, grpname);
227
228     if (bCom)
229     {
230         nrefgrp = 1;
231         nrefat  = isize[0];
232     }
233     else
234     {
235         nrefgrp = isize[0];
236         nrefat  = 1;
237     }
238
239     spol_atom2molindex(&(isize[1]), index[1], &(top->mols));
240     srefat--;
241
242     /* initialize reading trajectory:                         */
243     natoms = read_first_x(oenv, &status, ftp2fn(efTRX, NFILE, fnm), &t, &x, box);
244
245     rcut  = 0.99*sqrt(max_cutoff2(ir->ePBC, box));
246     if (rcut == 0)
247     {
248         rcut = 10*rmax;
249     }
250     rcut2 = sqr(rcut);
251     invbw = 1/bw;
252     nbin  = (int)(rcut*invbw)+2;
253     snew(hist, nbin);
254
255     rmin2 = sqr(rmin);
256     rmax2 = sqr(rmax);
257
258     nf    = 0;
259     ntot  = 0;
260     sdip  = 0;
261     sdip2 = 0;
262     sinp  = 0;
263     sdinp = 0;
264
265     molindex = top->mols.index;
266     atom     = top->atoms.atom;
267
268     gpbc = gmx_rmpbc_init(&top->idef, ir->ePBC, natoms);
269
270     /* start analysis of trajectory */
271     do
272     {
273         /* make molecules whole again */
274         gmx_rmpbc(gpbc, natoms, box, x);
275
276         set_pbc(&pbc, ir->ePBC, box);
277         if (bCom)
278         {
279             calc_com_pbc(nrefat, top, x, &pbc, index[0], xref, ir->ePBC);
280         }
281
282         for (m = 0; m < isize[1]; m++)
283         {
284             mol = index[1][m];
285             a0  = molindex[mol];
286             a1  = molindex[mol+1];
287             for (i = 0; i < nrefgrp; i++)
288             {
289                 pbc_dx(&pbc, x[a0+srefat], bCom ? xref : x[index[0][i]], trial);
290                 rtry2 = norm2(trial);
291                 if (i == 0 || rtry2 < rdx2)
292                 {
293                     copy_rvec(trial, dx);
294                     rdx2 = rtry2;
295                 }
296             }
297             if (rdx2 < rcut2)
298             {
299                 hist[(int)(sqrt(rdx2)*invbw)+1]++;
300             }
301             if (rdx2 >= rmin2 && rdx2 < rmax2)
302             {
303                 unitv(dx, dx);
304                 clear_rvec(dip);
305                 qav = 0;
306                 for (a = a0; a < a1; a++)
307                 {
308                     qav += atom[a].q;
309                 }
310                 qav /= (a1 - a0);
311                 for (a = a0; a < a1; a++)
312                 {
313                     q = atom[a].q - qav;
314                     for (d = 0; d < DIM; d++)
315                     {
316                         dip[d] += q*x[a][d];
317                     }
318                 }
319                 for (d = 0; d < DIM; d++)
320                 {
321                     dir[d] = -x[a0][d];
322                 }
323                 for (a = a0+1; a < a0+3; a++)
324                 {
325                     for (d = 0; d < DIM; d++)
326                     {
327                         dir[d] += 0.5*x[a][d];
328                     }
329                 }
330                 unitv(dir, dir);
331
332                 svmul(ENM2DEBYE, dip, dip);
333                 dip2   = norm2(dip);
334                 sdip  += sqrt(dip2);
335                 sdip2 += dip2;
336                 for (d = 0; d < DIM; d++)
337                 {
338                     sinp  += dx[d]*dip[d];
339                     sdinp += dx[d]*(dip[d] - refdip*dir[d]);
340                 }
341
342                 ntot++;
343             }
344         }
345         nf++;
346
347     }
348     while (read_next_x(oenv, status, &t, x, box));
349
350     gmx_rmpbc_done(gpbc);
351
352     /* clean up */
353     sfree(x);
354     close_trj(status);
355
356     fprintf(stderr, "Average number of molecules within %g nm is %.1f\n",
357             rmax, (real)ntot/(real)nf);
358     if (ntot > 0)
359     {
360         sdip  /= ntot;
361         sdip2 /= ntot;
362         sinp  /= ntot;
363         sdinp /= ntot;
364         fprintf(stderr, "Average dipole:                               %f (D), std.dev. %f\n",
365                 sdip, sqrt(sdip2-sqr(sdip)));
366         fprintf(stderr, "Average radial component of the dipole:       %f (D)\n",
367                 sinp);
368         fprintf(stderr, "Average radial component of the polarization: %f (D)\n",
369                 sdinp);
370     }
371
372     fp = xvgropen(opt2fn("-o", NFILE, fnm),
373                   "Cumulative solvent distribution", "r (nm)", "molecules", oenv);
374     nmol = 0;
375     for (i = 0; i <= nbin; i++)
376     {
377         nmol += hist[i];
378         fprintf(fp, "%g %g\n", i*bw, nmol/nf);
379     }
380     ffclose(fp);
381
382     do_view(oenv, opt2fn("-o", NFILE, fnm), NULL);
383
384     return 0;
385 }