Fix PQR file output
[gromacs.git] / src / gromacs / fileio / trxio.cpp
blob2ed5c41cc1da40227882008a0b326e367f22bb14
1 /*
2 * This file is part of the GROMACS molecular simulation package.
4 * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
5 * Copyright (c) 2001-2004, The GROMACS development team.
6 * Copyright (c) 2013,2014,2015,2016,2017,2018, 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.
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.
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.
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.
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.
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.
37 #include "gmxpre.h"
39 #include "trxio.h"
41 #include "config.h"
43 #include <cassert>
44 #include <cmath>
45 #include <cstring>
47 #include "gromacs/fileio/checkpoint.h"
48 #include "gromacs/fileio/confio.h"
49 #include "gromacs/fileio/filetypes.h"
50 #include "gromacs/fileio/g96io.h"
51 #include "gromacs/fileio/gmxfio.h"
52 #include "gromacs/fileio/gmxfio-xdr.h"
53 #include "gromacs/fileio/groio.h"
54 #include "gromacs/fileio/oenv.h"
55 #include "gromacs/fileio/pdbio.h"
56 #include "gromacs/fileio/timecontrol.h"
57 #include "gromacs/fileio/tngio.h"
58 #include "gromacs/fileio/tpxio.h"
59 #include "gromacs/fileio/trrio.h"
60 #include "gromacs/fileio/xdrf.h"
61 #include "gromacs/fileio/xtcio.h"
62 #include "gromacs/math/vec.h"
63 #include "gromacs/mdtypes/md_enums.h"
64 #include "gromacs/topology/atoms.h"
65 #include "gromacs/topology/symtab.h"
66 #include "gromacs/topology/topology.h"
67 #include "gromacs/trajectory/trajectoryframe.h"
68 #include "gromacs/utility/fatalerror.h"
69 #include "gromacs/utility/futil.h"
70 #include "gromacs/utility/gmxassert.h"
71 #include "gromacs/utility/smalloc.h"
73 #if GMX_USE_PLUGINS
74 #include "gromacs/fileio/vmdio.h"
75 #endif
77 /* defines for frame counter output */
78 #define SKIP1 10
79 #define SKIP2 100
80 #define SKIP3 1000
82 struct t_trxstatus
84 int flags; /* flags for read_first/next_frame */
85 int __frame;
86 real t0; /* time of the first frame, needed *
87 * for skipping frames with -dt */
88 real tf; /* internal frame time */
89 t_trxframe *xframe;
90 t_fileio *fio;
91 gmx_tng_trajectory_t tng;
92 int natoms;
93 double DT, BOX[3];
94 gmx_bool bReadBox;
95 char *persistent_line; /* Persistent line for reading g96 trajectories */
96 #if GMX_USE_PLUGINS
97 gmx_vmdplugin_t *vmdplugin;
98 #endif
101 /* utility functions */
103 gmx_bool bRmod_fd(double a, double b, double c, gmx_bool bDouble)
105 int iq;
106 double tol;
108 tol = 2*(bDouble ? GMX_DOUBLE_EPS : GMX_FLOAT_EPS);
110 iq = (int)((a - b + tol*a)/c);
112 if (fabs(a - b - c*iq) <= tol*fabs(a))
114 return TRUE;
116 else
118 return FALSE;
124 int check_times2(real t, real t0, gmx_bool bDouble)
126 int r;
128 #if !GMX_DOUBLE
129 /* since t is float, we can not use double precision for bRmod */
130 bDouble = FALSE;
131 #endif
133 r = -1;
134 if ((!bTimeSet(TBEGIN) || (t >= rTimeValue(TBEGIN))) &&
135 (!bTimeSet(TEND) || (t <= rTimeValue(TEND))))
137 if (bTimeSet(TDELTA) && !bRmod_fd(t, t0, rTimeValue(TDELTA), bDouble))
139 r = -1;
141 else
143 r = 0;
146 else if (bTimeSet(TEND) && (t >= rTimeValue(TEND)))
148 r = 1;
150 if (debug)
152 fprintf(debug, "t=%g, t0=%g, b=%g, e=%g, dt=%g: r=%d\n",
153 t, t0, rTimeValue(TBEGIN), rTimeValue(TEND), rTimeValue(TDELTA), r);
155 return r;
158 int check_times(real t)
160 return check_times2(t, t, FALSE);
163 static void initcount(t_trxstatus *status)
165 status->__frame = -1;
168 static void status_init(t_trxstatus *status)
170 status->flags = 0;
171 status->xframe = nullptr;
172 status->fio = nullptr;
173 status->__frame = -1;
174 status->t0 = 0;
175 status->tf = 0;
176 status->persistent_line = nullptr;
177 status->tng = nullptr;
181 int nframes_read(t_trxstatus *status)
183 return status->__frame;
186 static void printcount_(t_trxstatus *status, const gmx_output_env_t *oenv,
187 const char *l, real t)
189 if ((status->__frame < 2*SKIP1 || status->__frame % SKIP1 == 0) &&
190 (status->__frame < 2*SKIP2 || status->__frame % SKIP2 == 0) &&
191 (status->__frame < 2*SKIP3 || status->__frame % SKIP3 == 0) &&
192 output_env_get_trajectory_io_verbosity(oenv) != 0)
194 fprintf(stderr, "\r%-14s %6d time %8.3f ", l, status->__frame,
195 output_env_conv_time(oenv, t));
196 fflush(stderr);
200 static void printcount(t_trxstatus *status, const gmx_output_env_t *oenv, real t,
201 gmx_bool bSkip)
203 status->__frame++;
204 printcount_(status, oenv, bSkip ? "Skipping frame" : "Reading frame", t);
207 static void printlast(t_trxstatus *status, const gmx_output_env_t *oenv, real t)
209 printcount_(status, oenv, "Last frame", t);
210 fprintf(stderr, "\n");
211 fflush(stderr);
214 static void printincomp(t_trxstatus *status, t_trxframe *fr)
216 if (fr->not_ok & HEADER_NOT_OK)
218 fprintf(stderr, "WARNING: Incomplete header: nr %d time %g\n",
219 status->__frame+1, fr->time);
221 else if (fr->not_ok)
223 fprintf(stderr, "WARNING: Incomplete frame: nr %d time %g\n",
224 status->__frame+1, fr->time);
226 fflush(stderr);
229 int prec2ndec(real prec)
231 if (prec <= 0)
233 gmx_fatal(FARGS, "DEATH HORROR prec (%g) <= 0 in prec2ndec", prec);
236 return (int)(log(prec)/log(10.0)+0.5);
239 real ndec2prec(int ndec)
241 return pow(10.0, ndec);
244 t_fileio *trx_get_fileio(t_trxstatus *status)
246 return status->fio;
249 float trx_get_time_of_final_frame(t_trxstatus *status)
251 t_fileio *stfio = trx_get_fileio(status);
252 int filetype = gmx_fio_getftp(stfio);
253 int bOK;
254 float lasttime = -1;
256 if (filetype == efXTC)
258 lasttime =
259 xdr_xtc_get_last_frame_time(gmx_fio_getfp(stfio),
260 gmx_fio_getxdr(stfio),
261 status->natoms, &bOK);
262 if (!bOK)
264 gmx_fatal(FARGS, "Error reading last frame. Maybe seek not supported." );
267 else if (filetype == efTNG)
269 gmx_tng_trajectory_t tng = status->tng;
270 if (!tng)
272 gmx_fatal(FARGS, "Error opening TNG file.");
274 lasttime = gmx_tng_get_time_of_final_frame(tng);
276 else
278 gmx_incons("Only supported for TNG and XTC");
280 return lasttime;
283 void clear_trxframe(t_trxframe *fr, gmx_bool bFirst)
285 fr->not_ok = 0;
286 fr->bStep = FALSE;
287 fr->bTime = FALSE;
288 fr->bLambda = FALSE;
289 fr->bFepState = FALSE;
290 fr->bAtoms = FALSE;
291 fr->bPrec = FALSE;
292 fr->bX = FALSE;
293 fr->bV = FALSE;
294 fr->bF = FALSE;
295 fr->bBox = FALSE;
296 if (bFirst)
298 fr->bDouble = FALSE;
299 fr->natoms = -1;
300 fr->step = 0;
301 fr->time = 0;
302 fr->lambda = 0;
303 fr->fep_state = 0;
304 fr->atoms = nullptr;
305 fr->prec = 0;
306 fr->x = nullptr;
307 fr->v = nullptr;
308 fr->f = nullptr;
309 clear_mat(fr->box);
310 fr->bPBC = FALSE;
311 fr->ePBC = -1;
315 void set_trxframe_ePBC(t_trxframe *fr, int ePBC)
317 fr->bPBC = (ePBC == -1);
318 fr->ePBC = ePBC;
321 int write_trxframe_indexed(t_trxstatus *status, const t_trxframe *fr, int nind,
322 const int *ind, gmx_conect gc)
324 char title[STRLEN];
325 rvec *xout = nullptr, *vout = nullptr, *fout = nullptr;
326 int i, ftp = -1;
327 real prec;
329 if (fr->bPrec)
331 prec = fr->prec;
333 else
335 prec = 1000.0;
338 if (status->tng)
340 ftp = efTNG;
342 else if (status->fio)
344 ftp = gmx_fio_getftp(status->fio);
346 else
348 gmx_incons("No input file available");
351 switch (ftp)
353 case efTRR:
354 case efTNG:
355 break;
356 default:
357 if (!fr->bX)
359 gmx_fatal(FARGS, "Need coordinates to write a %s trajectory",
360 ftp2ext(ftp));
362 break;
365 switch (ftp)
367 case efTRR:
368 case efTNG:
369 if (fr->bV)
371 snew(vout, nind);
372 for (i = 0; i < nind; i++)
374 copy_rvec(fr->v[ind[i]], vout[i]);
377 if (fr->bF)
379 snew(fout, nind);
380 for (i = 0; i < nind; i++)
382 copy_rvec(fr->f[ind[i]], fout[i]);
385 // fallthrough
386 case efXTC:
387 if (fr->bX)
389 snew(xout, nind);
390 for (i = 0; i < nind; i++)
392 copy_rvec(fr->x[ind[i]], xout[i]);
395 break;
396 default:
397 break;
400 switch (ftp)
402 case efTNG:
403 gmx_write_tng_from_trxframe(status->tng, fr, nind);
404 break;
405 case efXTC:
406 write_xtc(status->fio, nind, fr->step, fr->time, fr->box, xout, prec);
407 break;
408 case efTRR:
409 gmx_trr_write_frame(status->fio, nframes_read(status),
410 fr->time, fr->step, fr->box, nind, xout, vout, fout);
411 break;
412 case efGRO:
413 case efPDB:
414 case efBRK:
415 case efENT:
416 if (!fr->bAtoms)
418 gmx_fatal(FARGS, "Can not write a %s file without atom names",
419 ftp2ext(ftp));
421 sprintf(title, "frame t= %.3f", fr->time);
422 if (ftp == efGRO)
424 write_hconf_indexed_p(gmx_fio_getfp(status->fio), title, fr->atoms, nind, ind,
425 fr->x, fr->bV ? fr->v : nullptr, fr->box);
427 else
429 write_pdbfile_indexed(gmx_fio_getfp(status->fio), title, fr->atoms,
430 fr->x, -1, fr->box, ' ', fr->step, nind, ind, gc, TRUE, FALSE);
432 break;
433 case efG96:
434 sprintf(title, "frame t= %.3f", fr->time);
435 write_g96_conf(gmx_fio_getfp(status->fio), title, fr, nind, ind);
436 break;
437 default:
438 gmx_fatal(FARGS, "Sorry, write_trxframe_indexed can not write %s",
439 ftp2ext(ftp));
440 break;
443 switch (ftp)
445 case efTRR:
446 case efTNG:
447 if (vout)
449 sfree(vout);
451 if (fout)
453 sfree(fout);
455 // fallthrough
456 case efXTC:
457 sfree(xout);
458 break;
459 default:
460 break;
463 return 0;
466 void trjtools_gmx_prepare_tng_writing(const char *filename,
467 char filemode,
468 t_trxstatus *in,
469 t_trxstatus **out,
470 const char *infile,
471 const int natoms,
472 const gmx_mtop_t *mtop,
473 const int *index,
474 const char *index_group_name)
476 if (filemode != 'w' && filemode != 'a')
478 gmx_incons("Sorry, can only prepare for TNG output.");
481 if (*out == nullptr)
483 snew((*out), 1);
485 status_init(*out);
487 if (in != nullptr)
489 gmx_prepare_tng_writing(filename,
490 filemode,
491 &in->tng,
492 &(*out)->tng,
493 natoms,
494 mtop,
495 index,
496 index_group_name);
498 else if (efTNG == fn2ftp(infile))
500 gmx_tng_trajectory_t tng_in;
501 gmx_tng_open(infile, 'r', &tng_in);
503 gmx_prepare_tng_writing(filename,
504 filemode,
505 &tng_in,
506 &(*out)->tng,
507 natoms,
508 mtop,
509 index,
510 index_group_name);
514 void write_tng_frame(t_trxstatus *status,
515 t_trxframe *frame)
517 gmx_write_tng_from_trxframe(status->tng, frame, -1);
520 int write_trxframe(t_trxstatus *status, t_trxframe *fr, gmx_conect gc)
522 char title[STRLEN];
523 real prec;
525 if (fr->bPrec)
527 prec = fr->prec;
529 else
531 prec = 1000.0;
534 if (status->tng)
536 gmx_tng_set_compression_precision(status->tng, prec);
537 write_tng_frame(status, fr);
539 return 0;
542 switch (gmx_fio_getftp(status->fio))
544 case efTRR:
545 break;
546 default:
547 if (!fr->bX)
549 gmx_fatal(FARGS, "Need coordinates to write a %s trajectory",
550 ftp2ext(gmx_fio_getftp(status->fio)));
552 break;
555 switch (gmx_fio_getftp(status->fio))
557 case efXTC:
558 write_xtc(status->fio, fr->natoms, fr->step, fr->time, fr->box, fr->x, prec);
559 break;
560 case efTRR:
561 gmx_trr_write_frame(status->fio, fr->step, fr->time, fr->lambda, fr->box, fr->natoms,
562 fr->bX ? fr->x : nullptr, fr->bV ? fr->v : nullptr, fr->bF ? fr->f : nullptr);
563 break;
564 case efGRO:
565 case efPDB:
566 case efBRK:
567 case efENT:
568 if (!fr->bAtoms)
570 gmx_fatal(FARGS, "Can not write a %s file without atom names",
571 ftp2ext(gmx_fio_getftp(status->fio)));
573 sprintf(title, "frame t= %.3f", fr->time);
574 if (gmx_fio_getftp(status->fio) == efGRO)
576 write_hconf_p(gmx_fio_getfp(status->fio), title, fr->atoms,
577 fr->x, fr->bV ? fr->v : nullptr, fr->box);
579 else
581 write_pdbfile(gmx_fio_getfp(status->fio), title,
582 fr->atoms, fr->x, fr->bPBC ? fr->ePBC : -1, fr->box,
583 ' ', fr->step, gc, TRUE);
585 break;
586 case efG96:
587 write_g96_conf(gmx_fio_getfp(status->fio), title, fr, -1, nullptr);
588 break;
589 default:
590 gmx_fatal(FARGS, "Sorry, write_trxframe can not write %s",
591 ftp2ext(gmx_fio_getftp(status->fio)));
592 break;
595 return 0;
598 int write_trx(t_trxstatus *status, int nind, const int *ind, const t_atoms *atoms,
599 int step, real time, matrix box, rvec x[], rvec *v,
600 gmx_conect gc)
602 t_trxframe fr;
604 clear_trxframe(&fr, TRUE);
605 fr.bStep = TRUE;
606 fr.step = step;
607 fr.bTime = TRUE;
608 fr.time = time;
609 fr.bAtoms = atoms != nullptr;
610 fr.atoms = const_cast<t_atoms *>(atoms);
611 fr.bX = TRUE;
612 fr.x = x;
613 fr.bV = v != nullptr;
614 fr.v = v;
615 fr.bBox = TRUE;
616 copy_mat(box, fr.box);
618 return write_trxframe_indexed(status, &fr, nind, ind, gc);
621 void close_trx(t_trxstatus *status)
623 if (status == nullptr)
625 return;
627 gmx_tng_close(&status->tng);
628 if (status->fio)
630 gmx_fio_close(status->fio);
632 sfree(status->persistent_line);
633 #if GMX_USE_PLUGINS
634 sfree(status->vmdplugin);
635 #endif
636 /* The memory in status->xframe is lost here,
637 * but the read_first_x/read_next_x functions are deprecated anyhow.
638 * read_first_frame/read_next_frame and close_trx should be used.
640 sfree(status);
643 t_trxstatus *open_trx(const char *outfile, const char *filemode)
645 t_trxstatus *stat;
646 if (filemode[0] != 'w' && filemode[0] != 'a' && filemode[1] != '+')
648 gmx_fatal(FARGS, "Sorry, write_trx can only write");
651 snew(stat, 1);
652 status_init(stat);
654 stat->fio = gmx_fio_open(outfile, filemode);
655 return stat;
658 static gmx_bool gmx_next_frame(t_trxstatus *status, t_trxframe *fr)
660 gmx_trr_header_t sh;
661 gmx_bool bOK, bRet;
663 bRet = FALSE;
665 if (gmx_trr_read_frame_header(status->fio, &sh, &bOK))
667 fr->bDouble = sh.bDouble;
668 fr->natoms = sh.natoms;
669 fr->bStep = TRUE;
670 fr->step = sh.step;
671 fr->bTime = TRUE;
672 fr->time = sh.t;
673 fr->bLambda = TRUE;
674 fr->bFepState = TRUE;
675 fr->lambda = sh.lambda;
676 fr->bBox = sh.box_size > 0;
677 if (status->flags & (TRX_READ_X | TRX_NEED_X))
679 if (fr->x == nullptr)
681 snew(fr->x, sh.natoms);
683 fr->bX = sh.x_size > 0;
685 if (status->flags & (TRX_READ_V | TRX_NEED_V))
687 if (fr->v == nullptr)
689 snew(fr->v, sh.natoms);
691 fr->bV = sh.v_size > 0;
693 if (status->flags & (TRX_READ_F | TRX_NEED_F))
695 if (fr->f == nullptr)
697 snew(fr->f, sh.natoms);
699 fr->bF = sh.f_size > 0;
701 if (gmx_trr_read_frame_data(status->fio, &sh, fr->box, fr->x, fr->v, fr->f))
703 bRet = TRUE;
705 else
707 fr->not_ok = DATA_NOT_OK;
710 else
711 if (!bOK)
713 fr->not_ok = HEADER_NOT_OK;
716 return bRet;
719 static gmx_bool pdb_next_x(t_trxstatus *status, FILE *fp, t_trxframe *fr)
721 t_atoms atoms;
722 t_symtab *symtab;
723 matrix boxpdb;
724 // Initiate model_nr to -1 rather than NOTSET.
725 // It is not worthwhile introducing extra variables in the
726 // read_pdbfile call to verify that a model_nr was read.
727 int ePBC, model_nr = -1, na;
728 char title[STRLEN], *time, *step;
729 double dbl;
731 atoms.nr = fr->natoms;
732 atoms.atom = nullptr;
733 atoms.pdbinfo = nullptr;
734 /* the other pointers in atoms should not be accessed if these are NULL */
735 snew(symtab, 1);
736 open_symtab(symtab);
737 na = read_pdbfile(fp, title, &model_nr, &atoms, symtab, fr->x, &ePBC, boxpdb, TRUE, nullptr);
738 free_symtab(symtab);
739 sfree(symtab);
740 set_trxframe_ePBC(fr, ePBC);
741 if (nframes_read(status) == 0)
743 fprintf(stderr, " '%s', %d atoms\n", title, fr->natoms);
745 fr->bPrec = TRUE;
746 fr->prec = 10000;
747 fr->bX = TRUE;
748 fr->bBox = (boxpdb[XX][XX] != 0.0);
749 if (fr->bBox)
751 copy_mat(boxpdb, fr->box);
754 fr->step = 0;
755 step = std::strstr(title, " step= ");
756 fr->bStep = (step && sscanf(step+7, "%" GMX_SCNd64, &fr->step) == 1);
758 dbl = 0.0;
759 time = std::strstr(title, " t= ");
760 fr->bTime = (time && sscanf(time+4, "%lf", &dbl) == 1);
761 fr->time = dbl;
763 if (na == 0)
765 return FALSE;
767 else
769 if (na != fr->natoms)
771 gmx_fatal(FARGS, "Number of atoms in pdb frame %d is %d instead of %d",
772 nframes_read(status), na, fr->natoms);
774 return TRUE;
778 static int pdb_first_x(t_trxstatus *status, FILE *fp, t_trxframe *fr)
780 initcount(status);
782 fprintf(stderr, "Reading frames from pdb file");
783 frewind(fp);
784 get_pdb_coordnum(fp, &fr->natoms);
785 if (fr->natoms == 0)
787 gmx_fatal(FARGS, "\nNo coordinates in pdb file\n");
789 frewind(fp);
790 snew(fr->x, fr->natoms);
791 pdb_next_x(status, fp, fr);
793 return fr->natoms;
796 bool read_next_frame(const gmx_output_env_t *oenv, t_trxstatus *status, t_trxframe *fr)
798 real pt;
799 int ct;
800 gmx_bool bOK, bMissingData = FALSE, bSkip = FALSE;
801 bool bRet = false;
802 int ftp;
804 pt = status->tf;
808 clear_trxframe(fr, FALSE);
810 if (status->tng)
812 /* Special treatment for TNG files */
813 ftp = efTNG;
815 else
817 ftp = gmx_fio_getftp(status->fio);
819 switch (ftp)
821 case efTRR:
822 bRet = gmx_next_frame(status, fr);
823 break;
824 case efCPT:
825 /* Checkpoint files can not contain mulitple frames */
826 break;
827 case efG96:
829 t_symtab *symtab = nullptr;
830 read_g96_conf(gmx_fio_getfp(status->fio), nullptr, nullptr, fr,
831 symtab, status->persistent_line);
832 bRet = (fr->natoms > 0);
833 break;
835 case efXTC:
836 if (bTimeSet(TBEGIN) && (status->tf < rTimeValue(TBEGIN)))
838 if (xtc_seek_time(status->fio, rTimeValue(TBEGIN), fr->natoms, TRUE))
840 gmx_fatal(FARGS, "Specified frame (time %f) doesn't exist or file corrupt/inconsistent.",
841 rTimeValue(TBEGIN));
843 initcount(status);
845 bRet = read_next_xtc(status->fio, fr->natoms, &fr->step, &fr->time, fr->box,
846 fr->x, &fr->prec, &bOK);
847 fr->bPrec = (bRet && fr->prec > 0);
848 fr->bStep = bRet;
849 fr->bTime = bRet;
850 fr->bX = bRet;
851 fr->bBox = bRet;
852 if (!bOK)
854 /* Actually the header could also be not ok,
855 but from bOK from read_next_xtc this can't be distinguished */
856 fr->not_ok = DATA_NOT_OK;
858 break;
859 case efTNG:
860 bRet = gmx_read_next_tng_frame(status->tng, fr, nullptr, 0);
861 break;
862 case efPDB:
863 bRet = pdb_next_x(status, gmx_fio_getfp(status->fio), fr);
864 break;
865 case efGRO:
866 bRet = gro_next_x_or_v(gmx_fio_getfp(status->fio), fr);
867 break;
868 default:
869 #if GMX_USE_PLUGINS
870 bRet = read_next_vmd_frame(status->vmdplugin, fr);
871 #else
872 gmx_fatal(FARGS, "DEATH HORROR in read_next_frame ftp=%s,status=%s",
873 ftp2ext(gmx_fio_getftp(status->fio)),
874 gmx_fio_getname(status->fio));
875 #endif
877 status->tf = fr->time;
879 if (bRet)
881 bMissingData = (((status->flags & TRX_NEED_X) && !fr->bX) ||
882 ((status->flags & TRX_NEED_V) && !fr->bV) ||
883 ((status->flags & TRX_NEED_F) && !fr->bF));
884 bSkip = FALSE;
885 if (!bMissingData)
887 ct = check_times2(fr->time, status->t0, fr->bDouble);
888 if (ct == 0 || ((status->flags & TRX_DONT_SKIP) && ct < 0))
890 printcount(status, oenv, fr->time, FALSE);
892 else if (ct > 0)
894 bRet = false;
896 else
898 printcount(status, oenv, fr->time, TRUE);
899 bSkip = TRUE;
905 while (bRet && (bMissingData || bSkip));
907 if (!bRet)
909 printlast(status, oenv, pt);
910 if (fr->not_ok)
912 printincomp(status, fr);
916 return bRet;
919 bool read_first_frame(const gmx_output_env_t *oenv, t_trxstatus **status,
920 const char *fn, t_trxframe *fr, int flags)
922 t_fileio *fio = nullptr;
923 gmx_bool bFirst, bOK;
924 int ftp = fn2ftp(fn);
926 clear_trxframe(fr, TRUE);
928 bFirst = TRUE;
930 snew((*status), 1);
932 status_init( *status );
933 initcount(*status);
934 (*status)->flags = flags;
936 if (efTNG == ftp)
938 /* Special treatment for TNG files */
939 gmx_tng_open(fn, 'r', &(*status)->tng);
941 else
943 fio = (*status)->fio = gmx_fio_open(fn, "r");
945 switch (ftp)
947 case efTRR:
948 break;
949 case efCPT:
950 read_checkpoint_trxframe(fio, fr);
951 bFirst = FALSE;
952 break;
953 case efG96:
955 /* Can not rewind a compressed file, so open it twice */
956 if (!(*status)->persistent_line)
958 /* allocate the persistent line */
959 snew((*status)->persistent_line, STRLEN+1);
961 t_symtab *symtab = nullptr;
962 read_g96_conf(gmx_fio_getfp(fio), fn, nullptr, fr, symtab, (*status)->persistent_line);
963 gmx_fio_close(fio);
964 clear_trxframe(fr, FALSE);
965 if (flags & (TRX_READ_X | TRX_NEED_X))
967 snew(fr->x, fr->natoms);
969 if (flags & (TRX_READ_V | TRX_NEED_V))
971 snew(fr->v, fr->natoms);
973 (*status)->fio = gmx_fio_open(fn, "r");
974 break;
976 case efXTC:
977 if (read_first_xtc(fio, &fr->natoms, &fr->step, &fr->time, fr->box, &fr->x,
978 &fr->prec, &bOK) == 0)
980 GMX_RELEASE_ASSERT(!bOK, "Inconsistent results - OK status from read_first_xtc, but 0 atom coords read");
981 fr->not_ok = DATA_NOT_OK;
983 if (fr->not_ok)
985 fr->natoms = 0;
986 printincomp(*status, fr);
988 else
990 fr->bPrec = (fr->prec > 0);
991 fr->bStep = TRUE;
992 fr->bTime = TRUE;
993 fr->bX = TRUE;
994 fr->bBox = TRUE;
995 printcount(*status, oenv, fr->time, FALSE);
997 bFirst = FALSE;
998 break;
999 case efTNG:
1000 fr->step = -1;
1001 if (!gmx_read_next_tng_frame((*status)->tng, fr, nullptr, 0))
1003 fr->not_ok = DATA_NOT_OK;
1004 fr->natoms = 0;
1005 printincomp(*status, fr);
1007 else
1009 printcount(*status, oenv, fr->time, FALSE);
1011 bFirst = FALSE;
1012 break;
1013 case efPDB:
1014 pdb_first_x(*status, gmx_fio_getfp(fio), fr);
1015 if (fr->natoms)
1017 printcount(*status, oenv, fr->time, FALSE);
1019 bFirst = FALSE;
1020 break;
1021 case efGRO:
1022 if (gro_first_x_or_v(gmx_fio_getfp(fio), fr))
1024 printcount(*status, oenv, fr->time, FALSE);
1026 bFirst = FALSE;
1027 break;
1028 default:
1029 #if GMX_USE_PLUGINS
1030 fprintf(stderr, "The file format of %s is not a known trajectory format to GROMACS.\n"
1031 "Please make sure that the file is a trajectory!\n"
1032 "GROMACS will now assume it to be a trajectory and will try to open it using the VMD plug-ins.\n"
1033 "This will only work in case the VMD plugins are found and it is a trajectory format supported by VMD.\n", fn);
1034 gmx_fio_fp_close(fio); /*only close the file without removing FIO entry*/
1035 if (!read_first_vmd_frame(fn, &(*status)->vmdplugin, fr))
1037 gmx_fatal(FARGS, "Not supported in read_first_frame: %s", fn);
1039 #else
1040 gmx_fatal(FARGS, "Not supported in read_first_frame: %s. Please make sure that the file is a trajectory.\n"
1041 "GROMACS is not compiled with plug-in support. Thus it cannot read non-GROMACS trajectory formats using the VMD plug-ins.\n"
1042 "Please compile with plug-in support if you want to read non-GROMACS trajectory formats.\n", fn);
1043 #endif
1044 break;
1046 (*status)->tf = fr->time;
1048 /* Return FALSE if we read a frame that's past the set ending time. */
1049 if (!bFirst && (!(flags & TRX_DONT_SKIP) && check_times(fr->time) > 0))
1051 (*status)->t0 = fr->time;
1052 return FALSE;
1055 if (bFirst ||
1056 (!(flags & TRX_DONT_SKIP) && check_times(fr->time) < 0))
1058 /* Read a frame when no frame was read or the first was skipped */
1059 if (!read_next_frame(oenv, *status, fr))
1061 return FALSE;
1064 (*status)->t0 = fr->time;
1066 /* We need the number of atoms for random-access XTC searching, even when
1067 * we don't have access to the actual frame data.
1069 (*status)->natoms = fr->natoms;
1071 return (fr->natoms > 0);
1074 /***** C O O R D I N A T E S T U F F *****/
1076 int read_first_x(const gmx_output_env_t *oenv, t_trxstatus **status, const char *fn,
1077 real *t, rvec **x, matrix box)
1079 t_trxframe fr;
1081 read_first_frame(oenv, status, fn, &fr, TRX_NEED_X);
1083 snew((*status)->xframe, 1);
1084 (*(*status)->xframe) = fr;
1085 *t = (*status)->xframe->time;
1086 *x = (*status)->xframe->x;
1087 copy_mat((*status)->xframe->box, box);
1089 return (*status)->xframe->natoms;
1092 gmx_bool read_next_x(const gmx_output_env_t *oenv, t_trxstatus *status, real *t,
1093 rvec x[], matrix box)
1095 gmx_bool bRet;
1097 status->xframe->x = x;
1098 /*xframe[status].x = x;*/
1099 bRet = read_next_frame(oenv, status, status->xframe);
1100 *t = status->xframe->time;
1101 copy_mat(status->xframe->box, box);
1103 return bRet;
1106 void rewind_trj(t_trxstatus *status)
1108 initcount(status);
1110 gmx_fio_rewind(status->fio);
1113 /***** T O P O L O G Y S T U F F ******/
1115 t_topology *read_top(const char *fn, int *ePBC)
1117 int epbc, natoms;
1118 t_topology *top;
1120 snew(top, 1);
1121 epbc = read_tpx_top(fn, nullptr, nullptr, &natoms, nullptr, nullptr, top);
1122 if (ePBC)
1124 *ePBC = epbc;
1127 return top;