Tagged files with gromacs 3.0 header and added some license info
[alexxy/gromacs.git] / include / reorder.h
index a01269c763a60803c9efc8bb974204c7a6907bb8..83662e28992ad11cd822accbea5df4659946c792 100644 (file)
@@ -1,37 +1,43 @@
 /*
  * $Id$
  * 
- *       This source code is part of
+ *                This source code is part of
  * 
- *        G   R   O   M   A   C   S
+ *                 G   R   O   M   A   C   S
  * 
- * GROningen MAchine for Chemical Simulations
+ *          GROningen MAchine for Chemical Simulations
  * 
- *               VERSION 2.0
+ *                        VERSION 3.0
  * 
- * Copyright (c) 1991-1999
+ * Copyright (c) 1991-2001
  * BIOSON Research Institute, Dept. of Biophysical Chemistry
  * University of Groningen, The Netherlands
  * 
- * Please refer to:
- * GROMACS: A message-passing parallel molecular dynamics implementation
- * H.J.C. Berendsen, D. van der Spoel and R. van Drunen
- * Comp. Phys. Comm. 91, 43-56 (1995)
+ * This program is free software; you can redistribute it and/or
+ * 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.
  * 
- * Also check out our WWW page:
- * http://md.chem.rug.nl/~gmx
- * or e-mail to:
- * gromacs@chem.rug.nl
+ * 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.
+ * 
+ * Do check out http://www.gromacs.org , or mail us at gromacs@gromacs.org .
  * 
  * And Hey:
- * Green Red Orange Magenta Azure Cyan Skyblue
+ * GRoups of Organic Molecules in ACtion for Science
  */
 
 #ifndef _reorder_h
 #define _reorder_h
 
 static char *SRCID_reorder_h = "$Id$";
-
 #ifdef HAVE_CONFIG_H
 #include <config.h>
 #endif