Merge branch 'master' of git://git.gromacs.org/gromacs
[gromacs/adressmacs.git] / src / kernel / gmxdump.c
blob4cfa38438a1adf62f6833164cbc83d40c28d3bcd
1 /*
2 *
3 * This source code is part of
4 *
5 * G R O M A C S
6 *
7 * GROningen MAchine for Chemical Simulations
8 *
9 * VERSION 3.2.0
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
32 * And Hey:
33 * Gallium Rubidium Oxygen Manganese Argon Carbon Silicon
35 #ifdef HAVE_CONFIG_H
36 #include <config.h>
37 #endif
39 #include <stdio.h>
40 #include <string.h>
41 #include <math.h>
42 #include "main.h"
43 #include "macros.h"
44 #include "futil.h"
45 #include "statutil.h"
46 #include "copyrite.h"
47 #include "sysstuff.h"
48 #include "txtdump.h"
49 #include "gmx_fatal.h"
50 #include "xtcio.h"
51 #include "enxio.h"
52 #include "smalloc.h"
53 #include "names.h"
54 #include "gmxfio.h"
55 #include "tpxio.h"
56 #include "trnio.h"
57 #include "txtdump.h"
58 #include "gmxcpp.h"
59 #include "checkpoint.h"
60 #include "mtop_util.h"
61 #include "sparsematrix.h"
62 #include "mtxio.h"
64 static void dump_top(FILE *fp,t_topology *top,char *tpr)
66 int i,j,k,*types;
68 fprintf(fp,"; Topology generated from %s by program %s\n",tpr,Program());
69 fprintf(fp,"[ defaults ]\n 1 1 no 1.0 1.0\n\n");
70 fprintf(fp,"[ atomtypes ]\n");
71 fprintf(fp,";name at.num mass charge ptype c6 c12\n");
72 snew(types,top->atomtypes.nr);
73 for(i=0; (i<top->atomtypes.nr); i++) {
74 for(j=0; (j<top->atoms.nr) && (top->atoms.atom[j].type != i); j++)
76 if (j<top->atoms.nr) {
77 types[i] = j;
78 fprintf(fp,"%5s %4d %8.4f %8.4f %2s %8.3f %8.3f\n",
79 *(top->atoms.atomtype[j]),top->atomtypes.atomnumber[i],
80 0.0,0.0,"A",0.0,0.0);
83 fprintf(fp,"[ nonbonded_params ]\n");
84 for(i=k=0; (i<top->idef.ntypes); i++) {
85 for(j=0; (j<top->idef.ntypes); j++,k++) {
86 fprintf(fp,"%12s %12s 1 %12.5e %12.5e\n",
87 *(top->atoms.atomtype[types[i]]),
88 *(top->atoms.atomtype[types[j]]),
89 top->idef.iparams[k].lj.c12,top->idef.iparams[k].lj.c6);
92 sfree(types);
95 static void list_tpx(const char *fn, gmx_bool bShowNumbers,const char *mdpfn,
96 gmx_bool bSysTop)
98 FILE *gp;
99 int fp,indent,i,j,**gcount,atot;
100 t_state state;
101 rvec *f=NULL;
102 t_inputrec ir;
103 t_tpxheader tpx;
104 gmx_mtop_t mtop;
105 gmx_groups_t *groups;
106 t_topology top;
108 read_tpxheader(fn,&tpx,TRUE,NULL,NULL);
110 read_tpx_state(fn,
111 tpx.bIr ? &ir : NULL,
112 &state,tpx.bF ? f : NULL,
113 tpx.bTop ? &mtop: NULL);
115 if (mdpfn && tpx.bIr) {
116 gp = gmx_fio_fopen(mdpfn,"w");
117 pr_inputrec(gp,0,NULL,&(ir),TRUE);
118 gmx_fio_fclose(gp);
121 if (!mdpfn) {
122 if (bSysTop)
123 top = gmx_mtop_t_to_t_topology(&mtop);
125 if (available(stdout,&tpx,0,fn)) {
126 indent=0;
127 indent=pr_title(stdout,indent,fn);
128 pr_inputrec(stdout,0,"inputrec",tpx.bIr ? &(ir) : NULL,FALSE);
130 indent = 0;
131 pr_header(stdout,indent,"header",&(tpx));
133 if (!bSysTop)
134 pr_mtop(stdout,indent,"topology",&(mtop),bShowNumbers);
135 else
136 pr_top(stdout,indent,"topology",&(top),bShowNumbers);
138 pr_rvecs(stdout,indent,"box",tpx.bBox ? state.box : NULL,DIM);
139 pr_rvecs(stdout,indent,"box_rel",tpx.bBox ? state.box_rel : NULL,DIM);
140 pr_rvecs(stdout,indent,"boxv",tpx.bBox ? state.boxv : NULL,DIM);
141 pr_rvecs(stdout,indent,"pres_prev",tpx.bBox ? state.pres_prev : NULL,DIM);
142 pr_rvecs(stdout,indent,"svir_prev",tpx.bBox ? state.svir_prev : NULL,DIM);
143 pr_rvecs(stdout,indent,"fvir_prev",tpx.bBox ? state.fvir_prev : NULL,DIM);
144 /* leave nosehoover_xi in for now to match the tpr version */
145 pr_doubles(stdout,indent,"nosehoover_xi",state.nosehoover_xi,state.ngtc);
146 /*pr_doubles(stdout,indent,"nosehoover_vxi",state.nosehoover_vxi,state.ngtc);*/
147 /*pr_doubles(stdout,indent,"therm_integral",state.therm_integral,state.ngtc);*/
148 pr_rvecs(stdout,indent,"x",tpx.bX ? state.x : NULL,state.natoms);
149 pr_rvecs(stdout,indent,"v",tpx.bV ? state.v : NULL,state.natoms);
150 if (state,tpx.bF) {
151 pr_rvecs(stdout,indent,"f",f,state.natoms);
155 groups = &mtop.groups;
157 snew(gcount,egcNR);
158 for(i=0; (i<egcNR); i++)
159 snew(gcount[i],groups->grps[i].nr);
161 for(i=0; (i<mtop.natoms); i++) {
162 for(j=0; (j<egcNR); j++)
163 gcount[j][ggrpnr(groups,j,i)]++;
165 printf("Group statistics\n");
166 for(i=0; (i<egcNR); i++) {
167 atot=0;
168 printf("%-12s: ",gtypes[i]);
169 for(j=0; (j<groups->grps[i].nr); j++) {
170 printf(" %5d",gcount[i][j]);
171 atot+=gcount[i][j];
173 printf(" (total %d atoms)\n",atot);
174 sfree(gcount[i]);
176 sfree(gcount);
178 done_state(&state);
179 sfree(f);
182 static void list_top(const char *fn)
184 int status,done;
185 #define BUFLEN 256
186 char buf[BUFLEN];
187 gmx_cpp_t handle;
188 char *cppopts[] = { NULL };
190 status = cpp_open_file(fn,&handle,cppopts);
191 if (status != 0)
192 gmx_fatal(FARGS,cpp_error(&handle,status));
193 do {
194 status = cpp_read_line(&handle,BUFLEN,buf);
195 done = (status == eCPP_EOF);
196 if (!done) {
197 if (status != eCPP_OK)
198 gmx_fatal(FARGS,cpp_error(&handle,status));
199 else
200 printf("%s\n",buf);
202 } while (!done);
203 status = cpp_close_file(&handle);
204 if (status != eCPP_OK)
205 gmx_fatal(FARGS,cpp_error(&handle,status));
208 static void list_trn(const char *fn)
210 t_fileio *fpread, *fpwrite;
211 int nframe,indent;
212 char buf[256];
213 rvec *x,*v,*f;
214 matrix box;
215 t_trnheader trn;
216 gmx_bool bOK;
218 fpread = open_trn(fn,"r");
219 fpwrite = open_tpx(NULL,"w");
220 gmx_fio_setdebug(fpwrite,TRUE);
222 nframe = 0;
223 while (fread_trnheader(fpread,&trn,&bOK)) {
224 snew(x,trn.natoms);
225 snew(v,trn.natoms);
226 snew(f,trn.natoms);
227 if (fread_htrn(fpread,&trn,
228 trn.box_size ? box : NULL,
229 trn.x_size ? x : NULL,
230 trn.v_size ? v : NULL,
231 trn.f_size ? f : NULL)) {
232 sprintf(buf,"%s frame %d",fn,nframe);
233 indent=0;
234 indent=pr_title(stdout,indent,buf);
235 pr_indent(stdout,indent);
236 fprintf(stdout,"natoms=%10d step=%10d time=%12.7e lambda=%10g\n",
237 trn.natoms,trn.step,trn.t,trn.lambda);
238 if (trn.box_size)
239 pr_rvecs(stdout,indent,"box",box,DIM);
240 if (trn.x_size)
241 pr_rvecs(stdout,indent,"x",x,trn.natoms);
242 if (trn.v_size)
243 pr_rvecs(stdout,indent,"v",v,trn.natoms);
244 if (trn.f_size)
245 pr_rvecs(stdout,indent,"f",f,trn.natoms);
247 else
248 fprintf(stderr,"\nWARNING: Incomplete frame: nr %d, t=%g\n",
249 nframe,trn.t);
251 sfree(x);
252 sfree(v);
253 sfree(f);
254 nframe++;
256 if (!bOK)
257 fprintf(stderr,"\nWARNING: Incomplete frame header: nr %d, t=%g\n",
258 nframe,trn.t);
259 close_tpx(fpwrite);
260 close_trn(fpread);
263 void list_xtc(const char *fn, gmx_bool bXVG)
265 t_fileio *xd;
266 int indent;
267 char buf[256];
268 rvec *x;
269 matrix box;
270 int nframe,natoms,step;
271 real prec,time;
272 gmx_bool bOK;
274 xd = open_xtc(fn,"r");
275 read_first_xtc(xd,&natoms,&step,&time,box,&x,&prec,&bOK);
277 nframe=0;
278 do {
279 if (bXVG) {
280 int i,d;
282 fprintf(stdout,"%g",time);
283 for(i=0; i<natoms; i++)
284 for(d=0; d<DIM; d++)
285 fprintf(stdout," %g",x[i][d]);
286 fprintf(stdout,"\n");
287 } else {
288 sprintf(buf,"%s frame %d",fn,nframe);
289 indent=0;
290 indent=pr_title(stdout,indent,buf);
291 pr_indent(stdout,indent);
292 fprintf(stdout,"natoms=%10d step=%10d time=%12.7e prec=%10g\n",
293 natoms,step,time,prec);
294 pr_rvecs(stdout,indent,"box",box,DIM);
295 pr_rvecs(stdout,indent,"x",x,natoms);
297 nframe++;
298 } while (read_next_xtc(xd,natoms,&step,&time,box,x,&prec,&bOK));
299 if (!bOK)
300 fprintf(stderr,"\nWARNING: Incomplete frame at time %g\n",time);
301 close_xtc(xd);
304 void list_trx(const char *fn,gmx_bool bXVG)
306 int ftp;
308 ftp = fn2ftp(fn);
309 if (ftp == efXTC)
310 list_xtc(fn,bXVG);
311 else if ((ftp == efTRR) || (ftp == efTRJ))
312 list_trn(fn);
313 else
314 fprintf(stderr,"File %s not supported. Try using more %s\n",
315 fn,fn);
318 void list_ene(const char *fn)
320 int ndr;
321 ener_file_t in;
322 gmx_bool bCont;
323 gmx_enxnm_t *enm=NULL;
324 t_enxframe *fr;
325 int i,j,nre,b;
326 real rav,minthird;
327 char buf[22];
329 printf("gmxdump: %s\n",fn);
330 in = open_enx(fn,"r");
331 do_enxnms(in,&nre,&enm);
333 printf("energy components:\n");
334 for(i=0; (i<nre); i++)
335 printf("%5d %-24s (%s)\n",i,enm[i].name,enm[i].unit);
337 minthird=-1.0/3.0;
338 snew(fr,1);
339 do {
340 bCont=do_enx(in,fr);
342 if (bCont)
344 printf("\n%24s %12.5e %12s %12s\n","time:",
345 fr->t,"step:",gmx_step_str(fr->step,buf));
346 printf("%24s %12s %12s %12s\n",
347 "","","nsteps:",gmx_step_str(fr->nsteps,buf));
348 printf("%24s %12.5e %12s %12s\n",
349 "delta_t:",fr->dt,"sum steps:",gmx_step_str(fr->nsum,buf));
350 if (fr->nre == nre) {
351 printf("%24s %12s %12s %12s\n",
352 "Component","Energy","Av. Energy","Sum Energy");
353 if (fr->nsum > 0) {
354 for(i=0; (i<nre); i++)
355 printf("%24s %12.5e %12.5e %12.5e\n",
356 enm[i].name,fr->ener[i].e,fr->ener[i].eav,
357 fr->ener[i].esum);
358 } else {
359 for(i=0; (i<nre); i++)
360 printf("%24s %12.5e\n",
361 enm[i].name,fr->ener[i].e);
364 for(b=0; b<fr->nblock; b++)
366 const char *typestr="";
368 t_enxblock *eb=&(fr->block[b]);
369 printf("Block data %2d (%3d subblocks, id=%d)\n",
370 b, eb->nsub, eb->id);
372 if (eb->id < enxNR)
373 typestr=enx_block_id_name[eb->id];
374 printf(" id='%s'\n", typestr);
375 for(i=0;i<eb->nsub;i++)
377 t_enxsubblock *sb=&(eb->sub[i]);
378 printf(" Sub block %3d (%5d elems, type=%s) values:\n",
379 i, sb->nr, xdr_datatype_names[sb->type]);
381 switch(sb->type)
383 case xdr_datatype_float:
384 for(j=0;j<sb->nr;j++)
385 printf("%14d %8.4f\n",j, sb->fval[j]);
386 break;
387 case xdr_datatype_double:
388 for(j=0;j<sb->nr;j++)
389 printf("%14d %10.6f\n",j, sb->dval[j]);
390 break;
391 case xdr_datatype_int:
392 for(j=0;j<sb->nr;j++)
393 printf("%14d %10d\n",j, sb->ival[j]);
394 break;
395 case xdr_datatype_large_int:
396 for(j=0;j<sb->nr;j++)
397 printf("%14d %s\n",
398 j, gmx_step_str(sb->lval[j],buf));
399 break;
400 case xdr_datatype_char:
401 for(j=0;j<sb->nr;j++)
402 printf("%14d %1c\n",j, sb->cval[j]);
403 break;
404 case xdr_datatype_string:
405 for(j=0;j<sb->nr;j++)
406 printf("%14d %80s\n",j, sb->sval[j]);
407 break;
408 default:
409 gmx_incons("Unknown subblock type");
414 } while (bCont);
416 close_enx(in);
418 free_enxframe(fr);
419 sfree(fr);
420 sfree(enm);
423 static void list_mtx(const char *fn)
425 int nrow,ncol,i,j,k;
426 real *full=NULL,value;
427 gmx_sparsematrix_t * sparse=NULL;
429 gmx_mtxio_read(fn,&nrow,&ncol,&full,&sparse);
431 if (full == NULL) {
432 snew(full,nrow*ncol);
433 for(i=0;i<nrow*ncol;i++) {
434 full[i] = 0;
437 for(i=0;i<sparse->nrow;i++) {
438 for(j=0;j<sparse->ndata[i];j++) {
439 k = sparse->data[i][j].col;
440 value = sparse->data[i][j].value;
441 full[i*ncol+k] = value;
442 full[k*ncol+i] = value;
445 gmx_sparsematrix_destroy(sparse);
448 printf("%d %d\n",nrow,ncol);
449 for(i=0; i<nrow; i++) {
450 for(j=0; j<ncol; j++) {
451 printf(" %g",full[i*ncol+j]);
453 printf("\n");
456 sfree(full);
459 int main(int argc,char *argv[])
461 const char *desc[] = {
462 "gmxdump reads a run input file ([TT].tpa[tt]/[TT].tpr[tt]/[TT].tpb[tt]),",
463 "a trajectory ([TT].trj[tt]/[TT].trr[tt]/[TT].xtc[tt]), an energy",
464 "file ([TT].ene[tt]/[TT].edr[tt]), or a checkpoint file ([TT].cpt[tt])",
465 "and prints that to standard output in a readable format.",
466 "This program is essential for checking your run input file in case of",
467 "problems.[PAR]",
468 "The program can also preprocess a topology to help finding problems.",
469 "Note that currently setting GMXLIB is the only way to customize",
470 "directories used for searching include files.",
472 t_filenm fnm[] = {
473 { efTPX, "-s", NULL, ffOPTRD },
474 { efTRX, "-f", NULL, ffOPTRD },
475 { efEDR, "-e", NULL, ffOPTRD },
476 { efCPT, NULL, NULL, ffOPTRD },
477 { efTOP, "-p", NULL, ffOPTRD },
478 { efMTX, "-mtx", "hessian", ffOPTRD },
479 { efMDP, "-om", NULL, ffOPTWR }
481 #define NFILE asize(fnm)
483 output_env_t oenv;
484 /* Command line options */
485 static gmx_bool bXVG=FALSE;
486 static gmx_bool bShowNumbers=TRUE;
487 static gmx_bool bSysTop=FALSE;
488 t_pargs pa[] = {
489 { "-xvg", FALSE, etBOOL, {&bXVG}, "HIDDENXVG layout for xtc" },
490 { "-nr",FALSE, etBOOL, {&bShowNumbers},"Show index numbers in output (leaving them out makes comparison easier, but creates a useless topology)" },
491 { "-sys", FALSE, etBOOL, {&bSysTop}, "List the atoms and bonded interactions for the whole system instead of for each molecule type" }
494 CopyRight(stderr,argv[0]);
495 parse_common_args(&argc,argv,0,NFILE,fnm,asize(pa),pa,
496 asize(desc),desc,0,NULL,&oenv);
499 if (ftp2bSet(efTPX,NFILE,fnm))
500 list_tpx(ftp2fn(efTPX,NFILE,fnm),bShowNumbers,
501 ftp2fn_null(efMDP,NFILE,fnm),bSysTop);
502 else if (ftp2bSet(efTRX,NFILE,fnm))
503 list_trx(ftp2fn(efTRX,NFILE,fnm),bXVG);
504 else if (ftp2bSet(efEDR,NFILE,fnm))
505 list_ene(ftp2fn(efEDR,NFILE,fnm));
506 else if (ftp2bSet(efCPT,NFILE,fnm))
507 list_checkpoint(ftp2fn(efCPT,NFILE,fnm),stdout);
508 else if (ftp2bSet(efTOP,NFILE,fnm))
509 list_top(ftp2fn(efTOP,NFILE,fnm));
510 else if (ftp2bSet(efMTX,NFILE,fnm))
511 list_mtx(ftp2fn(efMTX,NFILE,fnm));
513 thanx(stderr);
515 return 0;