Enforced rotation: fixed torque calculation for FLEX potential when using mass-weighting
[gromacs/adressmacs.git] / src / tools / gmx_editconf.c
blobe236753a22617681d9294f2cc9b714847e6d9352
1 /* -*- mode: c; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4; c-file-style: "stroustrup"; -*-
3 *
4 * This source code is part of
5 *
6 * G R O M A C S
7 *
8 * GROningen MAchine for Chemical Simulations
9 *
10 * VERSION 3.2.0
11 * Written by David van der Spoel, Erik Lindahl, Berk Hess, and others.
12 * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
13 * Copyright (c) 2001-2004, The GROMACS development team,
14 * check out http://www.gromacs.org for more information.
16 * This program is free software; you can redistribute it and/or
17 * modify it under the terms of the GNU General Public License
18 * as published by the Free Software Foundation; either version 2
19 * of the License, or (at your option) any later version.
21 * If you want to redistribute modifications, please consider that
22 * scientific software is very special. Version control is crucial -
23 * bugs must be traceable. We will be happy to consider code for
24 * inclusion in the official distribution, but derived work must not
25 * be called official GROMACS. Details are found in the README & COPYING
26 * files - if they are missing, get the official version at www.gromacs.org.
28 * To help us fund GROMACS development, we humbly ask that you cite
29 * the papers on the package - you can find them in the top README file.
31 * For more info, check our website at http://www.gromacs.org
33 * And Hey:
34 * Green Red Orange Magenta Azure Cyan Skyblue
36 #ifdef HAVE_CONFIG_H
37 #include <config.h>
38 #endif
40 #include <math.h>
41 #include <string.h>
42 #include <ctype.h>
43 #include "pdbio.h"
44 #include "confio.h"
45 #include "symtab.h"
46 #include "smalloc.h"
47 #include "macros.h"
48 #include "copyrite.h"
49 #include "statutil.h"
50 #include "string2.h"
51 #include "strdb.h"
52 #include "index.h"
53 #include "vec.h"
54 #include "typedefs.h"
55 #include "gbutil.h"
56 #include "strdb.h"
57 #include "physics.h"
58 #include "atomprop.h"
59 #include "tpxio.h"
60 #include "pbc.h"
61 #include "princ.h"
62 #include "txtdump.h"
63 #include "viewit.h"
64 #include "rmpbc.h"
65 #include "gmx_ana.h"
67 typedef struct
69 char sanm[12];
70 int natm;
71 int nw;
72 char anm[6][12];
73 } t_simat;
75 typedef struct
77 char reso[12];
78 char resn[12];
79 int nsatm;
80 t_simat sat[3];
81 } t_simlist;
82 static const char *pdbtp[epdbNR] =
83 { "ATOM ", "HETATM" };
85 real calc_mass(t_atoms *atoms, gmx_bool bGetMass, gmx_atomprop_t aps)
87 real tmass;
88 int i;
90 tmass = 0;
91 for (i = 0; (i < atoms->nr); i++)
93 if (bGetMass)
95 gmx_atomprop_query(aps, epropMass,
96 *atoms->resinfo[atoms->atom[i].resind].name,
97 *atoms->atomname[i], &(atoms->atom[i].m));
99 tmass += atoms->atom[i].m;
102 return tmass;
105 real calc_geom(int isize, atom_id *index, rvec *x, rvec geom_center, rvec min,
106 rvec max, gmx_bool bDiam)
108 real diam2, d;
109 char *grpnames;
110 int ii, i, j;
112 clear_rvec(geom_center);
113 diam2 = 0;
114 if (isize == 0)
116 clear_rvec(min);
117 clear_rvec(max);
119 else
121 if (index)
122 ii = index[0];
123 else
124 ii = 0;
125 for (j = 0; j < DIM; j++)
126 min[j] = max[j] = x[ii][j];
127 for (i = 0; i < isize; i++)
129 if (index)
130 ii = index[i];
131 else
132 ii = i;
133 rvec_inc(geom_center, x[ii]);
134 for (j = 0; j < DIM; j++)
136 if (x[ii][j] < min[j])
137 min[j] = x[ii][j];
138 if (x[ii][j] > max[j])
139 max[j] = x[ii][j];
141 if (bDiam)
143 if (index)
144 for (j = i + 1; j < isize; j++)
146 d = distance2(x[ii], x[index[j]]);
147 diam2 = max(d,diam2);
149 else
150 for (j = i + 1; j < isize; j++)
152 d = distance2(x[i], x[j]);
153 diam2 = max(d,diam2);
157 svmul(1.0 / isize, geom_center, geom_center);
160 return sqrt(diam2);
163 void center_conf(int natom, rvec *x, rvec center, rvec geom_cent)
165 int i;
166 rvec shift;
168 rvec_sub(center, geom_cent, shift);
170 printf(" shift :%7.3f%7.3f%7.3f (nm)\n", shift[XX], shift[YY],
171 shift[ZZ]);
173 for (i = 0; (i < natom); i++)
174 rvec_inc(x[i], shift);
177 void scale_conf(int natom, rvec x[], matrix box, rvec scale)
179 int i, j;
181 for (i = 0; i < natom; i++)
183 for (j = 0; j < DIM; j++)
184 x[i][j] *= scale[j];
186 for (i = 0; i < DIM; i++)
187 for (j = 0; j < DIM; j++)
188 box[i][j] *= scale[j];
191 void read_bfac(const char *fn, int *n_bfac, double **bfac_val, int **bfac_nr)
193 int i;
194 char **bfac_lines;
196 *n_bfac = get_lines(fn, &bfac_lines);
197 snew(*bfac_val, *n_bfac);
198 snew(*bfac_nr, *n_bfac);
199 fprintf(stderr, "Reading %d B-factors from %s\n", *n_bfac, fn);
200 for (i = 0; (i < *n_bfac); i++)
202 /*fprintf(stderr, "Line %d: %s",i,bfac_lines[i]);*/
203 sscanf(bfac_lines[i], "%d %lf", &(*bfac_nr)[i], &(*bfac_val)[i]);
204 /*fprintf(stderr," nr %d val %g\n",(*bfac_nr)[i],(*bfac_val)[i]);*/
209 void set_pdb_conf_bfac(int natoms, int nres, t_atoms *atoms, int n_bfac,
210 double *bfac, int *bfac_nr, gmx_bool peratom)
212 FILE *out;
213 real bfac_min, bfac_max;
214 int i, n;
215 gmx_bool found;
217 bfac_max = -1e10;
218 bfac_min = 1e10;
219 for (i = 0; (i < n_bfac); i++)
221 if (bfac_nr[i] - 1 >= atoms->nres)
222 peratom = TRUE;
223 /* if ((bfac_nr[i]-1<0) || (bfac_nr[i]-1>=atoms->nr))
224 gmx_fatal(FARGS,"Index of B-Factor %d is out of range: %d (%g)",
225 i+1,bfac_nr[i],bfac[i]); */
226 if (bfac[i] > bfac_max)
227 bfac_max = bfac[i];
228 if (bfac[i] < bfac_min)
229 bfac_min = bfac[i];
231 while ((bfac_max > 99.99) || (bfac_min < -99.99))
233 fprintf(stderr,
234 "Range of values for B-factors too large (min %g, max %g) "
235 "will scale down a factor 10\n", bfac_min, bfac_max);
236 for (i = 0; (i < n_bfac); i++)
237 bfac[i] /= 10;
238 bfac_max /= 10;
239 bfac_min /= 10;
241 while ((fabs(bfac_max) < 0.5) && (fabs(bfac_min) < 0.5))
243 fprintf(stderr,
244 "Range of values for B-factors too small (min %g, max %g) "
245 "will scale up a factor 10\n", bfac_min, bfac_max);
246 for (i = 0; (i < n_bfac); i++)
247 bfac[i] *= 10;
248 bfac_max *= 10;
249 bfac_min *= 10;
252 for (i = 0; (i < natoms); i++)
253 atoms->pdbinfo[i].bfac = 0;
255 if (!peratom)
257 fprintf(stderr, "Will attach %d B-factors to %d residues\n", n_bfac,
258 nres);
259 for (i = 0; (i < n_bfac); i++)
261 found = FALSE;
262 for (n = 0; (n < natoms); n++)
263 if (bfac_nr[i] == atoms->resinfo[atoms->atom[n].resind].nr)
265 atoms->pdbinfo[n].bfac = bfac[i];
266 found = TRUE;
268 if (!found)
270 gmx_warning("Residue nr %d not found\n", bfac_nr[i]);
274 else
276 fprintf(stderr, "Will attach %d B-factors to %d atoms\n", n_bfac,
277 natoms);
278 for (i = 0; (i < n_bfac); i++)
280 atoms->pdbinfo[bfac_nr[i] - 1].bfac = bfac[i];
285 void pdb_legend(FILE *out, int natoms, int nres, t_atoms *atoms, rvec x[])
287 real bfac_min, bfac_max, xmin, ymin, zmin;
288 int i;
289 int space = ' ';
291 bfac_max = -1e10;
292 bfac_min = 1e10;
293 xmin = 1e10;
294 ymin = 1e10;
295 zmin = 1e10;
296 for (i = 0; (i < natoms); i++)
298 xmin = min(xmin,x[i][XX]);
299 ymin = min(ymin,x[i][YY]);
300 zmin = min(zmin,x[i][ZZ]);
301 bfac_min = min(bfac_min,atoms->pdbinfo[i].bfac);
302 bfac_max = max(bfac_max,atoms->pdbinfo[i].bfac);
304 fprintf(stderr, "B-factors range from %g to %g\n", bfac_min, bfac_max);
305 for (i = 1; (i < 12); i++)
307 fprintf(out,
308 "%-6s%5u %-4.4s%3.3s %c%4d%c %8.3f%8.3f%8.3f%6.2f%6.2f\n",
309 "ATOM ", natoms + 1 + i, "CA", "LEG", space, nres + 1, space,
310 (xmin + (i * 0.12)) * 10, ymin * 10, zmin * 10, 1.0, bfac_min
311 + ((i - 1.0) * (bfac_max - bfac_min) / 10));
315 void visualize_images(const char *fn, int ePBC, matrix box)
317 t_atoms atoms;
318 rvec *img;
319 char *c, *ala;
320 int nat, i;
322 nat = NTRICIMG + 1;
323 init_t_atoms(&atoms, nat, FALSE);
324 atoms.nr = nat;
325 snew(img,nat);
326 /* FIXME: Constness should not be cast away */
327 c = (char *) "C";
328 ala = (char *) "ALA";
329 for (i = 0; i < nat; i++)
331 atoms.atomname[i] = &c;
332 atoms.atom[i].resind = i;
333 atoms.resinfo[i].name = &ala;
334 atoms.resinfo[i].nr = i + 1;
335 atoms.resinfo[i].chainid = 'A' + i / NCUCVERT;
337 calc_triclinic_images(box, img + 1);
339 write_sto_conf(fn, "Images", &atoms, img, NULL, ePBC, box);
341 free_t_atoms(&atoms, FALSE);
342 sfree(img);
345 void visualize_box(FILE *out, int a0, int r0, matrix box, rvec gridsize)
347 int *edge;
348 rvec *vert, shift;
349 int nx, ny, nz, nbox, nat;
350 int i, j, x, y, z;
351 int rectedge[24] =
352 { 0, 1, 1, 3, 3, 2, 0, 2, 0, 4, 1, 5, 3, 7, 2, 6, 4, 5, 5, 7, 7, 6, 6,
353 4 };
355 a0++;
356 r0++;
358 nx = (int) (gridsize[XX] + 0.5);
359 ny = (int) (gridsize[YY] + 0.5);
360 nz = (int) (gridsize[ZZ] + 0.5);
361 nbox = nx * ny * nz;
362 if (TRICLINIC(box))
364 nat = nbox * NCUCVERT;
365 snew(vert,nat);
366 calc_compact_unitcell_vertices(ecenterDEF, box, vert);
367 j = 0;
368 for (z = 0; z < nz; z++)
369 for (y = 0; y < ny; y++)
370 for (x = 0; x < nx; x++)
372 for (i = 0; i < DIM; i++)
373 shift[i] = x * box[0][i] + y * box[1][i] + z
374 * box[2][i];
375 for (i = 0; i < NCUCVERT; i++)
377 rvec_add(vert[i], shift, vert[j]);
378 j++;
382 for (i = 0; i < nat; i++)
384 fprintf(out, pdbformat, "ATOM", a0 + i, "C", "BOX", 'K' + i
385 / NCUCVERT, r0 + i, 10 * vert[i][XX], 10 * vert[i][YY], 10
386 * vert[i][ZZ]);
387 fprintf(out, "\n");
390 edge = compact_unitcell_edges();
391 for (j = 0; j < nbox; j++)
392 for (i = 0; i < NCUCEDGE; i++)
393 fprintf(out, "CONECT%5d%5d\n", a0 + j * NCUCVERT + edge[2 * i],
394 a0 + j * NCUCVERT + edge[2 * i + 1]);
396 sfree(vert);
398 else
400 i = 0;
401 for (z = 0; z <= 1; z++)
402 for (y = 0; y <= 1; y++)
403 for (x = 0; x <= 1; x++)
405 fprintf(out, pdbformat, "ATOM", a0 + i, "C", "BOX", 'K' + i
406 / 8, r0 + i, x * 10 * box[XX][XX],
407 y * 10 * box[YY][YY], z * 10 * box[ZZ][ZZ]);
408 fprintf(out, "\n");
409 i++;
411 for (i = 0; i < 24; i += 2)
412 fprintf(out, "CONECT%5d%5d\n", a0 + rectedge[i], a0 + rectedge[i
413 + 1]);
417 void calc_rotmatrix(rvec principal_axis, rvec targetvec, matrix rotmatrix)
419 rvec rotvec;
420 real ux,uy,uz,costheta,sintheta;
422 costheta = cos_angle(principal_axis,targetvec);
423 sintheta=sqrt(1.0-costheta*costheta); /* sign is always positive since 0<theta<pi */
425 /* Determine rotation from cross product with target vector */
426 cprod(principal_axis,targetvec,rotvec);
427 unitv(rotvec,rotvec);
428 printf("Aligning %g %g %g to %g %g %g : xprod %g %g %g\n",
429 principal_axis[XX],principal_axis[YY],principal_axis[ZZ],targetvec[XX],targetvec[YY],targetvec[ZZ],
430 rotvec[XX],rotvec[YY],rotvec[ZZ]);
432 ux=rotvec[XX];
433 uy=rotvec[YY];
434 uz=rotvec[ZZ];
435 rotmatrix[0][0]=ux*ux + (1.0-ux*ux)*costheta;
436 rotmatrix[0][1]=ux*uy*(1-costheta)-uz*sintheta;
437 rotmatrix[0][2]=ux*uz*(1-costheta)+uy*sintheta;
438 rotmatrix[1][0]=ux*uy*(1-costheta)+uz*sintheta;
439 rotmatrix[1][1]=uy*uy + (1.0-uy*uy)*costheta;
440 rotmatrix[1][2]=uy*uz*(1-costheta)-ux*sintheta;
441 rotmatrix[2][0]=ux*uz*(1-costheta)-uy*sintheta;
442 rotmatrix[2][1]=uy*uz*(1-costheta)+ux*sintheta;
443 rotmatrix[2][2]=uz*uz + (1.0-uz*uz)*costheta;
445 printf("Rotation matrix: \n%g %g %g\n%g %g %g\n%g %g %g\n",
446 rotmatrix[0][0],rotmatrix[0][1],rotmatrix[0][2],
447 rotmatrix[1][0],rotmatrix[1][1],rotmatrix[1][2],
448 rotmatrix[2][0],rotmatrix[2][1],rotmatrix[2][2]);
451 static void renum_resnr(t_atoms *atoms,int isize,const int *index,
452 int resnr_start)
454 int i,resind_prev,resind;
456 resind_prev = -1;
457 for(i=0; i<isize; i++)
459 resind = atoms->atom[index == NULL ? i : index[i]].resind;
460 if (resind != resind_prev)
462 atoms->resinfo[resind].nr = resnr_start;
463 resnr_start++;
465 resind_prev = resind;
469 int gmx_editconf(int argc, char *argv[])
471 const char
472 *desc[] =
474 "editconf converts generic structure format to [TT].gro[tt], [TT].g96[tt]",
475 "or [TT].pdb[tt].",
476 "[PAR]",
477 "The box can be modified with options [TT]-box[tt], [TT]-d[tt] and",
478 "[TT]-angles[tt]. Both [TT]-box[tt] and [TT]-d[tt]",
479 "will center the system in the box, unless [TT]-noc[tt] is used.",
480 "[PAR]",
481 "Option [TT]-bt[tt] determines the box type: [TT]triclinic[tt] is a",
482 "triclinic box, [TT]cubic[tt] is a rectangular box with all sides equal",
483 "[TT]dodecahedron[tt] represents a rhombic dodecahedron and",
484 "[TT]octahedron[tt] is a truncated octahedron.",
485 "The last two are special cases of a triclinic box.",
486 "The length of the three box vectors of the truncated octahedron is the",
487 "shortest distance between two opposite hexagons.",
488 "The volume of a dodecahedron is 0.71 and that of a truncated octahedron",
489 "is 0.77 of that of a cubic box with the same periodic image distance.",
490 "[PAR]",
491 "Option [TT]-box[tt] requires only",
492 "one value for a cubic box, dodecahedron and a truncated octahedron.",
493 "[PAR]",
494 "With [TT]-d[tt] and a [TT]triclinic[tt] box the size of the system in the x, y",
495 "and z directions is used. With [TT]-d[tt] and [TT]cubic[tt],",
496 "[TT]dodecahedron[tt] or [TT]octahedron[tt] boxes, the dimensions are set",
497 "to the diameter of the system (largest distance between atoms) plus twice",
498 "the specified distance.",
499 "[PAR]",
500 "Option [TT]-angles[tt] is only meaningful with option [TT]-box[tt] and",
501 "a triclinic box and can not be used with option [TT]-d[tt].",
502 "[PAR]",
503 "When [TT]-n[tt] or [TT]-ndef[tt] is set, a group",
504 "can be selected for calculating the size and the geometric center,",
505 "otherwise the whole system is used.",
506 "[PAR]",
507 "[TT]-rotate[tt] rotates the coordinates and velocities.",
508 "[PAR]",
509 "[TT]-princ[tt] aligns the principal axes of the system along the",
510 "coordinate axes, this may allow you to decrease the box volume,",
511 "but beware that molecules can rotate significantly in a nanosecond.",
512 "[PAR]",
513 "Scaling is applied before any of the other operations are",
514 "performed. Boxes and coordinates can be scaled to give a certain density (option",
515 "[TT]-density[tt]). Note that this may be inaccurate in case a gro",
516 "file is given as input. A special feature of the scaling option, when the",
517 "factor -1 is given in one dimension, one obtains a mirror image,",
518 "mirrored in one of the plains, when one uses -1 in three dimensions",
519 "a point-mirror image is obtained.[PAR]",
520 "Groups are selected after all operations have been applied.[PAR]",
521 "Periodicity can be removed in a crude manner.",
522 "It is important that the box sizes at the bottom of your input file",
523 "are correct when the periodicity is to be removed.",
524 "[PAR]",
525 "When writing [TT].pdb[tt] files, B-factors can be",
526 "added with the [TT]-bf[tt] option. B-factors are read",
527 "from a file with with following format: first line states number of",
528 "entries in the file, next lines state an index",
529 "followed by a B-factor. The B-factors will be attached per residue",
530 "unless an index is larger than the number of residues or unless the",
531 "[TT]-atom[tt] option is set. Obviously, any type of numeric data can",
532 "be added instead of B-factors. [TT]-legend[tt] will produce",
533 "a row of CA atoms with B-factors ranging from the minimum to the",
534 "maximum value found, effectively making a legend for viewing.",
535 "[PAR]",
536 "With the option -mead a special pdb (pqr) file for the MEAD electrostatics",
537 "program (Poisson-Boltzmann solver) can be made. A further prerequisite",
538 "is that the input file is a run input file.",
539 "The B-factor field is then filled with the Van der Waals radius",
540 "of the atoms while the occupancy field will hold the charge.",
541 "[PAR]",
542 "The option -grasp is similar, but it puts the charges in the B-factor",
543 "and the radius in the occupancy.",
544 "[PAR]",
545 "Option [TT]-align[tt] allows alignment",
546 "of the principal axis of a specified group against the given vector, ",
547 "with an optional center of rotation specified by [TT]-aligncenter[tt].",
548 "[PAR]",
549 "Finally with option [TT]-label[tt] editconf can add a chain identifier",
550 "to a pdb file, which can be useful for analysis with e.g. rasmol.",
551 "[PAR]",
552 "To convert a truncated octrahedron file produced by a package which uses",
553 "a cubic box with the corners cut off (such as Gromos) use:[BR]",
554 "[TT]editconf -f <in> -rotate 0 45 35.264 -bt o -box <veclen> -o <out>[tt][BR]",
555 "where [TT]veclen[tt] is the size of the cubic box times sqrt(3)/2." };
556 const char *bugs[] =
558 "For complex molecules, the periodicity removal routine may break down, ",
559 "in that case you can use trjconv." };
560 static real dist = 0.0, rbox = 0.0, to_diam = 0.0;
561 static gmx_bool bNDEF = FALSE, bRMPBC = FALSE, bCenter = FALSE, bReadVDW =
562 FALSE, bCONECT = FALSE;
563 static gmx_bool peratom = FALSE, bLegend = FALSE, bOrient = FALSE, bMead =
564 FALSE, bGrasp = FALSE, bSig56 = FALSE;
565 static rvec scale =
566 { 1, 1, 1 }, newbox =
567 { 0, 0, 0 }, newang =
568 { 90, 90, 90 };
569 static real rho = 1000.0, rvdw = 0.12;
570 static rvec center =
571 { 0, 0, 0 }, translation =
572 { 0, 0, 0 }, rotangles =
573 { 0, 0, 0 }, aligncenter =
574 { 0, 0, 0 }, targetvec =
575 { 0, 0, 0 };
576 static const char *btype[] =
577 { NULL, "triclinic", "cubic", "dodecahedron", "octahedron", NULL },
578 *label = "A";
579 static rvec visbox =
580 { 0, 0, 0 };
581 static int resnr_start = -1;
582 t_pargs
583 pa[] =
585 { "-ndef", FALSE, etBOOL,
586 { &bNDEF }, "Choose output from default index groups" },
587 { "-visbox", FALSE, etRVEC,
588 { visbox },
589 "HIDDENVisualize a grid of boxes, -1 visualizes the 14 box images" },
590 { "-bt", FALSE, etENUM,
591 { btype }, "Box type for -box and -d" },
592 { "-box", FALSE, etRVEC,
593 { newbox }, "Box vector lengths (a,b,c)" },
594 { "-angles", FALSE, etRVEC,
595 { newang }, "Angles between the box vectors (bc,ac,ab)" },
596 { "-d", FALSE, etREAL,
597 { &dist }, "Distance between the solute and the box" },
598 { "-c", FALSE, etBOOL,
599 { &bCenter },
600 "Center molecule in box (implied by -box and -d)" },
601 { "-center", FALSE, etRVEC,
602 { center }, "Coordinates of geometrical center" },
603 { "-aligncenter", FALSE, etRVEC,
604 { aligncenter }, "Center of rotation for alignment" },
605 { "-align", FALSE, etRVEC,
606 { targetvec },
607 "Align to target vector" },
608 { "-translate", FALSE, etRVEC,
609 { translation }, "Translation" },
610 { "-rotate", FALSE, etRVEC,
611 { rotangles },
612 "Rotation around the X, Y and Z axes in degrees" },
613 { "-princ", FALSE, etBOOL,
614 { &bOrient },
615 "Orient molecule(s) along their principal axes" },
616 { "-scale", FALSE, etRVEC,
617 { scale }, "Scaling factor" },
618 { "-density", FALSE, etREAL,
619 { &rho },
620 "Density (g/l) of the output box achieved by scaling" },
621 { "-pbc", FALSE, etBOOL,
622 { &bRMPBC },
623 "Remove the periodicity (make molecule whole again)" },
624 { "-resnr", FALSE, etINT,
625 { &resnr_start },
626 " Renumber residues starting from resnr" },
627 { "-grasp", FALSE, etBOOL,
628 { &bGrasp },
629 "Store the charge of the atom in the B-factor field and the radius of the atom in the occupancy field" },
631 "-rvdw", FALSE, etREAL,
632 { &rvdw },
633 "Default Van der Waals radius (in nm) if one can not be found in the database or if no parameters are present in the topology file" },
634 { "-sig56", FALSE, etREAL,
635 { &bSig56 },
636 "Use rmin/2 (minimum in the Van der Waals potential) rather than sigma/2 " },
638 "-vdwread", FALSE, etBOOL,
639 { &bReadVDW },
640 "Read the Van der Waals radii from the file vdwradii.dat rather than computing the radii based on the force field" },
641 { "-atom", FALSE, etBOOL,
642 { &peratom }, "Force B-factor attachment per atom" },
643 { "-legend", FALSE, etBOOL,
644 { &bLegend }, "Make B-factor legend" },
645 { "-label", FALSE, etSTR,
646 { &label }, "Add chain label for all residues" },
648 "-conect", FALSE, etBOOL,
649 { &bCONECT },
650 "Add CONECT records to a pdb file when written. Can only be done when a topology is present" } };
651 #define NPA asize(pa)
653 FILE *out;
654 const char *infile, *outfile;
655 char title[STRLEN];
656 int outftp, inftp, natom, i, j, n_bfac, itype, ntype;
657 double *bfac = NULL, c6, c12;
658 int *bfac_nr = NULL;
659 t_topology *top = NULL;
660 t_atoms atoms;
661 char *grpname, *sgrpname, *agrpname;
662 int isize, ssize, tsize, asize;
663 atom_id *index, *sindex, *tindex, *aindex;
664 rvec *x, *v, gc, min, max, size;
665 int ePBC;
666 matrix box,rotmatrix,trans;
667 rvec princd,tmpvec;
668 gmx_bool bIndex, bSetSize, bSetAng, bCubic, bDist, bSetCenter, bAlign;
669 gmx_bool bHaveV, bScale, bRho, bTranslate, bRotate, bCalcGeom, bCalcDiam;
670 real xs, ys, zs, xcent, ycent, zcent, diam = 0, mass = 0, d, vdw;
671 gmx_atomprop_t aps;
672 gmx_conect conect;
673 output_env_t oenv;
674 t_filenm fnm[] =
676 { efSTX, "-f", NULL, ffREAD },
677 { efNDX, "-n", NULL, ffOPTRD },
678 { efSTO, NULL, NULL, ffOPTWR },
679 { efPQR, "-mead", "mead", ffOPTWR },
680 { efDAT, "-bf", "bfact", ffOPTRD } };
681 #define NFILE asize(fnm)
683 CopyRight(stderr, argv[0]);
684 parse_common_args(&argc, argv, PCA_CAN_VIEW, NFILE, fnm, NPA, pa,
685 asize(desc), desc, asize(bugs), bugs, &oenv);
687 bIndex = opt2bSet("-n", NFILE, fnm) || bNDEF;
688 bMead = opt2bSet("-mead", NFILE, fnm);
689 bSetSize = opt2parg_bSet("-box", NPA, pa);
690 bSetAng = opt2parg_bSet("-angles", NPA, pa);
691 bSetCenter = opt2parg_bSet("-center", NPA, pa);
692 bDist = opt2parg_bSet("-d", NPA, pa);
693 bAlign = opt2parg_bSet("-align", NPA, pa);
694 /* Only automatically turn on centering without -noc */
695 if ((bDist || bSetSize || bSetCenter) && !opt2parg_bSet("-c", NPA, pa))
697 bCenter = TRUE;
699 bScale = opt2parg_bSet("-scale", NPA, pa);
700 bRho = opt2parg_bSet("-density", NPA, pa);
701 bTranslate = opt2parg_bSet("-translate", NPA, pa);
702 bRotate = opt2parg_bSet("-rotate", NPA, pa);
703 if (bScale && bRho)
704 fprintf(stderr, "WARNING: setting -density overrides -scale\n");
705 bScale = bScale || bRho;
706 bCalcGeom = bCenter || bRotate || bOrient || bScale;
707 bCalcDiam = btype[0][0] == 'c' || btype[0][0] == 'd' || btype[0][0] == 'o';
709 infile = ftp2fn(efSTX, NFILE, fnm);
710 if (bMead)
711 outfile = ftp2fn(efPQR, NFILE, fnm);
712 else
713 outfile = ftp2fn(efSTO, NFILE, fnm);
714 outftp = fn2ftp(outfile);
715 inftp = fn2ftp(infile);
717 aps = gmx_atomprop_init();
719 if (bMead && bGrasp)
721 printf("Incompatible options -mead and -grasp. Turning off -grasp\n");
722 bGrasp = FALSE;
724 if (bGrasp && (outftp != efPDB))
725 gmx_fatal(FARGS, "Output file should be a .pdb file"
726 " when using the -grasp option\n");
727 if ((bMead || bGrasp) && !((fn2ftp(infile) == efTPR) ||
728 (fn2ftp(infile) == efTPA) ||
729 (fn2ftp(infile) == efTPB)))
730 gmx_fatal(FARGS,"Input file should be a .tp[abr] file"
731 " when using the -mead option\n");
733 get_stx_coordnum(infile,&natom);
734 init_t_atoms(&atoms,natom,TRUE);
735 snew(x,natom);
736 snew(v,natom);
737 read_stx_conf(infile,title,&atoms,x,v,&ePBC,box);
738 if (fn2ftp(infile) == efPDB)
740 get_pdb_atomnumber(&atoms,aps);
742 printf("Read %d atoms\n",atoms.nr);
744 /* Get the element numbers if available in a pdb file */
745 if (fn2ftp(infile) == efPDB)
746 get_pdb_atomnumber(&atoms,aps);
748 if (ePBC != epbcNONE)
750 real vol = det(box);
751 printf("Volume: %g nm^3, corresponds to roughly %d electrons\n",
752 vol,100*((int)(vol*4.5)));
755 if (bMead || bGrasp || bCONECT)
756 top = read_top(infile,NULL);
758 if (bMead || bGrasp)
760 if (atoms.nr != top->atoms.nr)
761 gmx_fatal(FARGS,"Atom numbers don't match (%d vs. %d)",atoms.nr,top->atoms.nr);
762 snew(atoms.pdbinfo,top->atoms.nr);
763 ntype = top->idef.atnr;
764 for(i=0; (i<atoms.nr); i++) {
765 /* Determine the Van der Waals radius from the force field */
766 if (bReadVDW) {
767 if (!gmx_atomprop_query(aps,epropVDW,
768 *top->atoms.resinfo[top->atoms.atom[i].resind].name,
769 *top->atoms.atomname[i],&vdw))
770 vdw = rvdw;
772 else {
773 itype = top->atoms.atom[i].type;
774 c12 = top->idef.iparams[itype*ntype+itype].lj.c12;
775 c6 = top->idef.iparams[itype*ntype+itype].lj.c6;
776 if ((c6 != 0) && (c12 != 0)) {
777 real sig6;
778 if (bSig56)
779 sig6 = 2*c12/c6;
780 else
781 sig6 = c12/c6;
782 vdw = 0.5*pow(sig6,1.0/6.0);
784 else
785 vdw = rvdw;
787 /* Factor of 10 for nm -> Angstroms */
788 vdw *= 10;
790 if (bMead) {
791 atoms.pdbinfo[i].occup = top->atoms.atom[i].q;
792 atoms.pdbinfo[i].bfac = vdw;
794 else {
795 atoms.pdbinfo[i].occup = vdw;
796 atoms.pdbinfo[i].bfac = top->atoms.atom[i].q;
800 bHaveV=FALSE;
801 for (i=0; (i<natom) && !bHaveV; i++)
802 for (j=0; (j<DIM) && !bHaveV; j++)
803 bHaveV=bHaveV || (v[i][j]!=0);
804 printf("%selocities found\n",bHaveV?"V":"No v");
806 if (visbox[0] > 0) {
807 if (bIndex)
808 gmx_fatal(FARGS,"Sorry, can not visualize box with index groups");
809 if (outftp != efPDB)
810 gmx_fatal(FARGS,"Sorry, can only visualize box with a pdb file");
811 } else if (visbox[0] == -1)
812 visualize_images("images.pdb",ePBC,box);
814 /* remove pbc */
815 if (bRMPBC)
816 rm_gropbc(&atoms,x,box);
818 if (bCalcGeom) {
819 if (bIndex) {
820 fprintf(stderr,"\nSelect a group for determining the system size:\n");
821 get_index(&atoms,ftp2fn_null(efNDX,NFILE,fnm),
822 1,&ssize,&sindex,&sgrpname);
823 } else {
824 ssize = atoms.nr;
825 sindex = NULL;
827 diam=calc_geom(ssize,sindex,x,gc,min,max,bCalcDiam);
828 rvec_sub(max, min, size);
829 printf(" system size :%7.3f%7.3f%7.3f (nm)\n",
830 size[XX], size[YY], size[ZZ]);
831 if (bCalcDiam)
832 printf(" diameter :%7.3f (nm)\n",diam);
833 printf(" center :%7.3f%7.3f%7.3f (nm)\n", gc[XX], gc[YY], gc[ZZ]);
834 printf(" box vectors :%7.3f%7.3f%7.3f (nm)\n",
835 norm(box[XX]), norm(box[YY]), norm(box[ZZ]));
836 printf(" box angles :%7.2f%7.2f%7.2f (degrees)\n",
837 norm2(box[ZZ])==0 ? 0 :
838 RAD2DEG*acos(cos_angle_no_table(box[YY],box[ZZ])),
839 norm2(box[ZZ])==0 ? 0 :
840 RAD2DEG*acos(cos_angle_no_table(box[XX],box[ZZ])),
841 norm2(box[YY])==0 ? 0 :
842 RAD2DEG*acos(cos_angle_no_table(box[XX],box[YY])));
843 printf(" box volume :%7.2f (nm^3)\n",det(box));
846 if (bRho || bOrient || bAlign)
847 mass = calc_mass(&atoms,!fn2bTPX(infile),aps);
849 if (bOrient) {
850 atom_id *index;
851 char *grpnames;
853 /* Get a group for principal component analysis */
854 fprintf(stderr,"\nSelect group for the determining the orientation\n");
855 get_index(&atoms,ftp2fn_null(efNDX,NFILE,fnm),1,&isize,&index,&grpnames);
857 /* Orient the principal axes along the coordinate axes */
858 orient_princ(&atoms,isize,index,natom,x,bHaveV ? v : NULL, NULL);
859 sfree(index);
860 sfree(grpnames);
863 if ( bScale ) {
864 /* scale coordinates and box */
865 if (bRho) {
866 /* Compute scaling constant */
867 real vol,dens;
869 vol = det(box);
870 dens = (mass*AMU)/(vol*NANO*NANO*NANO);
871 fprintf(stderr,"Volume of input %g (nm^3)\n",vol);
872 fprintf(stderr,"Mass of input %g (a.m.u.)\n",mass);
873 fprintf(stderr,"Density of input %g (g/l)\n",dens);
874 if (vol==0 || mass==0)
875 gmx_fatal(FARGS,"Cannot scale density with "
876 "zero mass (%g) or volume (%g)\n",mass,vol);
878 scale[XX] = scale[YY] = scale[ZZ] = pow(dens/rho,1.0/3.0);
879 fprintf(stderr,"Scaling all box vectors by %g\n",scale[XX]);
881 scale_conf(atoms.nr,x,box,scale);
884 if (bAlign) {
885 if (bIndex) {
886 fprintf(stderr,"\nSelect a group that you want to align:\n");
887 get_index(&atoms,ftp2fn_null(efNDX,NFILE,fnm),
888 1,&asize,&aindex,&agrpname);
889 } else {
890 asize = atoms.nr;
891 snew(aindex,asize);
892 for (i=0;i<asize;i++)
893 aindex[i]=i;
895 printf("Aligning %d atoms (out of %d) to %g %g %g, center of rotation %g %g %g\n",asize,natom,
896 targetvec[XX],targetvec[YY],targetvec[ZZ],
897 aligncenter[XX],aligncenter[YY],aligncenter[ZZ]);
898 /*subtract out pivot point*/
899 for(i=0; i<asize; i++)
900 rvec_dec(x[aindex[i]],aligncenter);
901 /*now determine transform and rotate*/
902 /*will this work?*/
903 principal_comp(asize,aindex,atoms.atom,x, trans,princd);
905 unitv(targetvec,targetvec);
906 printf("Using %g %g %g as principal axis\n", trans[0][2],trans[1][2],trans[2][2]);
907 tmpvec[XX]=trans[0][2]; tmpvec[YY]=trans[1][2]; tmpvec[ZZ]=trans[2][2];
908 calc_rotmatrix(tmpvec, targetvec, rotmatrix);
909 /* rotmatrix finished */
911 for (i=0;i<asize;++i)
913 mvmul(rotmatrix,x[aindex[i]],tmpvec);
914 copy_rvec(tmpvec,x[aindex[i]]);
917 /*add pivot point back*/
918 for(i=0; i<asize; i++)
919 rvec_inc(x[aindex[i]],aligncenter);
920 if (!bIndex)
921 sfree(aindex);
924 if (bTranslate) {
925 if (bIndex) {
926 fprintf(stderr,"\nSelect a group that you want to translate:\n");
927 get_index(&atoms,ftp2fn_null(efNDX,NFILE,fnm),
928 1,&ssize,&sindex,&sgrpname);
929 } else {
930 ssize = atoms.nr;
931 sindex = NULL;
933 printf("Translating %d atoms (out of %d) by %g %g %g nm\n",ssize,natom,
934 translation[XX],translation[YY],translation[ZZ]);
935 if (sindex) {
936 for(i=0; i<ssize; i++)
937 rvec_inc(x[sindex[i]],translation);
939 else {
940 for(i=0; i<natom; i++)
941 rvec_inc(x[i],translation);
944 if (bRotate) {
945 /* Rotate */
946 printf("Rotating %g, %g, %g degrees around the X, Y and Z axis respectively\n",rotangles[XX],rotangles[YY],rotangles[ZZ]);
947 for(i=0; i<DIM; i++)
948 rotangles[i] *= DEG2RAD;
949 rotate_conf(natom,x,v,rotangles[XX],rotangles[YY],rotangles[ZZ]);
952 if (bCalcGeom) {
953 /* recalc geometrical center and max and min coordinates and size */
954 calc_geom(ssize,sindex,x,gc,min,max,FALSE);
955 rvec_sub(max, min, size);
956 if (bScale || bOrient || bRotate)
957 printf("new system size : %6.3f %6.3f %6.3f\n",
958 size[XX],size[YY],size[ZZ]);
961 if (bSetSize || bDist || (btype[0][0]=='t' && bSetAng)) {
962 ePBC = epbcXYZ;
963 if (!(bSetSize || bDist))
964 for (i=0; i<DIM; i++)
965 newbox[i] = norm(box[i]);
966 clear_mat(box);
967 /* calculate new boxsize */
968 switch(btype[0][0]){
969 case 't':
970 if (bDist)
971 for(i=0; i<DIM; i++)
972 newbox[i] = size[i]+2*dist;
973 if (!bSetAng) {
974 box[XX][XX] = newbox[XX];
975 box[YY][YY] = newbox[YY];
976 box[ZZ][ZZ] = newbox[ZZ];
977 } else {
978 matrix_convert(box,newbox,newang);
980 break;
981 case 'c':
982 case 'd':
983 case 'o':
984 if (bSetSize)
985 d = newbox[0];
986 else
987 d = diam+2*dist;
988 if (btype[0][0] == 'c')
989 for(i=0; i<DIM; i++)
990 box[i][i] = d;
991 else if (btype[0][0] == 'd') {
992 box[XX][XX] = d;
993 box[YY][YY] = d;
994 box[ZZ][XX] = d/2;
995 box[ZZ][YY] = d/2;
996 box[ZZ][ZZ] = d*sqrt(2)/2;
997 } else {
998 box[XX][XX] = d;
999 box[YY][XX] = d/3;
1000 box[YY][YY] = d*sqrt(2)*2/3;
1001 box[ZZ][XX] = -d/3;
1002 box[ZZ][YY] = d*sqrt(2)/3;
1003 box[ZZ][ZZ] = d*sqrt(6)/3;
1005 break;
1009 /* calculate new coords for geometrical center */
1010 if (!bSetCenter)
1011 calc_box_center(ecenterDEF,box,center);
1013 /* center molecule on 'center' */
1014 if (bCenter)
1015 center_conf(natom,x,center,gc);
1017 /* print some */
1018 if (bCalcGeom) {
1019 calc_geom(ssize,sindex,x, gc, min, max, FALSE);
1020 printf("new center :%7.3f%7.3f%7.3f (nm)\n",gc[XX],gc[YY],gc[ZZ]);
1022 if (bOrient || bScale || bDist || bSetSize) {
1023 printf("new box vectors :%7.3f%7.3f%7.3f (nm)\n",
1024 norm(box[XX]), norm(box[YY]), norm(box[ZZ]));
1025 printf("new box angles :%7.2f%7.2f%7.2f (degrees)\n",
1026 norm2(box[ZZ])==0 ? 0 :
1027 RAD2DEG*acos(cos_angle_no_table(box[YY],box[ZZ])),
1028 norm2(box[ZZ])==0 ? 0 :
1029 RAD2DEG*acos(cos_angle_no_table(box[XX],box[ZZ])),
1030 norm2(box[YY])==0 ? 0 :
1031 RAD2DEG*acos(cos_angle_no_table(box[XX],box[YY])));
1032 printf("new box volume :%7.2f (nm^3)\n",det(box));
1035 if (check_box(epbcXYZ,box))
1036 printf("\nWARNING: %s\n",check_box(epbcXYZ,box));
1038 if (bDist && btype[0][0]=='t')
1040 if(TRICLINIC(box))
1042 printf("\nWARNING: Your box is triclinic with non-orthogonal axes. In this case, the\n"
1043 "distance from the solute to a box surface along the corresponding normal\n"
1044 "vector might be somewhat smaller than your specified value %f.\n"
1045 "You can check the actual value with g_mindist -pi\n",dist);
1047 else
1049 printf("\nWARNING: No boxtype specified - distance condition applied in each dimension.\n"
1050 "If the molecule rotates the actual distance will be smaller. You might want\n"
1051 "to use a cubic box instead, or why not try a dodecahedron today?\n");
1054 if (bCONECT && (outftp == efPDB) && (inftp == efTPR))
1055 conect = gmx_conect_generate(top);
1056 else
1057 conect = NULL;
1059 if (bIndex) {
1060 fprintf(stderr,"\nSelect a group for output:\n");
1061 get_index(&atoms,opt2fn_null("-n",NFILE,fnm),
1062 1,&isize,&index,&grpname);
1064 if (resnr_start >= 0)
1066 renum_resnr(&atoms,isize,index,resnr_start);
1069 if (opt2parg_bSet("-label",NPA,pa)) {
1070 for(i=0; (i<atoms.nr); i++)
1071 atoms.resinfo[atoms.atom[i].resind].chainid=label[0];
1074 if (opt2bSet("-bf",NFILE,fnm) || bLegend)
1076 gmx_fatal(FARGS,"Sorry, cannot do bfactors with an index group.");
1079 if (outftp == efPDB)
1081 out=ffopen(outfile,"w");
1082 write_pdbfile_indexed(out,title,&atoms,x,ePBC,box,' ',1,isize,index,conect,TRUE);
1083 ffclose(out);
1085 else
1087 write_sto_conf_indexed(outfile,title,&atoms,x,bHaveV?v:NULL,ePBC,box,isize,index);
1090 else
1092 if (resnr_start >= 0)
1094 renum_resnr(&atoms,atoms.nr,NULL,resnr_start);
1097 if ((outftp == efPDB) || (outftp == efPQR)) {
1098 out=ffopen(outfile,"w");
1099 if (bMead) {
1100 set_pdb_wide_format(TRUE);
1101 fprintf(out,"REMARK "
1102 "The B-factors in this file hold atomic radii\n");
1103 fprintf(out,"REMARK "
1104 "The occupancy in this file hold atomic charges\n");
1106 else if (bGrasp) {
1107 fprintf(out,"GRASP PDB FILE\nFORMAT NUMBER=1\n");
1108 fprintf(out,"REMARK "
1109 "The B-factors in this file hold atomic charges\n");
1110 fprintf(out,"REMARK "
1111 "The occupancy in this file hold atomic radii\n");
1113 else if (opt2bSet("-bf",NFILE,fnm)) {
1114 read_bfac(opt2fn("-bf",NFILE,fnm),&n_bfac,&bfac,&bfac_nr);
1115 set_pdb_conf_bfac(atoms.nr,atoms.nres,&atoms,
1116 n_bfac,bfac,bfac_nr,peratom);
1118 if (opt2parg_bSet("-label",NPA,pa)) {
1119 for(i=0; (i<atoms.nr); i++)
1120 atoms.resinfo[atoms.atom[i].resind].chainid=label[0];
1122 write_pdbfile(out,title,&atoms,x,ePBC,box,' ',-1,conect,TRUE);
1123 if (bLegend)
1124 pdb_legend(out,atoms.nr,atoms.nres,&atoms,x);
1125 if (visbox[0] > 0)
1126 visualize_box(out,bLegend ? atoms.nr+12 : atoms.nr,
1127 bLegend? atoms.nres=12 : atoms.nres,box,visbox);
1128 ffclose(out);
1130 else
1131 write_sto_conf(outfile,title,&atoms,x,bHaveV?v:NULL,ePBC,box);
1133 gmx_atomprop_destroy(aps);
1135 do_view(oenv,outfile,NULL);
1137 thanx(stderr);
1139 return 0;