3 * This source code is part of
7 * GROningen MAchine for Chemical Simulations
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.
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.
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.
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.
30 * For more info, check our website at http://www.gromacs.org
33 * Green Red Orange Magenta Azure Cyan Skyblue
63 int gmx_densmap(int argc
,char *argv
[])
65 const char *desc
[] = {
66 "g_densmap computes 2D number-density maps.",
67 "It can make planar and axial-radial density maps.",
68 "The output [TT].xpm[tt] file can be visualized with for instance xv",
69 "and can be converted to postscript with xpm2ps.",
70 "Optionally, output can be in text form to a .dat file.",
72 "The default analysis is a 2-D number-density map for a selected",
73 "group of atoms in the x-y plane.",
74 "The averaging direction can be changed with the option [TT]-aver[tt].",
75 "When [TT]-xmin[tt] and/or [TT]-xmax[tt] are set only atoms that are",
76 "within the limit(s) in the averaging direction are taken into account.",
77 "The grid spacing is set with the option [TT]-bin[tt].",
78 "When [TT]-n1[tt] or [TT]-n2[tt] is non-zero, the grid",
79 "size is set by this option.",
80 "Box size fluctuations are properly taken into account.",
82 "When options [TT]-amax[tt] and [TT]-rmax[tt] are set, an axial-radial",
83 "number-density map is made. Three groups should be supplied, the centers",
84 "of mass of the first two groups define the axis, the third defines the",
85 "analysis group. The axial direction goes from -amax to +amax, where",
86 "the center is defined as the midpoint between the centers of mass and",
87 "the positive direction goes from the first to the second center of mass.",
88 "The radial direction goes from 0 to rmax or from -rmax to +rmax",
89 "when the [TT]-mirror[tt] option has been set.",
91 "The normalization of the output is set with the [TT]-unit[tt] option.",
92 "The default produces a true number density. Unit [TT]nm-2[tt] leaves out",
93 "the normalization for the averaging or the angular direction.",
94 "Option [TT]count[tt] produces the count for each grid cell.",
95 "When you do not want the scale in the output to go",
96 "from zero to the maximum density, you can set the maximum",
97 "with the option [TT]-dmax[tt]."
100 static real xmin
=-1,xmax
=-1,bin
=0.02,dmin
=0,dmax
=0,amax
=0,rmax
=0;
101 static bool bMirror
=FALSE
, bSums
=FALSE
;
102 static const char *eaver
[]={ NULL
, "z", "y", "x", NULL
};
103 static const char *eunit
[]={ NULL
, "nm-3", "nm-2", "count", NULL
};
106 { "-bin", FALSE
, etREAL
, {&bin
},
108 { "-aver", FALSE
, etENUM
, {eaver
},
109 "The direction to average over" },
110 { "-xmin", FALSE
, etREAL
, {&xmin
},
111 "Minimum coordinate for averaging" },
112 { "-xmax", FALSE
, etREAL
, {&xmax
},
113 "Maximum coordinate for averaging" },
114 { "-n1", FALSE
, etINT
, {&n1
},
115 "Number of grid cells in the first direction" },
116 { "-n2", FALSE
, etINT
, {&n2
},
117 "Number of grid cells in the second direction" },
118 { "-amax", FALSE
, etREAL
, {&amax
},
119 "Maximum axial distance from the center"},
120 { "-rmax", FALSE
, etREAL
, {&rmax
},
121 "Maximum radial distance" },
122 { "-mirror", FALSE
, etBOOL
, {&bMirror
},
123 "Add the mirror image below the axial axis" },
124 { "-sums", FALSE
, etBOOL
, {&bSums
},
125 "Print density sums (1D map) to stdout" },
126 { "-unit", FALSE
, etENUM
, {eunit
},
127 "Unit for the output" },
128 { "-dmin", FALSE
, etREAL
, {&dmin
},
129 "Minimum density in output"},
130 { "-dmax", FALSE
, etREAL
, {&dmax
},
131 "Maximum density in output (0 means calculate it)"},
133 bool bXmin
,bXmax
,bRadial
;
138 rvec
*x
,xcom
[2],direction
,center
,dx
;
142 int cav
=0,c1
=0,c2
=0,natoms
;
143 char **grpname
,title
[256],buf
[STRLEN
];
145 int i
,j
,k
,l
,ngrps
,anagrp
,*gnx
=NULL
,nindex
,nradial
=0,nfr
,nmpower
;
146 atom_id
**ind
=NULL
,*index
;
147 real
**grid
,maxgrid
,m1
,m2
,box1
,box2
,*tickx
,*tickz
,invcellvol
;
148 real invspa
=0,invspz
=0,axial
,r
,vol_old
,vol
,rowsum
;
150 t_rgb rlo
={1,1,1}, rhi
={0,0,0};
152 const char *label
[]={ "x (nm)", "y (nm)", "z (nm)" };
154 { efTRX
, "-f", NULL
, ffREAD
},
155 { efTPS
, NULL
, NULL
, ffOPTRD
},
156 { efNDX
, NULL
, NULL
, ffOPTRD
},
157 { efDAT
, "-od", "densmap", ffOPTWR
},
158 { efXPM
, "-o", "densmap", ffWRITE
}
160 #define NFILE asize(fnm)
163 CopyRight(stderr
,argv
[0]);
166 parse_common_args(&argc
,argv
,PCA_CAN_TIME
| PCA_CAN_VIEW
| PCA_BE_NICE
,
167 NFILE
,fnm
,npargs
,pa
,asize(desc
),desc
,0,NULL
,&oenv
);
169 bXmin
= opt2parg_bSet("-xmin",npargs
,pa
);
170 bXmax
= opt2parg_bSet("-xmax",npargs
,pa
);
171 bRadial
= (amax
>0 || rmax
>0);
173 if (amax
<=0 || rmax
<=0)
174 gmx_fatal(FARGS
,"Both amax and rmax should be larger than zero");
177 if (strcmp(eunit
[0],"nm-3") == 0) {
180 } else if (strcmp(eunit
[0],"nm-2") == 0) {
188 if (ftp2bSet(efTPS
,NFILE
,fnm
) || !ftp2bSet(efNDX
,NFILE
,fnm
))
189 read_tps_conf(ftp2fn(efTPS
,NFILE
,fnm
),title
,&top
,&ePBC
,&x
,NULL
,box
,
193 fprintf(stderr
,"\nSelect an analysis group\n");
197 "\nSelect two groups to define the axis and an analysis group\n");
202 get_index(&top
.atoms
,ftp2fn_null(efNDX
,NFILE
,fnm
),ngrps
,gnx
,ind
,grpname
);
204 nindex
= gnx
[anagrp
];
207 if ((gnx
[0]>1 || gnx
[1]>1) && !ftp2bSet(efTPS
,NFILE
,fnm
))
208 gmx_fatal(FARGS
,"No run input file was supplied (option -s), this is required for the center of mass calculation");
211 switch (eaver
[0][0]) {
212 case 'x': cav
= XX
; c1
= YY
; c2
= ZZ
; break;
213 case 'y': cav
= YY
; c1
= XX
; c2
= ZZ
; break;
214 case 'z': cav
= ZZ
; c1
= XX
; c2
= YY
; break;
217 natoms
=read_first_x(oenv
,&status
,ftp2fn(efTRX
,NFILE
,fnm
),&t
,&x
,box
);
221 n1
= (int)(box
[c1
][c1
]/bin
+ 0.5);
223 n2
= (int)(box
[c2
][c2
]/bin
+ 0.5);
225 n1
= (int)(2*amax
/bin
+ 0.5);
226 nradial
= (int)(rmax
/bin
+ 0.5);
227 invspa
= n1
/(2*amax
);
228 invspz
= nradial
/rmax
;
248 invcellvol
/= det(box
);
249 else if (nmpower
== -2)
250 invcellvol
/= box
[c1
][c1
]*box
[c2
][c2
];
251 for(i
=0; i
<nindex
; i
++) {
253 if ((!bXmin
|| x
[j
][cav
] >= xmin
) &&
254 (!bXmax
|| x
[j
][cav
] <= xmax
)) {
255 m1
= x
[j
][c1
]/box
[c1
][c1
];
260 m2
= x
[j
][c2
]/box
[c2
][c2
];
265 grid
[(int)(m1
*n1
)][(int)(m2
*n2
)] += invcellvol
;
269 set_pbc(&pbc
,ePBC
,box
);
272 /* One atom, just copy the coordinates */
273 copy_rvec(x
[ind
[i
][0]],xcom
[i
]);
275 /* Calculate the center of mass */
278 for(j
=0; j
<gnx
[i
]; j
++) {
280 m
= top
.atoms
.atom
[k
].m
;
282 xcom
[i
][l
] += m
*x
[k
][l
];
285 svmul(1/mtot
,xcom
[i
],xcom
[i
]);
288 pbc_dx(&pbc
,xcom
[1],xcom
[0],direction
);
290 center
[i
] = xcom
[0][i
] + 0.5*direction
[i
];
291 unitv(direction
,direction
);
292 for(i
=0; i
<nindex
; i
++) {
294 pbc_dx(&pbc
,x
[j
],center
,dx
);
295 axial
= iprod(dx
,direction
);
296 r
= sqrt(norm2(dx
) - axial
*axial
);
297 if (axial
>=-amax
&& axial
<amax
&& r
<rmax
) {
300 grid
[(int)((axial
+ amax
)*invspa
)][(int)(r
*invspz
)] += 1;
305 } while(read_next_x(oenv
,status
,&t
,natoms
,x
,box
));
308 /* normalize gridpoints */
311 for (i
=0; i
<n1
; i
++) {
312 for (j
=0; j
<n2
; j
++) {
314 if (grid
[i
][j
] > maxgrid
)
315 maxgrid
= grid
[i
][j
];
319 for (i
=0; i
<n1
; i
++) {
321 for (j
=0; j
<nradial
; j
++) {
323 case -3: vol
= M_PI
*(j
+1)*(j
+1)/(invspz
*invspz
*invspa
); break;
324 case -2: vol
= (j
+1)/(invspz
*invspa
); break;
325 default: vol
= j
+1; break;
331 grid
[i
][k
] /= nfr
*(vol
- vol_old
);
333 grid
[i
][nradial
-1-j
] = grid
[i
][k
];
335 if (grid
[i
][k
] > maxgrid
)
336 maxgrid
= grid
[i
][k
];
340 fprintf(stdout
,"\n The maximum density is %f %s\n",maxgrid
,unit
);
347 /* normalize box-axes */
350 for (i
=0; i
<=n1
; i
++)
351 tickx
[i
] = i
*box1
/n1
;
352 for (i
=0; i
<=n2
; i
++)
353 tickz
[i
] = i
*box2
/n2
;
355 for (i
=0; i
<=n1
; i
++)
356 tickx
[i
] = i
/invspa
- amax
;
358 for (i
=0; i
<=n2
; i
++)
359 tickz
[i
] = i
/invspz
- rmax
;
361 for (i
=0; i
<=n2
; i
++)
370 fprintf(stdout
,"Density sums:\n");
374 fprintf(stdout
,"%g\t",rowsum
);
376 fprintf(stdout
,"\n");
379 sprintf(buf
,"%s number density",grpname
[anagrp
]);
380 if (!bRadial
&& (bXmin
|| bXmax
)) {
382 sprintf(buf
+strlen(buf
),", %c > %g nm",eaver
[0][0],xmin
);
384 sprintf(buf
+strlen(buf
),", %c < %g nm",eaver
[0][0],xmax
);
386 sprintf(buf
+strlen(buf
),", %c: %g - %g nm",eaver
[0][0],xmin
,xmax
);
388 if (ftp2bSet(efDAT
,NFILE
,fnm
))
390 fp
= ffopen(ftp2fn(efDAT
,NFILE
,fnm
),"w");
391 /*optional text form output: first row is tickz; first col is tickx */
394 fprintf(fp
,"%g\t",tickz
[j
]);
399 fprintf(fp
,"%g\t",tickx
[i
]);
401 fprintf(fp
,"%g\t",grid
[i
][j
]);
408 fp
= ffopen(ftp2fn(efXPM
,NFILE
,fnm
),"w");
409 write_xpm(fp
,MAT_SPATIAL_X
| MAT_SPATIAL_Y
,buf
,unit
,
410 bRadial
? "axial (nm)" : label
[c1
],bRadial
? "r (nm)" : label
[c2
],
411 n1
,n2
,tickx
,tickz
,grid
,dmin
,maxgrid
,rlo
,rhi
,&nlev
);
417 do_view(oenv
,opt2fn("-o",NFILE
,fnm
),NULL
);