Remove unused code detected by PGI compiler
[gromacs.git] / src / gromacs / gmxana / anadih.cpp
blob310dc10e0c20173082a5bc3ae76f4e50d01e3849
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 <cstdio>
41 #include <cstring>
43 #include <algorithm>
45 #include "gromacs/fileio/confio.h"
46 #include "gromacs/fileio/trxio.h"
47 #include "gromacs/fileio/txtdump.h"
48 #include "gromacs/fileio/xvgr.h"
49 #include "gromacs/gmxana/gstat.h"
50 #include "gromacs/listed-forces/bonded.h"
51 #include "gromacs/math/units.h"
52 #include "gromacs/math/vec.h"
53 #include "gromacs/pbcutil/pbc.h"
54 #include "gromacs/utility/fatalerror.h"
55 #include "gromacs/utility/smalloc.h"
57 void print_one(const gmx_output_env_t *oenv, const char *base, const char *name,
58 const char *title, const char *ylabel, int nf, real time[],
59 real data[])
61 FILE *fp;
62 char buf[256], t2[256];
63 int k;
65 sprintf(buf, "%s%s.xvg", base, name);
66 fprintf(stderr, "\rPrinting %s ", buf);
67 sprintf(t2, "%s %s", title, name);
68 fp = xvgropen(buf, t2, "Time (ps)", ylabel, oenv);
69 for (k = 0; (k < nf); k++)
71 fprintf(fp, "%10g %10g\n", time[k], data[k]);
73 xvgrclose(fp);
76 static int calc_RBbin(real phi, int gmx_unused multiplicity, real gmx_unused core_frac)
78 /* multiplicity and core_frac NOT used,
79 * just given to enable use of pt-to-fn in caller low_ana_dih_trans*/
80 static const real r30 = M_PI/6.0;
81 static const real r90 = M_PI/2.0;
82 static const real r150 = M_PI*5.0/6.0;
84 if ((phi < r30) && (phi > -r30))
86 return 1;
88 else if ((phi > -r150) && (phi < -r90))
90 return 2;
92 else if ((phi < r150) && (phi > r90))
94 return 3;
96 return 0;
99 static int calc_Nbin(real phi, int multiplicity, real core_frac)
101 static const real r360 = 360*DEG2RAD;
102 real rot_width, core_width, core_offset, low, hi;
103 int bin;
104 /* with multiplicity 3 and core_frac 0.5
105 * 0<g(-)<120, 120<t<240, 240<g(+)<360
106 * 0< bin0 < 30, 30<bin1<90, 90<bin0<150, 150<bin2<210, 210<bin0<270, 270<bin3<330, 330<bin0<360
107 * so with multiplicity 3, bin1 is core g(-), bin2 is core t, bin3 is
108 core g(+), bin0 is between rotamers */
109 if (phi < 0)
111 phi += r360;
114 rot_width = 360/multiplicity;
115 core_width = core_frac * rot_width;
116 core_offset = (rot_width - core_width)/2.0;
117 for (bin = 1; bin <= multiplicity; bin++)
119 low = ((bin - 1) * rot_width ) + core_offset;
120 hi = ((bin - 1) * rot_width ) + core_offset + core_width;
121 low *= DEG2RAD;
122 hi *= DEG2RAD;
123 if ((phi > low) && (phi < hi))
125 return bin;
128 return 0;
131 void ana_dih_trans(const char *fn_trans, const char *fn_histo,
132 real **dih, int nframes, int nangles,
133 const char *grpname, real *time, gmx_bool bRb,
134 const gmx_output_env_t *oenv)
136 /* just a wrapper; declare extra args, then chuck away at end. */
137 int maxchi = 0;
138 t_dlist *dlist;
139 int *multiplicity;
140 int nlist = nangles;
141 int k;
143 snew(dlist, nlist);
144 snew(multiplicity, nangles);
145 for (k = 0; (k < nangles); k++)
147 multiplicity[k] = 3;
150 low_ana_dih_trans(TRUE, fn_trans, TRUE, fn_histo, maxchi,
151 dih, nlist, dlist, nframes,
152 nangles, grpname, multiplicity, time, bRb, 0.5, oenv);
153 sfree(dlist);
154 sfree(multiplicity);
158 void low_ana_dih_trans(gmx_bool bTrans, const char *fn_trans,
159 gmx_bool bHisto, const char *fn_histo, int maxchi,
160 real **dih, int nlist, t_dlist dlist[], int nframes,
161 int nangles, const char *grpname, int multiplicity[],
162 real *time, gmx_bool bRb, real core_frac,
163 const gmx_output_env_t *oenv)
165 FILE *fp;
166 int *tr_f, *tr_h;
167 char title[256];
168 int i, j, k, Dih, ntrans;
169 int cur_bin, new_bin;
170 real ttime;
171 real *rot_occ[NROT];
172 int (*calc_bin)(real, int, real);
173 real dt;
175 if (1 <= nframes)
177 return;
179 /* Assumes the frames are equally spaced in time */
180 dt = (time[nframes-1]-time[0])/(nframes-1);
182 /* Analysis of dihedral transitions */
183 fprintf(stderr, "Now calculating transitions...\n");
185 if (bRb)
187 calc_bin = calc_RBbin;
189 else
191 calc_bin = calc_Nbin;
194 for (k = 0; k < NROT; k++)
196 snew(rot_occ[k], nangles);
197 for (i = 0; (i < nangles); i++)
199 rot_occ[k][i] = 0;
202 snew(tr_h, nangles);
203 snew(tr_f, nframes);
205 /* dih[i][j] is the dihedral angle i in frame j */
206 ntrans = 0;
207 for (i = 0; (i < nangles); i++)
210 /*#define OLDIE*/
211 #ifdef OLDIE
212 mind = maxd = prev = dih[i][0];
213 #else
214 cur_bin = calc_bin(dih[i][0], multiplicity[i], core_frac);
215 rot_occ[cur_bin][i]++;
216 #endif
217 for (j = 1; (j < nframes); j++)
219 new_bin = calc_bin(dih[i][j], multiplicity[i], core_frac);
220 rot_occ[new_bin][i]++;
221 #ifndef OLDIE
222 if (cur_bin == 0)
224 cur_bin = new_bin;
226 else if ((new_bin != 0) && (cur_bin != new_bin))
228 cur_bin = new_bin;
229 tr_f[j]++;
230 tr_h[i]++;
231 ntrans++;
233 #else
234 /* why is all this md rubbish periodic? Remove 360 degree periodicity */
235 if ( (dih[i][j] - prev) > M_PI)
237 dih[i][j] -= 2*M_PI;
239 else if ( (dih[i][j] - prev) < -M_PI)
241 dih[i][j] += 2*M_PI;
244 prev = dih[i][j];
246 mind = std::min(mind, dih[i][j]);
247 maxd = std::max(maxd, dih[i][j]);
248 if ( (maxd - mind) > 2*M_PI/3) /* or 120 degrees, assuming */
249 { /* multiplicity 3. Not so general.*/
250 tr_f[j]++;
251 tr_h[i]++;
252 maxd = mind = dih[i][j]; /* get ready for next transition */
253 ntrans++;
255 #endif
256 } /* end j */
257 for (k = 0; k < NROT; k++)
259 rot_occ[k][i] /= nframes;
261 } /* end i */
262 fprintf(stderr, "Total number of transitions: %10d\n", ntrans);
263 if (ntrans > 0)
265 ttime = (dt*nframes*nangles)/ntrans;
266 fprintf(stderr, "Time between transitions: %10.3f ps\n", ttime);
269 /* new by grs - copy transitions from tr_h[] to dlist->ntr[]
270 * and rotamer populations from rot_occ to dlist->rot_occ[]
271 * based on fn histogramming in g_chi. diff roles for i and j here */
273 j = 0;
274 for (Dih = 0; (Dih < NONCHI+maxchi); Dih++)
276 for (i = 0; (i < nlist); i++)
278 if (((Dih < edOmega) ) ||
279 ((Dih == edOmega) && (has_dihedral(edOmega, &(dlist[i])))) ||
280 ((Dih > edOmega) && (dlist[i].atm.Cn[Dih-NONCHI+3] != -1)))
282 /* grs debug printf("Not OK? i %d j %d Dih %d \n", i, j, Dih) ; */
283 dlist[i].ntr[Dih] = tr_h[j];
284 for (k = 0; k < NROT; k++)
286 dlist[i].rot_occ[Dih][k] = rot_occ[k][j];
288 j++;
293 /* end addition by grs */
295 if (bTrans)
297 sprintf(title, "Number of transitions: %s", grpname);
298 fp = xvgropen(fn_trans, title, "Time (ps)", "# transitions/timeframe", oenv);
299 for (j = 0; (j < nframes); j++)
301 fprintf(fp, "%10.3f %10d\n", time[j], tr_f[j]);
303 xvgrclose(fp);
306 /* Compute histogram from # transitions per dihedral */
307 /* Use old array */
308 for (j = 0; (j < nframes); j++)
310 tr_f[j] = 0;
312 for (i = 0; (i < nangles); i++)
314 tr_f[tr_h[i]]++;
316 for (j = nframes; ((tr_f[j-1] == 0) && (j > 0)); j--)
321 ttime = dt*nframes;
322 if (bHisto)
324 sprintf(title, "Transition time: %s", grpname);
325 fp = xvgropen(fn_histo, title, "Time (ps)", "#", oenv);
326 for (i = j-1; (i > 0); i--)
328 if (tr_f[i] != 0)
330 fprintf(fp, "%10.3f %10d\n", ttime/i, tr_f[i]);
333 xvgrclose(fp);
336 sfree(tr_f);
337 sfree(tr_h);
338 for (k = 0; k < NROT; k++)
340 sfree(rot_occ[k]);
345 void mk_multiplicity_lookup (int *multiplicity, int maxchi,
346 int nlist, t_dlist dlist[], int nangles)
348 /* new by grs - for dihedral j (as in dih[j]) get multiplicity from dlist
349 * and store in multiplicity[j]
352 int j, Dih, i;
353 char name[4];
355 j = 0;
356 for (Dih = 0; (Dih < NONCHI+maxchi); Dih++)
358 for (i = 0; (i < nlist); i++)
360 std::strncpy(name, dlist[i].name, 3);
361 name[3] = '\0';
362 if (((Dih < edOmega) ) ||
363 ((Dih == edOmega) && (has_dihedral(edOmega, &(dlist[i])))) ||
364 ((Dih > edOmega) && (dlist[i].atm.Cn[Dih-NONCHI+3] != -1)))
366 /* default - we will correct the rest below */
367 multiplicity[j] = 3;
369 /* make omegas 2fold, though doesn't make much more sense than 3 */
370 if (Dih == edOmega && (has_dihedral(edOmega, &(dlist[i]))))
372 multiplicity[j] = 2;
375 /* dihedrals to aromatic rings, COO, CONH2 or guanidinium are 2fold*/
376 if (Dih > edOmega && (dlist[i].atm.Cn[Dih-NONCHI+3] != -1))
378 if ( ((std::strstr(name, "PHE") != NULL) && (Dih == edChi2)) ||
379 ((std::strstr(name, "TYR") != NULL) && (Dih == edChi2)) ||
380 ((std::strstr(name, "PTR") != NULL) && (Dih == edChi2)) ||
381 ((std::strstr(name, "TRP") != NULL) && (Dih == edChi2)) ||
382 ((std::strstr(name, "HIS") != NULL) && (Dih == edChi2)) ||
383 ((std::strstr(name, "GLU") != NULL) && (Dih == edChi3)) ||
384 ((std::strstr(name, "ASP") != NULL) && (Dih == edChi2)) ||
385 ((std::strstr(name, "GLN") != NULL) && (Dih == edChi3)) ||
386 ((std::strstr(name, "ASN") != NULL) && (Dih == edChi2)) ||
387 ((std::strstr(name, "ARG") != NULL) && (Dih == edChi4)) )
389 multiplicity[j] = 2;
392 j++;
396 if (j < nangles)
398 fprintf(stderr, "WARNING: not all dihedrals found in topology (only %d out of %d)!\n",
399 j, nangles);
401 /* Check for remaining dihedrals */
402 for (; (j < nangles); j++)
404 multiplicity[j] = 3;
409 void mk_chi_lookup (int **lookup, int maxchi,
410 int nlist, t_dlist dlist[])
413 /* by grs. should rewrite everything to use this. (but haven't,
414 * and at mmt only used in get_chi_product_traj
415 * returns the dihed number given the residue number (from-0)
416 * and chi (from-0) nr. -1 for chi undefined for that res (eg gly, ala..)*/
418 int i, j, Dih, Chi;
420 j = 0;
421 /* NONCHI points to chi1, therefore we have to start counting there. */
422 for (Dih = NONCHI; (Dih < NONCHI+maxchi); Dih++)
424 for (i = 0; (i < nlist); i++)
426 Chi = Dih - NONCHI;
427 if (((Dih < edOmega) ) ||
428 ((Dih == edOmega) && (has_dihedral(edOmega, &(dlist[i])))) ||
429 ((Dih > edOmega) && (dlist[i].atm.Cn[Dih-NONCHI+3] != -1)))
431 /* grs debug printf("Not OK? i %d j %d Dih %d \n", i, j, Dih) ; */
432 if (Dih > edOmega)
434 lookup[i][Chi] = j;
436 j++;
438 else
440 lookup[i][Chi] = -1;
448 void get_chi_product_traj (real **dih, int nframes, int nlist,
449 int maxchi, t_dlist dlist[], real time[],
450 int **lookup, int *multiplicity, gmx_bool bRb, gmx_bool bNormalize,
451 real core_frac, gmx_bool bAll, const char *fnall,
452 const gmx_output_env_t *oenv)
455 gmx_bool bRotZero, bHaveChi = FALSE;
456 int accum = 0, index, i, j, k, Xi, n, b;
457 real *chi_prtrj;
458 int *chi_prhist;
459 int nbin;
460 FILE *fp, *fpall;
461 char hisfile[256], histitle[256], *namept;
463 int (*calc_bin)(real, int, real);
465 /* Analysis of dihedral transitions */
466 fprintf(stderr, "Now calculating Chi product trajectories...\n");
468 if (bRb)
470 calc_bin = calc_RBbin;
472 else
474 calc_bin = calc_Nbin;
477 snew(chi_prtrj, nframes);
479 /* file for info on all residues */
480 if (bNormalize)
482 fpall = xvgropen(fnall, "Cumulative Rotamers", "Residue", "Probability", oenv);
484 else
486 fpall = xvgropen(fnall, "Cumulative Rotamers", "Residue", "# Counts", oenv);
489 for (i = 0; (i < nlist); i++)
492 /* get nbin, the nr. of cumulative rotamers that need to be considered */
493 nbin = 1;
494 for (Xi = 0; Xi < maxchi; Xi++)
496 index = lookup[i][Xi]; /* chi_(Xi+1) of res i (-1 if off end) */
497 if (index >= 0)
499 n = multiplicity[index];
500 nbin = n*nbin;
503 nbin += 1; /* for the "zero rotamer", outside the core region */
505 for (j = 0; (j < nframes); j++)
508 bRotZero = FALSE;
509 bHaveChi = TRUE;
510 index = lookup[i][0]; /* index into dih of chi1 of res i */
511 if (index == -1)
513 bRotZero = TRUE;
514 bHaveChi = FALSE;
516 else
518 b = calc_bin(dih[index][j], multiplicity[index], core_frac);
519 accum = b - 1;
520 if (b == 0)
522 bRotZero = TRUE;
524 for (Xi = 1; Xi < maxchi; Xi++)
526 index = lookup[i][Xi]; /* chi_(Xi+1) of res i (-1 if off end) */
527 if (index >= 0)
529 n = multiplicity[index];
530 b = calc_bin(dih[index][j], n, core_frac);
531 accum = n * accum + b - 1;
532 if (b == 0)
534 bRotZero = TRUE;
538 accum++;
540 if (bRotZero)
542 chi_prtrj[j] = 0.0;
544 else
546 chi_prtrj[j] = accum;
547 if (accum+1 > nbin)
549 nbin = accum+1;
553 if (bHaveChi)
556 if (bAll)
558 /* print cuml rotamer vs time */
559 print_one(oenv, "chiproduct", dlist[i].name, "chi product for",
560 "cumulative rotamer", nframes, time, chi_prtrj);
563 /* make a histogram pf culm. rotamer occupancy too */
564 snew(chi_prhist, nbin);
565 make_histo(NULL, nframes, chi_prtrj, nbin, chi_prhist, 0, nbin);
566 if (bAll)
568 sprintf(hisfile, "histo-chiprod%s.xvg", dlist[i].name);
569 sprintf(histitle, "cumulative rotamer distribution for %s", dlist[i].name);
570 fprintf(stderr, " and %s ", hisfile);
571 fp = xvgropen(hisfile, histitle, "number", "", oenv);
572 if (output_env_get_print_xvgr_codes(oenv))
574 fprintf(fp, "@ xaxis tick on\n");
575 fprintf(fp, "@ xaxis tick major 1\n");
576 fprintf(fp, "@ type xy\n");
578 for (k = 0; (k < nbin); k++)
580 if (bNormalize)
582 fprintf(fp, "%5d %10g\n", k, (1.0*chi_prhist[k])/nframes);
584 else
586 fprintf(fp, "%5d %10d\n", k, chi_prhist[k]);
589 fprintf(fp, "%s\n", output_env_get_print_xvgr_codes(oenv) ? "&" : "");
590 xvgrclose(fp);
593 /* and finally print out occupancies to a single file */
594 /* get the gmx from-1 res nr by setting a ptr to the number part
595 * of dlist[i].name - potential bug for 4-letter res names... */
596 namept = dlist[i].name + 3;
597 fprintf(fpall, "%5s ", namept);
598 for (k = 0; (k < nbin); k++)
600 if (bNormalize)
602 fprintf(fpall, " %10g", (1.0*chi_prhist[k])/nframes);
604 else
606 fprintf(fpall, " %10d", chi_prhist[k]);
609 fprintf(fpall, "\n");
611 sfree(chi_prhist);
612 /* histogram done */
616 sfree(chi_prtrj);
617 xvgrclose(fpall);
618 fprintf(stderr, "\n");
622 void calc_distribution_props(int nh, int histo[], real start,
623 int nkkk, t_karplus kkk[],
624 real *S2)
626 real d, dc, ds, c1, c2, tdc, tds;
627 real fac, ang, invth, Jc;
628 int i, j, th;
630 if (nh == 0)
632 gmx_fatal(FARGS, "No points in histogram (%s, %d)", __FILE__, __LINE__);
634 fac = 2*M_PI/nh;
636 /* Compute normalisation factor */
637 th = 0;
638 for (j = 0; (j < nh); j++)
640 th += histo[j];
642 invth = 1.0/th;
644 for (i = 0; (i < nkkk); i++)
646 kkk[i].Jc = 0;
647 kkk[i].Jcsig = 0;
649 tdc = 0, tds = 0;
650 for (j = 0; (j < nh); j++)
652 d = invth*histo[j];
653 ang = j*fac-start;
654 c1 = std::cos(ang);
655 dc = d*c1;
656 ds = d*std::sin(ang);
657 tdc += dc;
658 tds += ds;
659 for (i = 0; (i < nkkk); i++)
661 c1 = std::cos(ang+kkk[i].offset);
662 c2 = c1*c1;
663 Jc = (kkk[i].A*c2 + kkk[i].B*c1 + kkk[i].C);
664 kkk[i].Jc += histo[j]*Jc;
665 kkk[i].Jcsig += histo[j]*sqr(Jc);
668 for (i = 0; (i < nkkk); i++)
670 kkk[i].Jc /= th;
671 kkk[i].Jcsig = std::sqrt(kkk[i].Jcsig/th-sqr(kkk[i].Jc));
673 *S2 = tdc*tdc+tds*tds;
676 static void calc_angles(struct t_pbc *pbc,
677 int n3, int index[], real ang[], rvec x_s[])
679 int i, ix, t1, t2;
680 rvec r_ij, r_kj;
681 real costh = 0.0;
683 for (i = ix = 0; (ix < n3); i++, ix += 3)
685 ang[i] = bond_angle(x_s[index[ix]], x_s[index[ix+1]], x_s[index[ix+2]],
686 pbc, r_ij, r_kj, &costh, &t1, &t2);
688 if (debug)
690 fprintf(debug, "Angle[0]=%g, costh=%g, index0 = %d, %d, %d\n",
691 ang[0], costh, index[0], index[1], index[2]);
692 pr_rvec(debug, 0, "rij", r_ij, DIM, TRUE);
693 pr_rvec(debug, 0, "rkj", r_kj, DIM, TRUE);
697 static real calc_fraction(real angles[], int nangles)
699 int i;
700 real trans = 0, gauche = 0;
701 real angle;
703 for (i = 0; i < nangles; i++)
705 angle = angles[i] * RAD2DEG;
707 if (angle > 135 && angle < 225)
709 trans += 1.0;
711 else if (angle > 270 && angle < 330)
713 gauche += 1.0;
715 else if (angle < 90 && angle > 30)
717 gauche += 1.0;
720 if (trans+gauche > 0)
722 return trans/(trans+gauche);
724 else
726 return 0;
730 static void calc_dihs(struct t_pbc *pbc,
731 int n4, int index[], real ang[], rvec x_s[])
733 int i, ix, t1, t2, t3;
734 rvec r_ij, r_kj, r_kl, m, n;
735 real sign, aaa;
737 for (i = ix = 0; (ix < n4); i++, ix += 4)
739 aaa = dih_angle(x_s[index[ix]], x_s[index[ix+1]], x_s[index[ix+2]],
740 x_s[index[ix+3]], pbc,
741 r_ij, r_kj, r_kl, m, n,
742 &sign, &t1, &t2, &t3);
744 ang[i] = aaa; /* not taking into account ryckaert bellemans yet */
748 void make_histo(FILE *log,
749 int ndata, real data[], int npoints, int histo[],
750 real minx, real maxx)
752 double dx;
753 int i, ind;
755 if (minx == maxx)
757 minx = maxx = data[0];
758 for (i = 1; (i < ndata); i++)
760 minx = std::min(minx, data[i]);
761 maxx = std::max(maxx, data[i]);
763 fprintf(log, "Min data: %10g Max data: %10g\n", minx, maxx);
765 dx = npoints/(maxx-minx);
766 if (debug)
768 fprintf(debug,
769 "Histogramming: ndata=%d, nhisto=%d, minx=%g,maxx=%g,dx=%g\n",
770 ndata, npoints, minx, maxx, dx);
772 for (i = 0; (i < ndata); i++)
774 ind = static_cast<int>((data[i]-minx)*dx);
775 if ((ind >= 0) && (ind < npoints))
777 histo[ind]++;
779 else
781 fprintf(log, "index = %d, data[%d] = %g\n", ind, i, data[i]);
786 void normalize_histo(int npoints, int histo[], real dx, real normhisto[])
788 int i;
789 double d, fac;
791 d = 0;
792 for (i = 0; (i < npoints); i++)
794 d += dx*histo[i];
796 if (d == 0)
798 fprintf(stderr, "Empty histogram!\n");
799 return;
801 fac = 1.0/d;
802 for (i = 0; (i < npoints); i++)
804 normhisto[i] = fac*histo[i];
808 void read_ang_dih(const char *trj_fn,
809 gmx_bool bAngles, gmx_bool bSaveAll, gmx_bool bRb, gmx_bool bPBC,
810 int maxangstat, int angstat[],
811 int *nframes, real **time,
812 int isize, int index[],
813 real **trans_frac,
814 real **aver_angle,
815 real *dih[],
816 const gmx_output_env_t *oenv)
818 struct t_pbc *pbc;
819 t_trxstatus *status;
820 int i, angind, total, teller;
821 int nangles, n_alloc;
822 real t, fraction, pifac, aa, angle;
823 real *angles[2];
824 matrix box;
825 rvec *x;
826 int cur = 0;
827 #define prev (1-cur)
829 snew(pbc, 1);
830 read_first_x(oenv, &status, trj_fn, &t, &x, box);
832 if (bAngles)
834 nangles = isize/3;
835 pifac = M_PI;
837 else
839 nangles = isize/4;
840 pifac = 2.0*M_PI;
842 snew(angles[cur], nangles);
843 snew(angles[prev], nangles);
845 /* Start the loop over frames */
846 total = 0;
847 teller = 0;
848 n_alloc = 0;
849 *time = NULL;
850 *trans_frac = NULL;
851 *aver_angle = NULL;
855 if (teller >= n_alloc)
857 n_alloc += 100;
858 if (bSaveAll)
860 for (i = 0; (i < nangles); i++)
862 srenew(dih[i], n_alloc);
865 srenew(*time, n_alloc);
866 srenew(*trans_frac, n_alloc);
867 srenew(*aver_angle, n_alloc);
870 (*time)[teller] = t;
872 if (pbc)
874 set_pbc(pbc, -1, box);
877 if (bAngles)
879 calc_angles(pbc, isize, index, angles[cur], x);
881 else
883 calc_dihs(pbc, isize, index, angles[cur], x);
885 /* Trans fraction */
886 fraction = calc_fraction(angles[cur], nangles);
887 (*trans_frac)[teller] = fraction;
889 /* Change Ryckaert-Bellemans dihedrals to polymer convention
890 * Modified 990913 by Erik:
891 * We actually shouldn't change the convention, since it's
892 * calculated from polymer above, but we change the intervall
893 * from [-180,180] to [0,360].
895 if (bRb)
897 for (i = 0; (i < nangles); i++)
899 if (angles[cur][i] <= 0.0)
901 angles[cur][i] += 2*M_PI;
906 /* Periodicity in dihedral space... */
907 if (bPBC)
909 for (i = 0; (i < nangles); i++)
911 real dd = angles[cur][i];
912 angles[cur][i] = std::atan2(std::sin(dd), std::cos(dd));
915 else
917 if (teller > 1)
919 for (i = 0; (i < nangles); i++)
921 while (angles[cur][i] <= angles[prev][i] - M_PI)
923 angles[cur][i] += 2*M_PI;
925 while (angles[cur][i] > angles[prev][i] + M_PI)
927 angles[cur][i] -= 2*M_PI;
934 /* Average angles */
935 aa = 0;
936 for (i = 0; (i < nangles); i++)
938 aa = aa+angles[cur][i];
940 /* angle in rad / 2Pi * max determines bin. bins go from 0 to maxangstat,
941 even though scale goes from -pi to pi (dihedral) or -pi/2 to pi/2
942 (angle) Basically: translate the x-axis by Pi. Translate it back by
943 -Pi when plotting.
946 angle = angles[cur][i];
947 if (!bAngles)
949 while (angle < -M_PI)
951 angle += 2*M_PI;
953 while (angle >= M_PI)
955 angle -= 2*M_PI;
958 angle += M_PI;
961 /* Update the distribution histogram */
962 angind = static_cast<int>((angle*maxangstat)/pifac + 0.5);
963 if (angind == maxangstat)
965 angind = 0;
967 if ( (angind < 0) || (angind >= maxangstat) )
969 /* this will never happen */
970 gmx_fatal(FARGS, "angle (%f) index out of range (0..%d) : %d\n",
971 angle, maxangstat, angind);
974 angstat[angind]++;
975 if (angind == maxangstat)
977 fprintf(stderr, "angle %d fr %d = %g\n", i, cur, angle);
980 total++;
983 /* average over all angles */
984 (*aver_angle)[teller] = (aa/nangles);
986 /* this copies all current dih. angles to dih[i], teller is frame */
987 if (bSaveAll)
989 for (i = 0; i < nangles; i++)
991 dih[i][teller] = angles[cur][i];
995 /* Swap buffers */
996 cur = prev;
998 /* Increment loop counter */
999 teller++;
1001 while (read_next_x(oenv, status, &t, x, box));
1002 close_trj(status);
1004 sfree(x);
1005 sfree(angles[cur]);
1006 sfree(angles[prev]);
1008 *nframes = teller;