4 * This source code is part of
8 * GROningen MAchine for Chemical Simulations
12 * Copyright (c) 1991-1999
13 * BIOSON Research Institute, Dept. of Biophysical Chemistry
14 * University of Groningen, The Netherlands
17 * GROMACS: A message-passing parallel molecular dynamics implementation
18 * H.J.C. Berendsen, D. van der Spoel and R. van Drunen
19 * Comp. Phys. Comm. 91, 43-56 (1995)
21 * Also check out our WWW page:
22 * http://md.chem.rug.nl/~gmx
27 * Green Red Orange Magenta Azure Cyan Skyblue
42 #define XX 0 /* Defines for indexing in */
43 #define YY 1 /* vectors */
45 #define DIM 3 /* Dimension of vectors */
46 #define MAXPROC 256 /* Max number of processors */
50 /* typedef int bool; */
54 typedef unsigned int atom_id
; /* To indicate an atoms id */
55 typedef unsigned int atom_nr
; /* To indicate a number of atoms */
56 /* Notice that atom_id cannot use its full range when the types of atom_id */
57 /* and atom_nr are equal. */
58 #define NO_ATID (atom_id)(~0) /* Use this to indicate invalid atid */
62 #define GMX_MPI_REAL MPI_DOUBLE
63 #define GMX_REAL_EPS 2.2e-16
66 #define GMX_MPI_REAL MPI_FLOAT
67 #define GMX_REAL_EPS 1.2e-07
70 typedef real rvec
[DIM
];
72 typedef real matrix
[DIM
][DIM
];
74 typedef real tensor
[DIM
][DIM
];
76 typedef int ivec
[DIM
];
78 typedef int imatrix
[DIM
][DIM
];