Code beautification with uncrustify
[alexxy/gromacs.git] / src / gromacs / gmxlib / thread_mpi / scan.c
index f222bf9d54ae69cedb16df2be6edb0ffa983def6..1b7adf528e347e39f661259bbb3cd1a2092c2929 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
 #include "tmpi_config.h"
@@ -62,11 +62,11 @@ files.
 int tMPI_Scan(void* sendbuf, void* recvbuf, int count,
               tMPI_Datatype datatype, tMPI_Op op, tMPI_Comm comm)
 {
-    struct tmpi_thread *cur=tMPI_Get_current();
-    int myrank=tMPI_Comm_seek_rank(comm, cur);
-    int N=tMPI_Comm_N(comm);
-    int prev=myrank - 1; /* my previous neighbor */
-    int next=myrank + 1; /* my next neighbor */
+    struct tmpi_thread *cur    = tMPI_Get_current();
+    int                 myrank = tMPI_Comm_seek_rank(comm, cur);
+    int                 N      = tMPI_Comm_N(comm);
+    int                 prev   = myrank - 1; /* my previous neighbor */
+    int                 next   = myrank + 1; /* my next neighbor */
 
 #ifdef TMPI_PROFILE
     tMPI_Profile_count_start(cur);
@@ -75,26 +75,28 @@ int tMPI_Scan(void* sendbuf, void* recvbuf, int count,
     tMPI_Trace_print("tMPI_Scan(%p, %p, %d, %p, %p, %p)",
                      sendbuf, recvbuf, count, datatype, op, comm);
 #endif
-    if (count==0)
+    if (count == 0)
+    {
         return TMPI_SUCCESS;
+    }
     if (!recvbuf)
     {
         return tMPI_Error(comm, TMPI_ERR_BUF);
     }
-    if (sendbuf==TMPI_IN_PLACE) 
+    if (sendbuf == TMPI_IN_PLACE)
     {
-        sendbuf=recvbuf;
+        sendbuf = recvbuf;
     }
 
     /* we set our send and recv buffers */
-    tMPI_Atomic_ptr_set(&(comm->reduce_sendbuf[myrank]),sendbuf);
-    tMPI_Atomic_ptr_set(&(comm->reduce_recvbuf[myrank]),recvbuf);
+    tMPI_Atomic_ptr_set(&(comm->reduce_sendbuf[myrank]), sendbuf);
+    tMPI_Atomic_ptr_set(&(comm->reduce_recvbuf[myrank]), recvbuf);
 
     /* now wait for the previous rank to finish */
     if (myrank > 0)
     {
         void *a, *b;
-        int ret;
+        int   ret;
 
 #if defined(TMPI_PROFILE) && defined(TMPI_CYCLE_COUNT)
         tMPI_Profile_wait_start(cur);
@@ -120,8 +122,8 @@ int tMPI_Scan(void* sendbuf, void* recvbuf, int count,
         }
         b = sendbuf;
 
-        if ((ret=tMPI_Reduce_run_op(recvbuf, a, b, datatype,
-                                    count, op, comm)) != TMPI_SUCCESS)
+        if ((ret = tMPI_Reduce_run_op(recvbuf, a, b, datatype,
+                                      count, op, comm)) != TMPI_SUCCESS)
         {
             return ret;
         }
@@ -158,6 +160,3 @@ int tMPI_Scan(void* sendbuf, void* recvbuf, int count,
 #endif
     return TMPI_SUCCESS;
 }
-
-
-