Redefine the default boolean type to gmx_bool.
[alexxy/gromacs.git] / src / mdlib / sim_util.c
index 3658412110f419fd609c9fd220cb8895a193936a..61b7f87fde33959c5ed831457b04fada9967ea71 100644 (file)
@@ -420,14 +420,14 @@ void do_force(FILE *fplog,t_commrec *cr,
               real lambda,t_graph *graph,
               t_forcerec *fr,gmx_vsite_t *vsite,rvec mu_tot,
               double t,FILE *field,gmx_edsam_t ed,
-              bool bBornRadii,
+              gmx_bool bBornRadii,
               int flags)
 {
     int    cg0,cg1,i,j;
     int    start,homenr;
     double mu[2*DIM]; 
-    bool   bSepDVDL,bStateChanged,bNS,bFillGrid,bCalcCGCM,bBS;
-    bool   bDoLongRange,bDoForces,bSepLRF;
+    gmx_bool   bSepDVDL,bStateChanged,bNS,bFillGrid,bCalcCGCM,bBS;
+    gmx_bool   bDoLongRange,bDoForces,bSepLRF;
     matrix boxs;
     real   e,v,dvdl;
     t_pbc  pbc;
@@ -530,7 +530,9 @@ void do_force(FILE *fplog,t_commrec *cr,
 
     gmx_pme_send_x(cr,bBS ? boxs : box,x,
                    mdatoms->nChargePerturbed,lambda,
-                   ( flags & GMX_FORCE_VIRIAL),step);
+/* FIX ME after 4.5 */
+/* we are using gmx_bool of type char */
+                   ( flags & GMX_FORCE_VIRIAL) != 0,step);
 
     GMX_MPE_LOG(ev_send_coordinates_finish);
     wallcycle_stop(wcycle,ewcPP_PMESENDX);
@@ -1167,7 +1169,7 @@ void calc_dispcorr(FILE *fplog,t_inputrec *ir,t_forcerec *fr,
                    matrix box,real lambda,tensor pres,tensor virial,
                    real *prescorr, real *enercorr, real *dvdlcorr)
 {
-    bool bCorrAll,bCorrPres;
+    gmx_bool bCorrAll,bCorrPres;
     real dvdlambda,invvol,dens,ninter,avcsix,avctwelve,enerdiff,svir=0,spres=0;
     int  m;
     
@@ -1299,7 +1301,7 @@ void do_pbc_first(FILE *fplog,matrix box,t_forcerec *fr,
 
 static void low_do_pbc_mtop(FILE *fplog,int ePBC,matrix box,
                            gmx_mtop_t *mtop,rvec x[],
-                           bool bFirst)
+                           gmx_bool bFirst)
 {
   t_graph *graph;
   int mb,as,mol;
@@ -1354,7 +1356,7 @@ void finish_run(FILE *fplog,t_commrec *cr,const char *confout,
                 t_inputrec *inputrec,
                 t_nrnb nrnb[],gmx_wallcycle_t wcycle,
                 gmx_runtime_t *runtime,
-                bool bWriteStat)
+                gmx_bool bWriteStat)
 {
   int    i,j;
   t_nrnb *nrnb_tot=NULL;
@@ -1462,7 +1464,7 @@ void init_md(FILE *fplog,
              int nfile,const t_filenm fnm[],
              gmx_mdoutf_t **outf,t_mdebin **mdebin,
              tensor force_vir,tensor shake_vir,rvec mu_tot,
-             bool *bSimAnn,t_vcm **vcm, t_state *state, unsigned long Flags)
+             gmx_bool *bSimAnn,t_vcm **vcm, t_state *state, unsigned long Flags)
 {
     int  i,j,n;
     real tmpt,mod;