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