Fix remaining copyright headers
[alexxy/gromacs.git] / src / gromacs / gmxana / gmx_trjconv.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  * Copyright (c) 2013, by the GROMACS development team, led by
7  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
8  * and including many others, as listed in the AUTHORS file in the
9  * top-level source directory and at http://www.gromacs.org.
10  *
11  * GROMACS is free software; you can redistribute it and/or
12  * modify it under the terms of the GNU Lesser General Public License
13  * as published by the Free Software Foundation; either version 2.1
14  * of the License, or (at your option) any later version.
15  *
16  * GROMACS is distributed in the hope that it will be useful,
17  * but WITHOUT ANY WARRANTY; without even the implied warranty of
18  * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the GNU
19  * Lesser General Public License for more details.
20  *
21  * You should have received a copy of the GNU Lesser General Public
22  * License along with GROMACS; if not, see
23  * http://www.gnu.org/licenses, or write to the Free Software Foundation,
24  * Inc., 51 Franklin Street, Fifth Floor, Boston, MA  02110-1301  USA.
25  *
26  * If you want to redistribute modifications to GROMACS, please
27  * consider that scientific software is very special. Version
28  * control is crucial - bugs must be traceable. We will be happy to
29  * consider code for inclusion in the official distribution, but
30  * derived work must not be called official GROMACS. Details are found
31  * in the README & COPYING files - if they are missing, get the
32  * official version at http://www.gromacs.org.
33  *
34  * To help us fund GROMACS development, we humbly ask that you cite
35  * the research papers on the package. Check out http://www.gromacs.org.
36  */
37 #ifdef HAVE_CONFIG_H
38 #include <config.h>
39 #endif
40
41 #include <string.h>
42 #include <math.h>
43
44 #include "copyrite.h"
45 #include "macros.h"
46 #include "sysstuff.h"
47 #include "smalloc.h"
48 #include "typedefs.h"
49 #include "gromacs/fileio/gmxfio.h"
50 #include "gromacs/fileio/tpxio.h"
51 #include "gromacs/fileio/trxio.h"
52 #include "gromacs/fileio/trnio.h"
53 #include "gromacs/commandline/pargs.h"
54 #include "gromacs/fileio/futil.h"
55 #include "gromacs/fileio/pdbio.h"
56 #include "gromacs/fileio/confio.h"
57 #include "names.h"
58 #include "index.h"
59 #include "vec.h"
60 #include "gromacs/fileio/xtcio.h"
61 #include "do_fit.h"
62 #include "rmpbc.h"
63 #include "gromacs/fileio/g87io.h"
64 #include "pbc.h"
65 #include "viewit.h"
66 #include "xvgr.h"
67 #include "gmx_ana.h"
68 #include "gmx_sort.h"
69
70 #ifdef HAVE_UNISTD_H
71 #include <unistd.h>
72 #endif
73
74 enum {
75     euSel, euRect, euTric, euCompact, euNR
76 };
77
78
79 static void calc_pbc_cluster(int ecenter, int nrefat, t_topology *top, int ePBC,
80                              rvec x[], atom_id index[], matrix box)
81 {
82     int       m, i, j, j0, j1, jj, ai, aj;
83     int       imin, jmin;
84     real      fac, min_dist2;
85     rvec      dx, xtest, box_center;
86     int       nmol, imol_center;
87     atom_id  *molind;
88     gmx_bool *bMol, *bTmp;
89     rvec     *m_com, *m_shift;
90     t_pbc     pbc;
91     real     *com_dist2;
92     int      *cluster;
93     int      *added;
94     int       ncluster, nadded;
95     real      tmp_r2;
96
97     calc_box_center(ecenter, box, box_center);
98
99     /* Initiate the pbc structure */
100     memset(&pbc, 0, sizeof(pbc));
101     set_pbc(&pbc, ePBC, box);
102
103     /* Convert atom index to molecular */
104     nmol   = top->mols.nr;
105     molind = top->mols.index;
106     snew(bMol, nmol);
107     snew(m_com, nmol);
108     snew(m_shift, nmol);
109     snew(cluster, nmol);
110     snew(added, nmol);
111     snew(bTmp, top->atoms.nr);
112
113     for (i = 0; (i < nrefat); i++)
114     {
115         /* Mark all molecules in the index */
116         ai       = index[i];
117         bTmp[ai] = TRUE;
118         /* Binary search assuming the molecules are sorted */
119         j0 = 0;
120         j1 = nmol-1;
121         while (j0 < j1)
122         {
123             if (ai < molind[j0+1])
124             {
125                 j1 = j0;
126             }
127             else if (ai >= molind[j1])
128             {
129                 j0 = j1;
130             }
131             else
132             {
133                 jj = (j0+j1)/2;
134                 if (ai < molind[jj+1])
135                 {
136                     j1 = jj;
137                 }
138                 else
139                 {
140                     j0 = jj;
141                 }
142             }
143         }
144         bMol[j0] = TRUE;
145     }
146     /* Double check whether all atoms in all molecules that are marked are part
147      * of the cluster. Simultaneously compute the center of geometry.
148      */
149     min_dist2   = 10*sqr(trace(box));
150     imol_center = -1;
151     ncluster    = 0;
152     for (i = 0; i < nmol; i++)
153     {
154         for (j = molind[i]; j < molind[i+1]; j++)
155         {
156             if (bMol[i] && !bTmp[j])
157             {
158                 gmx_fatal(FARGS, "Molecule %d marked for clustering but not atom %d in it - check your index!", i+1, j+1);
159             }
160             else if (!bMol[i] && bTmp[j])
161             {
162                 gmx_fatal(FARGS, "Atom %d marked for clustering but not molecule %d - this is an internal error...", j+1, i+1);
163             }
164             else if (bMol[i])
165             {
166                 /* Make molecule whole, move 2nd and higher atom to same periodicity as 1st atom in molecule */
167                 if (j > molind[i])
168                 {
169                     pbc_dx(&pbc, x[j], x[j-1], dx);
170                     rvec_add(x[j-1], dx, x[j]);
171                 }
172                 /* Compute center of geometry of molecule - m_com[i] was zeroed when we did snew() on it! */
173                 rvec_inc(m_com[i], x[j]);
174             }
175         }
176         if (bMol[i])
177         {
178             /* Normalize center of geometry */
179             fac = 1.0/(molind[i+1]-molind[i]);
180             for (m = 0; (m < DIM); m++)
181             {
182                 m_com[i][m] *= fac;
183             }
184             /* Determine which molecule is closest to the center of the box */
185             pbc_dx(&pbc, box_center, m_com[i], dx);
186             tmp_r2 = iprod(dx, dx);
187
188             if (tmp_r2 < min_dist2)
189             {
190                 min_dist2   = tmp_r2;
191                 imol_center = i;
192             }
193             cluster[ncluster++] = i;
194         }
195     }
196     sfree(bTmp);
197
198     if (ncluster <= 0)
199     {
200         fprintf(stderr, "No molecules selected in the cluster\n");
201         return;
202     }
203     else if (imol_center == -1)
204     {
205         fprintf(stderr, "No central molecules could be found\n");
206         return;
207     }
208
209     nadded            = 0;
210     added[nadded++]   = imol_center;
211     bMol[imol_center] = FALSE;
212
213     while (nadded < ncluster)
214     {
215         /* Find min distance between cluster molecules and those remaining to be added */
216         min_dist2   = 10*sqr(trace(box));
217         imin        = -1;
218         jmin        = -1;
219         /* Loop over added mols */
220         for (i = 0; i < nadded; i++)
221         {
222             ai = added[i];
223             /* Loop over all mols */
224             for (j = 0; j < ncluster; j++)
225             {
226                 aj = cluster[j];
227                 /* check those remaining to be added */
228                 if (bMol[aj])
229                 {
230                     pbc_dx(&pbc, m_com[aj], m_com[ai], dx);
231                     tmp_r2 = iprod(dx, dx);
232                     if (tmp_r2 < min_dist2)
233                     {
234                         min_dist2   = tmp_r2;
235                         imin        = ai;
236                         jmin        = aj;
237                     }
238                 }
239             }
240         }
241
242         /* Add the best molecule */
243         added[nadded++]   = jmin;
244         bMol[jmin]        = FALSE;
245         /* Calculate the shift from the ai molecule */
246         pbc_dx(&pbc, m_com[jmin], m_com[imin], dx);
247         rvec_add(m_com[imin], dx, xtest);
248         rvec_sub(xtest, m_com[jmin], m_shift[jmin]);
249         rvec_inc(m_com[jmin], m_shift[jmin]);
250
251         for (j = molind[jmin]; j < molind[jmin+1]; j++)
252         {
253             rvec_inc(x[j], m_shift[jmin]);
254         }
255         fprintf(stdout, "\rClustering iteration %d of %d...", nadded, ncluster);
256         fflush(stdout);
257     }
258
259     sfree(added);
260     sfree(cluster);
261     sfree(bMol);
262     sfree(m_com);
263     sfree(m_shift);
264
265     fprintf(stdout, "\n");
266 }
267
268 static void put_molecule_com_in_box(int unitcell_enum, int ecenter,
269                                     t_block *mols,
270                                     int natoms, t_atom atom[],
271                                     int ePBC, matrix box, rvec x[])
272 {
273     atom_id i, j;
274     int     d;
275     rvec    com, new_com, shift, dx, box_center;
276     real    m;
277     double  mtot;
278     t_pbc   pbc;
279
280     calc_box_center(ecenter, box, box_center);
281     set_pbc(&pbc, ePBC, box);
282     if (mols->nr <= 0)
283     {
284         gmx_fatal(FARGS, "There are no molecule descriptions. I need a .tpr file for this pbc option.");
285     }
286     for (i = 0; (i < mols->nr); i++)
287     {
288         /* calc COM */
289         clear_rvec(com);
290         mtot = 0;
291         for (j = mols->index[i]; (j < mols->index[i+1] && j < natoms); j++)
292         {
293             m = atom[j].m;
294             for (d = 0; d < DIM; d++)
295             {
296                 com[d] += m*x[j][d];
297             }
298             mtot += m;
299         }
300         /* calculate final COM */
301         svmul(1.0/mtot, com, com);
302
303         /* check if COM is outside box */
304         copy_rvec(com, new_com);
305         switch (unitcell_enum)
306         {
307             case euRect:
308                 put_atoms_in_box(ePBC, box, 1, &new_com);
309                 break;
310             case euTric:
311                 put_atoms_in_triclinic_unitcell(ecenter, box, 1, &new_com);
312                 break;
313             case euCompact:
314                 put_atoms_in_compact_unitcell(ePBC, ecenter, box, 1, &new_com);
315                 break;
316         }
317         rvec_sub(new_com, com, shift);
318         if (norm2(shift) > 0)
319         {
320             if (debug)
321             {
322                 fprintf(debug, "\nShifting position of molecule %d "
323                         "by %8.3f  %8.3f  %8.3f\n", i+1,
324                         shift[XX], shift[YY], shift[ZZ]);
325             }
326             for (j = mols->index[i]; (j < mols->index[i+1] && j < natoms); j++)
327             {
328                 rvec_inc(x[j], shift);
329             }
330         }
331     }
332 }
333
334 static void put_residue_com_in_box(int unitcell_enum, int ecenter,
335                                    int natoms, t_atom atom[],
336                                    int ePBC, matrix box, rvec x[])
337 {
338     atom_id i, j, res_start, res_end, res_nat;
339     int     d, presnr;
340     real    m;
341     double  mtot;
342     rvec    box_center, com, new_com, shift;
343
344     calc_box_center(ecenter, box, box_center);
345
346     presnr    = NOTSET;
347     res_start = 0;
348     clear_rvec(com);
349     mtot = 0;
350     for (i = 0; i < natoms+1; i++)
351     {
352         if (i == natoms || (presnr != atom[i].resind && presnr != NOTSET))
353         {
354             /* calculate final COM */
355             res_end = i;
356             res_nat = res_end - res_start;
357             svmul(1.0/mtot, com, com);
358
359             /* check if COM is outside box */
360             copy_rvec(com, new_com);
361             switch (unitcell_enum)
362             {
363                 case euRect:
364                     put_atoms_in_box(ePBC, box, 1, &new_com);
365                     break;
366                 case euTric:
367                     put_atoms_in_triclinic_unitcell(ecenter, box, 1, &new_com);
368                     break;
369                 case euCompact:
370                     put_atoms_in_compact_unitcell(ePBC, ecenter, box, 1, &new_com);
371                     break;
372             }
373             rvec_sub(new_com, com, shift);
374             if (norm2(shift))
375             {
376                 if (debug)
377                 {
378                     fprintf(debug, "\nShifting position of residue %d (atoms %u-%u) "
379                             "by %g,%g,%g\n", atom[res_start].resind+1,
380                             res_start+1, res_end+1, shift[XX], shift[YY], shift[ZZ]);
381                 }
382                 for (j = res_start; j < res_end; j++)
383                 {
384                     rvec_inc(x[j], shift);
385                 }
386             }
387             clear_rvec(com);
388             mtot = 0;
389
390             /* remember start of new residue */
391             res_start = i;
392         }
393         if (i < natoms)
394         {
395             /* calc COM */
396             m = atom[i].m;
397             for (d = 0; d < DIM; d++)
398             {
399                 com[d] += m*x[i][d];
400             }
401             mtot += m;
402
403             presnr = atom[i].resind;
404         }
405     }
406 }
407
408 static void center_x(int ecenter, rvec x[], matrix box, int n, int nc, atom_id ci[])
409 {
410     int  i, m, ai;
411     rvec cmin, cmax, box_center, dx;
412
413     if (nc > 0)
414     {
415         copy_rvec(x[ci[0]], cmin);
416         copy_rvec(x[ci[0]], cmax);
417         for (i = 0; i < nc; i++)
418         {
419             ai = ci[i];
420             for (m = 0; m < DIM; m++)
421             {
422                 if (x[ai][m] < cmin[m])
423                 {
424                     cmin[m] = x[ai][m];
425                 }
426                 else if (x[ai][m] > cmax[m])
427                 {
428                     cmax[m] = x[ai][m];
429                 }
430             }
431         }
432         calc_box_center(ecenter, box, box_center);
433         for (m = 0; m < DIM; m++)
434         {
435             dx[m] = box_center[m]-(cmin[m]+cmax[m])*0.5;
436         }
437
438         for (i = 0; i < n; i++)
439         {
440             rvec_inc(x[i], dx);
441         }
442     }
443 }
444
445 static void mk_filenm(char *base, const char *ext, int ndigit, int file_nr,
446                       char out_file[])
447 {
448     char nbuf[128];
449     int  nd = 0, fnr;
450
451     strcpy(out_file, base);
452     fnr = file_nr;
453     do
454     {
455         fnr /= 10;
456         nd++;
457     }
458     while (fnr > 0);
459
460     if (nd < ndigit)
461     {
462         strncat(out_file, "00000000000", ndigit-nd);
463     }
464     sprintf(nbuf, "%d.", file_nr);
465     strcat(out_file, nbuf);
466     strcat(out_file, ext);
467 }
468
469 void check_trn(const char *fn)
470 {
471     if ((fn2ftp(fn) != efTRJ)  && (fn2ftp(fn) != efTRR))
472     {
473         gmx_fatal(FARGS, "%s is not a trajectory file, exiting\n", fn);
474     }
475 }
476
477 #ifndef GMX_NATIVE_WINDOWS
478 void do_trunc(const char *fn, real t0)
479 {
480     t_fileio        *in;
481     FILE            *fp;
482     gmx_bool         bStop, bOK;
483     t_trnheader      sh;
484     gmx_off_t        fpos;
485     char             yesno[256];
486     int              j;
487     real             t = 0;
488
489     if (t0 == -1)
490     {
491         gmx_fatal(FARGS, "You forgot to set the truncation time");
492     }
493
494     /* Check whether this is a .trj file */
495     check_trn(fn);
496
497     in   = open_trn(fn, "r");
498     fp   = gmx_fio_getfp(in);
499     if (fp == NULL)
500     {
501         fprintf(stderr, "Sorry, can not trunc %s, truncation of this filetype is not supported\n", fn);
502         close_trn(in);
503     }
504     else
505     {
506         j     = 0;
507         fpos  = gmx_fio_ftell(in);
508         bStop = FALSE;
509         while (!bStop && fread_trnheader(in, &sh, &bOK))
510         {
511             fread_htrn(in, &sh, NULL, NULL, NULL, NULL);
512             fpos = gmx_ftell(fp);
513             t    = sh.t;
514             if (t >= t0)
515             {
516                 gmx_fseek(fp, fpos, SEEK_SET);
517                 bStop = TRUE;
518             }
519         }
520         if (bStop)
521         {
522             fprintf(stderr, "Do you REALLY want to truncate this trajectory (%s) at:\n"
523                     "frame %d, time %g, bytes %ld ??? (type YES if so)\n",
524                     fn, j, t, (long int)fpos);
525             if (1 != scanf("%s", yesno))
526             {
527                 gmx_fatal(FARGS, "Error reading user input");
528             }
529             if (strcmp(yesno, "YES") == 0)
530             {
531                 fprintf(stderr, "Once again, I'm gonna DO this...\n");
532                 close_trn(in);
533                 if (0 != truncate(fn, fpos))
534                 {
535                     gmx_fatal(FARGS, "Error truncating file %s", fn);
536                 }
537             }
538             else
539             {
540                 fprintf(stderr, "Ok, I'll forget about it\n");
541             }
542         }
543         else
544         {
545             fprintf(stderr, "Already at end of file (t=%g)...\n", t);
546             close_trn(in);
547         }
548     }
549 }
550 #endif
551
552 int gmx_trjconv(int argc, char *argv[])
553 {
554     const char *desc[] = {
555         "[THISMODULE] can convert trajectory files in many ways:[BR]",
556         "[BB]1.[bb] from one format to another[BR]",
557         "[BB]2.[bb] select a subset of atoms[BR]",
558         "[BB]3.[bb] change the periodicity representation[BR]",
559         "[BB]4.[bb] keep multimeric molecules together[BR]",
560         "[BB]5.[bb] center atoms in the box[BR]",
561         "[BB]6.[bb] fit atoms to reference structure[BR]",
562         "[BB]7.[bb] reduce the number of frames[BR]",
563         "[BB]8.[bb] change the timestamps of the frames ",
564         "([TT]-t0[tt] and [TT]-timestep[tt])[BR]",
565         "[BB]9.[bb] cut the trajectory in small subtrajectories according",
566         "to information in an index file. This allows subsequent analysis of",
567         "the subtrajectories that could, for example, be the result of a",
568         "cluster analysis. Use option [TT]-sub[tt].",
569         "This assumes that the entries in the index file are frame numbers and",
570         "dumps each group in the index file to a separate trajectory file.[BR]",
571         "[BB]10.[bb] select frames within a certain range of a quantity given",
572         "in an [TT].xvg[tt] file.[PAR]",
573
574         "[gmx-trjcat] is better suited for concatenating multiple trajectory files.",
575         "[PAR]",
576
577         "Currently seven formats are supported for input and output:",
578         "[TT].xtc[tt], [TT].trr[tt], [TT].trj[tt], [TT].gro[tt], [TT].g96[tt],",
579         "[TT].pdb[tt] and [TT].g87[tt].",
580         "The file formats are detected from the file extension.",
581         "The precision of [TT].xtc[tt] and [TT].gro[tt] output is taken from the",
582         "input file for [TT].xtc[tt], [TT].gro[tt] and [TT].pdb[tt],",
583         "and from the [TT]-ndec[tt] option for other input formats. The precision",
584         "is always taken from [TT]-ndec[tt], when this option is set.",
585         "All other formats have fixed precision. [TT].trr[tt] and [TT].trj[tt]",
586         "output can be single or double precision, depending on the precision",
587         "of the [THISMODULE] binary.",
588         "Note that velocities are only supported in",
589         "[TT].trr[tt], [TT].trj[tt], [TT].gro[tt] and [TT].g96[tt] files.[PAR]",
590
591         "Option [TT]-app[tt] can be used to",
592         "append output to an existing trajectory file.",
593         "No checks are performed to ensure integrity",
594         "of the resulting combined trajectory file.[PAR]",
595
596         "Option [TT]-sep[tt] can be used to write every frame to a separate",
597         "[TT].gro, .g96[tt] or [TT].pdb[tt] file. By default, all frames all written to one file.",
598         "[TT].pdb[tt] files with all frames concatenated can be viewed with",
599         "[TT]rasmol -nmrpdb[tt].[PAR]",
600
601         "It is possible to select part of your trajectory and write it out",
602         "to a new trajectory file in order to save disk space, e.g. for leaving",
603         "out the water from a trajectory of a protein in water.",
604         "[BB]ALWAYS[bb] put the original trajectory on tape!",
605         "We recommend to use the portable [TT].xtc[tt] format for your analysis",
606         "to save disk space and to have portable files.[PAR]",
607
608         "There are two options for fitting the trajectory to a reference",
609         "either for essential dynamics analysis, etc.",
610         "The first option is just plain fitting to a reference structure",
611         "in the structure file. The second option is a progressive fit",
612         "in which the first timeframe is fitted to the reference structure ",
613         "in the structure file to obtain and each subsequent timeframe is ",
614         "fitted to the previously fitted structure. This way a continuous",
615         "trajectory is generated, which might not be the case when using the",
616         "regular fit method, e.g. when your protein undergoes large",
617         "conformational transitions.[PAR]",
618
619         "Option [TT]-pbc[tt] sets the type of periodic boundary condition",
620         "treatment:[BR]",
621         "[TT]* mol[tt] puts the center of mass of molecules in the box,",
622         "and requires a run input file to be supplied with [TT]-s[tt].[BR]",
623         "[TT]* res[tt] puts the center of mass of residues in the box.[BR]",
624         "[TT]* atom[tt] puts all the atoms in the box.[BR]",
625         "[TT]* nojump[tt] checks if atoms jump across the box and then puts",
626         "them back. This has the effect that all molecules",
627         "will remain whole (provided they were whole in the initial",
628         "conformation). [BB]Note[bb] that this ensures a continuous trajectory but",
629         "molecules may diffuse out of the box. The starting configuration",
630         "for this procedure is taken from the structure file, if one is",
631         "supplied, otherwise it is the first frame.[BR]",
632         "[TT]* cluster[tt] clusters all the atoms in the selected index",
633         "such that they are all closest to the center of mass of the cluster,",
634         "which is iteratively updated. [BB]Note[bb] that this will only give meaningful",
635         "results if you in fact have a cluster. Luckily that can be checked",
636         "afterwards using a trajectory viewer. Note also that if your molecules",
637         "are broken this will not work either.[BR]",
638         "The separate option [TT]-clustercenter[tt] can be used to specify an",
639         "approximate center for the cluster. This is useful e.g. if you have",
640         "two big vesicles, and you want to maintain their relative positions.[BR]",
641         "[TT]* whole[tt] only makes broken molecules whole.[PAR]",
642
643         "Option [TT]-ur[tt] sets the unit cell representation for options",
644         "[TT]mol[tt], [TT]res[tt] and [TT]atom[tt] of [TT]-pbc[tt].",
645         "All three options give different results for triclinic boxes and",
646         "identical results for rectangular boxes.",
647         "[TT]rect[tt] is the ordinary brick shape.",
648         "[TT]tric[tt] is the triclinic unit cell.",
649         "[TT]compact[tt] puts all atoms at the closest distance from the center",
650         "of the box. This can be useful for visualizing e.g. truncated octahedra",
651         "or rhombic dodecahedra. The center for options [TT]tric[tt] and [TT]compact[tt]",
652         "is [TT]tric[tt] (see below), unless the option [TT]-boxcenter[tt]",
653         "is set differently.[PAR]",
654
655         "Option [TT]-center[tt] centers the system in the box. The user can",
656         "select the group which is used to determine the geometrical center.",
657         "Option [TT]-boxcenter[tt] sets the location of the center of the box",
658         "for options [TT]-pbc[tt] and [TT]-center[tt]. The center options are:",
659         "[TT]tric[tt]: half of the sum of the box vectors,",
660         "[TT]rect[tt]: half of the box diagonal,",
661         "[TT]zero[tt]: zero.",
662         "Use option [TT]-pbc mol[tt] in addition to [TT]-center[tt] when you",
663         "want all molecules in the box after the centering.[PAR]",
664
665         "It is not always possible to use combinations of [TT]-pbc[tt],",
666         "[TT]-fit[tt], [TT]-ur[tt] and [TT]-center[tt] to do exactly what",
667         "you want in one call to [THISMODULE]. Consider using multiple",
668         "calls, and check out the GROMACS website for suggestions.[PAR]",
669
670         "With [TT]-dt[tt], it is possible to reduce the number of ",
671         "frames in the output. This option relies on the accuracy of the times",
672         "in your input trajectory, so if these are inaccurate use the",
673         "[TT]-timestep[tt] option to modify the time (this can be done",
674         "simultaneously). For making smooth movies, the program [gmx-filter]",
675         "can reduce the number of frames while using low-pass frequency",
676         "filtering, this reduces aliasing of high frequency motions.[PAR]",
677
678         "Using [TT]-trunc[tt] [THISMODULE] can truncate [TT].trj[tt] in place, i.e.",
679         "without copying the file. This is useful when a run has crashed",
680         "during disk I/O (i.e. full disk), or when two contiguous",
681         "trajectories must be concatenated without having double frames.[PAR]",
682
683         "Option [TT]-dump[tt] can be used to extract a frame at or near",
684         "one specific time from your trajectory.[PAR]",
685
686         "Option [TT]-drop[tt] reads an [TT].xvg[tt] file with times and values.",
687         "When options [TT]-dropunder[tt] and/or [TT]-dropover[tt] are set,",
688         "frames with a value below and above the value of the respective options",
689         "will not be written."
690     };
691
692     int         pbc_enum;
693     enum
694     {
695         epSel,
696         epNone,
697         epComMol,
698         epComRes,
699         epComAtom,
700         epNojump,
701         epCluster,
702         epWhole,
703         epNR
704     };
705     const char *pbc_opt[epNR + 1] =
706     {
707         NULL, "none", "mol", "res", "atom", "nojump", "cluster", "whole",
708         NULL
709     };
710
711     int         unitcell_enum;
712     const char *unitcell_opt[euNR+1] =
713     { NULL, "rect", "tric", "compact", NULL };
714
715     enum
716     {
717         ecSel, ecTric, ecRect, ecZero, ecNR
718     };
719     const char *center_opt[ecNR+1] =
720     { NULL, "tric", "rect", "zero", NULL };
721     int         ecenter;
722
723     int         fit_enum;
724     enum
725     {
726         efSel, efNone, efFit, efFitXY, efReset, efResetXY, efPFit, efNR
727     };
728     const char *fit[efNR + 1] =
729     {
730         NULL, "none", "rot+trans", "rotxy+transxy", "translation", "transxy",
731         "progressive", NULL
732     };
733
734     static gmx_bool  bAppend       = FALSE, bSeparate = FALSE, bVels = TRUE, bForce = FALSE, bCONECT = FALSE;
735     static gmx_bool  bCenter       = FALSE;
736     static int       skip_nr       = 1, ndec = 3, nzero = 0;
737     static real      tzero         = 0, delta_t = 0, timestep = 0, ttrunc = -1, tdump = -1, split_t = 0;
738     static rvec      newbox        = {0, 0, 0}, shift = {0, 0, 0}, trans = {0, 0, 0};
739     static char     *exec_command  = NULL;
740     static real      dropunder     = 0, dropover = 0;
741     static gmx_bool  bRound        = FALSE;
742
743     t_pargs
744         pa[] =
745     {
746         { "-skip", FALSE, etINT,
747           { &skip_nr }, "Only write every nr-th frame" },
748         { "-dt", FALSE, etTIME,
749           { &delta_t },
750           "Only write frame when t MOD dt = first time (%t)" },
751         { "-round", FALSE, etBOOL,
752           { &bRound }, "Round measurements to nearest picosecond"},
753         { "-dump", FALSE, etTIME,
754           { &tdump }, "Dump frame nearest specified time (%t)" },
755         { "-t0", FALSE, etTIME,
756           { &tzero },
757           "Starting time (%t) (default: don't change)" },
758         { "-timestep", FALSE, etTIME,
759           { &timestep },
760           "Change time step between input frames (%t)" },
761         { "-pbc", FALSE, etENUM,
762           { pbc_opt },
763           "PBC treatment (see help text for full description)" },
764         { "-ur", FALSE, etENUM,
765           { unitcell_opt }, "Unit-cell representation" },
766         { "-center", FALSE, etBOOL,
767           { &bCenter }, "Center atoms in box" },
768         { "-boxcenter", FALSE, etENUM,
769           { center_opt }, "Center for -pbc and -center" },
770         { "-box", FALSE, etRVEC,
771           { newbox },
772           "Size for new cubic box (default: read from input)" },
773         { "-trans", FALSE, etRVEC,
774           { trans },
775           "All coordinates will be translated by trans. This "
776           "can advantageously be combined with -pbc mol -ur "
777           "compact." },
778         { "-shift", FALSE, etRVEC,
779           { shift },
780           "All coordinates will be shifted by framenr*shift" },
781         { "-fit", FALSE, etENUM,
782           { fit },
783           "Fit molecule to ref structure in the structure file" },
784         { "-ndec", FALSE, etINT,
785           { &ndec },
786           "Precision for .xtc and .gro writing in number of "
787           "decimal places" },
788         { "-vel", FALSE, etBOOL,
789           { &bVels }, "Read and write velocities if possible" },
790         { "-force", FALSE, etBOOL,
791           { &bForce }, "Read and write forces if possible" },
792 #ifndef GMX_NATIVE_WINDOWS
793         { "-trunc", FALSE, etTIME,
794           { &ttrunc },
795           "Truncate input trajectory file after this time (%t)" },
796 #endif
797         { "-exec", FALSE, etSTR,
798           { &exec_command },
799           "Execute command for every output frame with the "
800           "frame number as argument" },
801         { "-app", FALSE, etBOOL,
802           { &bAppend }, "Append output" },
803         { "-split", FALSE, etTIME,
804           { &split_t },
805           "Start writing new file when t MOD split = first "
806           "time (%t)" },
807         { "-sep", FALSE, etBOOL,
808           { &bSeparate },
809           "Write each frame to a separate .gro, .g96 or .pdb "
810           "file" },
811         { "-nzero", FALSE, etINT,
812           { &nzero },
813           "If the -sep flag is set, use these many digits "
814           "for the file numbers and prepend zeros as needed" },
815         { "-dropunder", FALSE, etREAL,
816           { &dropunder }, "Drop all frames below this value" },
817         { "-dropover", FALSE, etREAL,
818           { &dropover }, "Drop all frames above this value" },
819         { "-conect", FALSE, etBOOL,
820           { &bCONECT },
821           "Add conect records when writing [TT].pdb[tt] files. Useful "
822           "for visualization of non-standard molecules, e.g. "
823           "coarse grained ones" }
824     };
825 #define NPA asize(pa)
826
827     FILE            *out    = NULL;
828     t_trxstatus     *trxout = NULL;
829     t_trxstatus     *status;
830     int              ftp, ftpin = 0, file_nr;
831     t_trxframe       fr, frout;
832     int              flags;
833     rvec            *xmem = NULL, *vmem = NULL, *fmem = NULL;
834     rvec            *xp   = NULL, x_shift, hbox, box_center, dx;
835     real             xtcpr, lambda, *w_rls = NULL;
836     int              m, i, d, frame, outframe, natoms, nout, ncent, nre, newstep = 0, model_nr;
837 #define SKIP 10
838     t_topology       top;
839     gmx_conect       gc    = NULL;
840     int              ePBC  = -1;
841     t_atoms         *atoms = NULL, useatoms;
842     matrix           top_box;
843     atom_id         *index, *cindex;
844     char            *grpnm;
845     int             *frindex, nrfri;
846     char            *frname;
847     int              ifit, irms, my_clust = -1;
848     atom_id         *ind_fit, *ind_rms;
849     char            *gn_fit, *gn_rms;
850     t_cluster_ndx   *clust           = NULL;
851     t_trxstatus    **clust_status    = NULL;
852     int             *clust_status_id = NULL;
853     int              ntrxopen        = 0;
854     int             *nfwritten       = NULL;
855     int              ndrop           = 0, ncol, drop0 = 0, drop1 = 0, dropuse = 0;
856     double         **dropval;
857     real             tshift = 0, t0 = -1, dt = 0.001, prec;
858     gmx_bool         bFit, bFitXY, bPFit, bReset;
859     int              nfitdim;
860     gmx_rmpbc_t      gpbc = NULL;
861     gmx_bool         bRmPBC, bPBCWhole, bPBCcomRes, bPBCcomMol, bPBCcomAtom, bPBC, bNoJump, bCluster;
862     gmx_bool         bCopy, bDoIt, bIndex, bTDump, bSetTime, bTPS = FALSE, bDTset = FALSE;
863     gmx_bool         bExec, bTimeStep = FALSE, bDumpFrame = FALSE, bSetPrec, bNeedPrec;
864     gmx_bool         bHaveFirstFrame, bHaveNextFrame, bSetBox, bSetUR, bSplit = FALSE;
865     gmx_bool         bSubTraj = FALSE, bDropUnder = FALSE, bDropOver = FALSE, bTrans = FALSE;
866     gmx_bool         bWriteFrame, bSplitHere;
867     const char      *top_file, *in_file, *out_file = NULL;
868     char             out_file2[256], *charpt;
869     char            *outf_base = NULL;
870     const char      *outf_ext  = NULL;
871     char             top_title[256], title[256], command[256], filemode[5];
872     int              xdr          = 0;
873     gmx_bool         bWarnCompact = FALSE;
874     const char      *warn;
875     output_env_t     oenv;
876
877     t_filenm         fnm[] = {
878         { efTRX, "-f",   NULL,      ffREAD  },
879         { efTRO, "-o",   NULL,      ffWRITE },
880         { efTPS, NULL,   NULL,      ffOPTRD },
881         { efNDX, NULL,   NULL,      ffOPTRD },
882         { efNDX, "-fr",  "frames",  ffOPTRD },
883         { efNDX, "-sub", "cluster", ffOPTRD },
884         { efXVG, "-drop", "drop",    ffOPTRD }
885     };
886 #define NFILE asize(fnm)
887
888     if (!parse_common_args(&argc, argv,
889                            PCA_CAN_BEGIN | PCA_CAN_END | PCA_CAN_VIEW |
890                            PCA_TIME_UNIT | PCA_BE_NICE,
891                            NFILE, fnm, NPA, pa, asize(desc), desc,
892                            0, NULL, &oenv))
893     {
894         return 0;
895     }
896
897     top_file = ftp2fn(efTPS, NFILE, fnm);
898     init_top(&top);
899
900     /* Check command line */
901     in_file = opt2fn("-f", NFILE, fnm);
902
903     if (ttrunc != -1)
904     {
905 #ifndef GMX_NATIVE_WINDOWS
906         do_trunc(in_file, ttrunc);
907 #endif
908     }
909     else
910     {
911         /* mark active cmdline options */
912         bSetBox    = opt2parg_bSet("-box", NPA, pa);
913         bSetTime   = opt2parg_bSet("-t0", NPA, pa);
914         bSetPrec   = opt2parg_bSet("-ndec", NPA, pa);
915         bSetUR     = opt2parg_bSet("-ur", NPA, pa);
916         bExec      = opt2parg_bSet("-exec", NPA, pa);
917         bTimeStep  = opt2parg_bSet("-timestep", NPA, pa);
918         bTDump     = opt2parg_bSet("-dump", NPA, pa);
919         bDropUnder = opt2parg_bSet("-dropunder", NPA, pa);
920         bDropOver  = opt2parg_bSet("-dropover", NPA, pa);
921         bTrans     = opt2parg_bSet("-trans", NPA, pa);
922         bSplit     = (split_t != 0);
923
924         /* parse enum options */
925         fit_enum      = nenum(fit);
926         bFit          = (fit_enum == efFit || fit_enum == efFitXY);
927         bFitXY        = fit_enum == efFitXY;
928         bReset        = (fit_enum == efReset || fit_enum == efResetXY);
929         bPFit         = fit_enum == efPFit;
930         pbc_enum      = nenum(pbc_opt);
931         bPBCWhole     = pbc_enum == epWhole;
932         bPBCcomRes    = pbc_enum == epComRes;
933         bPBCcomMol    = pbc_enum == epComMol;
934         bPBCcomAtom   = pbc_enum == epComAtom;
935         bNoJump       = pbc_enum == epNojump;
936         bCluster      = pbc_enum == epCluster;
937         bPBC          = pbc_enum != epNone;
938         unitcell_enum = nenum(unitcell_opt);
939         ecenter       = nenum(center_opt) - ecTric;
940
941         /* set and check option dependencies */
942         if (bPFit)
943         {
944             bFit = TRUE;        /* for pfit, fit *must* be set */
945         }
946         if (bFit)
947         {
948             bReset = TRUE;       /* for fit, reset *must* be set */
949         }
950         nfitdim = 0;
951         if (bFit || bReset)
952         {
953             nfitdim = (fit_enum == efFitXY || fit_enum == efResetXY) ? 2 : 3;
954         }
955         bRmPBC = bFit || bPBCWhole || bPBCcomRes || bPBCcomMol;
956
957         if (bSetUR)
958         {
959             if (!(bPBCcomRes || bPBCcomMol ||  bPBCcomAtom))
960             {
961                 fprintf(stderr,
962                         "WARNING: Option for unitcell representation (-ur %s)\n"
963                         "         only has effect in combination with -pbc %s, %s or %s.\n"
964                         "         Ingoring unitcell representation.\n\n",
965                         unitcell_opt[0], pbc_opt[2], pbc_opt[3], pbc_opt[4]);
966                 bSetUR = FALSE;
967             }
968         }
969         if (bFit && bPBC)
970         {
971             gmx_fatal(FARGS, "PBC condition treatment does not work together with rotational fit.\n"
972                       "Please do the PBC condition treatment first and then run trjconv in a second step\n"
973                       "for the rotational fit.\n"
974                       "First doing the rotational fit and then doing the PBC treatment gives incorrect\n"
975                       "results!");
976         }
977
978         /* ndec is in nr of decimal places, prec is a multiplication factor: */
979         prec = 1;
980         for (i = 0; i < ndec; i++)
981         {
982             prec *= 10;
983         }
984
985         bIndex = ftp2bSet(efNDX, NFILE, fnm);
986
987
988         /* Determine output type */
989         out_file = opt2fn("-o", NFILE, fnm);
990         ftp      = fn2ftp(out_file);
991         fprintf(stderr, "Will write %s: %s\n", ftp2ext(ftp), ftp2desc(ftp));
992         bNeedPrec = (ftp == efXTC || ftp == efGRO);
993         if (bVels)
994         {
995             /* check if velocities are possible in input and output files */
996             ftpin = fn2ftp(in_file);
997             bVels = (ftp == efTRR || ftp == efTRJ || ftp == efGRO || ftp == efG96)
998                 && (ftpin == efTRR || ftpin == efTRJ || ftpin == efGRO || ftpin == efG96 ||
999                     ftpin == efCPT);
1000         }
1001         if (bSeparate || bSplit)
1002         {
1003             outf_ext = strrchr(out_file, '.');
1004             if (outf_ext == NULL)
1005             {
1006                 gmx_fatal(FARGS, "Output file name '%s' does not contain a '.'", out_file);
1007             }
1008             outf_base = strdup(out_file);
1009             outf_base[outf_ext - out_file] = '\0';
1010         }
1011
1012         bSubTraj = opt2bSet("-sub", NFILE, fnm);
1013         if (bSubTraj)
1014         {
1015             if ((ftp != efXTC) && (ftp != efTRR))
1016             {
1017                 /* It seems likely that other trajectory file types
1018                  * could work here. */
1019                 gmx_fatal(FARGS, "Can only use the sub option with output file types "
1020                           "xtc and trr");
1021             }
1022             clust = cluster_index(NULL, opt2fn("-sub", NFILE, fnm));
1023
1024             /* Check for number of files disabled, as FOPEN_MAX is not the correct
1025              * number to check for. In my linux box it is only 16.
1026              */
1027             if (0 && (clust->clust->nr > FOPEN_MAX-4))
1028             {
1029                 gmx_fatal(FARGS, "Can not open enough (%d) files to write all the"
1030                           " trajectories.\ntry splitting the index file in %d parts.\n"
1031                           "FOPEN_MAX = %d",
1032                           clust->clust->nr, 1+clust->clust->nr/FOPEN_MAX, FOPEN_MAX);
1033             }
1034             gmx_warning("The -sub option could require as many open output files as there are\n"
1035                         "index groups in the file (%d). If you get I/O errors opening new files,\n"
1036                         "try reducing the number of index groups in the file, and perhaps\n"
1037                         "using trjconv -sub several times on different chunks of your index file.\n",
1038                         clust->clust->nr);
1039
1040             snew(clust_status, clust->clust->nr);
1041             snew(clust_status_id, clust->clust->nr);
1042             snew(nfwritten, clust->clust->nr);
1043             for (i = 0; (i < clust->clust->nr); i++)
1044             {
1045                 clust_status[i]    = NULL;
1046                 clust_status_id[i] = -1;
1047             }
1048             bSeparate = bSplit = FALSE;
1049         }
1050         /* skipping */
1051         if (skip_nr <= 0)
1052         {
1053         }
1054
1055         /* Determine whether to read a topology */
1056         bTPS = (ftp2bSet(efTPS, NFILE, fnm) ||
1057                 bRmPBC || bReset || bPBCcomMol || bCluster ||
1058                 (ftp == efGRO) || (ftp == efPDB) || bCONECT);
1059
1060         /* Determine if when can read index groups */
1061         bIndex = (bIndex || bTPS);
1062
1063         if (bTPS)
1064         {
1065             read_tps_conf(top_file, top_title, &top, &ePBC, &xp, NULL, top_box,
1066                           bReset || bPBCcomRes);
1067             atoms = &top.atoms;
1068
1069             if (0 == top.mols.nr && (bCluster || bPBCcomMol))
1070             {
1071                 gmx_fatal(FARGS, "Option -pbc %s requires a .tpr file for the -s option", pbc_opt[pbc_enum]);
1072             }
1073
1074             /* top_title is only used for gro and pdb,
1075              * the header in such a file is top_title t= ...
1076              * to prevent a double t=, remove it from top_title
1077              */
1078             if ((charpt = strstr(top_title, " t= ")))
1079             {
1080                 charpt[0] = '\0';
1081             }
1082
1083             if (bCONECT)
1084             {
1085                 gc = gmx_conect_generate(&top);
1086             }
1087             if (bRmPBC)
1088             {
1089                 gpbc = gmx_rmpbc_init(&top.idef, ePBC, top.atoms.nr);
1090             }
1091         }
1092
1093         /* get frame number index */
1094         frindex = NULL;
1095         if (opt2bSet("-fr", NFILE, fnm))
1096         {
1097             printf("Select groups of frame number indices:\n");
1098             rd_index(opt2fn("-fr", NFILE, fnm), 1, &nrfri, (atom_id **)&frindex, &frname);
1099             if (debug)
1100             {
1101                 for (i = 0; i < nrfri; i++)
1102                 {
1103                     fprintf(debug, "frindex[%4d]=%4d\n", i, frindex[i]);
1104                 }
1105             }
1106         }
1107
1108         /* get index groups etc. */
1109         if (bReset)
1110         {
1111             printf("Select group for %s fit\n",
1112                    bFit ? "least squares" : "translational");
1113             get_index(atoms, ftp2fn_null(efNDX, NFILE, fnm),
1114                       1, &ifit, &ind_fit, &gn_fit);
1115
1116             if (bFit)
1117             {
1118                 if (ifit < 2)
1119                 {
1120                     gmx_fatal(FARGS, "Need at least 2 atoms to fit!\n");
1121                 }
1122                 else if (ifit == 3)
1123                 {
1124                     fprintf(stderr, "WARNING: fitting with only 2 atoms is not unique\n");
1125                 }
1126             }
1127         }
1128         else if (bCluster)
1129         {
1130             printf("Select group for clustering\n");
1131             get_index(atoms, ftp2fn_null(efNDX, NFILE, fnm),
1132                       1, &ifit, &ind_fit, &gn_fit);
1133         }
1134
1135         if (bIndex)
1136         {
1137             if (bCenter)
1138             {
1139                 printf("Select group for centering\n");
1140                 get_index(atoms, ftp2fn_null(efNDX, NFILE, fnm),
1141                           1, &ncent, &cindex, &grpnm);
1142             }
1143             printf("Select group for output\n");
1144             get_index(atoms, ftp2fn_null(efNDX, NFILE, fnm),
1145                       1, &nout, &index, &grpnm);
1146         }
1147         else
1148         {
1149             /* no index file, so read natoms from TRX */
1150             if (!read_first_frame(oenv, &status, in_file, &fr, TRX_DONT_SKIP))
1151             {
1152                 gmx_fatal(FARGS, "Could not read a frame from %s", in_file);
1153             }
1154             natoms = fr.natoms;
1155             close_trj(status);
1156             sfree(fr.x);
1157             snew(index, natoms);
1158             for (i = 0; i < natoms; i++)
1159             {
1160                 index[i] = i;
1161             }
1162             nout = natoms;
1163             if (bCenter)
1164             {
1165                 ncent  = nout;
1166                 cindex = index;
1167             }
1168         }
1169
1170         if (bReset)
1171         {
1172             snew(w_rls, atoms->nr);
1173             for (i = 0; (i < ifit); i++)
1174             {
1175                 w_rls[ind_fit[i]] = atoms->atom[ind_fit[i]].m;
1176             }
1177
1178             /* Restore reference structure and set to origin,
1179                store original location (to put structure back) */
1180             if (bRmPBC)
1181             {
1182                 gmx_rmpbc(gpbc, top.atoms.nr, top_box, xp);
1183             }
1184             copy_rvec(xp[index[0]], x_shift);
1185             reset_x_ndim(nfitdim, ifit, ind_fit, atoms->nr, NULL, xp, w_rls);
1186             rvec_dec(x_shift, xp[index[0]]);
1187         }
1188         else
1189         {
1190             clear_rvec(x_shift);
1191         }
1192
1193         if (bDropUnder || bDropOver)
1194         {
1195             /* Read the .xvg file with the drop values */
1196             fprintf(stderr, "\nReading drop file ...");
1197             ndrop = read_xvg(opt2fn("-drop", NFILE, fnm), &dropval, &ncol);
1198             fprintf(stderr, " %d time points\n", ndrop);
1199             if (ndrop == 0 || ncol < 2)
1200             {
1201                 gmx_fatal(FARGS, "Found no data points in %s",
1202                           opt2fn("-drop", NFILE, fnm));
1203             }
1204             drop0 = 0;
1205             drop1 = 0;
1206         }
1207
1208         /* Make atoms struct for output in GRO or PDB files */
1209         if ((ftp == efGRO) || ((ftp == efG96) && bTPS) || (ftp == efPDB))
1210         {
1211             /* get memory for stuff to go in .pdb file */
1212             init_t_atoms(&useatoms, atoms->nr, FALSE);
1213             sfree(useatoms.resinfo);
1214             useatoms.resinfo = atoms->resinfo;
1215             for (i = 0; (i < nout); i++)
1216             {
1217                 useatoms.atomname[i] = atoms->atomname[index[i]];
1218                 useatoms.atom[i]     = atoms->atom[index[i]];
1219                 useatoms.nres        = max(useatoms.nres, useatoms.atom[i].resind+1);
1220             }
1221             useatoms.nr = nout;
1222         }
1223         /* select what to read */
1224         if (ftp == efTRR || ftp == efTRJ)
1225         {
1226             flags = TRX_READ_X;
1227         }
1228         else
1229         {
1230             flags = TRX_NEED_X;
1231         }
1232         if (bVels)
1233         {
1234             flags = flags | TRX_READ_V;
1235         }
1236         if (bForce)
1237         {
1238             flags = flags | TRX_READ_F;
1239         }
1240
1241         /* open trx file for reading */
1242         bHaveFirstFrame = read_first_frame(oenv, &status, in_file, &fr, flags);
1243         if (fr.bPrec)
1244         {
1245             fprintf(stderr, "\nPrecision of %s is %g (nm)\n", in_file, 1/fr.prec);
1246         }
1247         if (bNeedPrec)
1248         {
1249             if (bSetPrec || !fr.bPrec)
1250             {
1251                 fprintf(stderr, "\nSetting output precision to %g (nm)\n", 1/prec);
1252             }
1253             else
1254             {
1255                 fprintf(stderr, "Using output precision of %g (nm)\n", 1/prec);
1256             }
1257         }
1258
1259         if (bHaveFirstFrame)
1260         {
1261             set_trxframe_ePBC(&fr, ePBC);
1262
1263             natoms = fr.natoms;
1264
1265             if (bSetTime)
1266             {
1267                 tshift = tzero-fr.time;
1268             }
1269             else
1270             {
1271                 tzero = fr.time;
1272             }
1273
1274             /* open output for writing */
1275             if ((bAppend) && (gmx_fexist(out_file)))
1276             {
1277                 strcpy(filemode, "a");
1278                 fprintf(stderr, "APPENDING to existing file %s\n", out_file);
1279             }
1280             else
1281             {
1282                 strcpy(filemode, "w");
1283             }
1284             switch (ftp)
1285             {
1286                 case efXTC:
1287                 case efG87:
1288                 case efTRR:
1289                 case efTRJ:
1290                     out = NULL;
1291                     if (!bSplit && !bSubTraj)
1292                     {
1293                         trxout = open_trx(out_file, filemode);
1294                     }
1295                     break;
1296                 case efGRO:
1297                 case efG96:
1298                 case efPDB:
1299                     if (( !bSeparate && !bSplit ) && !bSubTraj)
1300                     {
1301                         out = ffopen(out_file, filemode);
1302                     }
1303                     break;
1304             }
1305
1306             bCopy = FALSE;
1307             if (bIndex)
1308             {
1309                 /* check if index is meaningful */
1310                 for (i = 0; i < nout; i++)
1311                 {
1312                     if (index[i] >= natoms)
1313                     {
1314                         gmx_fatal(FARGS,
1315                                   "Index[%d] %d is larger than the number of atoms in the\n"
1316                                   "trajectory file (%d). There is a mismatch in the contents\n"
1317                                   "of your -f, -s and/or -n files.", i, index[i]+1, natoms);
1318                     }
1319                     bCopy = bCopy || (i != index[i]);
1320                 }
1321             }
1322             if (bCopy)
1323             {
1324                 snew(xmem, nout);
1325                 if (bVels)
1326                 {
1327                     snew(vmem, nout);
1328                 }
1329                 if (bForce)
1330                 {
1331                     snew(fmem, nout);
1332                 }
1333             }
1334
1335             if (ftp == efG87)
1336             {
1337                 fprintf(gmx_fio_getfp(trx_get_fileio(trxout)),
1338                         "Generated by %s. #atoms=%d, a BOX is"
1339                         " stored in this file.\n", ShortProgram(), nout);
1340             }
1341
1342             /* Start the big loop over frames */
1343             file_nr  =  0;
1344             frame    =  0;
1345             outframe =  0;
1346             model_nr =  0;
1347             bDTset   = FALSE;
1348
1349             /* Main loop over frames */
1350             do
1351             {
1352                 if (!fr.bStep)
1353                 {
1354                     /* set the step */
1355                     fr.step = newstep;
1356                     newstep++;
1357                 }
1358                 if (bSubTraj)
1359                 {
1360                     /*if (frame >= clust->clust->nra)
1361                        gmx_fatal(FARGS,"There are more frames in the trajectory than in the cluster index file\n");*/
1362                     if (frame > clust->maxframe)
1363                     {
1364                         my_clust = -1;
1365                     }
1366                     else
1367                     {
1368                         my_clust = clust->inv_clust[frame];
1369                     }
1370                     if ((my_clust < 0) || (my_clust >= clust->clust->nr) ||
1371                         (my_clust == NO_ATID))
1372                     {
1373                         my_clust = -1;
1374                     }
1375                 }
1376
1377                 if (bSetBox)
1378                 {
1379                     /* generate new box */
1380                     clear_mat(fr.box);
1381                     for (m = 0; m < DIM; m++)
1382                     {
1383                         fr.box[m][m] = newbox[m];
1384                     }
1385                 }
1386
1387                 if (bTrans)
1388                 {
1389                     for (i = 0; i < natoms; i++)
1390                     {
1391                         rvec_inc(fr.x[i], trans);
1392                     }
1393                 }
1394
1395                 if (bTDump)
1396                 {
1397                     /* determine timestep */
1398                     if (t0 == -1)
1399                     {
1400                         t0 = fr.time;
1401                     }
1402                     else
1403                     {
1404                         if (!bDTset)
1405                         {
1406                             dt     = fr.time-t0;
1407                             bDTset = TRUE;
1408                         }
1409                     }
1410                     /* This is not very elegant, as one can not dump a frame after
1411                      * a timestep with is more than twice as small as the first one. */
1412                     bDumpFrame = (fr.time > tdump-0.5*dt) && (fr.time <= tdump+0.5*dt);
1413                 }
1414                 else
1415                 {
1416                     bDumpFrame = FALSE;
1417                 }
1418
1419                 /* determine if an atom jumped across the box and reset it if so */
1420                 if (bNoJump && (bTPS || frame != 0))
1421                 {
1422                     for (d = 0; d < DIM; d++)
1423                     {
1424                         hbox[d] = 0.5*fr.box[d][d];
1425                     }
1426                     for (i = 0; i < natoms; i++)
1427                     {
1428                         if (bReset)
1429                         {
1430                             rvec_dec(fr.x[i], x_shift);
1431                         }
1432                         for (m = DIM-1; m >= 0; m--)
1433                         {
1434                             if (hbox[m] > 0)
1435                             {
1436                                 while (fr.x[i][m]-xp[i][m] <= -hbox[m])
1437                                 {
1438                                     for (d = 0; d <= m; d++)
1439                                     {
1440                                         fr.x[i][d] += fr.box[m][d];
1441                                     }
1442                                 }
1443                                 while (fr.x[i][m]-xp[i][m] > hbox[m])
1444                                 {
1445                                     for (d = 0; d <= m; d++)
1446                                     {
1447                                         fr.x[i][d] -= fr.box[m][d];
1448                                     }
1449                                 }
1450                             }
1451                         }
1452                     }
1453                 }
1454                 else if (bCluster)
1455                 {
1456                     calc_pbc_cluster(ecenter, ifit, &top, ePBC, fr.x, ind_fit, fr.box);
1457                 }
1458
1459                 if (bPFit)
1460                 {
1461                     /* Now modify the coords according to the flags,
1462                        for normal fit, this is only done for output frames */
1463                     if (bRmPBC)
1464                     {
1465                         gmx_rmpbc_trxfr(gpbc, &fr);
1466                     }
1467
1468                     reset_x_ndim(nfitdim, ifit, ind_fit, natoms, NULL, fr.x, w_rls);
1469                     do_fit(natoms, w_rls, xp, fr.x);
1470                 }
1471
1472                 /* store this set of coordinates for future use */
1473                 if (bPFit || bNoJump)
1474                 {
1475                     if (xp == NULL)
1476                     {
1477                         snew(xp, natoms);
1478                     }
1479                     for (i = 0; (i < natoms); i++)
1480                     {
1481                         copy_rvec(fr.x[i], xp[i]);
1482                         rvec_inc(fr.x[i], x_shift);
1483                     }
1484                 }
1485
1486                 if (frindex)
1487                 {
1488                     /* see if we have a frame from the frame index group */
1489                     for (i = 0; i < nrfri && !bDumpFrame; i++)
1490                     {
1491                         bDumpFrame = frame == frindex[i];
1492                     }
1493                 }
1494                 if (debug && bDumpFrame)
1495                 {
1496                     fprintf(debug, "dumping %d\n", frame);
1497                 }
1498
1499                 bWriteFrame =
1500                     ( ( !bTDump && !frindex && frame % skip_nr == 0 ) || bDumpFrame );
1501
1502                 if (bWriteFrame && (bDropUnder || bDropOver))
1503                 {
1504                     while (dropval[0][drop1] < fr.time && drop1+1 < ndrop)
1505                     {
1506                         drop0 = drop1;
1507                         drop1++;
1508                     }
1509                     if (fabs(dropval[0][drop0] - fr.time)
1510                         < fabs(dropval[0][drop1] - fr.time))
1511                     {
1512                         dropuse = drop0;
1513                     }
1514                     else
1515                     {
1516                         dropuse = drop1;
1517                     }
1518                     if ((bDropUnder && dropval[1][dropuse] < dropunder) ||
1519                         (bDropOver && dropval[1][dropuse] > dropover))
1520                     {
1521                         bWriteFrame = FALSE;
1522                     }
1523                 }
1524
1525                 if (bWriteFrame)
1526                 {
1527
1528                     /* calc new time */
1529                     if (bTimeStep)
1530                     {
1531                         fr.time = tzero+frame*timestep;
1532                     }
1533                     else
1534                     if (bSetTime)
1535                     {
1536                         fr.time += tshift;
1537                     }
1538
1539                     if (bTDump)
1540                     {
1541                         fprintf(stderr, "\nDumping frame at t= %g %s\n",
1542                                 output_env_conv_time(oenv, fr.time), output_env_get_time_unit(oenv));
1543                     }
1544
1545                     /* check for writing at each delta_t */
1546                     bDoIt = (delta_t == 0);
1547                     if (!bDoIt)
1548                     {
1549                         if (!bRound)
1550                         {
1551                             bDoIt = bRmod(fr.time, tzero, delta_t);
1552                         }
1553                         else
1554                         {
1555                             /* round() is not C89 compatible, so we do this:  */
1556                             bDoIt = bRmod(floor(fr.time+0.5), floor(tzero+0.5),
1557                                           floor(delta_t+0.5));
1558                         }
1559                     }
1560
1561                     if (bDoIt || bTDump)
1562                     {
1563                         /* print sometimes */
1564                         if ( ((outframe % SKIP) == 0) || (outframe < SKIP) )
1565                         {
1566                             fprintf(stderr, " ->  frame %6d time %8.3f      \r",
1567                                     outframe, output_env_conv_time(oenv, fr.time));
1568                         }
1569
1570                         if (!bPFit)
1571                         {
1572                             /* Now modify the coords according to the flags,
1573                                for PFit we did this already! */
1574
1575                             if (bRmPBC)
1576                             {
1577                                 gmx_rmpbc_trxfr(gpbc, &fr);
1578                             }
1579
1580                             if (bReset)
1581                             {
1582                                 reset_x_ndim(nfitdim, ifit, ind_fit, natoms, NULL, fr.x, w_rls);
1583                                 if (bFit)
1584                                 {
1585                                     do_fit_ndim(nfitdim, natoms, w_rls, xp, fr.x);
1586                                 }
1587                                 if (!bCenter)
1588                                 {
1589                                     for (i = 0; i < natoms; i++)
1590                                     {
1591                                         rvec_inc(fr.x[i], x_shift);
1592                                     }
1593                                 }
1594                             }
1595
1596                             if (bCenter)
1597                             {
1598                                 center_x(ecenter, fr.x, fr.box, natoms, ncent, cindex);
1599                             }
1600                         }
1601
1602                         if (bPBCcomAtom)
1603                         {
1604                             switch (unitcell_enum)
1605                             {
1606                                 case euRect:
1607                                     put_atoms_in_box(ePBC, fr.box, natoms, fr.x);
1608                                     break;
1609                                 case euTric:
1610                                     put_atoms_in_triclinic_unitcell(ecenter, fr.box, natoms, fr.x);
1611                                     break;
1612                                 case euCompact:
1613                                     warn = put_atoms_in_compact_unitcell(ePBC, ecenter, fr.box,
1614                                                                          natoms, fr.x);
1615                                     if (warn && !bWarnCompact)
1616                                     {
1617                                         fprintf(stderr, "\n%s\n", warn);
1618                                         bWarnCompact = TRUE;
1619                                     }
1620                                     break;
1621                             }
1622                         }
1623                         if (bPBCcomRes)
1624                         {
1625                             put_residue_com_in_box(unitcell_enum, ecenter,
1626                                                    natoms, atoms->atom, ePBC, fr.box, fr.x);
1627                         }
1628                         if (bPBCcomMol)
1629                         {
1630                             put_molecule_com_in_box(unitcell_enum, ecenter,
1631                                                     &top.mols,
1632                                                     natoms, atoms->atom, ePBC, fr.box, fr.x);
1633                         }
1634                         /* Copy the input trxframe struct to the output trxframe struct */
1635                         frout        = fr;
1636                         frout.bV     = (frout.bV && bVels);
1637                         frout.bF     = (frout.bF && bForce);
1638                         frout.natoms = nout;
1639                         if (bNeedPrec && (bSetPrec || !fr.bPrec))
1640                         {
1641                             frout.bPrec = TRUE;
1642                             frout.prec  = prec;
1643                         }
1644                         if (bCopy)
1645                         {
1646                             frout.x = xmem;
1647                             if (frout.bV)
1648                             {
1649                                 frout.v = vmem;
1650                             }
1651                             if (frout.bF)
1652                             {
1653                                 frout.f = fmem;
1654                             }
1655                             for (i = 0; i < nout; i++)
1656                             {
1657                                 copy_rvec(fr.x[index[i]], frout.x[i]);
1658                                 if (frout.bV)
1659                                 {
1660                                     copy_rvec(fr.v[index[i]], frout.v[i]);
1661                                 }
1662                                 if (frout.bF)
1663                                 {
1664                                     copy_rvec(fr.f[index[i]], frout.f[i]);
1665                                 }
1666                             }
1667                         }
1668
1669                         if (opt2parg_bSet("-shift", NPA, pa))
1670                         {
1671                             for (i = 0; i < nout; i++)
1672                             {
1673                                 for (d = 0; d < DIM; d++)
1674                                 {
1675                                     frout.x[i][d] += outframe*shift[d];
1676                                 }
1677                             }
1678                         }
1679
1680                         if (!bRound)
1681                         {
1682                             bSplitHere = bSplit && bRmod(fr.time, tzero, split_t);
1683                         }
1684                         else
1685                         {
1686                             /* round() is not C89 compatible, so we do this: */
1687                             bSplitHere = bSplit && bRmod(floor(fr.time+0.5),
1688                                                          floor(tzero+0.5),
1689                                                          floor(split_t+0.5));
1690                         }
1691                         if (bSeparate || bSplitHere)
1692                         {
1693                             mk_filenm(outf_base, ftp2ext(ftp), nzero, file_nr, out_file2);
1694                         }
1695
1696                         switch (ftp)
1697                         {
1698                             case efTRJ:
1699                             case efTRR:
1700                             case efG87:
1701                             case efXTC:
1702                                 if (bSplitHere)
1703                                 {
1704                                     if (trxout)
1705                                     {
1706                                         close_trx(trxout);
1707                                     }
1708                                     trxout = open_trx(out_file2, filemode);
1709                                 }
1710                                 if (bSubTraj)
1711                                 {
1712                                     if (my_clust != -1)
1713                                     {
1714                                         char buf[STRLEN];
1715                                         if (clust_status_id[my_clust] == -1)
1716                                         {
1717                                             sprintf(buf, "%s.%s", clust->grpname[my_clust], ftp2ext(ftp));
1718                                             clust_status[my_clust]    = open_trx(buf, "w");
1719                                             clust_status_id[my_clust] = 1;
1720                                             ntrxopen++;
1721                                         }
1722                                         else if (clust_status_id[my_clust] == -2)
1723                                         {
1724                                             gmx_fatal(FARGS, "File %s.xtc should still be open (%d open .xtc files)\n" "in order to write frame %d. my_clust = %d",
1725                                                       clust->grpname[my_clust], ntrxopen, frame,
1726                                                       my_clust);
1727                                         }
1728                                         write_trxframe(clust_status[my_clust], &frout, gc);
1729                                         nfwritten[my_clust]++;
1730                                         if (nfwritten[my_clust] ==
1731                                             (clust->clust->index[my_clust+1]-
1732                                              clust->clust->index[my_clust]))
1733                                         {
1734                                             close_trx(clust_status[my_clust]);
1735                                             clust_status[my_clust]    = NULL;
1736                                             clust_status_id[my_clust] = -2;
1737                                             ntrxopen--;
1738                                             if (ntrxopen < 0)
1739                                             {
1740                                                 gmx_fatal(FARGS, "Less than zero open .xtc files!");
1741                                             }
1742                                         }
1743                                     }
1744                                 }
1745                                 else
1746                                 {
1747                                     write_trxframe(trxout, &frout, gc);
1748                                 }
1749                                 break;
1750                             case efGRO:
1751                             case efG96:
1752                             case efPDB:
1753                                 sprintf(title, "Generated by trjconv : %s t= %9.5f",
1754                                         top_title, fr.time);
1755                                 if (bSeparate || bSplitHere)
1756                                 {
1757                                     out = ffopen(out_file2, "w");
1758                                 }
1759                                 switch (ftp)
1760                                 {
1761                                     case efGRO:
1762                                         write_hconf_p(out, title, &useatoms, prec2ndec(frout.prec),
1763                                                       frout.x, frout.bV ? frout.v : NULL, frout.box);
1764                                         break;
1765                                     case efPDB:
1766                                         fprintf(out, "REMARK    GENERATED BY TRJCONV\n");
1767                                         sprintf(title, "%s t= %9.5f", top_title, frout.time);
1768                                         /* if reading from pdb, we want to keep the original
1769                                            model numbering else we write the output frame
1770                                            number plus one, because model 0 is not allowed in pdb */
1771                                         if (ftpin == efPDB && fr.bStep && fr.step > model_nr)
1772                                         {
1773                                             model_nr = fr.step;
1774                                         }
1775                                         else
1776                                         {
1777                                             model_nr++;
1778                                         }
1779                                         write_pdbfile(out, title, &useatoms, frout.x,
1780                                                       frout.ePBC, frout.box, ' ', model_nr, gc, TRUE);
1781                                         break;
1782                                     case efG96:
1783                                         frout.title = title;
1784                                         if (bSeparate || bTDump)
1785                                         {
1786                                             frout.bTitle = TRUE;
1787                                             if (bTPS)
1788                                             {
1789                                                 frout.bAtoms = TRUE;
1790                                             }
1791                                             frout.atoms  = &useatoms;
1792                                             frout.bStep  = FALSE;
1793                                             frout.bTime  = FALSE;
1794                                         }
1795                                         else
1796                                         {
1797                                             frout.bTitle = (outframe == 0);
1798                                             frout.bAtoms = FALSE;
1799                                             frout.bStep  = TRUE;
1800                                             frout.bTime  = TRUE;
1801                                         }
1802                                         write_g96_conf(out, &frout, -1, NULL);
1803                                 }
1804                                 if (bSeparate)
1805                                 {
1806                                     ffclose(out);
1807                                     out = NULL;
1808                                 }
1809                                 break;
1810                             default:
1811                                 gmx_fatal(FARGS, "DHE, ftp=%d\n", ftp);
1812                         }
1813                         if (bSeparate || bSplitHere)
1814                         {
1815                             file_nr++;
1816                         }
1817
1818                         /* execute command */
1819                         if (bExec)
1820                         {
1821                             char c[255];
1822                             sprintf(c, "%s  %d", exec_command, file_nr-1);
1823                             /*fprintf(stderr,"Executing '%s'\n",c);*/
1824 #ifdef GMX_NO_SYSTEM
1825                             printf("Warning-- No calls to system(3) supported on this platform.");
1826                             printf("Warning-- Skipping execution of 'system(\"%s\")'.", c);
1827 #else
1828                             if (0 != system(c))
1829                             {
1830                                 gmx_fatal(FARGS, "Error executing command: %s", c);
1831                             }
1832 #endif
1833                         }
1834                         outframe++;
1835                     }
1836                 }
1837                 frame++;
1838                 bHaveNextFrame = read_next_frame(oenv, status, &fr);
1839             }
1840             while (!(bTDump && bDumpFrame) && bHaveNextFrame);
1841         }
1842
1843         if (!bHaveFirstFrame || (bTDump && !bDumpFrame))
1844         {
1845             fprintf(stderr, "\nWARNING no output, "
1846                     "last frame read at t=%g\n", fr.time);
1847         }
1848         fprintf(stderr, "\n");
1849
1850         close_trj(status);
1851         sfree(outf_base);
1852
1853         if (bRmPBC)
1854         {
1855             gmx_rmpbc_done(gpbc);
1856         }
1857
1858         if (trxout)
1859         {
1860             close_trx(trxout);
1861         }
1862         else if (out != NULL)
1863         {
1864             ffclose(out);
1865         }
1866         if (bSubTraj)
1867         {
1868             for (i = 0; (i < clust->clust->nr); i++)
1869             {
1870                 if (clust_status_id[i] >= 0)
1871                 {
1872                     close_trx(clust_status[i]);
1873                 }
1874             }
1875         }
1876     }
1877
1878     do_view(oenv, out_file, NULL);
1879
1880     return 0;
1881 }