dca2ed387811c4706340a29e6c51a6ebf9f14b51
[alexxy/gromacs.git] / src / tools / gmx_trjcat.c
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.
14
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.
19  * 
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.
26  * 
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.
29  * 
30  * For more info, check our website at http://www.gromacs.org
31  * 
32  * And Hey:
33  * Green Red Orange Magenta Azure Cyan Skyblue
34  */
35 #ifdef HAVE_CONFIG_H
36 #include <config.h>
37 #endif
38
39 #include <string.h>
40 #include <math.h>
41 #include "macros.h"
42 #include "sysstuff.h"
43 #include "smalloc.h"
44 #include "typedefs.h"
45 #include "copyrite.h"
46 #include "gmxfio.h"
47 #include "tpxio.h"
48 #include "trnio.h"
49 #include "statutil.h"
50 #include "futil.h"
51 #include "pdbio.h"
52 #include "confio.h"
53 #include "names.h"
54 #include "index.h"
55 #include "vec.h"
56 #include "xtcio.h"
57 #include "do_fit.h"
58 #include "rmpbc.h"
59 #include "wgms.h"
60 #include "pbc.h"
61 #include "xvgr.h"
62 #include "xdrf.h"
63 #include "gmx_ana.h"
64
65 #define TIME_EXPLICIT 0
66 #define TIME_CONTINUE 1
67 #define TIME_LAST     2
68 #ifndef FLT_MAX
69 #define FLT_MAX 1e36
70 #endif
71 #define FLAGS (TRX_READ_X | TRX_READ_V | TRX_READ_F)
72
73 static void scan_trj_files(char **fnms, int nfiles, real *readtime,
74                            real *timestep, atom_id imax,
75                            const output_env_t oenv)
76 {
77     /* Check start time of all files */
78     int i, natoms = 0;
79     t_trxstatus *status;
80     real t;
81     t_trxframe fr;
82     gmx_bool ok;
83
84     for (i = 0; i < nfiles; i++)
85     {
86         ok = read_first_frame(oenv, &status, fnms[i], &fr, FLAGS);
87
88         if (!ok)
89             gmx_fatal(FARGS,"\nCouldn't read frame from file." );
90         if(fr.bTime)
91             readtime[i]=fr.time;
92         else
93         {
94             readtime[i]=0;
95             fprintf(stderr,"\nWARNING: Couldn't find a time in the frame.\n");
96         }
97
98         if(i==0) 
99         {
100             natoms=fr.natoms;
101         }
102         else 
103         {
104             if (imax==NO_ATID) 
105             {
106                 if(natoms!=fr.natoms) 
107                     gmx_fatal(FARGS,"\nDifferent numbers of atoms (%d/%d) in files",
108                               natoms,fr.natoms);
109             } 
110             else 
111             {
112                 if(fr.natoms <= imax) 
113                 {
114                     gmx_fatal(FARGS,"\nNot enough atoms (%d) for index group (%d)",
115                               fr.natoms,imax);
116                 }
117             }
118         }
119         ok=read_next_frame(oenv,status,&fr);
120         if(ok && fr.bTime) 
121         {
122             timestep[i] = fr.time - readtime[i];
123         } 
124         else 
125         {
126             timestep[i] = 0;
127         }
128
129         close_trj(status);
130         if (fr.bX)
131           sfree(fr.x);
132         if (fr.bV)
133           sfree(fr.v);
134         if (fr.bF)
135           sfree(fr.f);
136     }
137     fprintf(stderr,"\n");
138
139 }
140
141 static void sort_files(char **fnms, real *settime, int nfile)
142 {
143     int i, j, minidx;
144     real timeswap;
145     char *chptr;
146
147     for (i = 0; i < nfile; i++)
148     {
149         minidx = i;
150         for (j = i + 1; j < nfile; j++)
151         {
152             if (settime[j] < settime[minidx])
153             {
154                 minidx = j;
155             }
156         }
157         if (minidx != i)
158         {
159             timeswap = settime[i];
160             settime[i] = settime[minidx];
161             settime[minidx] = timeswap;
162             chptr = fnms[i];
163             fnms[i] = fnms[minidx];
164             fnms[minidx] = chptr;
165         }
166     }
167 }
168
169 static void edit_files(char **fnms, int nfiles, real *readtime, real *timestep,
170                        real *settime, int *cont_type, gmx_bool bSetTime,
171                        gmx_bool bSort, const output_env_t oenv)
172 {
173     int i;
174     gmx_bool ok;
175     char inputstring[STRLEN], *chptr;
176
177     if (bSetTime)
178     {
179         fprintf(stderr, "\n\nEnter the new start time (%s) for each file.\n"
180                 "There are two special options, both disable sorting:\n\n"
181                 "c (continue) - The start time is taken from the end\n"
182                 "of the previous file. Use it when your continuation run\n"
183                 "restarts with t=0.\n\n"
184                 "l (last) - The time in this file will be changed the\n"
185                 "same amount as in the previous. Use it when the time in the\n"
186                 "new run continues from the end of the previous one,\n"
187                 "since this takes possible overlap into account.\n\n",
188                 output_env_get_time_unit(oenv));
189
190         fprintf(
191                 stderr,
192                 "          File             Current start (%s)  New start (%s)\n"
193                 "---------------------------------------------------------\n",
194                 output_env_get_time_unit(oenv), output_env_get_time_unit(oenv));
195
196         for (i = 0; i < nfiles; i++)
197         {
198             fprintf(stderr, "%25s   %10.3f %s          ", fnms[i],
199                     output_env_conv_time(oenv, readtime[i]), output_env_get_time_unit(oenv));
200             ok = FALSE;
201             do
202             {
203                 if (NULL == fgets(inputstring, STRLEN - 1, stdin))
204                 {
205                     gmx_fatal(FARGS,"Error reading user input" );
206                 }
207
208                 inputstring[strlen(inputstring)-1]=0;
209
210                 if(inputstring[0]=='c' || inputstring[0]=='C')
211                 {
212                     cont_type[i]=TIME_CONTINUE;
213                     bSort=FALSE;
214                     ok=TRUE;
215                     settime[i]=FLT_MAX;
216                 }
217                 else if(inputstring[0]=='l' ||
218                     inputstring[0]=='L')
219                 {
220                     cont_type[i]=TIME_LAST;
221                     bSort=FALSE;
222                     ok=TRUE;
223                     settime[i]=FLT_MAX;
224                 }
225                 else
226                 {
227                     settime[i]=strtod(inputstring,&chptr)*
228                     output_env_get_time_invfactor(oenv);
229                     if(chptr==inputstring)
230                     {
231                         fprintf(stderr,"'%s' not recognized as a floating point number, 'c' or 'l'. "
232                                 "Try again: ",inputstring);
233                     }
234                     else {
235                         cont_type[i]=TIME_EXPLICIT;
236                         ok=TRUE;
237                     }
238                 }
239             } while (!ok);
240         }
241         if(cont_type[0]!=TIME_EXPLICIT)
242         {
243             cont_type[0]=TIME_EXPLICIT;
244             settime[0]=0;
245         }
246     }
247     else
248     {
249         for(i=0;i<nfiles;i++)
250         {
251             settime[i]=readtime[i];
252         }
253     }
254     if(!bSort)
255     {
256         fprintf(stderr,"Sorting disabled.\n");
257     }
258     else
259     {
260         sort_files(fnms,settime,nfiles);
261     }
262     /* Write out the new order and start times */
263     fprintf(stderr,"\nSummary of files and start times used:\n\n"
264             "          File                Start time       Time step\n"
265             "---------------------------------------------------------\n");
266     for(i=0;i<nfiles;i++)
267         switch(cont_type[i])
268         {
269         case TIME_EXPLICIT:
270             fprintf(stderr,"%25s   %10.3f %s   %10.3f %s",
271                     fnms[i],
272                     output_env_conv_time(oenv,settime[i]),output_env_get_time_unit(oenv),
273                     output_env_conv_time(oenv,timestep[i]),output_env_get_time_unit(oenv));
274             if ( i>0 &&
275                 cont_type[i-1]==TIME_EXPLICIT && settime[i]==settime[i-1] )
276                 fprintf(stderr," WARNING: same Start time as previous");
277             fprintf(stderr,"\n");
278             break;
279         case TIME_CONTINUE:
280             fprintf(stderr,"%25s        Continue from last file\n",fnms[i]);
281             break;
282         case TIME_LAST:
283             fprintf(stderr,"%25s        Change by same amount as last file\n",
284                     fnms[i]);
285             break;
286         }
287     fprintf(stderr,"\n");
288
289     settime[nfiles]=FLT_MAX;
290     cont_type[nfiles]=TIME_EXPLICIT;
291     readtime[nfiles]=FLT_MAX;
292 }
293
294 static void do_demux(int nset, char *fnms[], char *fnms_out[], int nval,
295                      real **value, real *time, real dt_remd, int isize,
296                      atom_id index[], real dt, const output_env_t oenv)
297 {
298     int i, j, k, natoms, nnn;
299     t_trxstatus **fp_in, **fp_out;
300     gmx_bool bCont, *bSet;
301     real t, first_time = 0;
302     t_trxframe *trx;
303
304     snew(fp_in,nset);
305     snew(trx,nset);
306     snew(bSet,nset);
307     natoms = -1;
308     t = -1;
309     for (i = 0; (i < nset); i++)
310     {
311         nnn = read_first_frame(oenv, &(fp_in[i]), fnms[i], &(trx[i]),
312                                TRX_NEED_X);
313         if (natoms == -1)
314         {
315             natoms = nnn;
316             first_time = trx[i].time;
317         }
318         else if (natoms != nnn)
319         {
320             gmx_fatal(FARGS,"Trajectory file %s has %d atoms while previous trajs had %d atoms" ,fnms[i],nnn,natoms);
321         }
322         if (t == -1)
323         {
324             t = trx[i].time;
325         }
326         else if (t != trx[i].time)
327         {
328             gmx_fatal(FARGS,"Trajectory file %s has time %f while previous trajs had time %f",fnms[i],trx[i].time,t);
329         }
330     }
331
332     snew(fp_out,nset);
333     for(i=0; (i<nset); i++)
334     {
335         fp_out[i] = open_trx(fnms_out[i],"w");
336     }
337     k = 0;
338     if (gmx_nint(time[k] - t) != 0)
339     {
340         gmx_fatal(FARGS,"First time in demuxing table does not match trajectories");
341     }
342     do
343     {
344         while ((k+1 < nval) && ((trx[0].time - time[k+1]) > dt_remd*0.1))
345         {
346             k++;
347         }
348         if (debug) 
349         {
350             fprintf(debug,"trx[0].time = %g, time[k] = %g\n",trx[0].time,time[k]);
351         }
352         for(i=0; (i<nset); i++)
353         {
354             bSet[i] = FALSE;
355         }
356         for(i=0; (i<nset); i++)
357         {
358             j = gmx_nint(value[i][k]);
359             range_check(j,0,nset);
360             if (bSet[j])
361             {
362                 gmx_fatal(FARGS,"Demuxing the same replica %d twice at time %f",
363                           j,trx[0].time);
364             }
365             bSet[j] = TRUE;
366
367             if (dt==0 || bRmod(trx[i].time,first_time,dt))
368             {
369                 if (index)
370                 {
371                     write_trxframe_indexed(fp_out[j],&trx[i],isize,index,NULL);
372                 }
373                 else
374                 {
375                     write_trxframe(fp_out[j],&trx[i],NULL);
376                 }
377             }
378         }
379
380         bCont = (k < nval);
381         for(i=0; (i<nset); i++)
382         {
383             bCont = bCont && read_next_frame(oenv,fp_in[i],&trx[i]);
384         }
385     } while (bCont);
386
387     for(i=0; (i<nset); i++)
388     {
389         close_trx(fp_in[i]);
390         close_trx(fp_out[i]);
391     }
392 }
393
394 int gmx_trjcat(int argc, char *argv[])
395 {
396     const char
397     *desc[] =
398         {
399             "[TT]trjcat[tt] concatenates several input trajectory files in sorted order. ",
400             "In case of double time frames the one in the later file is used. ",
401             "By specifying [TT]-settime[tt] you will be asked for the start time ",
402             "of each file. The input files are taken from the command line, ",
403             "such that a command like [TT]trjcat -f *.trr -o fixed.trr[tt] should do ",
404             "the trick. Using [TT]-cat[tt], you can simply paste several files ",
405             "together without removal of frames with identical time stamps.[PAR]",
406             "One important option is inferred when the output file is amongst the",
407             "input files. In that case that particular file will be appended to",
408             "which implies you do not need to store double the amount of data.",
409             "Obviously the file to append to has to be the one with lowest starting",
410             "time since one can only append at the end of a file.[PAR]",
411             "If the [TT]-demux[tt] option is given, the N trajectories that are",
412             "read, are written in another order as specified in the [TT].xvg[tt] file.",
413             "The [TT].xvg[tt] file should contain something like:[PAR]",
414             "[TT]0  0  1  2  3  4  5[BR]",
415             "2  1  0  2  3  5  4[tt][BR]",
416             "Where the first number is the time, and subsequent numbers point to",
417             "trajectory indices.",
418             "The frames corresponding to the numbers present at the first line",
419             "are collected into the output trajectory. If the number of frames in",
420             "the trajectory does not match that in the [TT].xvg[tt] file then the program",
421             "tries to be smart. Beware." };
422     static gmx_bool bVels = TRUE;
423     static int prec = 3;
424     static gmx_bool bCat = FALSE;
425     static gmx_bool bSort = TRUE;
426     static gmx_bool bKeepLast = FALSE;
427     static gmx_bool bKeepLastAppend = FALSE;
428     static gmx_bool bOverwrite = FALSE;
429     static gmx_bool bSetTime = FALSE;
430     static gmx_bool bDeMux;
431     static real begin = -1;
432     static real end = -1;
433     static real dt = 0;
434
435     t_pargs
436         pa[] =
437             {
438             { "-b", FALSE, etTIME,
439                 { &begin }, "First time to use (%t)" },
440             { "-e", FALSE, etTIME,
441                 { &end }, "Last time to use (%t)" },
442             { "-dt", FALSE, etTIME,
443                 { &dt }, "Only write frame when t MOD dt = first time (%t)" },
444             { "-prec", FALSE, etINT,
445                 { &prec }, "Precision for [TT].xtc[tt] and [TT].gro[tt] writing in number of decimal places" },
446             { "-vel", FALSE, etBOOL,
447                 { &bVels }, "Read and write velocities if possible" },
448             { "-settime", FALSE, etBOOL,
449                 { &bSetTime }, "Change starting time interactively" },
450             { "-sort", FALSE, etBOOL,
451                 { &bSort }, "Sort trajectory files (not frames)" },
452             { "-keeplast", FALSE, etBOOL,
453                 { &bKeepLast }, "Keep overlapping frames at end of trajectory" },
454             { "-overwrite", FALSE, etBOOL,
455                 { &bOverwrite }, "Overwrite overlapping frames during appending" },
456             { "-cat", FALSE, etBOOL,
457                 { &bCat }, "Do not discard double time frames" } };
458 #define npargs asize(pa)
459     int ftpin, i, frame, frame_out, step = 0, trjout = 0;
460     t_trxstatus *status;
461     rvec *x, *v;
462     real xtcpr, t_corr;
463     t_trxframe fr, frout;
464     char **fnms, **fnms_out, *in_file, *out_file;
465     int n_append;
466     t_trxstatus *trxout = NULL;
467     gmx_bool bNewFile, bIndex, bWrite;
468     int earliersteps, nfile_in, nfile_out, *cont_type, last_ok_step;
469     real *readtime, *timest, *settime;
470     real first_time = 0, lasttime = NOTSET, last_ok_t = -1, timestep;
471     real last_frame_time, searchtime;
472     int isize, j;
473     atom_id *index = NULL, imax;
474     char *grpname;
475     real **val = NULL, *t = NULL, dt_remd;
476     int n, nset;
477     gmx_bool bOK;
478     gmx_off_t fpos;
479     output_env_t oenv;
480     t_filenm fnm[] =
481         {
482             { efTRX, "-f", NULL, ffRDMULT },
483             { efTRO, "-o", NULL, ffWRMULT },
484             { efNDX, "-n", "index", ffOPTRD },
485             { efXVG, "-demux", "remd", ffOPTRD } };
486
487 #define NFILE asize(fnm)
488
489     CopyRight(stderr, argv[0]);
490     parse_common_args(&argc, argv, PCA_BE_NICE | PCA_TIME_UNIT, NFILE, fnm,
491                       asize(pa), pa, asize(desc), desc, 0, NULL, &oenv);
492
493     bIndex = ftp2bSet(efNDX, NFILE, fnm);
494     bDeMux = ftp2bSet(efXVG, NFILE, fnm);
495     bSort = bSort && !bDeMux;
496
497     imax = NO_ATID;
498     if (bIndex)
499     {
500         printf("Select group for output\n");
501         rd_index(ftp2fn(efNDX, NFILE, fnm), 1, &isize, &index, &grpname);
502         /* scan index */
503         imax = index[0];
504         for (i = 1; i < isize; i++)
505         {
506             imax = max(imax, index[i]);
507         }
508     }
509     if (bDeMux)
510     {
511         nset = 0;
512         dt_remd = 0;
513         val = read_xvg_time(opt2fn("-demux", NFILE, fnm), TRUE,
514                             opt2parg_bSet("-b", npargs, pa), begin,
515                             opt2parg_bSet("-e", npargs, pa), end, 1, &nset, &n,
516                             &dt_remd, &t);
517         printf("Read %d sets of %d points, dt = %g\n\n", nset, n, dt_remd);
518         if (debug)
519         {
520             fprintf(debug, "Dump of replica_index.xvg\n");
521             for (i = 0; (i < n); i++)
522             {
523                 fprintf(debug, "%10g", t[i]);
524                 for (j = 0; (j < nset); j++)
525                 {
526                     fprintf(debug, "  %3d", gmx_nint(val[j][i]));
527                 }
528                 fprintf(debug, "\n");
529             }
530         }
531     }
532     /* prec is in nr of decimal places, xtcprec is a multiplication factor: */
533     xtcpr = 1;
534     for (i = 0; i < prec; i++)
535     {
536         xtcpr *= 10;
537     }
538     
539     nfile_in = opt2fns(&fnms, "-f", NFILE, fnm);
540     if (!nfile_in)
541     {
542         gmx_fatal(FARGS,"No input files!" );
543     }
544     
545     if (bDeMux && (nfile_in != nset))
546     {
547         gmx_fatal(FARGS,"You have specified %d files and %d entries in the demux table",nfile_in,nset);
548     }
549     
550     nfile_out = opt2fns(&fnms_out,"-o",NFILE,fnm);
551     if (!nfile_out)
552     {
553         gmx_fatal(FARGS,"No output files!");
554     }
555     if ((nfile_out > 1) && !bDeMux)
556     {
557         gmx_fatal(FARGS,"Don't know what to do with more than 1 output file if  not demultiplexing");
558     }
559     else if (bDeMux && (nfile_out != nset) && (nfile_out != 1))
560     {
561         gmx_fatal(FARGS,"Number of output files should be 1 or %d (#input files), not %d",nset,nfile_out);
562     }
563     if (bDeMux) 
564     {
565         if (nfile_out != nset) 
566         {
567             char *buf = strdup(fnms_out[0]);
568             snew(fnms_out,nset);
569             for(i=0; (i<nset); i++) 
570             {
571                 snew(fnms_out[i],strlen(buf)+32);
572                 sprintf(fnms_out[i],"%d_%s",i,buf);
573             }
574             sfree(buf);
575         }
576         do_demux(nfile_in,fnms,fnms_out,n,val,t,dt_remd,isize,index,dt,oenv);
577     }
578     else 
579     {
580         snew(readtime,nfile_in+1);
581         snew(timest,nfile_in+1);
582         scan_trj_files(fnms,nfile_in,readtime,timest,imax,oenv);
583
584         snew(settime,nfile_in+1);
585         snew(cont_type,nfile_in+1);
586         edit_files(fnms,nfile_in,readtime,timest,settime,cont_type,bSetTime,bSort,
587                    oenv);
588
589         /* Check whether the output file is amongst the input files 
590          * This has to be done after sorting etc.
591          */
592         out_file = fnms_out[0];
593         n_append = -1;
594         for(i=0; ((i<nfile_in) && (n_append==-1)); i++) 
595         {
596             if (strcmp(fnms[i],out_file) == 0) 
597             {
598                 n_append = i;
599             }
600         }
601         if (n_append == 0) {
602             fprintf(stderr,"Will append to %s rather than creating a new file\n",
603                     out_file);
604         }
605         else if (n_append != -1)
606         {
607             gmx_fatal(FARGS,"Can only append to the first file which is %s (not %s)",
608                       fnms[0],out_file);
609         }
610         earliersteps=0;    
611
612         /* Not checking input format, could be dangerous :-) */
613         /* Not checking output format, equally dangerous :-) */
614
615         frame=-1;
616         frame_out=-1;
617         /* the default is not to change the time at all,
618          * but this is overridden by the edit_files routine
619          */
620         t_corr=0;
621
622         if (n_append == -1) 
623         {
624             trxout = open_trx(out_file,"w");
625             memset(&frout,0,sizeof(frout));
626         }
627         else 
628         {
629             t_fileio *stfio;
630
631             if (!read_first_frame(oenv,&status,out_file,&fr,FLAGS))
632                 gmx_fatal(FARGS,"Reading first frame from %s",out_file);
633
634             stfio=trx_get_fileio(status);
635             if (!bKeepLast && !bOverwrite)
636             {
637                 fprintf(stderr, "\n\nWARNING: Appending without -overwrite implies -keeplast "
638                     "between the first two files. \n"
639                     "If the trajectories have an overlap and have not been written binary \n"
640                     "reproducible this will produce an incorrect trajectory!\n\n");
641             
642                 /* Fails if last frame is incomplete
643                  * We can't do anything about it without overwriting
644                  * */
645                 if (gmx_fio_getftp(stfio) == efXTC) 
646                 {
647                     lasttime = 
648                          xdr_xtc_get_last_frame_time(gmx_fio_getfp(stfio),
649                                                      gmx_fio_getxdr(stfio),
650                                                      fr.natoms,&bOK);
651                     fr.time = lasttime;
652                     if (!bOK)
653                     {
654                        gmx_fatal(FARGS,"Error reading last frame. Maybe seek not supported." );
655                     }     
656                 }
657                 else 
658                 {
659                     while (read_next_frame(oenv,status,&fr))
660                         ;
661                     lasttime = fr.time;                    
662                 }
663                 bKeepLastAppend = TRUE;
664                 close_trj(status);
665                 trxout = open_trx(out_file,"a");
666             }
667             else if (bOverwrite)
668             {
669                 if (gmx_fio_getftp(stfio) != efXTC) {
670                     gmx_fatal(FARGS,"Overwrite only supported for XTC." );
671                 }
672                 last_frame_time = 
673                           xdr_xtc_get_last_frame_time(gmx_fio_getfp(stfio),
674                                                       gmx_fio_getxdr(stfio),
675                                                       fr.natoms,&bOK);
676                 if (!bOK)
677                 {
678                    gmx_fatal(FARGS,"Error reading last frame. Maybe seek not supported." );
679                 }
680                 /* xtc_seek_time broken for trajectories containing only 1 or 2 frames 
681                  *     or when seek time = 0 */
682                 if (nfile_in>1 && settime[1]<last_frame_time+timest[0]*0.5)  
683                 {
684                     /* Jump to one time-frame before the start of next
685                      *  trajectory file */
686                     searchtime = settime[1]-timest[0]*1.25;
687                 } 
688                 else 
689                 {
690                     searchtime = last_frame_time;
691                 }
692                 if (xtc_seek_time(stfio,searchtime,fr.natoms,TRUE))
693                 {
694                     gmx_fatal(FARGS,"Error seeking to append position.");
695                 }
696                 read_next_frame(oenv,status,&fr);
697                 if (fabs(searchtime - fr.time) > timest[0]*0.5)
698                 {
699                     gmx_fatal(FARGS,"Error seeking: attempted to seek to %f but got %f.",
700                               searchtime,fr.time);
701                 }
702                 lasttime = fr.time;             
703                 fpos = gmx_fio_ftell(stfio);
704                 close_trj(status);
705                 trxout = open_trx(out_file,"r+");
706                 if (gmx_fio_seek(trx_get_fileio(trxout),fpos)) {
707                     gmx_fatal(FARGS,"Error seeking to append position.");
708                 }
709             }
710             printf("\n Will append after %f \n",lasttime);
711             frout = fr;
712         }
713         /* Lets stitch up some files */
714         timestep = timest[0];
715         for(i=n_append+1; (i<nfile_in); i++) 
716         {
717             /* Open next file */
718
719             /* set the next time from the last frame in previous file */
720             if (i > 0) 
721             {
722                 if (frame_out >= 0) 
723                 {
724                     if(cont_type[i]==TIME_CONTINUE) 
725                     {
726                         begin =frout.time;
727                         begin += 0.5*timestep;
728                         settime[i]=frout.time;
729                         cont_type[i]=TIME_EXPLICIT;       
730                     }
731                     else if(cont_type[i]==TIME_LAST) 
732                     {
733                         begin=frout.time;
734                         begin += 0.5*timestep;
735                     }
736                     /* Or, if the time in the next part should be changed by the
737                      * same amount, start at half a timestep from the last time
738                      * so we dont repeat frames.
739                      */
740                     /* I don't understand the comment above, but for all the cases
741                      * I tried the code seems to work properly. B. Hess 2008-4-2.
742                      */
743                 }
744                 /* Or, if time is set explicitly, we check for overlap/gap */
745                 if(cont_type[i]==TIME_EXPLICIT) 
746                 {
747                     if( ( i < nfile_in ) &&
748                         ( frout.time < settime[i]-1.5*timestep ) ) 
749                     {
750                         fprintf(stderr, "WARNING: Frames around t=%f %s have a different "
751                                 "spacing than the rest,\n"
752                                 "might be a gap or overlap that couldn't be corrected "
753                                 "automatically.\n",output_env_conv_time(oenv,frout.time),
754                                 output_env_get_time_unit(oenv));
755                     }
756                 }
757             }
758
759             /* if we don't have a timestep in the current file, use the old one */
760             if ( timest[i] != 0 )
761             {
762                 timestep = timest[i];
763             }
764             read_first_frame(oenv,&status,fnms[i],&fr,FLAGS);
765             if(!fr.bTime) 
766             {
767                 fr.time=0;
768                 fprintf(stderr,"\nWARNING: Couldn't find a time in the frame.\n");
769             }
770
771             if(cont_type[i]==TIME_EXPLICIT)
772             {
773                 t_corr=settime[i]-fr.time;
774             }
775             /* t_corr is the amount we want to change the time.
776              * If the user has chosen not to change the time for
777              * this part of the trajectory t_corr remains at 
778              * the value it had in the last part, changing this
779              * by the same amount.
780              * If no value was given for the first trajectory part
781              * we let the time start at zero, see the edit_files routine.
782              */
783
784             bNewFile=TRUE;
785
786             printf("\n");
787             if (lasttime != NOTSET)
788             {
789                 printf("lasttime %g\n", lasttime);
790             }
791
792             do 
793             {
794                 /* copy the input frame to the output frame */
795                 frout=fr;
796                 /* set the new time by adding the correct calculated above */
797                 frout.time += t_corr; 
798                 /* quit if we have reached the end of what should be written */
799                 if((end > 0) && (frout.time > end+GMX_REAL_EPS)) 
800                 {
801                     i=nfile_in;
802                     break;
803                 }
804
805                 /* determine if we should write this frame (dt is handled elsewhere) */
806                 if (bCat) /* write all frames of all files */
807                 {
808                     bWrite = TRUE;
809                 }
810                 else if ( bKeepLast || (bKeepLastAppend && i==1)) 
811                     /* write till last frame of this traj
812                        and skip first frame(s) of next traj */
813                 {
814                     bWrite = ( frout.time > lasttime+0.5*timestep );
815                 }
816                 else /* write till first frame of next traj */
817                 {
818                     bWrite = ( frout.time < settime[i+1]-0.5*timestep );
819                 }
820
821                 if( bWrite && (frout.time >= begin) ) 
822                 {
823                     frame++;
824                     if (frame_out == -1)
825                         first_time = frout.time;
826                     lasttime = frout.time;
827                     if (dt==0 || bRmod(frout.time,first_time,dt)) 
828                     {
829                         frame_out++;
830                         last_ok_t=frout.time;
831                         if(bNewFile) 
832                         {
833                             fprintf(stderr,"\nContinue writing frames from %s t=%g %s, "
834                                     "frame=%d      \n",
835                                     fnms[i],output_env_conv_time(oenv,frout.time),output_env_get_time_unit(oenv),
836                                     frame);
837                             bNewFile=FALSE;
838                         }
839
840                         if (bIndex)
841                         {
842                             write_trxframe_indexed(trxout,&frout,isize,index,
843                                                    NULL);
844                         }
845                         else
846                         {
847                             write_trxframe(trxout,&frout,NULL);
848                         }
849                         if ( ((frame % 10) == 0) || (frame < 10) )
850                         {
851                             fprintf(stderr," ->  frame %6d time %8.3f %s     \r",
852                                     frame_out,output_env_conv_time(oenv,frout.time),output_env_get_time_unit(oenv));
853                         }
854                     }
855                 }
856             } while( read_next_frame(oenv,status,&fr));
857
858             close_trj(status);
859
860             earliersteps+=step;   
861         }  
862         if (trxout)
863         {
864             close_trx(trxout);
865         }
866         fprintf(stderr,"\nLast frame written was %d, time %f %s\n",
867                 frame,output_env_conv_time(oenv,last_ok_t),output_env_get_time_unit(oenv)); 
868     }
869     thanx(stderr);
870
871     return 0;
872 }