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
49 #include "gmx_fatal.h"
54 #define TIME_EXPLICIT 0
55 #define TIME_CONTINUE 1
61 static int *select_it(int nre
,gmx_enxnm_t
*nm
,int *nset
)
66 gmx_bool bVerbose
= TRUE
;
68 if ((getenv("VERBOSE")) != NULL
)
71 fprintf(stderr
,"Select the terms you want to scale from the following list\n");
72 fprintf(stderr
,"End your selection with 0\n");
76 for(j
=0; (j
<4) && (k
<nre
); j
++,k
++)
77 fprintf(stderr
," %3d=%14s",k
+1,nm
[k
].name
);
84 if(1 != scanf("%d",&n
))
86 gmx_fatal(FARGS
,"Cannot read energy term");
88 if ((n
>0) && (n
<=nre
))
93 for(i
=(*nset
)=0; (i
<nre
); i
++)
102 static gmx_bool
same_time(real t1
,real t2
)
106 return (fabs(t1
-t2
) < tol
);
110 gmx_bool
bRgt(double a
,double b
)
114 if ( a
> (b
- tol
*(a
+b
)) )
120 static void sort_files(char **fnms
,real
*settime
,int nfile
)
126 for(i
=0;i
<nfile
;i
++) {
128 for(j
=i
+1;j
<nfile
;j
++) {
129 if(settime
[j
]<settime
[minidx
])
134 settime
[i
]=settime
[minidx
];
135 settime
[minidx
]=timeswap
;
137 fnms
[i
]=fnms
[minidx
];
144 static int scan_ene_files(char **fnms
, int nfiles
,
145 real
*readtime
, real
*timestep
, int *nremax
)
147 /* Check number of energy terms and start time of all files */
148 int f
,i
,nre
,nremin
=0,nresav
=0;
151 char inputstring
[STRLEN
];
157 for(f
=0; f
<nfiles
; f
++) {
158 in
= open_enx(fnms
[f
],"r");
160 do_enxnms(in
,&nre
,&enm
);
174 nremin
= min(nremin
,fr
->nre
);
175 *nremax
= max(*nremax
,fr
->nre
);
178 "Energy files don't match, different number of energies:\n"
179 " %s: %d\n %s: %d\n",fnms
[f
-1],nresav
,fnms
[f
],fr
->nre
);
181 "\nContinue conversion using only the first %d terms (n/y)?\n"
182 "(you should be sure that the energy terms match)\n",nremin
);
183 if(NULL
==fgets(inputstring
,STRLEN
-1,stdin
))
185 gmx_fatal(FARGS
,"Error reading user input");
187 if (inputstring
[0]!='y' && inputstring
[0]!='Y') {
188 fprintf(stderr
,"Will not convert\n");
197 fprintf(stderr
,"\n");
198 free_enxnms(nre
,enm
);
208 static void edit_files(char **fnms
,int nfiles
,real
*readtime
,
209 real
*settime
,int *cont_type
,gmx_bool bSetTime
,gmx_bool bSort
)
213 char inputstring
[STRLEN
],*chptr
;
217 fprintf(stderr
,"\n\nEnter the new start time:\n\n");
219 fprintf(stderr
,"\n\nEnter the new start time for each file.\n"
220 "There are two special options, both disables sorting:\n\n"
221 "c (continue) - The start time is taken from the end\n"
222 "of the previous file. Use it when your continuation run\n"
223 "restarts with t=0 and there is no overlap.\n\n"
224 "l (last) - The time in this file will be changed the\n"
225 "same amount as in the previous. Use it when the time in the\n"
226 "new run continues from the end of the previous one,\n"
227 "since this takes possible overlap into account.\n\n");
229 fprintf(stderr
," File Current start New start\n"
230 "---------------------------------------------------------\n");
232 for(i
=0;i
<nfiles
;i
++) {
233 fprintf(stderr
,"%25s %10.3f ",fnms
[i
],readtime
[i
]);
236 if(NULL
==fgets(inputstring
,STRLEN
-1,stdin
))
238 gmx_fatal(FARGS
,"Error reading user input");
240 inputstring
[strlen(inputstring
)-1]=0;
242 if(inputstring
[0]=='c' || inputstring
[0]=='C') {
243 cont_type
[i
]=TIME_CONTINUE
;
248 else if(inputstring
[0]=='l' ||
249 inputstring
[0]=='L') {
250 cont_type
[i
]=TIME_LAST
;
256 settime
[i
]=strtod(inputstring
,&chptr
);
257 if(chptr
==inputstring
) {
258 fprintf(stderr
,"Try that again: ");
261 cont_type
[i
]=TIME_EXPLICIT
;
267 if(cont_type
[0]!=TIME_EXPLICIT
) {
268 cont_type
[0]=TIME_EXPLICIT
;
273 for(i
=0;i
<nfiles
;i
++)
274 settime
[i
]=readtime
[i
];
276 if(bSort
&& (nfiles
>1))
277 sort_files(fnms
,settime
,nfiles
);
279 fprintf(stderr
,"Sorting disabled.\n");
282 /* Write out the new order and start times */
283 fprintf(stderr
,"\nSummary of files and start times used:\n\n"
285 "-----------------------------------------\n");
286 for(i
=0;i
<nfiles
;i
++)
287 switch(cont_type
[i
]) {
289 fprintf(stderr
,"%25s %10.3f\n",fnms
[i
],settime
[i
]);
292 fprintf(stderr
,"%25s Continue from end of last file\n",fnms
[i
]);
295 fprintf(stderr
,"%25s Change by same amount as last file\n",fnms
[i
]);
298 fprintf(stderr
,"\n");
300 settime
[nfiles
]=FLT_MAX
;
301 cont_type
[nfiles
]=TIME_EXPLICIT
;
302 readtime
[nfiles
]=FLT_MAX
;
306 static void copy_ee(t_energy
*src
, t_energy
*dst
, int nre
)
312 dst
[i
].esum
=src
[i
].esum
;
313 dst
[i
].eav
=src
[i
].eav
;
318 static void remove_last_eeframe(t_energy
*lastee
, gmx_large_int_t laststep
,
319 t_energy
*ee
, int nre
)
322 gmx_large_int_t p
=laststep
+1;
326 lastee
[i
].esum
-=ee
[i
].e
;
327 sigmacorr
=lastee
[i
].esum
-(p
-1)*ee
[i
].e
;
328 lastee
[i
].eav
-=(sigmacorr
*sigmacorr
)/((p
-1)*p
);
334 static void update_ee(t_energy
*lastee
,gmx_large_int_t laststep
,
335 t_energy
*startee
,gmx_large_int_t startstep
,
336 t_energy
*ee
, int step
,
337 t_energy
*outee
, int nre
)
340 double sigmacorr
,nom
,denom
;
341 double prestart_esum
;
342 double prestart_sigma
;
346 /* add statistics from earlier file if present */
348 outee
[i
].esum
=lastee
[i
].esum
+ee
[i
].esum
;
349 nom
=(lastee
[i
].esum
*(step
+1)-ee
[i
].esum
*(laststep
));
350 denom
=((step
+1.0)*(laststep
)*(step
+1.0+laststep
));
351 sigmacorr
=nom
*nom
/denom
;
352 outee
[i
].eav
=lastee
[i
].eav
+ee
[i
].eav
+sigmacorr
;
355 /* otherwise just copy to output */
356 outee
[i
].esum
=ee
[i
].esum
;
357 outee
[i
].eav
=ee
[i
].eav
;
360 /* if we didnt start to write at the first frame
361 * we must compensate the statistics for this
362 * there are laststep frames in the earlier file
363 * and step+1 frames in this one.
366 gmx_large_int_t q
=laststep
+step
;
367 gmx_large_int_t p
=startstep
+1;
368 prestart_esum
=startee
[i
].esum
-startee
[i
].e
;
369 sigmacorr
=prestart_esum
-(p
-1)*startee
[i
].e
;
370 prestart_sigma
=startee
[i
].eav
-
371 sigmacorr
*sigmacorr
/(p
*(p
-1));
372 sigmacorr
=prestart_esum
/(p
-1)-
374 outee
[i
].esum
-=prestart_esum
;
376 outee
[i
].eav
=outee
[i
].eav
-prestart_sigma
-
377 sigmacorr
*sigmacorr
*((p
-1)*q
)/(q
-p
+1);
380 if((outee
[i
].eav
/(laststep
+step
+1))<(GMX_REAL_EPS
))
386 static void update_last_ee(t_energy
*lastee
, gmx_large_int_t laststep
,
387 t_energy
*ee
,gmx_large_int_t step
,int nre
)
391 update_ee(lastee
,laststep
,NULL
,0,ee
,step
,tmp
,nre
);
392 copy_ee(tmp
,lastee
,nre
);
396 static void update_ee_sum(int nre
,
397 gmx_large_int_t
*ee_sum_step
,
398 gmx_large_int_t
*ee_sum_nsteps
,
399 gmx_large_int_t
*ee_sum_nsum
,
401 t_enxframe
*fr
,int out_step
)
403 gmx_large_int_t nsteps
,nsum
,fr_nsum
;
406 nsteps
= *ee_sum_nsteps
;
417 ee_sum
[i
].esum
= fr
->ener
[i
].e
;
422 ee_sum
[i
].esum
= fr
->ener
[i
].esum
;
423 ee_sum
[i
].eav
= fr
->ener
[i
].eav
;
428 } else if (out_step
+ *ee_sum_nsum
- *ee_sum_step
== nsteps
+ fr
->nsteps
) {
432 dsqr(ee_sum
[i
].esum
/nsum
433 - (ee_sum
[i
].esum
+ fr
->ener
[i
].e
)/(nsum
+ 1))*nsum
*(nsum
+ 1);
434 ee_sum
[i
].esum
+= fr
->ener
[i
].e
;
437 for(i
=0; i
<fr
->nre
; i
++) {
440 dsqr(ee_sum
[i
].esum
/nsum
441 - (ee_sum
[i
].esum
+ fr
->ener
[i
].esum
)/(nsum
+ fr
->nsum
))*
442 nsum
*(nsum
+ fr
->nsum
)/(double)fr
->nsum
;
443 ee_sum
[i
].esum
+= fr
->ener
[i
].esum
;
446 nsteps
+= fr
->nsteps
;
450 fprintf(stderr
,"\nWARNING: missing energy sums at time %f\n",fr
->t
);
456 *ee_sum_step
= out_step
;
457 *ee_sum_nsteps
= nsteps
;
461 int gmx_eneconv(int argc
,char *argv
[])
463 const char *desc
[] = {
464 "With [IT]multiple files[it] specified for the [TT]-f[tt] option:[BR]",
465 "Concatenates several energy files in sorted order.",
466 "In case of double time frames the one",
467 "in the later file is used. By specifying [TT]-settime[tt] you will be",
468 "asked for the start time of each file. The input files are taken",
469 "from the command line,",
470 "such that the command [TT]eneconv -o fixed.edr *.edr[tt] should do",
472 "With [IT]one file[it] specified for [TT]-f[tt]:[BR]",
473 "Reads one energy file and writes another, applying the [TT]-dt[tt],",
474 "[TT]-offset[tt], [TT]-t0[tt] and [TT]-settime[tt] options and",
475 "converting to a different format if necessary (indicated by file",
477 "[TT]-settime[tt] is applied first, then [TT]-dt[tt]/[TT]-offset[tt]",
478 "followed by [TT]-b[tt] and [TT]-e[tt] to select which frames to write."
480 const char *bugs
[] = {
481 "When combining trajectories the sigma and E^2 (necessary for statistics) are not updated correctly. Only the actual energy is correct. One thus has to compute statistics in another way."
483 ener_file_t in
=NULL
, out
=NULL
;
484 gmx_enxnm_t
*enm
=NULL
;
486 ener_file_t in
,out
=NULL
;
487 gmx_enxnm_t
*enm
=NULL
;
490 gmx_large_int_t ee_sum_step
=0,ee_sum_nsteps
,ee_sum_nsum
;
492 gmx_large_int_t lastfilestep
,laststep
,startstep
,startstep_file
=0;
494 int nre
,nremax
,this_nre
,nfile
,f
,i
,j
,kkk
,nset
,*set
=NULL
;
497 real
*readtime
,*settime
,timestep
,t1
,tadjust
;
498 char inputstring
[STRLEN
],*chptr
,buf
[22],buf2
[22],buf3
[22];
501 gmx_bool bNewFile
,bFirst
,bNewOutput
;
503 gmx_bool warned_about_dh
=FALSE
;
504 t_enxblock
*blocks
=NULL
;
509 { efEDR
, "-f", NULL
, ffRDMULT
},
510 { efEDR
, "-o", "fixed", ffWRITE
},
513 #define NFILE asize(fnm)
515 static real delta_t
=0.0, toffset
=0,scalefac
=1;
516 static gmx_bool bSetTime
=FALSE
;
517 static gmx_bool bSort
=TRUE
,bError
=TRUE
;
518 static real begin
=-1;
520 gmx_bool remove_dh
=FALSE
;
523 { "-b", FALSE
, etREAL
, {&begin
},
524 "First time to use"},
525 { "-e", FALSE
, etREAL
, {&end
},
527 { "-dt", FALSE
, etREAL
, {&delta_t
},
528 "Only write out frame when t MOD dt = offset" },
529 { "-offset", FALSE
, etREAL
, {&toffset
},
530 "Time offset for -dt option" },
531 { "-settime", FALSE
, etBOOL
, {&bSetTime
},
532 "Change starting time interactively" },
533 { "-sort", FALSE
, etBOOL
, {&bSort
},
534 "Sort energy files (not frames)"},
535 { "-rmdh", FALSE
, etBOOL
, {&remove_dh
},
536 "Remove free energy block data" },
537 { "-scalefac", FALSE
, etREAL
, {&scalefac
},
538 "Multiply energy component by this factor" },
539 { "-error", FALSE
, etBOOL
, {&bError
},
540 "Stop on errors in the file" }
543 CopyRight(stderr
,argv
[0]);
544 parse_common_args(&argc
,argv
,PCA_BE_NICE
,NFILE
,fnm
,asize(pa
),
545 pa
,asize(desc
),desc
,asize(bugs
),bugs
,&oenv
);
553 laststep
=startstep
=0;
555 nfile
= opt2fns(&fnms
,"-f",NFILE
,fnm
);
558 gmx_fatal(FARGS
,"No input files!");
560 snew(settime
,nfile
+1);
561 snew(readtime
,nfile
+1);
562 snew(cont_type
,nfile
+1);
564 nre
=scan_ene_files(fnms
,nfile
,readtime
,×tep
,&nremax
);
565 edit_files(fnms
,nfile
,readtime
,settime
,cont_type
,bSetTime
,bSort
);
575 snew(fro
->ener
,nremax
);
581 for(f
=0;f
<nfile
;f
++) {
584 in
=open_enx(fnms
[f
],"r");
586 do_enxnms(in
,&this_nre
,&enm
);
589 set
= select_it(nre
,enm
,&nset
);
591 /* write names to the output file */
592 out
=open_enx(opt2fn("-o",NFILE
,fnm
),"w");
593 do_enxnms(out
,&nre
,&enm
);
596 /* start reading from the next file */
597 while ((fro
->t
<= (settime
[f
+1] + GMX_REAL_EPS
)) &&
600 startstep_file
= fr
->step
;
601 tadjust
= settime
[f
] - fr
->t
;
602 if(cont_type
[f
+1]==TIME_LAST
) {
603 settime
[f
+1] = readtime
[f
+1]-readtime
[f
]+settime
[f
];
604 cont_type
[f
+1] = TIME_EXPLICIT
;
609 if (tadjust
+ fr
->t
<= last_t
) {
610 /* Skip this frame, since we already have it / past it */
612 fprintf(debug
,"fr->step %s, fr->t %.4f\n",
613 gmx_step_str(fr
->step
,buf
),fr
->t
);
614 fprintf(debug
,"tadjust %12.6e + fr->t %12.6e <= t %12.6e\n",
615 tadjust
,fr
->t
,last_t
);
620 fro
->step
= lastfilestep
+ fr
->step
- startstep_file
;
621 fro
->t
= tadjust
+ fr
->t
;
623 bWrite
= ((begin
<0 || (begin
>=0 && (fro
->t
>= begin
-GMX_REAL_EPS
))) &&
624 (end
<0 || (end
>=0 && (fro
->t
<= end
+GMX_REAL_EPS
))) &&
625 (fro
->t
<= settime
[f
+1]+0.5*timestep
));
629 "fr->step %s, fr->t %.4f, fro->step %s fro->t %.4f, w %d\n",
630 gmx_step_str(fr
->step
,buf
),fr
->t
,
631 gmx_step_str(fro
->step
,buf2
),fro
->t
,bWrite
);
635 if ((end
> 0) && (fro
->t
> end
+GMX_REAL_EPS
)) {
640 if (fro
->t
>= begin
-GMX_REAL_EPS
) {
643 startstep
= fr
->step
;
646 update_ee_sum(nre
,&ee_sum_step
,&ee_sum_nsteps
,&ee_sum_nsum
,ee_sum
,
651 /* determine if we should write it */
652 if (bWrite
&& (delta_t
==0 || bRmod(fro
->t
,toffset
,delta_t
))) {
653 laststep
= fro
->step
;
657 fprintf(stderr
,"\nContinue writing frames from t=%g, step=%s\n",
658 fro
->t
,gmx_step_str(fro
->step
,buf
));
661 /* Copy the energies */
662 for(i
=0; i
<nre
; i
++) {
663 fro
->ener
[i
].e
= fr
->ener
[i
].e
;
666 fro
->nsteps
= ee_sum_nsteps
;
669 if (ee_sum_nsum
<= 1) {
672 fro
->nsum
= gmx_large_int_to_int(ee_sum_nsum
,
673 "energy average summation");
674 /* Copy the energy sums */
675 for(i
=0; i
<nre
; i
++) {
676 fro
->ener
[i
].esum
= ee_sum
[i
].esum
;
677 fro
->ener
[i
].eav
= ee_sum
[i
].eav
;
680 /* We wrote the energies, so reset the counts */
685 for(kkk
=0; kkk
<nset
; kkk
++) {
686 fro
->ener
[set
[kkk
]].e
*= scalefac
;
688 fro
->ener
[set
[kkk
]].eav
*= scalefac
*scalefac
;
689 fro
->ener
[set
[kkk
]].esum
*= scalefac
;
693 /* Copy restraint stuff */
694 /*fro->ndisre = fr->ndisre;
695 fro->disre_rm3tav = fr->disre_rm3tav;
696 fro->disre_rt = fr->disre_rt;*/
697 fro
->nblock
= fr
->nblock
;
698 /*fro->nr = fr->nr;*/
699 fro
->block
= fr
->block
;
701 /* check if we have blocks with delta_h data and are throwing
708 if (!blocks
|| nblocks_alloc
< fr
->nblock
)
710 /* we pre-allocate the blocks */
711 nblocks_alloc
=fr
->nblock
;
712 snew(blocks
, nblocks_alloc
);
714 nblocks
=0; /* number of blocks so far */
716 for(i
=0;i
<fr
->nblock
;i
++)
718 if ( (fr
->block
[i
].id
!= enxDHCOLL
) &&
719 (fr
->block
[i
].id
!= enxDH
) &&
720 (fr
->block
[i
].id
!= enxDHHIST
) )
722 /* copy everything verbatim */
723 blocks
[nblocks
] = fr
->block
[i
];
727 /* now set the block pointer to the new blocks */
728 fro
->nblock
= nblocks
;
731 else if (delta_t
> 0)
733 if (!warned_about_dh
)
735 for(i
=0;i
<fr
->nblock
;i
++)
737 if (fr
->block
[i
].id
== enxDH
||
738 fr
->block
[i
].id
== enxDHHIST
)
741 if (fr
->block
[i
].id
== enxDH
)
743 size
=fr
->block
[i
].sub
[2].nr
;
751 printf("\nWARNING: %s contains delta H blocks or histograms for which\n"
752 " some data is thrown away on a block-by-block basis, where each block\n"
753 " contains up to %d samples.\n"
754 " This is almost certainly not what you want.\n"
755 " Use the -rmdh option to throw all delta H samples away.\n"
756 " Use g_energy -odh option to extract these samples.\n",
758 warned_about_dh
=TRUE
;
768 if (noutfr
% 1000 == 0)
769 fprintf(stderr
,"Writing frame time %g ",fro
->t
);
774 printf("\nLast step written from %s: t %g, step %s\n",
775 fnms
[f
],last_t
,gmx_step_str(laststep
,buf
));
776 lastfilestep
= laststep
;
778 /* set the next time from the last in previous file */
779 if (cont_type
[f
+1]==TIME_CONTINUE
) {
780 settime
[f
+1] = fro
->t
;
781 /* in this case we have already written the last frame of
782 * previous file, so update begin to avoid doubling it
783 * with the start of the next file
785 begin
= fro
->t
+0.5*timestep
;
786 /* cont_type[f+1]==TIME_EXPLICIT; */
789 if ((fro
->t
< end
) && (f
< nfile
-1) &&
790 (fro
->t
< settime
[f
+1]-1.5*timestep
))
792 "\nWARNING: There might be a gap around t=%g\n",fro
->t
);
794 /* move energies to lastee */
796 free_enxnms(this_nre
,enm
);
798 fprintf(stderr
,"\n");
801 fprintf(stderr
,"No frames written.\n");
803 fprintf(stderr
,"Last frame written was at step %s, time %f\n",
804 gmx_step_str(fro
->step
,buf
),fro
->t
);
805 fprintf(stderr
,"Wrote %d frames\n",noutfr
);