Code beautification with uncrustify
[alexxy/gromacs.git] / src / programs / mdrun / genalg.h
index 1bb6e940c794f774fe36dde52f567994e5f3a22d..a87840bab1ec49d5ca13edce3f093e55fb05f725 100644 (file)
@@ -1,11 +1,11 @@
 /*
- * 
+ *
  *                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.
  * modify it under the terms of the GNU General Public License
  * as published by the Free Software Foundation; either version 2
  * 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.
- * 
+ *
  * 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.
- * 
+ *
  * For more info, check our website at http://www.gromacs.org
- * 
+ *
  * And Hey:
  * Gallium Rubidium Oxygen Manganese Argon Carbon Silicon
  */
 #define _genalg_h
 
 typedef struct {
-  int  np;          /* Number of points           */
-  int  atype;       /* Atom type                  */
-  int  ptype;       /* Parameter type             */
-  real rmin,rmax;   /* Minimum and maximum value  */
-  real dr;
-  real rval;        /* Current value              */
+    int  np;         /* Number of points           */
+    int  atype;      /* Atom type                  */
+    int  ptype;      /* Parameter type             */
+    real rmin, rmax; /* Minimum and maximum value  */
+    real dr;
+    real rval;       /* Current value              */
 } t_range;
 
 typedef struct {
-  int  NP,D;
-  int  strategy;
-  int  seed;
-  int  ipop,gen;        /* Current population member and generation */
-  int  imin;            /* Member with lowest energy */
-  real CR,FF;
-  real **pold,**pnew;   /* Old and new populations */
-  real *best,*bestit,*cost,*tmp,*msf,*energy;
-  tensor *pres;
-  rvec *scale;
+    int     NP, D;
+    int     strategy;
+    int     seed;
+    int     ipop, gen;    /* Current population member and generation */
+    int     imin;         /* Member with lowest energy */
+    real    CR, FF;
+    real  **pold, **pnew; /* Old and new populations */
+    real   *best, *bestit, *cost, *tmp, *msf, *energy;
+    tensor *pres;
+    rvec   *scale;
 } t_genalg;
 
-enum { eseSIGMA, eseEPSILON, eseBHAMA, eseBHAMB, eseBHAMC, 
-       eseCELLX, eseCELLY, eseCELLZ, eseNR };
+enum {
+    eseSIGMA, eseEPSILON, eseBHAMA, eseBHAMB, eseBHAMC,
+    eseCELLX, eseCELLY, eseCELLZ, eseNR
+};
 
-extern real value_rand(t_range *r,int *seed);
+extern real value_rand(t_range *r, int *seed);
 
-extern t_genalg *init_ga(FILE *fplog,const char *infile,int D,t_range range[]);
+extern t_genalg *init_ga(FILE *fplog, const char *infile, int D, t_range range[]);
 
-extern void update_ga(FILE *fpout_ptr,t_range range[],t_genalg *ga);
+extern void update_ga(FILE *fpout_ptr, t_range range[], t_genalg *ga);
 
-extern gmx_bool print_ga(FILE *fp,t_genalg *ga,real msf,tensor pres,rvec scale,
-                    real energy,t_range range[],real tol);
+extern gmx_bool print_ga(FILE *fp, t_genalg *ga, real msf, tensor pres, rvec scale,
+                         real energy, t_range range[], real tol);
 
-extern real cost(tensor P,real MSF,real energy);
+extern real cost(tensor P, real MSF, real energy);
 
 #endif