Remove continuation from convert_tpr
[gromacs.git] / src / gromacs / gmxana / gmx_bundle.cpp
blob17c8167279ecf26f49f53b2a779b1a5db06ee6d5
1 /*
2 * This file is part of the GROMACS molecular simulation package.
4 * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
5 * Copyright (c) 2001-2004, The GROMACS development team.
6 * Copyright (c) 2013,2014,2015, by the GROMACS development team, led by
7 * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
8 * and including many others, as listed in the AUTHORS file in the
9 * top-level source directory and at http://www.gromacs.org.
11 * GROMACS is free software; you can redistribute it and/or
12 * modify it under the terms of the GNU Lesser General Public License
13 * as published by the Free Software Foundation; either version 2.1
14 * of the License, or (at your option) any later version.
16 * GROMACS is distributed in the hope that it will be useful,
17 * but WITHOUT ANY WARRANTY; without even the implied warranty of
18 * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
19 * Lesser General Public License for more details.
21 * You should have received a copy of the GNU Lesser General Public
22 * License along with GROMACS; if not, see
23 * http://www.gnu.org/licenses, or write to the Free Software Foundation,
24 * Inc., 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA.
26 * If you want to redistribute modifications to GROMACS, please
27 * consider that scientific software is very special. Version
28 * control is crucial - bugs must be traceable. We will be happy to
29 * consider code for inclusion in the official distribution, but
30 * derived work must not be called official GROMACS. Details are found
31 * in the README & COPYING files - if they are missing, get the
32 * official version at http://www.gromacs.org.
34 * To help us fund GROMACS development, we humbly ask that you cite
35 * the research papers on the package. Check out http://www.gromacs.org.
37 #include "gmxpre.h"
39 #include <cmath>
40 #include <cstring>
42 #include "gromacs/commandline/pargs.h"
43 #include "gromacs/fileio/confio.h"
44 #include "gromacs/fileio/trxio.h"
45 #include "gromacs/fileio/xvgr.h"
46 #include "gromacs/gmxana/gmx_ana.h"
47 #include "gromacs/math/functions.h"
48 #include "gromacs/math/units.h"
49 #include "gromacs/math/vec.h"
50 #include "gromacs/pbcutil/rmpbc.h"
51 #include "gromacs/topology/index.h"
52 #include "gromacs/topology/topology.h"
53 #include "gromacs/trajectory/trajectoryframe.h"
54 #include "gromacs/utility/arraysize.h"
55 #include "gromacs/utility/fatalerror.h"
56 #include "gromacs/utility/futil.h"
57 #include "gromacs/utility/smalloc.h"
59 #define MAX_ENDS 3
61 typedef struct {
62 int n;
63 int nend;
64 rvec *end[MAX_ENDS];
65 rvec *mid;
66 rvec *dir;
67 real *len;
68 } t_bundle;
70 static void rotate_ends(t_bundle *bun, rvec axis, int c0, int c1)
72 int end, i;
73 rvec ax, tmp;
75 unitv(axis, ax);
76 for (end = 0; end < bun->nend; end++)
78 for (i = 0; i < bun->n; i++)
80 copy_rvec(bun->end[end][i], tmp);
81 bun->end[end][i][c0] = ax[c1]*tmp[c0] - ax[c0]*tmp[c1];
82 bun->end[end][i][c1] = ax[c0]*tmp[c0] + ax[c1]*tmp[c1];
85 copy_rvec(axis, tmp);
86 axis[c0] = ax[c1]*tmp[c0] - ax[c0]*tmp[c1];
87 axis[c1] = ax[c0]*tmp[c0] + ax[c1]*tmp[c1];
90 static void calc_axes(rvec x[], t_atom atom[], int gnx[], int *index[],
91 gmx_bool bRot, t_bundle *bun)
93 int end, i, div, d;
94 real *mtot, m;
95 rvec axis[MAX_ENDS], cent;
97 snew(mtot, bun->n);
99 clear_rvec(axis[0]);
100 clear_rvec(axis[1]);
102 for (end = 0; end < bun->nend; end++)
104 for (i = 0; i < bun->n; i++)
106 clear_rvec(bun->end[end][i]);
107 mtot[i] = 0;
109 div = gnx[end]/bun->n;
110 for (i = 0; i < gnx[end]; i++)
112 m = atom[index[end][i]].m;
113 for (d = 0; d < DIM; d++)
115 bun->end[end][i/div][d] += m*x[index[end][i]][d];
117 mtot[i/div] += m;
119 clear_rvec(axis[end]);
120 for (i = 0; i < bun->n; i++)
122 svmul(1.0/mtot[i], bun->end[end][i], bun->end[end][i]);
123 rvec_inc(axis[end], bun->end[end][i]);
125 svmul(1.0/bun->n, axis[end], axis[end]);
127 sfree(mtot);
129 rvec_add(axis[0], axis[1], cent);
130 svmul(0.5, cent, cent);
131 /* center the bundle on the origin */
132 for (end = 0; end < bun->nend; end++)
134 rvec_dec(axis[end], cent);
135 for (i = 0; i < bun->n; i++)
137 rvec_dec(bun->end[end][i], cent);
140 if (bRot)
142 /* rotate the axis parallel to the z-axis */
143 rotate_ends(bun, axis[0], YY, ZZ);
144 rotate_ends(bun, axis[0], XX, ZZ);
146 for (i = 0; i < bun->n; i++)
148 rvec_add(bun->end[0][i], bun->end[1][i], bun->mid[i]);
149 svmul(0.5, bun->mid[i], bun->mid[i]);
150 rvec_sub(bun->end[0][i], bun->end[1][i], bun->dir[i]);
151 bun->len[i] = norm(bun->dir[i]);
152 unitv(bun->dir[i], bun->dir[i]);
156 static void dump_axes(t_trxstatus *status, t_trxframe *fr, t_atoms *outat,
157 t_bundle *bun)
159 t_trxframe frout;
160 static rvec *xout = NULL;
161 int i;
163 if (xout == NULL)
165 snew(xout, outat->nr);
168 for (i = 0; i < bun->n; i++)
170 copy_rvec(bun->end[0][i], xout[3*i]);
171 if (bun->nend >= 3)
173 copy_rvec(bun->end[2][i], xout[3*i+1]);
175 else
177 copy_rvec(bun->mid[i], xout[3*i+1]);
179 copy_rvec(bun->end[1][i], xout[3*i+2]);
181 frout = *fr;
182 frout.bV = FALSE;
183 frout.bF = FALSE;
184 frout.bBox = FALSE;
185 frout.bAtoms = TRUE;
186 frout.natoms = outat->nr;
187 frout.atoms = outat;
188 frout.x = xout;
189 write_trxframe(status, &frout, NULL);
192 int gmx_bundle(int argc, char *argv[])
194 const char *desc[] = {
195 "[THISMODULE] analyzes bundles of axes. The axes can be for instance",
196 "helix axes. The program reads two index groups and divides both",
197 "of them in [TT]-na[tt] parts. The centers of mass of these parts",
198 "define the tops and bottoms of the axes.",
199 "Several quantities are written to file:",
200 "the axis length, the distance and the z-shift of the axis mid-points",
201 "with respect to the average center of all axes, the total tilt,",
202 "the radial tilt and the lateral tilt with respect to the average axis.",
203 "[PAR]",
204 "With options [TT]-ok[tt], [TT]-okr[tt] and [TT]-okl[tt] the total,",
205 "radial and lateral kinks of the axes are plotted. An extra index",
206 "group of kink atoms is required, which is also divided into [TT]-na[tt]",
207 "parts. The kink angle is defined as the angle between the kink-top and",
208 "the bottom-kink vectors.",
209 "[PAR]",
210 "With option [TT]-oa[tt] the top, mid (or kink when [TT]-ok[tt] is set)",
211 "and bottom points of each axis",
212 "are written to a [REF].pdb[ref] file each frame. The residue numbers correspond",
213 "to the axis numbers. When viewing this file with Rasmol, use the",
214 "command line option [TT]-nmrpdb[tt], and type [TT]set axis true[tt] to",
215 "display the reference axis."
217 static int n = 0;
218 static gmx_bool bZ = FALSE;
219 t_pargs pa[] = {
220 { "-na", FALSE, etINT, {&n},
221 "Number of axes" },
222 { "-z", FALSE, etBOOL, {&bZ},
223 "Use the [IT]z[it]-axis as reference instead of the average axis" }
225 FILE *flen, *fdist, *fz, *ftilt, *ftiltr, *ftiltl;
226 FILE *fkink = NULL, *fkinkr = NULL, *fkinkl = NULL;
227 t_trxstatus *status;
228 t_trxstatus *fpdb;
229 t_topology top;
230 int ePBC;
231 rvec *xtop;
232 matrix box;
233 t_trxframe fr;
234 t_atoms outatoms;
235 real t, comp;
236 char *grpname[MAX_ENDS];
237 /* FIXME: The constness should not be cast away */
238 char *anm = (char *)"CA", *rnm = (char *)"GLY";
239 int i, gnx[MAX_ENDS];
240 int *index[MAX_ENDS];
241 t_bundle bun;
242 gmx_bool bKink;
243 rvec va, vb, vc, vr, vl;
244 gmx_output_env_t *oenv;
245 gmx_rmpbc_t gpbc = NULL;
247 #define NLEG asize(leg)
248 t_filenm fnm[] = {
249 { efTRX, "-f", NULL, ffREAD },
250 { efTPS, NULL, NULL, ffREAD },
251 { efNDX, NULL, NULL, ffOPTRD },
252 { efXVG, "-ol", "bun_len", ffWRITE },
253 { efXVG, "-od", "bun_dist", ffWRITE },
254 { efXVG, "-oz", "bun_z", ffWRITE },
255 { efXVG, "-ot", "bun_tilt", ffWRITE },
256 { efXVG, "-otr", "bun_tiltr", ffWRITE },
257 { efXVG, "-otl", "bun_tiltl", ffWRITE },
258 { efXVG, "-ok", "bun_kink", ffOPTWR },
259 { efXVG, "-okr", "bun_kinkr", ffOPTWR },
260 { efXVG, "-okl", "bun_kinkl", ffOPTWR },
261 { efPDB, "-oa", "axes", ffOPTWR }
263 #define NFILE asize(fnm)
265 if (!parse_common_args(&argc, argv, PCA_CAN_TIME | PCA_TIME_UNIT,
266 NFILE, fnm, asize(pa), pa, asize(desc), desc, 0, NULL, &oenv))
268 return 0;
271 read_tps_conf(ftp2fn(efTPS, NFILE, fnm), &top, &ePBC, &xtop, NULL, box, TRUE);
273 bKink = opt2bSet("-ok", NFILE, fnm) || opt2bSet("-okr", NFILE, fnm)
274 || opt2bSet("-okl", NFILE, fnm);
275 if (bKink)
277 bun.nend = 3;
279 else
281 bun.nend = 2;
284 fprintf(stderr, "Select a group of top and a group of bottom ");
285 if (bKink)
287 fprintf(stderr, "and a group of kink ");
289 fprintf(stderr, "atoms\n");
290 get_index(&top.atoms, ftp2fn_null(efNDX, NFILE, fnm), bun.nend,
291 gnx, index, grpname);
293 if (n <= 0 || gnx[0] % n || gnx[1] % n || (bKink && gnx[2] % n))
295 gmx_fatal(FARGS,
296 "The size of one of your index groups is not a multiple of n");
298 bun.n = n;
299 snew(bun.end[0], n);
300 snew(bun.end[1], n);
301 if (bKink)
303 snew(bun.end[2], n);
305 snew(bun.mid, n);
306 snew(bun.dir, n);
307 snew(bun.len, n);
309 flen = xvgropen(opt2fn("-ol", NFILE, fnm), "Axis lengths",
310 output_env_get_xvgr_tlabel(oenv), "(nm)", oenv);
311 fdist = xvgropen(opt2fn("-od", NFILE, fnm), "Distance of axis centers",
312 output_env_get_xvgr_tlabel(oenv), "(nm)", oenv);
313 fz = xvgropen(opt2fn("-oz", NFILE, fnm), "Z-shift of axis centers",
314 output_env_get_xvgr_tlabel(oenv), "(nm)", oenv);
315 ftilt = xvgropen(opt2fn("-ot", NFILE, fnm), "Axis tilts",
316 output_env_get_xvgr_tlabel(oenv), "(degrees)", oenv);
317 ftiltr = xvgropen(opt2fn("-otr", NFILE, fnm), "Radial axis tilts",
318 output_env_get_xvgr_tlabel(oenv), "(degrees)", oenv);
319 ftiltl = xvgropen(opt2fn("-otl", NFILE, fnm), "Lateral axis tilts",
320 output_env_get_xvgr_tlabel(oenv), "(degrees)", oenv);
322 if (bKink)
324 fkink = xvgropen(opt2fn("-ok", NFILE, fnm), "Kink angles",
325 output_env_get_xvgr_tlabel(oenv), "(degrees)", oenv);
326 fkinkr = xvgropen(opt2fn("-okr", NFILE, fnm), "Radial kink angles",
327 output_env_get_xvgr_tlabel(oenv), "(degrees)", oenv);
328 if (output_env_get_print_xvgr_codes(oenv))
330 fprintf(fkinkr, "@ subtitle \"+ = ) ( - = ( )\"\n");
332 fkinkl = xvgropen(opt2fn("-okl", NFILE, fnm), "Lateral kink angles",
333 output_env_get_xvgr_tlabel(oenv), "(degrees)", oenv);
336 if (opt2bSet("-oa", NFILE, fnm))
338 init_t_atoms(&outatoms, 3*n, FALSE);
339 outatoms.nr = 3*n;
340 for (i = 0; i < 3*n; i++)
342 outatoms.atomname[i] = &anm;
343 outatoms.atom[i].resind = i/3;
344 outatoms.resinfo[i/3].name = &rnm;
345 outatoms.resinfo[i/3].nr = i/3 + 1;
346 outatoms.resinfo[i/3].ic = ' ';
348 fpdb = open_trx(opt2fn("-oa", NFILE, fnm), "w");
350 else
352 fpdb = NULL;
355 read_first_frame(oenv, &status, ftp2fn(efTRX, NFILE, fnm), &fr, TRX_NEED_X);
356 gpbc = gmx_rmpbc_init(&top.idef, ePBC, fr.natoms);
360 gmx_rmpbc_trxfr(gpbc, &fr);
361 calc_axes(fr.x, top.atoms.atom, gnx, index, !bZ, &bun);
362 t = output_env_conv_time(oenv, fr.time);
363 fprintf(flen, " %10g", t);
364 fprintf(fdist, " %10g", t);
365 fprintf(fz, " %10g", t);
366 fprintf(ftilt, " %10g", t);
367 fprintf(ftiltr, " %10g", t);
368 fprintf(ftiltl, " %10g", t);
369 if (bKink)
371 fprintf(fkink, " %10g", t);
372 fprintf(fkinkr, " %10g", t);
373 fprintf(fkinkl, " %10g", t);
376 for (i = 0; i < bun.n; i++)
378 fprintf(flen, " %6g", bun.len[i]);
379 fprintf(fdist, " %6g", norm(bun.mid[i]));
380 fprintf(fz, " %6g", bun.mid[i][ZZ]);
381 fprintf(ftilt, " %6g", RAD2DEG*acos(bun.dir[i][ZZ]));
382 comp = bun.mid[i][XX]*bun.dir[i][XX]+bun.mid[i][YY]*bun.dir[i][YY];
383 fprintf(ftiltr, " %6g", RAD2DEG*
384 std::asin(comp/std::hypot(comp, bun.dir[i][ZZ])));
385 comp = bun.mid[i][YY]*bun.dir[i][XX]-bun.mid[i][XX]*bun.dir[i][YY];
386 fprintf(ftiltl, " %6g", RAD2DEG*
387 std::asin(comp/std::hypot(comp, bun.dir[i][ZZ])));
388 if (bKink)
390 rvec_sub(bun.end[0][i], bun.end[2][i], va);
391 rvec_sub(bun.end[2][i], bun.end[1][i], vb);
392 unitv(va, va);
393 unitv(vb, vb);
394 fprintf(fkink, " %6g", RAD2DEG*acos(iprod(va, vb)));
395 cprod(va, vb, vc);
396 copy_rvec(bun.mid[i], vr);
397 vr[ZZ] = 0;
398 unitv(vr, vr);
399 fprintf(fkinkr, " %6g", RAD2DEG*std::asin(iprod(vc, vr)));
400 vl[XX] = vr[YY];
401 vl[YY] = -vr[XX];
402 vl[ZZ] = 0;
403 fprintf(fkinkl, " %6g", RAD2DEG*std::asin(iprod(vc, vl)));
406 fprintf(flen, "\n");
407 fprintf(fdist, "\n");
408 fprintf(fz, "\n");
409 fprintf(ftilt, "\n");
410 fprintf(ftiltr, "\n");
411 fprintf(ftiltl, "\n");
412 if (bKink)
414 fprintf(fkink, "\n");
415 fprintf(fkinkr, "\n");
416 fprintf(fkinkl, "\n");
418 if (fpdb)
420 dump_axes(fpdb, &fr, &outatoms, &bun);
423 while (read_next_frame(oenv, status, &fr));
424 gmx_rmpbc_done(gpbc);
426 close_trx(status);
428 if (fpdb)
430 close_trx(fpdb);
432 xvgrclose(flen);
433 xvgrclose(fdist);
434 xvgrclose(fz);
435 xvgrclose(ftilt);
436 xvgrclose(ftiltr);
437 xvgrclose(ftiltl);
438 if (bKink)
440 xvgrclose(fkink);
441 xvgrclose(fkinkr);
442 xvgrclose(fkinkl);
445 return 0;