Code beautification with uncrustify
[alexxy/gromacs.git] / src / gromacs / gmxlib / thread_mpi / tmpi_init.c
index ee3a906a0ff296afd8647136880479a4c8afe02e..4fa6169513aa9fdd0f078c6aab38ccdda6a1c932 100644 (file)
@@ -1,39 +1,39 @@
 /*
-This source code file is part of thread_mpi.  
-Written by Sander Pronk, Erik Lindahl, and possibly others. 
+   This source code file is part of thread_mpi.
+   Written by Sander Pronk, Erik Lindahl, and possibly others.
 
-Copyright (c) 2009, Sander Pronk, Erik Lindahl.
-All rights reserved.
+   Copyright (c) 2009, Sander Pronk, Erik Lindahl.
+   All rights reserved.
 
-Redistribution and use in source and binary forms, with or without
-modification, are permitted provided that the following conditions are met:
-1) Redistributions of source code must retain the above copyright
+   Redistribution and use in source and binary forms, with or without
+   modification, are permitted provided that the following conditions are met:
+   1) Redistributions of source code must retain the above copyright
    notice, this list of conditions and the following disclaimer.
-2) Redistributions in binary form must reproduce the above copyright
+   2) Redistributions in binary form must reproduce the above copyright
    notice, this list of conditions and the following disclaimer in the
    documentation and/or other materials provided with the distribution.
-3) Neither the name of the copyright holders nor the
+   3) Neither the name of the copyright holders nor the
    names of its contributors may be used to endorse or promote products
    derived from this software without specific prior written permission.
 
-THIS SOFTWARE IS PROVIDED BY US ''AS IS'' AND ANY
-EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE IMPLIED
-WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE ARE
-DISCLAIMED. IN NO EVENT SHALL WE BE LIABLE FOR ANY
-DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR CONSEQUENTIAL DAMAGES
-(INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES;
-LOSS OF USE, DATA, OR PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND
-ON ANY THEORY OF LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT
-(INCLUDING NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE OF THIS
-SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE.
-
-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 should not
-be called official thread_mpi. Details are found in the README & COPYING
-files.
-*/
+   THIS SOFTWARE IS PROVIDED BY US ''AS IS'' AND ANY
+   EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE IMPLIED
+   WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE ARE
+   DISCLAIMED. IN NO EVENT SHALL WE BE LIABLE FOR ANY
+   DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR CONSEQUENTIAL DAMAGES
+   (INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES;
+   LOSS OF USE, DATA, OR PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND
+   ON ANY THEORY OF LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT
+   (INCLUDING NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE OF THIS
+   SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE.
+
+   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 should not
+   be called official thread_mpi. Details are found in the README & COPYING
+   files.
+ */
 
 
 #ifdef HAVE_TMPI_CONFIG_H
@@ -52,7 +52,7 @@ files.
 #include <stdlib.h>
 #include <stdio.h>
 #include <string.h>
-#if ! (defined( _WIN32 ) || defined( _WIN64 ) )
+#if !(defined( _WIN32 ) || defined( _WIN64 ) )
 #include <sys/time.h>
 
 #endif
@@ -72,13 +72,13 @@ files.
 /* there are a few global variables that maintain information about the
    running threads. Some are defined by the MPI standard: */
 /* TMPI_COMM_WORLD is in tmpi_malloc.c due to technical reasons */
-tMPI_Group TMPI_GROUP_EMPTY=NULL;
+tMPI_Group TMPI_GROUP_EMPTY = NULL;
 
 
 /* the threads themselves (tmpi_comm only contains lists of pointers to this
       structure */
-struct tmpi_thread *threads=NULL;
-int Nthreads=0;
+struct tmpi_thread *threads  = NULL;
+int                 Nthreads = 0;
 
 /* thread info */
 tMPI_Thread_key_t id_key; /* the key to get the thread id */
@@ -87,10 +87,10 @@ tMPI_Thread_key_t id_key; /* the key to get the thread id */
 
 /* whether MPI has finalized (we need this to distinguish pre-inited from
        post-finalized states */
-static tmpi_bool tmpi_finalized=FALSE;
+static tmpi_bool tmpi_finalized = FALSE;
 
 /* misc. global information about MPI */
-struct tmpi_global *tmpi_global=NULL;
+struct tmpi_global *tmpi_global = NULL;
 
 
 
@@ -98,9 +98,9 @@ struct tmpi_global *tmpi_global=NULL;
 
 
 /* start N threads with argc, argv (used by tMPI_Init)*/
-void tMPI_Start_threads(tmpi_bool main_returns, int N, 
+void tMPI_Start_threads(tmpi_bool main_returns, int N,
                         tMPI_Affinity_strategy aff_strategy,
-                        int *argc, char ***argv, 
+                        int *argc, char ***argv,
                         void (*start_fn)(void*), void *start_arg,
                         int (*start_fn_main)(int, char**));
 
@@ -119,14 +119,14 @@ static void tMPI_Thread_destroy(struct tmpi_thread *th);
 #ifdef TMPI_TRACE
 void tMPI_Trace_print(const char *fmt, ...)
 {
-    va_list argp;
-    struct tmpi_thread* th=NULL;
-    static tMPI_Thread_mutex_t mtx=TMPI_THREAD_MUTEX_INITIALIZER;
+    va_list                    argp;
+    struct tmpi_thread       * th  = NULL;
+    static tMPI_Thread_mutex_t mtx = TMPI_THREAD_MUTEX_INITIALIZER;
 
     tMPI_Thread_mutex_lock(&mtx);
     if (threads)
     {
-        th=tMPI_Get_current();
+        th = tMPI_Get_current();
         printf("THREAD %02d: ", (int)(th-threads));
     }
     else
@@ -147,10 +147,12 @@ void tMPI_Trace_print(const char *fmt, ...)
 struct tmpi_thread *tMPI_Get_current(void)
 {
     if (!threads)
+    {
         return NULL;
+    }
 
     return (struct tmpi_thread*)tMPI_thread_getspecific(id_key);
-} 
+}
 
 
 unsigned int tMPI_Threadnr(struct tmpi_thread *thr)
@@ -179,17 +181,19 @@ struct tmpi_thread *tMPI_Get_thread(tMPI_Comm comm, int rank)
 tmpi_bool tMPI_Is_master(void)
 {
     /* if there are no other threads, we're the main thread */
-    if ( (!TMPI_COMM_WORLD) || TMPI_COMM_WORLD->grp.N==0)
+    if ( (!TMPI_COMM_WORLD) || TMPI_COMM_WORLD->grp.N == 0)
+    {
         return TRUE;
+    }
 
     /* otherwise we know this through thread specific data: */
     /* whether the thread pointer points to the head of the threads array */
-    return (tmpi_bool)(tMPI_Get_current() == threads); 
+    return (tmpi_bool)(tMPI_Get_current() == threads);
 }
 
 tMPI_Comm tMPI_Get_comm_self(void)
 {
-    struct tmpi_thread* th=tMPI_Get_current();
+    struct tmpi_thread* th = tMPI_Get_current();
     return th->self_comm;
 }
 
@@ -197,16 +201,16 @@ tMPI_Comm tMPI_Get_comm_self(void)
 int tMPI_Get_N(int *argc, char ***argv, const char *optname, int *nthreads)
 {
     int i;
-    int ret=TMPI_SUCCESS;
+    int ret = TMPI_SUCCESS;
 
-    *nthreads=0;
+    *nthreads = 0;
     if (!optname)
     {
-        i=0;
+        i = 0;
     }
     else
     {
-        for(i=1;i<*argc;i++)
+        for (i = 1; i < *argc; i++)
         {
             if (strcmp(optname, (*argv)[i]) == 0)
             {
@@ -218,19 +222,22 @@ int tMPI_Get_N(int *argc, char ***argv, const char *optname, int *nthreads)
     {
         /* the number of processes is an argument */
         char *end;
-        *nthreads=strtol((*argv)[i+1], &end, 10);
-        if ( !end || (*end != 0) )
+        *nthreads = strtol((*argv)[i+1], &end, 10);
+        if (!end || (*end != 0) )
         {
-            *nthreads=0;
-            ret=TMPI_FAILURE;
+            *nthreads = 0;
+            ret       = TMPI_FAILURE;
         }
     }
-    if (*nthreads<1)
+    if (*nthreads < 1)
     {
-        int nth=tMPI_Thread_get_hw_number();
+        int nth = tMPI_Thread_get_hw_number();
 
-        if (nth<1) nth=1; /* make sure it's at least 1 */
-        *nthreads=nth;
+        if (nth < 1)
+        {
+            nth = 1;      /* make sure it's at least 1 */
+        }
+        *nthreads = nth;
     }
 
     return ret;
@@ -238,26 +245,26 @@ int tMPI_Get_N(int *argc, char ***argv, const char *optname, int *nthreads)
 
 static void tMPI_Thread_init(struct tmpi_thread *th)
 {
-    int N_envelopes=(Nthreads+1)*N_EV_ALLOC;  
-    int N_send_envelopes=N_EV_ALLOC;  
-    int N_reqs=(Nthreads+1)*N_EV_ALLOC;  
+    int N_envelopes      = (Nthreads+1)*N_EV_ALLOC;
+    int N_send_envelopes = N_EV_ALLOC;
+    int N_reqs           = (Nthreads+1)*N_EV_ALLOC;
     int i;
 
     /* we set our thread id, as a thread-specific piece of global data. */
     tMPI_Thread_setspecific(id_key, th);
 
     /* allocate comm.self */
-    th->self_comm=tMPI_Comm_alloc(TMPI_COMM_WORLD, 1);
-    th->self_comm->grp.peers[0]=th;
+    th->self_comm               = tMPI_Comm_alloc(TMPI_COMM_WORLD, 1);
+    th->self_comm->grp.peers[0] = th;
 
     /* allocate envelopes */
     tMPI_Free_env_list_init( &(th->envelopes), N_envelopes );
     /* recv list */
     tMPI_Recv_env_list_init( &(th->evr));
     /* send lists */
-    th->evs=(struct send_envelope_list*)tMPI_Malloc(
-                        sizeof(struct send_envelope_list)*Nthreads);
-    for(i=0;i<Nthreads;i++)
+    th->evs = (struct send_envelope_list*)tMPI_Malloc(
+                sizeof(struct send_envelope_list)*Nthreads);
+    for (i = 0; i < Nthreads; i++)
     {
         tMPI_Send_env_list_init( &(th->evs[i]), N_send_envelopes);
     }
@@ -289,7 +296,7 @@ static void tMPI_Thread_destroy(struct tmpi_thread *th)
     int i;
 
     tMPI_Recv_env_list_destroy( &(th->evr));
-    for(i=0;i<Nthreads;i++)
+    for (i = 0; i < Nthreads; i++)
     {
         tMPI_Send_env_list_destroy( &(th->evs[i]));
     }
@@ -302,7 +309,7 @@ static void tMPI_Thread_destroy(struct tmpi_thread *th)
     tMPI_Copy_buffer_list_destroy(&(th->cbl_multi));
 #endif
 
-    for(i=0;i<th->argc;i++)
+    for (i = 0; i < th->argc; i++)
     {
         free(th->argv[i]);
     }
@@ -310,9 +317,9 @@ static void tMPI_Thread_destroy(struct tmpi_thread *th)
 
 static void tMPI_Global_init(struct tmpi_global *g, int Nthreads)
 {
-    g->usertypes=NULL;
-    g->N_usertypes=0;
-    g->Nalloc_usertypes=0;
+    g->usertypes        = NULL;
+    g->N_usertypes      = 0;
+    g->Nalloc_usertypes = 0;
     tMPI_Thread_mutex_init(&(g->timer_mutex));
     tMPI_Spinlock_init(&(g->datatype_lock));
 
@@ -320,12 +327,12 @@ static void tMPI_Global_init(struct tmpi_global *g, int Nthreads)
 
     tMPI_Thread_mutex_init(&(g->comm_link_lock));
 
-#if ! (defined( _WIN32 ) || defined( _WIN64 ) )
+#if !(defined( _WIN32 ) || defined( _WIN64 ) )
     /* the time at initialization. */
     gettimeofday( &(g->timer_init), NULL);
 #else
     /* the time at initialization. */
-    g->timer_init=GetTickCount();
+    g->timer_init = GetTickCount();
 #endif
 
 }
@@ -342,7 +349,7 @@ static void tMPI_Global_destroy(struct tmpi_global *g)
 
 static void* tMPI_Thread_starter(void *arg)
 {
-    struct tmpi_thread *th=(struct tmpi_thread*)arg;
+    struct tmpi_thread *th = (struct tmpi_thread*)arg;
 
 #ifdef TMPI_TRACE
     tMPI_Trace_print("Created thread nr. %d", (int)(th-threads));
@@ -350,8 +357,8 @@ static void* tMPI_Thread_starter(void *arg)
 
     tMPI_Thread_init(th);
 
-    /* start_fn, start_arg, argc and argv were set by the calling function */ 
-    if (! th->start_fn )
+    /* start_fn, start_arg, argc and argv were set by the calling function */
+    if (!th->start_fn)
     {
         th->start_fn_main(th->argc, th->argv);
     }
@@ -359,106 +366,108 @@ static void* tMPI_Thread_starter(void *arg)
     {
         th->start_fn(th->start_arg);
         if (!tmpi_finalized)
+        {
             tMPI_Finalize();
+        }
     }
 
     return 0;
 }
 
 
-void tMPI_Start_threads(tmpi_bool main_returns, int N, 
+void tMPI_Start_threads(tmpi_bool main_returns, int N,
                         tMPI_Affinity_strategy aff_strategy,
-                        int *argc, char ***argv, 
+                        int *argc, char ***argv,
                         void (*start_fn)(void*), void *start_arg,
                         int (*start_fn_main)(int, char**))
 {
 #ifdef TMPI_TRACE
-    tMPI_Trace_print("tMPI_Start_threads(%d, %d, %d, %d, %d, %p, %p, %p, %p)", 
-                      main_returns, N, aff_strategy, argc, argv, start_fn, 
-                      start_arg);
+    tMPI_Trace_print("tMPI_Start_threads(%d, %d, %d, %d, %d, %p, %p, %p, %p)",
+                     main_returns, N, aff_strategy, argc, argv, start_fn,
+                     start_arg);
 #endif
-    if (N>0) 
+    if (N > 0)
     {
         int i;
-        int set_affinity=FALSE;
+        int set_affinity = FALSE;
 
-        tmpi_finalized=FALSE;
-        Nthreads=N;
+        tmpi_finalized = FALSE;
+        Nthreads       = N;
 
         /* allocate global data */
-        tmpi_global=(struct tmpi_global*)
-                        tMPI_Malloc(sizeof(struct tmpi_global));
+        tmpi_global = (struct tmpi_global*)
+            tMPI_Malloc(sizeof(struct tmpi_global));
         tMPI_Global_init(tmpi_global, N);
 
         /* allocate world and thread data */
-        threads=(struct tmpi_thread*)tMPI_Malloc(sizeof(struct tmpi_thread)*N);
-        TMPI_COMM_WORLD=tMPI_Comm_alloc(NULL, N);
-        TMPI_GROUP_EMPTY=tMPI_Group_alloc();
+        threads          = (struct tmpi_thread*)tMPI_Malloc(sizeof(struct tmpi_thread)*N);
+        TMPI_COMM_WORLD  = tMPI_Comm_alloc(NULL, N);
+        TMPI_GROUP_EMPTY = tMPI_Group_alloc();
 
         if (tMPI_Thread_key_create(&id_key, NULL))
         {
             tMPI_Error(TMPI_COMM_WORLD, TMPI_ERR_INIT);
         }
-        for(i=0;i<N;i++)
+        for (i = 0; i < N; i++)
         {
-            TMPI_COMM_WORLD->grp.peers[i]=&(threads[i]);
+            TMPI_COMM_WORLD->grp.peers[i] = &(threads[i]);
 
             /* copy argc, argv */
             if (argc && argv)
             {
                 int j;
-                threads[i].argc=*argc;
-                threads[i].argv=(char**)tMPI_Malloc(threads[i].argc*
-                                                   sizeof(char*));
-                for(j=0;j<threads[i].argc;j++)
+                threads[i].argc = *argc;
+                threads[i].argv = (char**)tMPI_Malloc(threads[i].argc*
+                                                      sizeof(char*));
+                for (j = 0; j < threads[i].argc; j++)
                 {
-#if ! (defined( _WIN32 ) || defined( _WIN64 ) )
-                    threads[i].argv[j]=strdup( (*argv)[j] );
+#if !(defined( _WIN32 ) || defined( _WIN64 ) )
+                    threads[i].argv[j] = strdup( (*argv)[j] );
 #else
-                    threads[i].argv[j]=_strdup( (*argv)[j] );
+                    threads[i].argv[j] = _strdup( (*argv)[j] );
 #endif
                 }
             }
             else
             {
-                threads[i].argc=0;
-                threads[i].argv=NULL;
+                threads[i].argc = 0;
+                threads[i].argv = NULL;
             }
-            threads[i].start_fn=start_fn;
-            threads[i].start_fn_main=start_fn_main;
-            threads[i].start_arg=start_arg;
+            threads[i].start_fn      = start_fn;
+            threads[i].start_fn_main = start_fn_main;
+            threads[i].start_arg     = start_arg;
         }
 
         /* now check whether to set affinity */
-        if (aff_strategy == TMPI_AFFINITY_ALL_CORES) 
+        if (aff_strategy == TMPI_AFFINITY_ALL_CORES)
         {
-            int nhw=tMPI_Thread_get_hw_number();
+            int nhw = tMPI_Thread_get_hw_number();
             if ((nhw > 1) && (nhw == N))
             {
-                set_affinity=TRUE;
+                set_affinity = TRUE;
             }
         }
 
         /* set thread 0's properties */
-        threads[0].thread_id=tMPI_Thread_self();
+        threads[0].thread_id = tMPI_Thread_self();
         if (set_affinity)
         {
             /* set the main thread's affinity */
             tMPI_Thread_setaffinity_single(threads[0].thread_id, 0);
         }
 
-        for(i=1;i<N;i++) /* zero is the main thread */
+        for (i = 1; i < N; i++) /* zero is the main thread */
         {
             int ret;
-            ret=tMPI_Thread_create(&(threads[i].thread_id), 
-                                   tMPI_Thread_starter,
-                                   (void*)&(threads[i]) ) ;
+            ret = tMPI_Thread_create(&(threads[i].thread_id),
+                                     tMPI_Thread_starter,
+                                     (void*)&(threads[i]) );
 
             if (set_affinity)
             {
                 tMPI_Thread_setaffinity_single(threads[i].thread_id, i);
             }
-            if(ret)
+            if (ret)
             {
                 tMPI_Error(TMPI_COMM_WORLD, TMPI_ERR_INIT);
             }
@@ -466,31 +475,35 @@ void tMPI_Start_threads(tmpi_bool main_returns, int N,
         /* the main thread also runs start_fn if we don't want
            it to return */
         if (!main_returns)
+        {
             tMPI_Thread_starter((void*)&(threads[0]));
+        }
         else
+        {
             tMPI_Thread_init(&(threads[0]));
+        }
     }
 }
 
 
-int tMPI_Init(int *argc, char ***argv, 
+int tMPI_Init(int *argc, char ***argv,
               int (*start_function)(int, char**))
 {
 #ifdef TMPI_TRACE
     tMPI_Trace_print("tMPI_Init(%p, %p, %p)", argc, argv, start_function);
 #endif
 
-    if (TMPI_COMM_WORLD==0) /* we're the main process */
+    if (TMPI_COMM_WORLD == 0) /* we're the main process */
     {
-        int N=0;
+        int N = 0;
         tMPI_Get_N(argc, argv, "-nt", &N);
-        tMPI_Start_threads(TRUE, N, TMPI_AFFINITY_ALL_CORES, argc, argv, 
+        tMPI_Start_threads(TRUE, N, TMPI_AFFINITY_ALL_CORES, argc, argv,
                            NULL, NULL, start_function);
     }
     else
     {
-        /* if we're a sub-thread we need don't need to do anyhing, because 
-           everything has already been set up by either the main thread, 
+        /* if we're a sub-thread we need don't need to do anyhing, because
+           everything has already been set up by either the main thread,
            or the thread runner function.*/
     }
     return TMPI_SUCCESS;
@@ -499,7 +512,7 @@ int tMPI_Init(int *argc, char ***argv,
 
 
 
-int tMPI_Init_fn(int main_thread_returns, int N, 
+int tMPI_Init_fn(int main_thread_returns, int N,
                  tMPI_Affinity_strategy aff_strategy,
                  void (*start_function)(void*), void *arg)
 {
@@ -507,15 +520,18 @@ int tMPI_Init_fn(int main_thread_returns, int N,
     tMPI_Trace_print("tMPI_Init_fn(%d, %p, %p)", N, start_function, arg);
 #endif
 
-    if (N<1)
+    if (N < 1)
     {
-        N=tMPI_Thread_get_hw_number();
-        if (N<1) N=1; /*because that's what the fn returns if it doesn't know*/
+        N = tMPI_Thread_get_hw_number();
+        if (N < 1)
+        {
+            N = 1;    /*because that's what the fn returns if it doesn't know*/
+        }
     }
 
-    if (TMPI_COMM_WORLD==0 && N>=1) /* we're the main process */
+    if (TMPI_COMM_WORLD == 0 && N >= 1) /* we're the main process */
     {
-        tMPI_Start_threads(main_thread_returns, N, aff_strategy, 
+        tMPI_Start_threads(main_thread_returns, N, aff_strategy,
                            0, 0, start_function, arg, NULL);
     }
     return TMPI_SUCCESS;
@@ -527,7 +543,7 @@ int tMPI_Initialized(int *flag)
     tMPI_Trace_print("tMPI_Initialized(%p)", flag);
 #endif
 
-    *flag=(TMPI_COMM_WORLD && !tmpi_finalized);
+    *flag = (TMPI_COMM_WORLD && !tmpi_finalized);
 
     return TMPI_SUCCESS;
 }
@@ -545,7 +561,7 @@ int tMPI_Finalize(void)
 
 #ifdef TMPI_PROFILE
     {
-        struct tmpi_thread *cur=tMPI_Get_current();
+        struct tmpi_thread *cur = tMPI_Get_current();
 
         tMPI_Profile_stop( &(cur->profile) );
         tMPI_Thread_barrier_wait( &(tmpi_global->barrier) );
@@ -561,9 +577,9 @@ int tMPI_Finalize(void)
     if (tMPI_Is_master())
     {
 
-        /* we just wait for all threads to finish; the order isn't very 
+        /* we just wait for all threads to finish; the order isn't very
            relevant, as all threads should arrive at their endpoints soon. */
-        for(i=1;i<Nthreads;i++)
+        for (i = 1; i < Nthreads; i++)
         {
             if (tMPI_Thread_join(threads[i].thread_id, NULL))
             {
@@ -571,7 +587,7 @@ int tMPI_Finalize(void)
             }
             tMPI_Thread_destroy(&(threads[i]));
         }
-        /* at this point, we are the only thread left, so we can 
+        /* at this point, we are the only thread left, so we can
            destroy the global structures with impunity. */
         tMPI_Thread_destroy(&(threads[0]));
         free(threads);
@@ -582,28 +598,28 @@ int tMPI_Finalize(void)
             tMPI_Comm cur;
 
             tMPI_Thread_mutex_lock(&(tmpi_global->comm_link_lock));
-            cur=TMPI_COMM_WORLD->next;
-            while(cur && (cur!=TMPI_COMM_WORLD) )
+            cur = TMPI_COMM_WORLD->next;
+            while (cur && (cur != TMPI_COMM_WORLD) )
             {
-                tMPI_Comm next=cur->next;
+                tMPI_Comm next = cur->next;
                 tMPI_Comm_destroy(cur, FALSE);
-                cur=next;
+                cur = next;
             }
             tMPI_Comm_destroy(TMPI_COMM_WORLD, FALSE);
             tMPI_Thread_mutex_unlock(&(tmpi_global->comm_link_lock));
         }
 
         tMPI_Group_free(&TMPI_GROUP_EMPTY);
-        threads=0;
-        TMPI_COMM_WORLD=NULL;
-        TMPI_GROUP_EMPTY=NULL;
-        Nthreads=0;
+        threads          = 0;
+        TMPI_COMM_WORLD  = NULL;
+        TMPI_GROUP_EMPTY = NULL;
+        Nthreads         = 0;
 
         /* deallocate the 'global' structure */
         tMPI_Global_destroy(tmpi_global);
         free(tmpi_global);
 
-        tmpi_finalized=TRUE;
+        tmpi_finalized = TRUE;
     }
     else
     {
@@ -618,7 +634,7 @@ int tMPI_Finalized(int *flag)
 #ifdef TMPI_TRACE
     tMPI_Trace_print("tMPI_Finalized(%p)", flag);
 #endif
-    *flag=tmpi_finalized;
+    *flag = tmpi_finalized;
 
     return TMPI_SUCCESS;
 }
@@ -632,25 +648,31 @@ int tMPI_Abort(tMPI_Comm comm, int errorcode)
 #endif
 #if 0
     /* we abort(). This way we can run a debugger on it */
-    fprintf(stderr, "tMPI_Abort called with error code %d",errorcode);
-    if (comm==TMPI_COMM_WORLD)
+    fprintf(stderr, "tMPI_Abort called with error code %d", errorcode);
+    if (comm == TMPI_COMM_WORLD)
+    {
         fprintf(stderr, " on TMPI_COMM_WORLD");
-    fprintf(stderr,"\n");
+    }
+    fprintf(stderr, "\n");
     fflush(stdout);
 
     abort();
 #else
     /* we just kill all threads, but not the main process */
-    
+
     if (tMPI_Is_master())
     {
-        if (comm==TMPI_COMM_WORLD)
-            fprintf(stderr, 
-               "tMPI_Abort called on TMPI_COMM_WORLD main with errorcode=%d\n",
-               errorcode);
+        if (comm == TMPI_COMM_WORLD)
+        {
+            fprintf(stderr,
+                    "tMPI_Abort called on TMPI_COMM_WORLD main with errorcode=%d\n",
+                    errorcode);
+        }
         else
-        fprintf(stderr, "tMPI_Abort called on main thread with errorcode=%d\n",
-                errorcode);
+        {
+            fprintf(stderr, "tMPI_Abort called on main thread with errorcode=%d\n",
+                    errorcode);
+        }
         fflush(stderr);
         exit(errorcode);
     }
@@ -658,10 +680,10 @@ int tMPI_Abort(tMPI_Comm comm, int errorcode)
     {
         int *ret;
         /* kill myself */
-        fprintf(stderr, "tMPI_Abort called with error code %d on thread %d\n", 
-                        errorcode, tMPI_This_threadnr());
+        fprintf(stderr, "tMPI_Abort called with error code %d on thread %d\n",
+                errorcode, tMPI_This_threadnr());
         fflush(stderr);
-        ret=(int*)malloc(sizeof(int));
+        ret = (int*)malloc(sizeof(int));
         tMPI_Thread_exit(ret);
     }
 #endif
@@ -671,9 +693,9 @@ int tMPI_Abort(tMPI_Comm comm, int errorcode)
 
 int tMPI_Get_processor_name(char *name, int *resultlen)
 {
-    int nr=tMPI_Threadnr(tMPI_Get_current());
-    unsigned int digits=0;
-    const unsigned int base=10;
+    int                nr     = tMPI_Threadnr(tMPI_Get_current());
+    unsigned int       digits = 0;
+    const unsigned int base   = 10;
 
 #ifdef TMPI_TRACE
     tMPI_Trace_print("tMPI_Get_processor_name(%p, %p)", name, resultlen);
@@ -683,43 +705,53 @@ int tMPI_Get_processor_name(char *name, int *resultlen)
 
     /* first determine number of digits */
     {
-        int rest=nr;
-        while(rest > 0)
+        int rest = nr;
+        while (rest > 0)
         {
             rest /= base;
             digits++;
         }
-        if (digits==0)
-            digits=1;
+        if (digits == 0)
+        {
+            digits = 1;
+        }
     }
-#if ! (defined( _WIN32 ) || defined( _WIN64 ) )
+#if !(defined( _WIN32 ) || defined( _WIN64 ) )
     strcpy(name, "thread #");
 #else
     strncpy_s(name, TMPI_MAX_PROCESSOR_NAME, "thread #", TMPI_MAX_PROCESSOR_NAME);
 #endif
     /* now construct the number */
     {
-        size_t len=strlen(name);
+        size_t       len = strlen(name);
         unsigned int i;
-        int rest=nr;
+        int          rest = nr;
 
-        for(i=0;i<digits;i++)
+        for (i = 0; i < digits; i++)
         {
-            size_t pos=len + (digits-i-1);
+            size_t pos = len + (digits-i-1);
             if (pos < (TMPI_MAX_PROCESSOR_NAME -1) )
-                name[ pos ]=(char)('0' + rest%base);
+            {
+                name[ pos ] = (char)('0' + rest%base);
+            }
             rest /= base;
         }
         if ( (digits+len) < TMPI_MAX_PROCESSOR_NAME)
-            name[digits + len]='\0';
+        {
+            name[digits + len] = '\0';
+        }
         else
-            name[TMPI_MAX_PROCESSOR_NAME]='\0';
+        {
+            name[TMPI_MAX_PROCESSOR_NAME] = '\0';
+        }
 
     }
     if (resultlen)
-        *resultlen=(int)strlen(name); /* For some reason the MPI standard
-                                         uses ints instead of size_ts for
-                                         sizes. */
+    {
+        *resultlen = (int)strlen(name); /* For some reason the MPI standard
+                                           uses ints instead of size_ts for
+                                           sizes. */
+    }
     return TMPI_SUCCESS;
 }
 
@@ -730,32 +762,32 @@ int tMPI_Get_processor_name(char *name, int *resultlen)
 /* TODO: there must be better ways to do this */
 double tMPI_Wtime(void)
 {
-    double ret=0;
+    double ret = 0;
 
 #ifdef TMPI_TRACE
     tMPI_Trace_print("tMPI_Wtime()");
 #endif
 
-#if ! (defined( _WIN32 ) || defined( _WIN64 ) )
+#if !(defined( _WIN32 ) || defined( _WIN64 ) )
     {
         struct timeval tv;
-        long int secdiff;
-        int usecdiff;
+        long int       secdiff;
+        int            usecdiff;
 
         gettimeofday(&tv, NULL);
-        secdiff = tv.tv_sec - tmpi_global->timer_init.tv_sec;
+        secdiff  = tv.tv_sec - tmpi_global->timer_init.tv_sec;
         usecdiff = tv.tv_usec - tmpi_global->timer_init.tv_usec;
 
-        ret=(double)secdiff + 1e-6*usecdiff;
+        ret = (double)secdiff + 1e-6*usecdiff;
     }
 #else
     {
-        DWORD tv=GetTickCount();
-   
+        DWORD tv = GetTickCount();
+
         /* the windows absolute time GetTickCount() wraps around in ~49 days,
            so it's safer to always use differences, and assume that our
            program doesn't run that long.. */
-        ret=1e-3*((unsigned int)(tv - tmpi_global->timer_init));
+        ret = 1e-3*((unsigned int)(tv - tmpi_global->timer_init));
     }
 #endif
     return ret;
@@ -763,7 +795,7 @@ double tMPI_Wtime(void)
 
 double tMPI_Wtick(void)
 {
-#if ! (defined( _WIN32 ) || defined( _WIN64 ) )
+#if !(defined( _WIN32 ) || defined( _WIN64 ) )
     /* In Unix, we don't really know. Any modern OS should be at least
        this precise, though */
     return 1./100.;
@@ -791,6 +823,3 @@ int tMPI_Get_count(tMPI_Status *status, tMPI_Datatype datatype, int *count)
     *count = (int)(status->transferred/datatype->size);
     return TMPI_SUCCESS;
 }
-
-
-