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,2016,2017,2018, 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.
43 #include "gromacs/commandline/pargs.h"
44 #include "gromacs/commandline/viewit.h"
45 #include "gromacs/fileio/confio.h"
46 #include "gromacs/fileio/pdbio.h"
47 #include "gromacs/fileio/trxio.h"
48 #include "gromacs/fileio/xvgr.h"
49 #include "gromacs/gmxana/gmx_ana.h"
50 #include "gromacs/gmxana/princ.h"
51 #include "gromacs/linearalgebra/eigensolver.h"
52 #include "gromacs/math/do_fit.h"
53 #include "gromacs/math/functions.h"
54 #include "gromacs/math/utilities.h"
55 #include "gromacs/math/vec.h"
56 #include "gromacs/pbcutil/rmpbc.h"
57 #include "gromacs/topology/index.h"
58 #include "gromacs/topology/topology.h"
59 #include "gromacs/utility/arraysize.h"
60 #include "gromacs/utility/cstringutil.h"
61 #include "gromacs/utility/futil.h"
62 #include "gromacs/utility/smalloc.h"
64 static real
find_pdb_bfac(const t_atoms
*atoms
, t_resinfo
*ri
, char *atomnm
)
69 std::strcpy(rresnm
, *ri
->name
);
71 for (i
= 0; (i
< atoms
->nr
); i
++)
73 if ((ri
->nr
== atoms
->resinfo
[atoms
->atom
[i
].resind
].nr
) &&
74 (ri
->ic
== atoms
->resinfo
[atoms
->atom
[i
].resind
].ic
) &&
75 (std::strcmp(*atoms
->resinfo
[atoms
->atom
[i
].resind
].name
, rresnm
) == 0) &&
76 (std::strstr(*atoms
->atomname
[i
], atomnm
) != nullptr))
83 fprintf(stderr
, "\rCan not find %s%d-%s in pdbfile\n",
84 rresnm
, ri
->nr
, atomnm
);
89 return atoms
->pdbinfo
[i
].bfac
;
92 static void correlate_aniso(const char *fn
, t_atoms
*ref
, t_atoms
*calc
,
93 const gmx_output_env_t
*oenv
)
98 fp
= xvgropen(fn
, "Correlation between X-Ray and Computed Uij", "X-Ray",
100 for (i
= 0; (i
< ref
->nr
); i
++)
102 if (ref
->pdbinfo
[i
].bAnisotropic
)
104 for (j
= U11
; (j
<= U23
); j
++)
106 fprintf(fp
, "%10d %10d\n", ref
->pdbinfo
[i
].uij
[j
], calc
->pdbinfo
[i
].uij
[j
]);
113 static void average_residues(double f
[], double **U
, int uind
,
114 int isize
, const int index
[], const real w_rls
[],
115 const t_atoms
*atoms
)
127 for (i
= 0; i
< isize
; i
++)
129 av
+= w_rls
[index
[i
]]*(f
!= nullptr ? f
[i
] : U
[i
][uind
]);
130 m
+= w_rls
[index
[i
]];
132 atoms
->atom
[index
[i
]].resind
!= atoms
->atom
[index
[i
+1]].resind
)
137 for (j
= start
; j
<= i
; j
++)
144 for (j
= start
; j
<= i
; j
++)
156 static void print_dir(FILE *fp
, real
*Uaver
)
158 real eigvec
[DIM
*DIM
];
163 fprintf(fp
, "MSF X Y Z\n");
164 for (d
= 0; d
< DIM
; d
++)
166 fprintf(fp
, " %c ", 'X'+d
-XX
);
167 for (m
= 0; m
< DIM
; m
++)
169 fprintf(fp
, " %9.2e", Uaver
[3*m
+d
]);
171 fprintf(fp
, "%s\n", m
== DIM
? " (nm^2)" : "");
174 for (m
= 0; m
< DIM
*DIM
; m
++)
180 eigensolver(tmp
, DIM
, 0, DIM
, eigval
, eigvec
);
182 fprintf(fp
, "\n Eigenvectors\n\n");
183 fprintf(fp
, "Eigv %-8.2e %-8.2e %-8.2e (nm^2)\n\n",
184 eigval
[2], eigval
[1], eigval
[0]);
185 for (d
= 0; d
< DIM
; d
++)
187 fprintf(fp
, " %c ", 'X'+d
-XX
);
188 for (m
= DIM
-1; m
>= 0; m
--)
190 fprintf(fp
, "%7.4f ", eigvec
[3*m
+d
]);
196 int gmx_rmsf(int argc
, char *argv
[])
198 const char *desc
[] = {
199 "[THISMODULE] computes the root mean square fluctuation (RMSF, i.e. standard ",
200 "deviation) of atomic positions in the trajectory (supplied with [TT]-f[tt])",
201 "after (optionally) fitting to a reference frame (supplied with [TT]-s[tt]).[PAR]",
202 "With option [TT]-oq[tt] the RMSF values are converted to B-factor",
203 "values, which are written to a [REF].pdb[ref] file. By default, the coordinates",
204 "in this output file are taken from the structure file provided with [TT]-s[tt],"
205 "although you can also use coordinates read from a different [REF].pdb[ref] file"
206 "provided with [TT]-q[tt]. There is very little error checking, so in this case"
207 "it is your responsibility to make sure all atoms in the structure file"
208 "and [REF].pdb[ref] file correspond exactly to each other.[PAR]",
209 "Option [TT]-ox[tt] writes the B-factors to a file with the average",
210 "coordinates in the trajectory.[PAR]",
211 "With the option [TT]-od[tt] the root mean square deviation with",
212 "respect to the reference structure is calculated.[PAR]",
213 "With the option [TT]-aniso[tt], [THISMODULE] will compute anisotropic",
214 "temperature factors and then it will also output average coordinates",
215 "and a [REF].pdb[ref] file with ANISOU records (corresonding to the [TT]-oq[tt]",
216 "or [TT]-ox[tt] option). Please note that the U values",
217 "are orientation-dependent, so before comparison with experimental data",
218 "you should verify that you fit to the experimental coordinates.[PAR]",
219 "When a [REF].pdb[ref] input file is passed to the program and the [TT]-aniso[tt]",
221 "a correlation plot of the Uij will be created, if any anisotropic",
222 "temperature factors are present in the [REF].pdb[ref] file.[PAR]",
223 "With option [TT]-dir[tt] the average MSF (3x3) matrix is diagonalized.",
224 "This shows the directions in which the atoms fluctuate the most and",
227 static gmx_bool bRes
= FALSE
, bAniso
= FALSE
, bFit
= TRUE
;
229 { "-res", FALSE
, etBOOL
, {&bRes
},
230 "Calculate averages for each residue" },
231 { "-aniso", FALSE
, etBOOL
, {&bAniso
},
232 "Compute anisotropic termperature factors" },
233 { "-fit", FALSE
, etBOOL
, {&bFit
},
234 "Do a least squares superposition before computing RMSF. Without this you must make sure that the reference structure and the trajectory match." }
237 int i
, m
, teller
= 0;
242 t_atoms
*pdbatoms
, *refatoms
;
245 rvec
*x
, *pdbx
, *xref
;
249 FILE *fp
; /* the graphics file */
250 const char *devfn
, *dirfn
;
258 real bfac
, pdb_bfac
, *Uaver
;
261 rvec
*rmsd_x
= nullptr;
262 double *rmsf
, invcount
, totmass
;
266 gmx_rmpbc_t gpbc
= nullptr;
268 gmx_output_env_t
*oenv
;
270 const char *leg
[2] = { "MD", "X-Ray" };
273 { efTRX
, "-f", nullptr, ffREAD
},
274 { efTPS
, nullptr, nullptr, ffREAD
},
275 { efNDX
, nullptr, nullptr, ffOPTRD
},
276 { efPDB
, "-q", nullptr, ffOPTRD
},
277 { efPDB
, "-oq", "bfac", ffOPTWR
},
278 { efPDB
, "-ox", "xaver", ffOPTWR
},
279 { efXVG
, "-o", "rmsf", ffWRITE
},
280 { efXVG
, "-od", "rmsdev", ffOPTWR
},
281 { efXVG
, "-oc", "correl", ffOPTWR
},
282 { efLOG
, "-dir", "rmsf", ffOPTWR
}
284 #define NFILE asize(fnm)
286 if (!parse_common_args(&argc
, argv
, PCA_CAN_TIME
| PCA_CAN_VIEW
,
287 NFILE
, fnm
, asize(pargs
), pargs
, asize(desc
), desc
, 0, nullptr,
293 bReadPDB
= ftp2bSet(efPDB
, NFILE
, fnm
);
294 devfn
= opt2fn_null("-od", NFILE
, fnm
);
295 dirfn
= opt2fn_null("-dir", NFILE
, fnm
);
297 read_tps_conf(ftp2fn(efTPS
, NFILE
, fnm
), &top
, &ePBC
, &xref
, nullptr, box
, TRUE
);
298 const char *title
= *top
.name
;
299 snew(w_rls
, top
.atoms
.nr
);
301 fprintf(stderr
, "Select group(s) for root mean square calculation\n");
302 get_index(&top
.atoms
, ftp2fn_null(efNDX
, NFILE
, fnm
), 1, &isize
, &index
, &grpnames
);
305 for (i
= 0; i
< isize
; i
++)
307 w_rls
[index
[i
]] = top
.atoms
.atom
[index
[i
]].m
;
310 /* Malloc the rmsf arrays */
311 snew(xav
, isize
*DIM
);
313 for (i
= 0; i
< isize
; i
++)
327 /* Read coordinates twice */
328 read_tps_conf(opt2fn("-q", NFILE
, fnm
), top_pdb
, nullptr, nullptr, nullptr, pdbbox
, FALSE
);
330 *pdbatoms
= top_pdb
->atoms
;
331 read_tps_conf(opt2fn("-q", NFILE
, fnm
), top_pdb
, nullptr, &pdbx
, nullptr, pdbbox
, FALSE
);
332 /* TODO Should this assert that top_pdb->atoms.nr == top.atoms.nr?
333 * See discussion at https://gerrit.gromacs.org/#/c/6430/1 */
334 title
= *top_pdb
->name
;
336 *refatoms
= top_pdb
->atoms
;
341 pdbatoms
= &top
.atoms
;
342 refatoms
= &top
.atoms
;
344 snew(pdbatoms
->pdbinfo
, pdbatoms
->nr
);
345 pdbatoms
->havePdbInfo
= TRUE
;
346 copy_mat(box
, pdbbox
);
351 sub_xcm(xref
, isize
, index
, top
.atoms
.atom
, xcm
, FALSE
);
354 natom
= read_first_x(oenv
, &status
, ftp2fn(efTRX
, NFILE
, fnm
), &t
, &x
, box
);
358 gpbc
= gmx_rmpbc_init(&top
.idef
, ePBC
, natom
);
361 /* Now read the trj again to compute fluctuations */
367 /* Remove periodic boundary */
368 gmx_rmpbc(gpbc
, natom
, box
, x
);
370 /* Set center of mass to zero */
371 sub_xcm(x
, isize
, index
, top
.atoms
.atom
, xcm
, FALSE
);
373 /* Fit to reference structure */
374 do_fit(natom
, w_rls
, xref
, x
);
377 /* Calculate Anisotropic U Tensor */
378 for (i
= 0; i
< isize
; i
++)
381 for (d
= 0; d
< DIM
; d
++)
383 xav
[i
*DIM
+ d
] += x
[aid
][d
];
384 for (m
= 0; m
< DIM
; m
++)
386 U
[i
][d
*DIM
+ m
] += x
[aid
][d
]*x
[aid
][m
];
393 /* Calculate RMS Deviation */
394 for (i
= 0; (i
< isize
); i
++)
397 for (d
= 0; (d
< DIM
); d
++)
399 rmsd_x
[i
][d
] += gmx::square(x
[aid
][d
]-xref
[aid
][d
]);
406 while (read_next_x(oenv
, status
, &t
, x
, box
));
411 gmx_rmpbc_done(gpbc
);
415 invcount
= 1.0/count
;
416 snew(Uaver
, DIM
*DIM
);
418 for (i
= 0; i
< isize
; i
++)
420 for (d
= 0; d
< DIM
; d
++)
422 xav
[i
*DIM
+ d
] *= invcount
;
424 for (d
= 0; d
< DIM
; d
++)
426 for (m
= 0; m
< DIM
; m
++)
428 U
[i
][d
*DIM
+ m
] = U
[i
][d
*DIM
+ m
]*invcount
429 - xav
[i
*DIM
+ d
]*xav
[i
*DIM
+ m
];
430 Uaver
[3*d
+m
] += top
.atoms
.atom
[index
[i
]].m
*U
[i
][d
*DIM
+ m
];
433 totmass
+= top
.atoms
.atom
[index
[i
]].m
;
435 for (d
= 0; d
< DIM
*DIM
; d
++)
442 for (d
= 0; d
< DIM
*DIM
; d
++)
444 average_residues(nullptr, U
, d
, isize
, index
, w_rls
, &top
.atoms
);
450 for (i
= 0; i
< isize
; i
++)
453 pdbatoms
->pdbinfo
[aid
].bAnisotropic
= TRUE
;
454 pdbatoms
->pdbinfo
[aid
].uij
[U11
] = static_cast<int>(1e6
*U
[i
][XX
*DIM
+ XX
]);
455 pdbatoms
->pdbinfo
[aid
].uij
[U22
] = static_cast<int>(1e6
*U
[i
][YY
*DIM
+ YY
]);
456 pdbatoms
->pdbinfo
[aid
].uij
[U33
] = static_cast<int>(1e6
*U
[i
][ZZ
*DIM
+ ZZ
]);
457 pdbatoms
->pdbinfo
[aid
].uij
[U12
] = static_cast<int>(1e6
*U
[i
][XX
*DIM
+ YY
]);
458 pdbatoms
->pdbinfo
[aid
].uij
[U13
] = static_cast<int>(1e6
*U
[i
][XX
*DIM
+ ZZ
]);
459 pdbatoms
->pdbinfo
[aid
].uij
[U23
] = static_cast<int>(1e6
*U
[i
][YY
*DIM
+ ZZ
]);
471 for (i
= 0; i
< isize
; i
++)
473 rmsf
[i
] = U
[i
][XX
*DIM
+ XX
] + U
[i
][YY
*DIM
+ YY
] + U
[i
][ZZ
*DIM
+ ZZ
];
478 fprintf(stdout
, "\n");
479 print_dir(stdout
, Uaver
);
480 fp
= gmx_ffopen(dirfn
, "w");
481 print_dir(fp
, Uaver
);
485 for (i
= 0; i
< isize
; i
++)
491 /* Write RMSF output */
494 bfac
= 8.0*M_PI
*M_PI
/3.0*100;
495 fp
= xvgropen(ftp2fn(efXVG
, NFILE
, fnm
), "B-Factors",
496 label
, "(A\\b\\S\\So\\N\\S2\\N)", oenv
);
497 xvgr_legend(fp
, 2, leg
, oenv
);
498 for (i
= 0; (i
< isize
); i
++)
500 if (!bRes
|| i
+1 == isize
||
501 top
.atoms
.atom
[index
[i
]].resind
!= top
.atoms
.atom
[index
[i
+1]].resind
)
503 resind
= top
.atoms
.atom
[index
[i
]].resind
;
504 pdb_bfac
= find_pdb_bfac(pdbatoms
, &top
.atoms
.resinfo
[resind
],
505 *(top
.atoms
.atomname
[index
[i
]]));
507 fprintf(fp
, "%5d %10.5f %10.5f\n",
508 bRes
? top
.atoms
.resinfo
[top
.atoms
.atom
[index
[i
]].resind
].nr
: index
[i
]+1, rmsf
[i
]*bfac
,
516 fp
= xvgropen(ftp2fn(efXVG
, NFILE
, fnm
), "RMS fluctuation", label
, "(nm)", oenv
);
517 for (i
= 0; i
< isize
; i
++)
519 if (!bRes
|| i
+1 == isize
||
520 top
.atoms
.atom
[index
[i
]].resind
!= top
.atoms
.atom
[index
[i
+1]].resind
)
522 fprintf(fp
, "%5d %8.4f\n",
523 bRes
? top
.atoms
.resinfo
[top
.atoms
.atom
[index
[i
]].resind
].nr
: index
[i
]+1, std::sqrt(rmsf
[i
]));
529 for (i
= 0; i
< isize
; i
++)
531 pdbatoms
->pdbinfo
[index
[i
]].bfac
= 800*M_PI
*M_PI
/3.0*rmsf
[i
];
536 for (i
= 0; i
< isize
; i
++)
538 rmsf
[i
] = (rmsd_x
[i
][XX
]+rmsd_x
[i
][YY
]+rmsd_x
[i
][ZZ
])/count
;
542 average_residues(rmsf
, nullptr, 0, isize
, index
, w_rls
, &top
.atoms
);
544 /* Write RMSD output */
545 fp
= xvgropen(devfn
, "RMS Deviation", label
, "(nm)", oenv
);
546 for (i
= 0; i
< isize
; i
++)
548 if (!bRes
|| i
+1 == isize
||
549 top
.atoms
.atom
[index
[i
]].resind
!= top
.atoms
.atom
[index
[i
+1]].resind
)
551 fprintf(fp
, "%5d %8.4f\n",
552 bRes
? top
.atoms
.resinfo
[top
.atoms
.atom
[index
[i
]].resind
].nr
: index
[i
]+1, std::sqrt(rmsf
[i
]));
558 if (opt2bSet("-oq", NFILE
, fnm
))
560 /* Write a .pdb file with B-factors and optionally anisou records */
561 for (i
= 0; i
< isize
; i
++)
563 rvec_inc(pdbx
[index
[i
]], xcm
);
565 write_sto_conf_indexed(opt2fn("-oq", NFILE
, fnm
), title
, pdbatoms
, pdbx
,
566 nullptr, ePBC
, pdbbox
, isize
, index
);
568 if (opt2bSet("-ox", NFILE
, fnm
))
571 snew(bFactorX
, top
.atoms
.nr
);
572 for (i
= 0; i
< isize
; i
++)
574 for (d
= 0; d
< DIM
; d
++)
576 bFactorX
[index
[i
]][d
] = xcm
[d
] + xav
[i
*DIM
+ d
];
579 /* Write a .pdb file with B-factors and optionally anisou records */
580 write_sto_conf_indexed(opt2fn("-ox", NFILE
, fnm
), title
, pdbatoms
, bFactorX
, nullptr,
581 ePBC
, pdbbox
, isize
, index
);
586 correlate_aniso(opt2fn("-oc", NFILE
, fnm
), refatoms
, pdbatoms
, oenv
);
587 do_view(oenv
, opt2fn("-oc", NFILE
, fnm
), "-nxy");
589 do_view(oenv
, opt2fn("-o", NFILE
, fnm
), "-nxy");
592 do_view(oenv
, opt2fn("-od", NFILE
, fnm
), "-nxy");