Sort all includes in src/gromacs
[alexxy/gromacs.git] / src / gromacs / gmxlib / copyrite.cpp
1 /*
2  * This file is part of the GROMACS molecular simulation package.
3  *
4  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
5  * Copyright (c) 2001-2004, The GROMACS development team.
6  * Copyright (c) 2013,2014, by the GROMACS development team, led by
7  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
8  * and including many others, as listed in the AUTHORS file in the
9  * top-level source directory and at http://www.gromacs.org.
10  *
11  * GROMACS is free software; you can redistribute it and/or
12  * modify it under the terms of the GNU Lesser General Public License
13  * as published by the Free Software Foundation; either version 2.1
14  * of the License, or (at your option) any later version.
15  *
16  * GROMACS is distributed in the hope that it will be useful,
17  * but WITHOUT ANY WARRANTY; without even the implied warranty of
18  * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the GNU
19  * Lesser General Public License for more details.
20  *
21  * You should have received a copy of the GNU Lesser General Public
22  * License along with GROMACS; if not, see
23  * http://www.gnu.org/licenses, or write to the Free Software Foundation,
24  * Inc., 51 Franklin Street, Fifth Floor, Boston, MA  02110-1301  USA.
25  *
26  * If you want to redistribute modifications to GROMACS, please
27  * consider that scientific software is very special. Version
28  * control is crucial - bugs must be traceable. We will be happy to
29  * consider code for inclusion in the official distribution, but
30  * derived work must not be called official GROMACS. Details are found
31  * in the README & COPYING files - if they are missing, get the
32  * official version at http://www.gromacs.org.
33  *
34  * To help us fund GROMACS development, we humbly ask that you cite
35  * the research papers on the package. Check out http://www.gromacs.org.
36  */
37 #include "gmxpre.h"
38
39 #include "gromacs/legacyheaders/copyrite.h"
40
41 #include "config.h"
42
43 #include <stdio.h>
44 #include <stdlib.h>
45 #include <string.h>
46 #include <time.h>
47
48 #ifdef HAVE_LIBMKL
49 #include <mkl.h>
50 #endif
51 #ifdef HAVE_EXTRAE
52 #include <extrae_user_events.h>
53 #endif
54 #include <boost/version.hpp>
55
56 /* This file is completely threadsafe - keep it that way! */
57
58 #include "buildinfo.h"
59 #include "gromacs/fft/fft.h"
60 #include "gromacs/fileio/strdb.h"
61 #include "gromacs/legacyheaders/macros.h"
62 #include "gromacs/math/vec.h"
63 #include "gromacs/random/random.h"
64 #include "gromacs/utility/baseversion.h"
65 #include "gromacs/utility/cstringutil.h"
66 #include "gromacs/utility/exceptions.h"
67 #include "gromacs/utility/futil.h"
68 #include "gromacs/utility/gmxassert.h"
69 #include "gromacs/utility/programcontext.h"
70 #include "gromacs/utility/smalloc.h"
71
72 static gmx_bool be_cool(void)
73 {
74     /* Yes, it is bad to check the environment variable every call,
75      * but we dont call this routine often, and it avoids using
76      * a mutex for locking the variable...
77      */
78 #ifdef GMX_COOL_QUOTES
79     return (getenv("GMX_NO_QUOTES") == NULL);
80 #else
81     /*be uncool*/
82     return FALSE;
83 #endif
84 }
85
86 static void pukeit(const char *db, const char *defstring, char *retstring,
87                    int retsize, int *cqnum)
88 {
89     FILE     *fp;
90     char    **help;
91     int       i, nhlp;
92     gmx_rng_t rng;
93
94     if (be_cool() && ((fp = low_libopen(db, FALSE)) != NULL))
95     {
96         nhlp = fget_lines(fp, &help);
97         /* for libraries we can use the low-level close routines */
98         gmx_ffclose(fp);
99         rng    = gmx_rng_init(gmx_rng_make_seed());
100         *cqnum = static_cast<int>(nhlp*gmx_rng_uniform_real(rng));
101         gmx_rng_destroy(rng);
102         if (strlen(help[*cqnum]) >= STRLEN)
103         {
104             help[*cqnum][STRLEN-1] = '\0';
105         }
106         strncpy(retstring, help[*cqnum], retsize);
107         for (i = 0; (i < nhlp); i++)
108         {
109             sfree(help[i]);
110         }
111         sfree(help);
112     }
113     else
114     {
115         *cqnum = -1;
116         strncpy(retstring, defstring, retsize);
117     }
118 }
119
120 void bromacs(char *retstring, int retsize)
121 {
122     int dum;
123
124     pukeit("bromacs.dat",
125            "Groningen Machine for Chemical Simulation",
126            retstring, retsize, &dum);
127 }
128
129 void cool_quote(char *retstring, int retsize, int *cqnum)
130 {
131     char *tmpstr;
132     char *ptr;
133     int   tmpcq, *p;
134
135     if (cqnum != NULL)
136     {
137         p = cqnum;
138     }
139     else
140     {
141         p = &tmpcq;
142     }
143
144     /* protect audience from explicit lyrics */
145     snew(tmpstr, retsize+1);
146     pukeit("gurgle.dat", "Thanx for Using GROMACS - Have a Nice Day",
147            tmpstr, retsize-2, p);
148
149     if ((ptr = strchr(tmpstr, '_')) != NULL)
150     {
151         *ptr = '\0';
152         ptr++;
153         sprintf(retstring, "\"%s\" %s", tmpstr, ptr);
154     }
155     else
156     {
157         strcpy(retstring, tmpstr);
158     }
159     sfree(tmpstr);
160 }
161
162 static void printCopyright(FILE *fp)
163 {
164     static const char * const Contributors[] = {
165         "Emile Apol",
166         "Rossen Apostolov",
167         "Herman J.C. Berendsen",
168         "Par Bjelkmar",
169         "Aldert van Buuren",
170         "Rudi van Drunen",
171         "Anton Feenstra",
172         "Sebastian Fritsch",
173         "Gerrit Groenhof",
174         "Christoph Junghans",
175         "Peter Kasson",
176         "Carsten Kutzner",
177         "Per Larsson",
178         "Justin A. Lemkul",
179         "Magnus Lundborg",
180         "Pieter Meulenhoff",
181         "Erik Marklund",
182         "Teemu Murtola",
183         "Szilard Pall",
184         "Sander Pronk",
185         "Roland Schulz",
186         "Alexey Shvetsov",
187         "Michael Shirts",
188         "Alfons Sijbers",
189         "Peter Tieleman",
190         "Christian Wennberg",
191         "Maarten Wolf"
192     };
193     static const char * const CopyrightText[] = {
194         "Copyright (c) 1991-2000, University of Groningen, The Netherlands.",
195         "Copyright (c) 2001-2014, The GROMACS development team at",
196         "Uppsala University, Stockholm University and",
197         "the Royal Institute of Technology, Sweden.",
198         "check out http://www.gromacs.org for more information."
199     };
200     static const char * const LicenseText[] = {
201         "GROMACS is free software; you can redistribute it and/or modify it",
202         "under the terms of the GNU Lesser General Public License",
203         "as published by the Free Software Foundation; either version 2.1",
204         "of the License, or (at your option) any later version."
205     };
206
207 #define NCONTRIBUTORS (int)asize(Contributors)
208 #define NCR (int)asize(CopyrightText)
209
210 // FAH has an exception permission from LGPL to allow digital signatures in Gromacs.
211 #ifdef GMX_FAHCORE
212 #define NLICENSE 0
213 #else
214 #define NLICENSE (int)asize(LicenseText)
215 #endif
216
217     fprintf(fp, "GROMACS is written by:\n");
218     for (int i = 0; i < NCONTRIBUTORS; )
219     {
220         for (int j = 0; j < 4 && i < NCONTRIBUTORS; ++j, ++i)
221         {
222             fprintf(fp, "%-18s ", Contributors[i]);
223         }
224         fprintf(fp, "\n");
225     }
226     fprintf(fp, "and the project leaders:\n");
227     fprintf(fp, "Mark Abraham, Berk Hess, Erik Lindahl, and David van der Spoel\n");
228     fprintf(fp, "\n");
229     for (int i = 0; i < NCR; ++i)
230     {
231         fprintf(fp, "%s\n", CopyrightText[i]);
232     }
233     fprintf(fp, "\n");
234     for (int i = 0; i < NLICENSE; ++i)
235     {
236         fprintf(fp, "%s\n", LicenseText[i]);
237     }
238 }
239
240
241 void gmx_thanx(FILE *fp)
242 {
243     char cq[1024];
244     int  cqnum = -1;
245
246     /* protect the audience from suggestive discussions */
247     cool_quote(cq, 1023, &cqnum);
248
249     if (cqnum >= 0)
250     {
251         fprintf(fp, "\ngcq#%d: %s\n\n", cqnum, cq);
252     }
253     else
254     {
255         fprintf(fp, "\n%s\n\n", cq);
256     }
257 }
258
259 typedef struct {
260     const char *key;
261     const char *author;
262     const char *title;
263     const char *journal;
264     int         volume, year;
265     const char *pages;
266 } t_citerec;
267
268 void please_cite(FILE *fp, const char *key)
269 {
270     static const t_citerec citedb[] = {
271         { "Allen1987a",
272           "M. P. Allen and D. J. Tildesley",
273           "Computer simulation of liquids",
274           "Oxford Science Publications",
275           1, 1987, "1" },
276         { "Berendsen95a",
277           "H. J. C. Berendsen, D. van der Spoel and R. van Drunen",
278           "GROMACS: A message-passing parallel molecular dynamics implementation",
279           "Comp. Phys. Comm.",
280           91, 1995, "43-56" },
281         { "Berendsen84a",
282           "H. J. C. Berendsen, J. P. M. Postma, A. DiNola and J. R. Haak",
283           "Molecular dynamics with coupling to an external bath",
284           "J. Chem. Phys.",
285           81, 1984, "3684-3690" },
286         { "Ryckaert77a",
287           "J. P. Ryckaert and G. Ciccotti and H. J. C. Berendsen",
288           "Numerical Integration of the Cartesian Equations of Motion of a System with Constraints; Molecular Dynamics of n-Alkanes",
289           "J. Comp. Phys.",
290           23, 1977, "327-341" },
291         { "Miyamoto92a",
292           "S. Miyamoto and P. A. Kollman",
293           "SETTLE: An Analytical Version of the SHAKE and RATTLE Algorithms for Rigid Water Models",
294           "J. Comp. Chem.",
295           13, 1992, "952-962" },
296         { "Cromer1968a",
297           "D. T. Cromer & J. B. Mann",
298           "X-ray scattering factors computed from numerical Hartree-Fock wave functions",
299           "Acta Cryst. A",
300           24, 1968, "321" },
301         { "Barth95a",
302           "E. Barth and K. Kuczera and B. Leimkuhler and R. D. Skeel",
303           "Algorithms for Constrained Molecular Dynamics",
304           "J. Comp. Chem.",
305           16, 1995, "1192-1209" },
306         { "Essmann95a",
307           "U. Essmann, L. Perera, M. L. Berkowitz, T. Darden, H. Lee and L. G. Pedersen ",
308           "A smooth particle mesh Ewald method",
309           "J. Chem. Phys.",
310           103, 1995, "8577-8592" },
311         { "Torda89a",
312           "A. E. Torda and R. M. Scheek and W. F. van Gunsteren",
313           "Time-dependent distance restraints in molecular dynamics simulations",
314           "Chem. Phys. Lett.",
315           157, 1989, "289-294" },
316         { "Tironi95a",
317           "I. G. Tironi and R. Sperb and P. E. Smith and W. F. van Gunsteren",
318           "Generalized reaction field method for molecular dynamics simulations",
319           "J. Chem. Phys",
320           102, 1995, "5451-5459" },
321         { "Hess97a",
322           "B. Hess and H. Bekker and H. J. C. Berendsen and J. G. E. M. Fraaije",
323           "LINCS: A Linear Constraint Solver for molecular simulations",
324           "J. Comp. Chem.",
325           18, 1997, "1463-1472" },
326         { "Hess2008a",
327           "B. Hess",
328           "P-LINCS: A Parallel Linear Constraint Solver for molecular simulation",
329           "J. Chem. Theory Comput.",
330           4, 2008, "116-122" },
331         { "Hess2008b",
332           "B. Hess and C. Kutzner and D. van der Spoel and E. Lindahl",
333           "GROMACS 4: Algorithms for highly efficient, load-balanced, and scalable molecular simulation",
334           "J. Chem. Theory Comput.",
335           4, 2008, "435-447" },
336         { "Hub2010",
337           "J. S. Hub, B. L. de Groot and D. van der Spoel",
338           "g_wham - A free weighted histogram analysis implementation including robust error and autocorrelation estimates",
339           "J. Chem. Theory Comput.",
340           6, 2010, "3713-3720"},
341         { "In-Chul99a",
342           "Y. In-Chul and M. L. Berkowitz",
343           "Ewald summation for systems with slab geometry",
344           "J. Chem. Phys.",
345           111, 1999, "3155-3162" },
346         { "DeGroot97a",
347           "B. L. de Groot and D. M. F. van Aalten and R. M. Scheek and A. Amadei and G. Vriend and H. J. C. Berendsen",
348           "Prediction of Protein Conformational Freedom From Distance Constrains",
349           "Proteins",
350           29, 1997, "240-251" },
351         { "Spoel98a",
352           "D. van der Spoel and P. J. van Maaren and H. J. C. Berendsen",
353           "A systematic study of water models for molecular simulation. Derivation of models optimized for use with a reaction-field.",
354           "J. Chem. Phys.",
355           108, 1998, "10220-10230" },
356         { "Wishart98a",
357           "D. S. Wishart and A. M. Nip",
358           "Protein Chemical Shift Analysis: A Practical Guide",
359           "Biochem. Cell Biol.",
360           76, 1998, "153-163" },
361         { "Maiorov95",
362           "V. N. Maiorov and G. M. Crippen",
363           "Size-Independent Comparison of Protein Three-Dimensional Structures",
364           "PROTEINS: Struct. Funct. Gen.",
365           22, 1995, "273-283" },
366         { "Feenstra99",
367           "K. A. Feenstra and B. Hess and H. J. C. Berendsen",
368           "Improving Efficiency of Large Time-scale Molecular Dynamics Simulations of Hydrogen-rich Systems",
369           "J. Comput. Chem.",
370           20, 1999, "786-798" },
371         { "Lourenco2013a",
372           "Tuanan C. Lourenco and Mariny F. C. Coelho and Teodorico C. Ramalho and David van der Spoel and Luciano T. Costa",
373           "Insights on the Solubility of CO2 in 1-Ethyl-3-methylimidazolium Bis(trifluoromethylsulfonyl)imide from the Microscopic Point of View",
374           "Environ. Sci. Technol.",
375           47, 2013, "7421-7429" },
376         { "Timneanu2004a",
377           "N. Timneanu and C. Caleman and J. Hajdu and D. van der Spoel",
378           "Auger Electron Cascades in Water and Ice",
379           "Chem. Phys.",
380           299, 2004, "277-283" },
381         { "Pascal2011a",
382           "T. A. Pascal and S. T. Lin and W. A. Goddard III",
383           "Thermodynamics of liquids: standard molar entropies and heat capacities of common solvents from 2PT molecular dynamics",
384           "Phys. Chem. Chem. Phys.",
385           13, 2011, "169-181" },
386         { "Caleman2011b",
387           "C. Caleman and P. J. van Maaren and M. Hong and J. S. Hub and L. T. da Costa and D. van der Spoel",
388           "Force Field Benchmark of Organic Liquids: Density, Enthalpy of Vaporization, Heat Capacities, Surface Tension, Isothermal Compressibility, Volumetric Expansion Coefficient, and Dielectric Constant",
389           "J. Chem. Theo. Comp.",
390           8, 2012, "61" },
391         { "Lindahl2001a",
392           "E. Lindahl and B. Hess and D. van der Spoel",
393           "GROMACS 3.0: A package for molecular simulation and trajectory analysis",
394           "J. Mol. Mod.",
395           7, 2001, "306-317" },
396         { "Wang2001a",
397           "J. Wang and W. Wang and S. Huo and M. Lee and P. A. Kollman",
398           "Solvation model based on weighted solvent accessible surface area",
399           "J. Phys. Chem. B",
400           105, 2001, "5055-5067" },
401         { "Eisenberg86a",
402           "D. Eisenberg and A. D. McLachlan",
403           "Solvation energy in protein folding and binding",
404           "Nature",
405           319, 1986, "199-203" },
406         { "Bondi1964a",
407           "A. Bondi",
408           "van der Waals Volumes and Radii",
409           "J. Phys. Chem.",
410           68, 1964, "441-451" },
411         { "Eisenhaber95",
412           "Frank Eisenhaber and Philip Lijnzaad and Patrick Argos and Chris Sander and Michael Scharf",
413           "The Double Cube Lattice Method: Efficient Approaches to Numerical Integration of Surface Area and Volume and to Dot Surface Contouring of Molecular Assemblies",
414           "J. Comp. Chem.",
415           16, 1995, "273-284" },
416         { "Hess2002",
417           "B. Hess, H. Saint-Martin and H.J.C. Berendsen",
418           "Flexible constraints: an adiabatic treatment of quantum degrees of freedom, with application to the flexible and polarizable MCDHO model for water",
419           "J. Chem. Phys.",
420           116, 2002, "9602-9610" },
421         { "Hetenyi2002b",
422           "Csaba Hetenyi and David van der Spoel",
423           "Efficient docking of peptides to proteins without prior knowledge of the binding site.",
424           "Prot. Sci.",
425           11, 2002, "1729-1737" },
426         { "Hess2003",
427           "B. Hess and R.M. Scheek",
428           "Orientation restraints in molecular dynamics simulations using time and ensemble averaging",
429           "J. Magn. Res.",
430           164, 2003, "19-27" },
431         { "Rappe1991a",
432           "A. K. Rappe and W. A. Goddard III",
433           "Charge Equillibration for Molecular Dynamics Simulations",
434           "J. Phys. Chem.",
435           95, 1991, "3358-3363" },
436         { "Mu2005a",
437           "Y. Mu, P. H. Nguyen and G. Stock",
438           "Energy landscape of a small peptide revelaed by dihedral angle principal component analysis",
439           "Prot. Struct. Funct. Bioinf.",
440           58, 2005, "45-52" },
441         { "Okabe2001a",
442           "T. Okabe and M. Kawata and Y. Okamoto and M. Mikami",
443           "Replica-exchange {M}onte {C}arlo method for the isobaric-isothermal ensemble",
444           "Chem. Phys. Lett.",
445           335, 2001, "435-439" },
446         { "Hukushima96a",
447           "K. Hukushima and K. Nemoto",
448           "Exchange Monte Carlo Method and Application to Spin Glass Simulations",
449           "J. Phys. Soc. Jpn.",
450           65, 1996, "1604-1608" },
451         { "Tropp80a",
452           "J. Tropp",
453           "Dipolar Relaxation and Nuclear Overhauser effects in nonrigid molecules: The effect of fluctuating internuclear distances",
454           "J. Chem. Phys.",
455           72, 1980, "6035-6043" },
456         { "Bultinck2002a",
457           "P. Bultinck and W. Langenaeker and P. Lahorte and F. De Proft and P. Geerlings and M. Waroquier and J. P. Tollenaere",
458           "The electronegativity equalization method I: Parametrization and validation for atomic charge calculations",
459           "J. Phys. Chem. A",
460           106, 2002, "7887-7894" },
461         { "Yang2006b",
462           "Q. Y. Yang and K. A. Sharp",
463           "Atomic charge parameters for the finite difference Poisson-Boltzmann method using electronegativity neutralization",
464           "J. Chem. Theory Comput.",
465           2, 2006, "1152-1167" },
466         { "Spoel2005a",
467           "D. van der Spoel, E. Lindahl, B. Hess, G. Groenhof, A. E. Mark and H. J. C. Berendsen",
468           "GROMACS: Fast, Flexible and Free",
469           "J. Comp. Chem.",
470           26, 2005, "1701-1719" },
471         { "Spoel2006b",
472           "D. van der Spoel, P. J. van Maaren, P. Larsson and N. Timneanu",
473           "Thermodynamics of hydrogen bonding in hydrophilic and hydrophobic media",
474           "J. Phys. Chem. B",
475           110, 2006, "4393-4398" },
476         { "Spoel2006d",
477           "D. van der Spoel and M. M. Seibert",
478           "Protein folding kinetics and thermodynamics from atomistic simulations",
479           "Phys. Rev. Letters",
480           96, 2006, "238102" },
481         { "Palmer94a",
482           "B. J. Palmer",
483           "Transverse-current autocorrelation-function calculations of the shear viscosity for molecular liquids",
484           "Phys. Rev. E",
485           49, 1994, "359-366" },
486         { "Bussi2007a",
487           "G. Bussi, D. Donadio and M. Parrinello",
488           "Canonical sampling through velocity rescaling",
489           "J. Chem. Phys.",
490           126, 2007, "014101" },
491         { "Hub2006",
492           "J. S. Hub and B. L. de Groot",
493           "Does CO2 permeate through Aquaporin-1?",
494           "Biophys. J.",
495           91, 2006, "842-848" },
496         { "Hub2008",
497           "J. S. Hub and B. L. de Groot",
498           "Mechanism of selectivity in aquaporins and aquaglyceroporins",
499           "PNAS",
500           105, 2008, "1198-1203" },
501         { "Friedrich2009",
502           "M. S. Friedrichs, P. Eastman, V. Vaidyanathan, M. Houston, S. LeGrand, A. L. Beberg, D. L. Ensign, C. M. Bruns, and V. S. Pande",
503           "Accelerating Molecular Dynamic Simulation on Graphics Processing Units",
504           "J. Comp. Chem.",
505           30, 2009, "864-872" },
506         { "Engin2010",
507           "O. Engin, A. Villa, M. Sayar and B. Hess",
508           "Driving Forces for Adsorption of Amphiphilic Peptides to Air-Water Interface",
509           "J. Phys. Chem. B",
510           114, 2010, "11093" },
511         { "Fritsch12",
512           "S. Fritsch, C. Junghans and K. Kremer",
513           "Adaptive molecular simulation study on structure formation of toluene around C60 using Gromacs",
514           "J. Chem. Theo. Comp.",
515           8, 2012, "398" },
516         { "Junghans10",
517           "C. Junghans and S. Poblete",
518           "A reference implementation of the adaptive resolution scheme in ESPResSo",
519           "Comp. Phys. Comm.",
520           181, 2010, "1449" },
521         { "Wang2010",
522           "H. Wang, F. Dommert, C.Holm",
523           "Optimizing working parameters of the smooth particle mesh Ewald algorithm in terms of accuracy and efficiency",
524           "J. Chem. Phys. B",
525           133, 2010, "034117" },
526         { "Sugita1999a",
527           "Y. Sugita, Y. Okamoto",
528           "Replica-exchange molecular dynamics method for protein folding",
529           "Chem. Phys. Lett.",
530           314, 1999, "141-151" },
531         { "Kutzner2011",
532           "C. Kutzner and J. Czub and H. Grubmuller",
533           "Keep it Flexible: Driving Macromolecular Rotary Motions in Atomistic Simulations with GROMACS",
534           "J. Chem. Theory Comput.",
535           7, 2011, "1381-1393" },
536         { "Hoefling2011",
537           "M. Hoefling, N. Lima, D. Haenni, C.A.M. Seidel, B. Schuler, H. Grubmuller",
538           "Structural Heterogeneity and Quantitative FRET Efficiency Distributions of Polyprolines through a Hybrid Atomistic Simulation and Monte Carlo Approach",
539           "PLoS ONE",
540           6, 2011, "e19791" },
541         { "Hockney1988",
542           "R. W. Hockney and J. W. Eastwood",
543           "Computer simulation using particles",
544           "IOP, Bristol",
545           1, 1988, "1" },
546         { "Ballenegger2012",
547           "V. Ballenegger, J.J. Cerda, and C. Holm",
548           "How to Convert SPME to P3M: Influence Functions and Error Estimates",
549           "J. Chem. Theory Comput.",
550           8, 2012, "936-947" },
551         { "Garmay2012",
552           "Garmay Yu, Shvetsov A, Karelov D, Lebedev D, Radulescu A, Petukhov M, Isaev-Ivanov V",
553           "Correlated motion of protein subdomains and large-scale conformational flexibility of RecA protein filament",
554           "Journal of Physics: Conference Series",
555           340, 2012, "012094" },
556         { "Kutzner2011b",
557           "C. Kutzner, H. Grubmuller, B. L. de Groot, and U. Zachariae",
558           "Computational Electrophysiology: The Molecular Dynamics of Ion Channel Permeation and Selectivity in Atomistic Detail",
559           "Biophys. J.",
560           101, 2011, "809-817"},
561         { "Lundborg2014",
562           "M. Lundborg, R. Apostolov, D. Spangberg, A. Gardenas, D. van der Spoel and E. Lindahl",
563           "An efficient and extensible format, library, and API for binary trajectory data from molecular simulations",
564           "J. Comput. Chem.",
565           35, 2014, "260-269"},
566         { "Goga2012",
567           "N. Goga and A. J. Rzepiela and A. H. de Vries and S. J. Marrink and H. J. C. Berendsen",
568           "Efficient Algorithms for Langevin and DPD Dynamics",
569           "J. Chem. Theory Comput.",
570           8, 2012, "3637--3649"}
571     };
572 #define NSTR (int)asize(citedb)
573
574     int   index;
575     char *author;
576     char *title;
577 #define LINE_WIDTH 79
578
579     if (fp == NULL)
580     {
581         return;
582     }
583
584     for (index = 0; (index < NSTR) && (strcmp(citedb[index].key, key) != 0); index++)
585     {
586         ;
587     }
588
589     fprintf(fp, "\n++++ PLEASE READ AND CITE THE FOLLOWING REFERENCE ++++\n");
590     if (index < NSTR)
591     {
592         /* Insert newlines */
593         author = wrap_lines(citedb[index].author, LINE_WIDTH, 0, FALSE);
594         title  = wrap_lines(citedb[index].title, LINE_WIDTH, 0, FALSE);
595         fprintf(fp, "%s\n%s\n%s %d (%d) pp. %s\n",
596                 author, title, citedb[index].journal,
597                 citedb[index].volume, citedb[index].year,
598                 citedb[index].pages);
599         sfree(author);
600         sfree(title);
601     }
602     else
603     {
604         fprintf(fp, "Entry %s not found in citation database\n", key);
605     }
606     fprintf(fp, "-------- -------- --- Thank You --- -------- --------\n\n");
607     fflush(fp);
608 }
609
610 const char *GromacsVersion()
611 {
612     return gmx_version();
613 }
614
615 const char *ShortProgram(void)
616 {
617     const char *programName = NULL;
618
619     try
620     {
621         // TODO: Use the display name once it doesn't break anything.
622         programName = gmx::getProgramContext().programName();
623     }
624     GMX_CATCH_ALL_AND_EXIT_WITH_FATAL_ERROR;
625
626     return programName;
627 }
628
629 const char *Program(void)
630 {
631     try
632     {
633         return gmx::getProgramContext().fullBinaryPath();
634     }
635     GMX_CATCH_ALL_AND_EXIT_WITH_FATAL_ERROR;
636 }
637
638
639 extern void gmx_print_version_info_gpu(FILE *fp);
640
641 static void gmx_print_version_info(FILE *fp)
642 {
643     fprintf(fp, "Gromacs version:    %s\n", gmx_version());
644     const char *const git_hash = gmx_version_git_full_hash();
645     if (git_hash[0] != '\0')
646     {
647         fprintf(fp, "GIT SHA1 hash:      %s\n", git_hash);
648     }
649     const char *const base_hash = gmx_version_git_central_base_hash();
650     if (base_hash[0] != '\0')
651     {
652         fprintf(fp, "Branched from:      %s\n", base_hash);
653     }
654
655 #ifdef GMX_DOUBLE
656     fprintf(fp, "Precision:          double\n");
657 #else
658     fprintf(fp, "Precision:          single\n");
659 #endif
660     fprintf(fp, "Memory model:       %u bit\n", (unsigned)(8*sizeof(void *)));
661
662 #ifdef GMX_THREAD_MPI
663     fprintf(fp, "MPI library:        thread_mpi\n");
664 #elif defined(GMX_MPI)
665     fprintf(fp, "MPI library:        MPI\n");
666 #else
667     fprintf(fp, "MPI library:        none\n");
668 #endif
669 #ifdef GMX_OPENMP
670     fprintf(fp, "OpenMP support:     enabled\n");
671 #else
672     fprintf(fp, "OpenMP support:     disabled\n");
673 #endif
674 #ifdef GMX_GPU
675     fprintf(fp, "GPU support:        enabled\n");
676 #else
677     fprintf(fp, "GPU support:        disabled\n");
678 #endif
679     /* A preprocessor trick to avoid duplicating logic from vec.h */
680 #define gmx_stringify2(x) #x
681 #define gmx_stringify(x) gmx_stringify2(x)
682     fprintf(fp, "invsqrt routine:    %s\n", gmx_stringify(gmx_invsqrt(x)));
683 #ifndef __MIC__
684     fprintf(fp, "SIMD instructions:  %s\n", GMX_SIMD_STRING);
685 #else
686     fprintf(fp, "SIMD instructions:  %s\n", "Intel MIC");
687 #endif
688
689     fprintf(fp, "FFT library:        %s\n", gmx_fft_get_version_info());
690 #ifdef HAVE_RDTSCP
691     fprintf(fp, "RDTSCP usage:       enabled\n");
692 #else
693     fprintf(fp, "RDTSCP usage:       disabled\n");
694 #endif
695 #ifdef GMX_CXX11
696     fprintf(fp, "C++11 compilation:  enabled\n");
697 #else
698     fprintf(fp, "C++11 compilation:  disabled\n");
699 #endif
700 #ifdef GMX_USE_TNG
701     fprintf(fp, "TNG support:        enabled\n");
702 #else
703     fprintf(fp, "TNG support:        disabled\n");
704 #endif
705 #ifdef HAVE_EXTRAE
706     unsigned major, minor, revision;
707     Extrae_get_version(&major, &minor, &revision);
708     fprintf(fp, "Tracing support:    enabled. Using Extrae-%d.%d.%d\n", major, minor, revision);
709 #else
710     fprintf(fp, "Tracing support:    disabled\n");
711 #endif
712
713
714     fprintf(fp, "Built on:           %s\n", BUILD_TIME);
715     fprintf(fp, "Built by:           %s\n", BUILD_USER);
716     fprintf(fp, "Build OS/arch:      %s\n", BUILD_HOST);
717     fprintf(fp, "Build CPU vendor:   %s\n", BUILD_CPU_VENDOR);
718     fprintf(fp, "Build CPU brand:    %s\n", BUILD_CPU_BRAND);
719     fprintf(fp, "Build CPU family:   %d   Model: %d   Stepping: %d\n",
720             BUILD_CPU_FAMILY, BUILD_CPU_MODEL, BUILD_CPU_STEPPING);
721     /* TODO: The below strings can be quite long, so it would be nice to wrap
722      * them. Can wait for later, as the master branch has ready code to do all
723      * that. */
724     fprintf(fp, "Build CPU features: %s\n", BUILD_CPU_FEATURES);
725     fprintf(fp, "C compiler:         %s\n", BUILD_C_COMPILER);
726     fprintf(fp, "C compiler flags:   %s\n", BUILD_CFLAGS);
727     fprintf(fp, "C++ compiler:       %s\n", BUILD_CXX_COMPILER);
728     fprintf(fp, "C++ compiler flags: %s\n", BUILD_CXXFLAGS);
729 #ifdef HAVE_LIBMKL
730     /* MKL might be used for LAPACK/BLAS even if FFTs use FFTW, so keep it separate */
731     fprintf(fp, "Linked with Intel MKL version %d.%d.%d.\n",
732             __INTEL_MKL__, __INTEL_MKL_MINOR__, __INTEL_MKL_UPDATE__);
733 #endif
734 #ifdef GMX_EXTERNAL_BOOST
735     const bool bExternalBoost = true;
736 #else
737     const bool bExternalBoost = false;
738 #endif
739     fprintf(fp, "Boost version:      %d.%d.%d%s\n", BOOST_VERSION / 100000,
740             BOOST_VERSION / 100 % 1000, BOOST_VERSION % 100,
741             bExternalBoost ? " (external)" : " (internal)");
742 #ifdef GMX_GPU
743     gmx_print_version_info_gpu(fp);
744 #endif
745 }
746
747 #ifdef GMX_DOUBLE
748 void gmx_is_double_precision()
749 {
750     /* allow precision detection */
751 }
752 #else
753 void gmx_is_single_precision()
754 {
755     /* allow precision detection */
756 }
757 #endif
758
759 namespace gmx
760 {
761
762 BinaryInformationSettings::BinaryInformationSettings()
763     : bExtendedInfo_(false), bCopyright_(false),
764       bGeneratedByHeader_(false), prefix_(""), suffix_("")
765 {
766 }
767
768 void printBinaryInformation(FILE                          *fp,
769                             const ProgramContextInterface &programContext)
770 {
771     printBinaryInformation(fp, programContext, BinaryInformationSettings());
772 }
773
774 void printBinaryInformation(FILE                            *fp,
775                             const ProgramContextInterface   &programContext,
776                             const BinaryInformationSettings &settings)
777 {
778     const char *prefix          = settings.prefix_;
779     const char *suffix          = settings.suffix_;
780     const char *precisionString = "";
781 #ifdef GMX_DOUBLE
782     precisionString = " (double precision)";
783 #endif
784     const char *const name = programContext.displayName();
785     if (settings.bGeneratedByHeader_)
786     {
787         fprintf(fp, "%sCreated by:%s\n", prefix, suffix);
788     }
789     if (settings.bCopyright_)
790     {
791         GMX_RELEASE_ASSERT(prefix[0] == '\0' && suffix[0] == '\0',
792                            "Prefix/suffix not supported with copyright");
793         // This line is printed again after the copyright notice to make it
794         // appear together with all the other information, so that it is not
795         // necessary to read stuff above the copyright notice.
796         // The line above the copyright notice puts the copyright notice is
797         // context, though.
798         // TODO: It would be nice to know here whether we are really running a
799         // Gromacs binary or some other binary that is calling Gromacs; we
800         // could then print "%s is part of GROMACS" or some alternative text.
801         fprintf(fp, "%sGROMACS:    %s, %s%s%s\n", prefix, name,
802                 gmx_version(), precisionString, suffix);
803         fprintf(fp, "\n");
804         printCopyright(fp);
805         fprintf(fp, "\n");
806     }
807     fprintf(fp, "%sGROMACS:      %s, %s%s%s\n", prefix, name,
808             gmx_version(), precisionString, suffix);
809     const char *const binaryPath = programContext.fullBinaryPath();
810     if (binaryPath != NULL && binaryPath[0] != '\0')
811     {
812         fprintf(fp, "%sExecutable:   %s%s\n", prefix, binaryPath, suffix);
813     }
814     const char *const libraryPath = programContext.defaultLibraryDataPath();
815     if (libraryPath != NULL && libraryPath[0] != '\0')
816     {
817         fprintf(fp, "%sLibrary dir:  %s%s\n", prefix, libraryPath, suffix);
818     }
819     const char *const commandLine = programContext.commandLine();
820     if (commandLine != NULL && commandLine[0] != '\0')
821     {
822         fprintf(fp, "%sCommand line:%s\n%s  %s%s\n",
823                 prefix, suffix, prefix, commandLine, suffix);
824     }
825     if (settings.bExtendedInfo_)
826     {
827         GMX_RELEASE_ASSERT(prefix[0] == '\0' && suffix[0] == '\0',
828                            "Prefix/suffix not supported with extended info");
829         fprintf(fp, "\n");
830         gmx_print_version_info(fp);
831     }
832 }
833
834 } // namespace gmx