Sort all includes in src/gromacs
[alexxy/gromacs.git] / src / gromacs / legacyheaders / checkpoint.h
index eb31d258651c4b6feab3d9e71d31e63dd8e8e201..78f329dc232d728fbccc0fea5a932ab7b773f766 100644 (file)
@@ -1,44 +1,47 @@
 /*
+ * This file is part of the GROMACS molecular simulation package.
  *
- *                This source code is part of
- *
- *                 G   R   O   M   A   C   S
- *
- *          GROningen MAchine for Chemical Simulations
- *
- *                        VERSION 3.2.0
- * Written by David van der Spoel, Erik Lindahl, Berk Hess, and others.
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
- * Copyright (c) 2001-2004, The GROMACS development team,
- * check out http://www.gromacs.org for more information.
-
- * This program is free software; you can redistribute it and/or
- * modify it under the terms of the GNU General Public License
- * as published by the Free Software Foundation; either version 2
+ * 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.
+ *
+ * GROMACS is free software; you can redistribute it and/or
+ * modify it under the terms of the GNU Lesser General Public License
+ * as published by the Free Software Foundation; either version 2.1
  * of the License, or (at your option) any later version.
  *
- * If you want to redistribute modifications, please consider that
- * scientific software is very special. Version control is crucial -
- * bugs must be traceable. We will be happy to consider code for
- * inclusion in the official distribution, but derived work must not
- * be called official GROMACS. Details are found in the README & COPYING
- * files - if they are missing, get the official version at www.gromacs.org.
+ * GROMACS is distributed in the hope that it will be useful,
+ * but WITHOUT ANY WARRANTY; without even the implied warranty of
+ * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the GNU
+ * Lesser General Public License for more details.
  *
- * To help us fund GROMACS development, we humbly ask that you cite
- * the papers on the package - you can find them in the top README file.
+ * You should have received a copy of the GNU Lesser General Public
+ * License along with GROMACS; if not, see
+ * http://www.gnu.org/licenses, or write to the Free Software Foundation,
+ * Inc., 51 Franklin Street, Fifth Floor, Boston, MA  02110-1301  USA.
  *
- * For more info, check our website at http://www.gromacs.org
+ * If you want to redistribute modifications to GROMACS, please
+ * consider that scientific software is very special. Version
+ * control is crucial - bugs must be traceable. We will be happy to
+ * consider code for inclusion in the official distribution, but
+ * derived work must not be called official GROMACS. Details are found
+ * in the README & COPYING files - if they are missing, get the
+ * official version at http://www.gromacs.org.
  *
- * And Hey:
- * Gromacs Runs On Most of All Computer Systems
+ * To help us fund GROMACS development, we humbly ask that you cite
+ * the research papers on the package. Check out http://www.gromacs.org.
  */
 
 #ifndef _checkpoint_h
 #define _checkpoint_h
 
 
-#include "typedefs.h"
-#include "gmxfio.h"
+#include "gromacs/fileio/filenm.h"
+#include "gromacs/fileio/gmxfio.h"
+#include "gromacs/legacyheaders/typedefs.h"
 
 #ifdef __cplusplus
 extern "C" {
@@ -51,12 +54,12 @@ extern "C" {
  * Appends the _step<step>.cpt with bNumberAndKeep,
  * otherwise moves the previous <fn>.cpt to <fn>_prev.cpt
  */
-void write_checkpoint(const char *fn,gmx_bool bNumberAndKeep,
-                     FILE *fplog,t_commrec *cr,
-                     int eIntegrator, int simulation_part,
-                     gmx_bool bExpanded, int elamstats,
-                     gmx_large_int_t step,double t,
-                     t_state *state);
+void write_checkpoint(const char *fn, gmx_bool bNumberAndKeep,
+                      FILE *fplog, t_commrec *cr,
+                      int eIntegrator, int simulation_part,
+                      gmx_bool bExpanded, int elamstats,
+                      gmx_int64_t step, double t,
+                      t_state *state);
 
 /* Loads a checkpoint from fn for run continuation.
  * Generates a fatal error on system size mismatch.
@@ -68,24 +71,25 @@ void write_checkpoint(const char *fn,gmx_bool bNumberAndKeep,
  * With bAppend and bForceAppend: truncate anyhow if the system does not
  * support file locking.
  */
-void load_checkpoint(const char *fn,FILE **fplog,
-                    t_commrec *cr,gmx_bool bPartDecomp,ivec dd_nc,
-                    t_inputrec *ir,t_state *state,gmx_bool *bReadRNG,
-             gmx_bool *bReadEkin,gmx_bool bAppend,gmx_bool bForceAppend);
+void load_checkpoint(const char *fn, FILE **fplog,
+                     t_commrec *cr, ivec dd_nc,
+                     t_inputrec *ir, t_state *state,
+                     gmx_bool *bReadEkin,
+                     gmx_bool bAppend, gmx_bool bForceAppend);
 
 /* Read the state from checkpoint file.
  * Arrays in state that are NULL are allocated.
  * If bReadRNG=TRUE a RNG state compatible with the current
  * number of nodes was read.
  */
-void read_checkpoint_state(const char *fn,int *simulation_part,
-                                 gmx_large_int_t *step,double *t,t_state *state);
+void read_checkpoint_state(const char *fn, int *simulation_part,
+                           gmx_int64_t *step, double *t, t_state *state);
 
 /* Read everything that can be stored in t_trxframe from a checkpoint file */
-void read_checkpoint_trxframe(t_fileio *fp,t_trxframe *fr);
+void read_checkpoint_trxframe(t_fileio *fp, t_trxframe *fr);
 
 /* Print the complete contents of checkpoint file fn to out */
-void list_checkpoint(const char *fn,FILE *out);
+void list_checkpoint(const char *fn, FILE *out);
 
 /* Read just the simulation 'generation' and with bAppendReq check files.
  * This is necessary already at the beginning of mdrun,
@@ -97,11 +101,11 @@ void list_checkpoint(const char *fn,FILE *out);
  * When TRUE is returned, bAddPart will tell whether the simulation part
  * needs to be added to the output file name.
  */
-gmx_bool read_checkpoint_simulation_part(const char *filename,int *simulation_part,
-                                     gmx_large_int_t *step,t_commrec *cr,
-                                     gmx_bool bAppendReq,
-                                     int nfile,const t_filenm fnm[],
-                                     const char *part_suffix,gmx_bool *bAddPart);
+gmx_bool read_checkpoint_simulation_part(const char *filename, int *simulation_part,
+                                         gmx_int64_t *step, t_commrec *cr,
+                                         gmx_bool bAppendReq,
+                                         int nfile, const t_filenm fnm[],
+                                         const char *part_suffix, gmx_bool *bAddPart);
 
 #ifdef __cplusplus
 }