Sort all includes in src/gromacs
[alexxy/gromacs.git] / src / gromacs / fileio / confio.h
index b1d37770d8d43bfab0b6ed8a7be8d4b6961b24c1..2b149c23a82b59884c77e6b218554834b8e03e24 100644 (file)
@@ -2,8 +2,8 @@
  * This file is part of the GROMACS molecular simulation package.
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
- * Copyright (c) 2001-2004, The GROMACS development team,
- * Copyright (c) 2013, by the GROMACS development team, led by
+ * Copyright (c) 2001-2004, The GROMACS development team.
+ * Copyright (c) 2013,2014, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
 #ifndef GMX_FILEIO_CONFIO_H
 #define GMX_FILEIO_CONFIO_H
 
+#include <stdio.h>
 
-#include "../legacyheaders/typedefs.h"
+#include "gromacs/fileio/trx.h"
+#include "gromacs/legacyheaders/types/simple.h"
 
 /* For reading coordinate files it is assumed that enough memory
  * has been allocated beforehand.
@@ -48,6 +50,9 @@
 extern "C" {
 #endif
 
+struct gmx_mtop_t;
+struct t_atoms;
+
 int read_g96_conf(FILE *fp, const char *infile, t_trxframe *fr, char *line);
 /* read a Gromos96 coordinate or trajectory file,                       *
  * returns the number of atoms                                          *
@@ -66,29 +71,29 @@ gmx_bool gro_next_x_or_v(FILE *status, t_trxframe *fr);
 int gro_first_x_or_v(FILE *status, t_trxframe *fr);
 /* read first/next x and/or v frame from gro file */
 
-void write_hconf_indexed_p(FILE *out, const char *title, t_atoms *atoms,
+void write_hconf_indexed_p(FILE *out, const char *title, struct t_atoms *atoms,
                            int nx, const atom_id index[], int ndec,
                            rvec *x, rvec *v, matrix box);
 
-void write_hconf_p(FILE *out, const char *title, t_atoms *atoms, int ndec,
+void write_hconf_p(FILE *out, const char *title, struct t_atoms *atoms, int ndec,
                    rvec *x, rvec *v, matrix box);
 /* Write a Gromos file with precision ndec: number of decimal places in x,
  * v has one place more. */
 
 void write_sto_conf_indexed(const char *outfile, const char *title,
-                            t_atoms *atoms,
+                            struct t_atoms *atoms,
                             rvec x[], rvec *v, int ePBC, matrix box,
                             atom_id nindex, atom_id index[]);
 /* like write_sto_conf, but indexed */
 
 void write_sto_conf(const char *outfile, const char *title,
-                    t_atoms *atoms,
+                    struct t_atoms *atoms,
                     rvec x[], rvec *v, int ePBC, matrix box);
 /* write atoms, x, v (if .gro and not NULL) and box (if not NULL)
  * to an STO (.gro or .pdb) file */
 
 void write_sto_conf_mtop(const char *outfile, const char *title,
-                         gmx_mtop_t *mtop,
+                         struct gmx_mtop_t *mtop,
                          rvec x[], rvec *v, int ePBC, matrix box);
 /* As write_sto_conf, but uses a gmx_mtop_t struct */
 
@@ -96,7 +101,7 @@ void get_stx_coordnum (const char *infile, int *natoms);
 /* read the number of atoms from an STX file */
 
 void read_stx_conf(const char *infile, char *title,
-                   t_atoms *atoms,
+                   struct t_atoms *atoms,
                    rvec x[], rvec *v, int *ePBC, matrix box);
 /* Read atoms, x, v and box from an STX file.
  * If ePBC!=NULL return the type of pbc in *ePBC or -1 if unknown.