New tool that extracts dye dynamics from trajectories
[alexxy/gromacs.git] / src / gmxlib / copyrite.c
1 /*
2  * 
3  *                This source code is part of
4  * 
5  *                 G   R   O   M   A   C   S
6  * 
7  *          GROningen MAchine for Chemical Simulations
8  * 
9  *                        VERSION 3.2.0
10  * Written by David van der Spoel, Erik Lindahl, Berk Hess, and others.
11  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
12  * Copyright (c) 2001-2004, The GROMACS development team,
13  * check out http://www.gromacs.org for more information.
14
15  * This program is free software; you can redistribute it and/or
16  * modify it under the terms of the GNU General Public License
17  * as published by the Free Software Foundation; either version 2
18  * of the License, or (at your option) any later version.
19  * 
20  * If you want to redistribute modifications, please consider that
21  * scientific software is very special. Version control is crucial -
22  * bugs must be traceable. We will be happy to consider code for
23  * inclusion in the official distribution, but derived work must not
24  * be called official GROMACS. Details are found in the README & COPYING
25  * files - if they are missing, get the official version at www.gromacs.org.
26  * 
27  * To help us fund GROMACS development, we humbly ask that you cite
28  * the papers on the package - you can find them in the top README file.
29  * 
30  * For more info, check our website at http://www.gromacs.org
31  * 
32  * And Hey:
33  * GROningen Mixture of Alchemy and Childrens' Stories
34  */
35 #ifdef HAVE_CONFIG_H
36 #include <config.h>
37 #endif
38
39 #ifdef GMX_THREADS
40 #include <thread_mpi.h>
41 #endif
42
43 /* This file is completely threadsafe - keep it that way! */
44
45 #include <string.h>
46 #include <ctype.h>
47 #include "sysstuff.h"
48 #include "smalloc.h"
49 #include "string2.h"
50 #include "macros.h"
51 #include "time.h"
52 #include "random.h"
53 #include "statutil.h"
54 #include "copyrite.h"
55 #include "strdb.h"
56 #include "futil.h"
57
58 static void pr_two(FILE *out,int c,int i)
59 {
60   if (i < 10)
61     fprintf(out,"%c0%1d",c,i);
62   else
63     fprintf(out,"%c%2d",c,i);
64 }
65
66 void pr_difftime(FILE *out,double dt)
67 {
68   int    ndays,nhours,nmins,nsecs;
69   gmx_bool   bPrint,bPrinted;
70
71   ndays = dt/(24*3600);
72   dt    = dt-24*3600*ndays;
73   nhours= dt/3600;
74   dt    = dt-3600*nhours;
75   nmins = dt/60;
76   dt    = dt-nmins*60;
77   nsecs = dt;
78   bPrint= (ndays > 0);
79   bPrinted=bPrint;
80   if (bPrint) 
81     fprintf(out,"%d",ndays);
82   bPrint=bPrint || (nhours > 0);
83   if (bPrint) {
84     if (bPrinted)
85       pr_two(out,'d',nhours);
86     else 
87       fprintf(out,"%d",nhours);
88   }
89   bPrinted=bPrinted || bPrint;
90   bPrint=bPrint || (nmins > 0);
91   if (bPrint) {
92     if (bPrinted)
93       pr_two(out,'h',nmins);
94     else 
95       fprintf(out,"%d",nmins);
96   }
97   bPrinted=bPrinted || bPrint;
98   if (bPrinted)
99     pr_two(out,':',nsecs);
100   else
101     fprintf(out,"%ds",nsecs);
102   fprintf(out,"\n");
103 }
104
105
106 gmx_bool be_cool(void)
107 {
108   /* Yes, it is bad to check the environment variable every call,
109    * but we dont call this routine often, and it avoids using 
110    * a mutex for locking the variable...
111    */
112 #ifdef GMX_FAHCORE
113   /*be uncool*/
114   return FALSE;
115 #else
116   return (getenv("GMX_NO_QUOTES") == NULL);
117 #endif
118 }
119
120 void space(FILE *out, int n)
121 {
122   fprintf(out,"%*s",n,"");
123 }
124
125 void f(char *a)
126 {
127     int i;
128     int len=strlen(a);
129     
130     for(i=0;i<len;i++)
131         a[i]=~a[i]; 
132 }
133
134 static void sp_print(FILE *out,const char *s)
135 {
136   int slen;
137   
138   slen=strlen(s);
139   space(out,(80-slen)/2);
140   fprintf(out,"%s\n",s);
141 }
142
143 static void ster_print(FILE *out,const char *s)
144 {
145   int  slen;
146   char buf[128];
147   
148   snprintf(buf,128,":-)  %s  (-:",s);
149   slen=strlen(buf);
150   space(out,(80-slen)/2);
151   fprintf(out,"%s\n",buf);
152 }
153
154
155 static void pukeit(const char *db,const char *defstring, char *retstring, 
156                    int retsize, int *cqnum)
157 {
158   FILE *fp;
159   char **help;
160   int  i,nhlp;
161   int  seed;
162  
163   if (be_cool() && ((fp = low_libopen(db,FALSE)) != NULL)) {
164     nhlp=fget_lines(fp,&help);
165     /* for libraries we can use the low-level close routines */
166     ffclose(fp);
167     seed=time(NULL);
168     *cqnum=nhlp*rando(&seed);
169     if (strlen(help[*cqnum]) >= STRLEN)
170       help[*cqnum][STRLEN-1] = '\0';
171     strncpy(retstring,help[*cqnum],retsize);
172     f(retstring);
173     for(i=0; (i<nhlp); i++)
174       sfree(help[i]);
175     sfree(help);
176   }
177   else 
178     strncpy(retstring,defstring,retsize);
179 }
180
181 void bromacs(char *retstring, int retsize)
182 {
183   int dum;
184
185   pukeit("bromacs.dat",
186          "Groningen Machine for Chemical Simulation",
187          retstring,retsize,&dum);
188 }
189
190 void cool_quote(char *retstring, int retsize, int *cqnum)
191 {
192   char *tmpstr;
193   char *s,*ptr;
194   int tmpcq,*p;
195   
196   if (cqnum!=NULL)
197     p = cqnum;
198   else
199     p = &tmpcq;
200   
201   /* protect audience from explicit lyrics */
202   snew(tmpstr,retsize+1);
203   pukeit("gurgle.dat","Thanx for Using GROMACS - Have a Nice Day",
204          tmpstr,retsize-2,p);
205
206   if ((ptr = strchr(tmpstr,'_')) != NULL) {
207     *ptr='\0';
208     ptr++;
209     sprintf(retstring,"\"%s\" %s",tmpstr,ptr);
210   }
211   else {
212     strcpy(retstring,tmpstr);
213   }
214   sfree(tmpstr);
215 }
216
217 void CopyRight(FILE *out,const char *szProgram)
218 {
219   /* Dont change szProgram arbitrarily - it must be argv[0], i.e. the 
220    * name of a file. Otherwise, we won't be able to find the library dir.
221    */
222 #define NCR (int)asize(CopyrightText)
223 #ifdef GMX_FAHCORE
224 #define NGPL 0 /*FAH has an exception permission from GPL to allow digital signatures in Gromacs*/
225 #else
226 #define NGPL (int)asize(GPLText)
227 #endif
228
229   char buf[256],tmpstr[1024];
230   int i;
231
232 #ifdef GMX_FAHCORE
233   set_program_name("Gromacs");
234 #else
235   set_program_name(szProgram);
236 #endif
237
238   ster_print(out,"G  R  O  M  A  C  S");
239   fprintf(out,"\n");
240   
241   bromacs(tmpstr,1023);
242   sp_print(out,tmpstr); 
243   fprintf(out,"\n");
244
245   ster_print(out,GromacsVersion());
246   fprintf(out,"\n");
247
248   /* fprintf(out,"\n");*/
249
250   /* sp_print(out,"PLEASE NOTE: THIS IS A BETA VERSION\n");
251   
252   fprintf(out,"\n"); */
253
254   for(i=0; (i<NCR); i++) 
255     sp_print(out,CopyrightText[i]);
256   for(i=0; (i<NGPL); i++)
257     sp_print(out,GPLText[i]);
258
259   fprintf(out,"\n");
260
261   snprintf(buf,256,"%s",Program());
262 #ifdef GMX_DOUBLE
263   strcat(buf," (double precision)");
264 #endif
265   ster_print(out,buf);
266   fprintf(out,"\n");
267 }
268
269
270 void thanx(FILE *fp)
271 {
272   char cq[1024];
273   int  cqnum;
274
275   /* protect the audience from suggestive discussions */
276   cool_quote(cq,1023,&cqnum);
277   
278   if (be_cool()) 
279     fprintf(fp,"\ngcq#%d: %s\n\n",cqnum,cq);
280   else
281     fprintf(fp,"\n%s\n\n",cq);
282 }
283
284 typedef struct {
285   const char *key;
286   const char *author;
287   const char *title;
288   const char *journal;
289   int volume,year;
290   const char *pages;
291 } t_citerec;
292
293 void please_cite(FILE *fp,const char *key)
294 {
295   static const t_citerec citedb[] = {
296     { "Allen1987a",
297       "M. P. Allen and D. J. Tildesley",
298       "Computer simulation of liquids",
299       "Oxford Science Publications",
300       1, 1987, "1" },
301     { "Berendsen95a",
302       "H. J. C. Berendsen, D. van der Spoel and R. van Drunen",
303       "GROMACS: A message-passing parallel molecular dynamics implementation",
304       "Comp. Phys. Comm.",
305       91, 1995, "43-56" },
306     { "Berendsen84a",
307       "H. J. C. Berendsen, J. P. M. Postma, A. DiNola and J. R. Haak",
308       "Molecular dynamics with coupling to an external bath",
309       "J. Chem. Phys.",
310       81, 1984, "3684-3690" },
311     { "Ryckaert77a",
312       "J. P. Ryckaert and G. Ciccotti and H. J. C. Berendsen",
313       "Numerical Integration of the Cartesian Equations of Motion of a System with Constraints; Molecular Dynamics of n-Alkanes",
314       "J. Comp. Phys.",
315       23, 1977, "327-341" },
316     { "Miyamoto92a",
317       "S. Miyamoto and P. A. Kollman",
318       "SETTLE: An Analytical Version of the SHAKE and RATTLE Algorithms for Rigid Water Models",
319       "J. Comp. Chem.",
320       13, 1992, "952-962" },
321     { "Cromer1968a",
322       "D. T. Cromer & J. B. Mann",
323       "X-ray scattering factors computed from numerical Hartree-Fock wave functions",
324       "Acta Cryst. A",
325       24, 1968, "321" },
326     { "Barth95a",
327       "E. Barth and K. Kuczera and B. Leimkuhler and R. D. Skeel",
328       "Algorithms for Constrained Molecular Dynamics",
329       "J. Comp. Chem.",
330       16, 1995, "1192-1209" },
331     { "Essmann95a",
332       "U. Essmann, L. Perera, M. L. Berkowitz, T. Darden, H. Lee and L. G. Pedersen ",
333       "A smooth particle mesh Ewald method",
334       "J. Chem. Phys.",
335       103, 1995, "8577-8592" },
336     { "Torda89a",
337       "A. E. Torda and R. M. Scheek and W. F. van Gunsteren",
338       "Time-dependent distance restraints in molecular dynamics simulations",
339       "Chem. Phys. Lett.",
340       157, 1989, "289-294" },
341     { "Tironi95a",
342       "I. G. Tironi and R. Sperb and P. E. Smith and W. F. van Gunsteren",
343       "Generalized reaction field method for molecular dynamics simulations",
344       "J. Chem. Phys",
345       102, 1995, "5451-5459" },
346     { "Hess97a",
347       "B. Hess and H. Bekker and H. J. C. Berendsen and J. G. E. M. Fraaije",
348       "LINCS: A Linear Constraint Solver for molecular simulations",
349       "J. Comp. Chem.",
350       18, 1997, "1463-1472" },
351     { "Hess2008a",
352       "B. Hess",
353       "P-LINCS: A Parallel Linear Constraint Solver for molecular simulation",
354       "J. Chem. Theory Comput.",
355       4, 2008, "116-122" },
356     { "Hess2008b",
357       "B. Hess and C. Kutzner and D. van der Spoel and E. Lindahl",
358       "GROMACS 4: Algorithms for highly efficient, load-balanced, and scalable molecular simulation",
359       "J. Chem. Theory Comput.",
360       4, 2008, "435-447" },
361     { "Hub2010",
362       "J. S. Hub, B. L. de Groot and D. van der Spoel",
363       "g_wham - A free weighted histogram analysis implementation including robust error and autocorrelation estimates",
364       "J. Chem. Theory Comput.",
365       6, 2010, "3713-3720"}, 
366     { "In-Chul99a",
367       "Y. In-Chul and M. L. Berkowitz",
368       "Ewald summation for systems with slab geometry",
369       "J. Chem. Phys.",
370       111, 1999, "3155-3162" },
371     { "DeGroot97a",
372       "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",
373       "Prediction of Protein Conformational Freedom From Distance Constrains",
374       "Proteins",
375       29, 1997, "240-251" },
376     { "Spoel98a",
377       "D. van der Spoel and P. J. van Maaren and H. J. C. Berendsen",
378       "A systematic study of water models for molecular simulation. Derivation of models optimized for use with a reaction-field.",
379       "J. Chem. Phys.",
380       108, 1998, "10220-10230" },
381     { "Wishart98a",
382       "D. S. Wishart and A. M. Nip",
383       "Protein Chemical Shift Analysis: A Practical Guide",
384       "Biochem. Cell Biol.",
385       76, 1998, "153-163" },
386     { "Maiorov95",
387       "V. N. Maiorov and G. M. Crippen",
388       "Size-Independent Comparison of Protein Three-Dimensional Structures",
389       "PROTEINS: Struct. Funct. Gen.",
390       22, 1995, "273-283" },
391     { "Feenstra99",
392       "K. A. Feenstra and B. Hess and H. J. C. Berendsen",
393       "Improving Efficiency of Large Time-scale Molecular Dynamics Simulations of Hydrogen-rich Systems",
394       "J. Comput. Chem.",
395       20, 1999, "786-798" },
396     { "Timneanu2004a",
397       "N. Timneanu and C. Caleman and J. Hajdu and D. van der Spoel",
398       "Auger Electron Cascades in Water and Ice",
399       "Chem. Phys.",
400       299, 2004, "277-283" },
401     { "Pascal2011a",
402       "T. A. Pascal and S. T. Lin and W. A. Goddard III",
403       "Thermodynamics of liquids: standard molar entropies and heat capacities of common solvents from 2PT molecular dynamics",
404       "Phys. Chem. Chem. Phys.",
405       13, 2011, "169-181" },
406     { "Caleman2011b",
407       "C. Caleman and M. Hong and J. S. Hub and L. T. da Costa and P. J. van Maaren and D. van der Spoel",
408       "Force Field Benchmark 1: Density, Heat of Vaporization, Heat Capacity, Surface Tension and Dielectric Constant of 152 Organic Liquids",
409       "Submitted",
410       0, 2011, "" },
411     { "Lindahl2001a",
412       "E. Lindahl and B. Hess and D. van der Spoel",
413       "GROMACS 3.0: A package for molecular simulation and trajectory analysis",
414       "J. Mol. Mod.",
415       7, 2001, "306-317" },
416     { "Wang2001a",
417       "J. Wang and W. Wang and S. Huo and M. Lee and P. A. Kollman",
418       "Solvation model based on weighted solvent accessible surface area",
419       "J. Phys. Chem. B",
420       105, 2001, "5055-5067" },
421     { "Eisenberg86a",
422       "D. Eisenberg and A. D. McLachlan",
423       "Solvation energy in protein folding and binding",
424       "Nature",
425       319, 1986, "199-203" },
426     { "Eisenhaber95",
427       "Frank Eisenhaber and Philip Lijnzaad and Patrick Argos and Chris Sander and Michael Scharf",
428       "The Double Cube Lattice Method: Efficient Approaches to Numerical Integration of Surface Area and Volume and to Dot Surface Contouring of Molecular Assemblies",
429       "J. Comp. Chem.",
430       16, 1995, "273-284" },
431     { "Hess2002",
432       "B. Hess, H. Saint-Martin and H.J.C. Berendsen",
433       "Flexible constraints: an adiabatic treatment of quantum degrees of freedom, with application to the flexible and polarizable MCDHO model for water",
434       "J. Chem. Phys.",
435       116, 2002, "9602-9610" },
436     { "Hetenyi2002b",
437       "Csaba Hetenyi and David van der Spoel",
438       "Efficient docking of peptides to proteins without prior knowledge of the binding site.",
439       "Prot. Sci.",
440       11, 2002, "1729-1737" },
441     { "Hess2003",
442       "B. Hess and R.M. Scheek",
443       "Orientation restraints in molecular dynamics simulations using time and ensemble averaging",
444       "J. Magn. Res.",
445       164, 2003, "19-27" },
446     { "Rappe1991a",
447       "A. K. Rappe and W. A. Goddard III",
448       "Charge Equillibration for Molecular Dynamics Simulations",
449       "J. Phys. Chem.",
450       95, 1991, "3358-3363" },
451     { "Mu2005a",
452       "Y. Mu, P. H. Nguyen and G. Stock",
453       "Energy landscape of a small peptide revelaed by dihedral angle principal component analysis",
454       "Prot. Struct. Funct. Bioinf.",
455       58, 2005, "45-52" },
456     { "Okabe2001a",
457       "T. Okabe and M. Kawata and Y. Okamoto and M. Mikami",
458       "Replica-exchange {M}onte {C}arlo method for the isobaric-isothermal ensemble",
459       "Chem. Phys. Lett.",
460       335, 2001, "435-439" },
461     { "Hukushima96a",
462       "K. Hukushima and K. Nemoto",
463       "Exchange Monte Carlo Method and Application to Spin Glass Simulations",
464       "J. Phys. Soc. Jpn.",
465       65, 1996, "1604-1608" },
466     { "Tropp80a",
467       "J. Tropp",
468       "Dipolar Relaxation and Nuclear Overhauser effects in nonrigid molecules: The effect of fluctuating internuclear distances",
469       "J. Chem. Phys.",
470       72, 1980, "6035-6043" },
471     { "Bultinck2002a",
472        "P. Bultinck and W. Langenaeker and P. Lahorte and F. De Proft and P. Geerlings and M. Waroquier and J. P. Tollenaere",
473       "The electronegativity equalization method I: Parametrization and validation for atomic charge calculations",
474       "J. Phys. Chem. A",
475       106, 2002, "7887-7894" },
476     { "Yang2006b",
477       "Q. Y. Yang and K. A. Sharp",
478       "Atomic charge parameters for the finite difference Poisson-Boltzmann method using electronegativity neutralization",
479       "J. Chem. Theory Comput.",
480       2, 2006, "1152-1167" },
481     { "Spoel2005a",
482       "D. van der Spoel, E. Lindahl, B. Hess, G. Groenhof, A. E. Mark and H. J. C. Berendsen",
483       "GROMACS: Fast, Flexible and Free",
484       "J. Comp. Chem.",
485       26, 2005, "1701-1719" },
486     { "Spoel2006b",
487       "D. van der Spoel, P. J. van Maaren, P. Larsson and N. Timneanu",
488       "Thermodynamics of hydrogen bonding in hydrophilic and hydrophobic media",
489       "J. Phys. Chem. B",
490       110, 2006, "4393-4398" },
491     { "Spoel2006d",
492       "D. van der Spoel and M. M. Seibert",
493       "Protein folding kinetics and thermodynamics from atomistic simulations",
494       "Phys. Rev. Letters",
495       96, 2006, "238102" },
496     { "Palmer94a",
497       "B. J. Palmer",
498       "Transverse-current autocorrelation-function calculations of the shear viscosity for molecular liquids",
499       "Phys. Rev. E",
500       49, 1994, "359-366" },
501     { "Bussi2007a",
502       "G. Bussi, D. Donadio and M. Parrinello",
503       "Canonical sampling through velocity rescaling",
504       "J. Chem. Phys.",
505       126, 2007, "014101" },
506     { "Hub2006",
507       "J. S. Hub and B. L. de Groot",
508       "Does CO2 permeate through Aquaporin-1?",
509       "Biophys. J.",
510       91, 2006, "842-848" },
511     { "Hub2008",
512       "J. S. Hub and B. L. de Groot",
513       "Mechanism of selectivity in aquaporins and aquaglyceroporins",
514       "PNAS",
515       105, 2008, "1198-1203" },
516     { "Friedrich2009",
517       "M. S. Friedrichs, P. Eastman, V. Vaidyanathan, M. Houston, S. LeGrand, A. L. Beberg, D. L. Ensign, C. M. Bruns, and V. S. Pande",
518       "Accelerating Molecular Dynamic Simulation on Graphics Processing Units",
519       "J. Comp. Chem.",
520       30, 2009, "864-872" },
521     { "Engin2010",
522       "O. Engin, A. Villa, M. Sayar and B. Hess",
523       "Driving Forces for Adsorption of Amphiphilic Peptides to Air-Water Interface",
524       "J. Phys. Chem. B",
525       0, 2010, "???" },
526     { "Fritsch12",
527       "S. Fritsch, C. Junghans and K. Kremer",
528       "Adaptive molecular simulation study on structure formation of toluene around C60 using Gromacs",
529       "J. Chem. Theo. Comp.",
530       0, 2012, "???" },
531     { "Junghans10",
532       "C. Junghans and S. Poblete",
533       "A reference implementation of the adaptive resolution scheme in ESPResSo",
534       "Comp. Phys. Comm.",
535       181, 2010, "1449" },
536     { "Wang2010",
537       "H. Wang, F. Dommert, C.Holm",
538       "Optimizing working parameters of the smooth particle mesh Ewald algorithm in terms of accuracy and efficiency",
539       "J. Chem. Phys. B",
540       133, 2010, "034117" },
541     { "Kutzner2011",
542       "C. Kutzner and J. Czub and H. Grubmuller",
543       "Keep it Flexible: Driving Macromolecular Rotary Motions in Atomistic Simulations with GROMACS",
544       "J. Chem. Theory Comput.",
545       7, 2011, "1381-1393" },
546     { "Hoefling2011",
547       "M. Hoefling, N. Lima, D. Haenni, C.A.M. Seidel, B. Schuler, H. Grubmuller",
548       "Structural Heterogeneity and Quantitative FRET Efficiency Distributions of Polyprolines through a Hybrid Atomistic Simulation and Monte Carlo Approach",
549       "PLoS ONE",
550       6, 2011, "e19791"
551     }
552   };
553 #define NSTR (int)asize(citedb)
554   
555   int  j,index;
556   char *author;
557   char *title;
558 #define LINE_WIDTH 79
559   
560   if (fp == NULL)
561     return;
562
563   for(index=0; (index<NSTR) && (strcmp(citedb[index].key,key) != 0); index++)
564     ;
565   
566   fprintf(fp,"\n++++ PLEASE READ AND CITE THE FOLLOWING REFERENCE ++++\n");
567   if (index < NSTR) {
568     /* Insert newlines */
569     author = wrap_lines(citedb[index].author,LINE_WIDTH,0,FALSE);
570     title  = wrap_lines(citedb[index].title,LINE_WIDTH,0,FALSE);
571     fprintf(fp,"%s\n%s\n%s %d (%d) pp. %s\n",
572             author,title,citedb[index].journal,
573             citedb[index].volume,citedb[index].year,
574             citedb[index].pages);
575     sfree(author);
576     sfree(title);
577   }
578   else {
579     fprintf(fp,"Entry %s not found in citation database\n",key);
580   }
581   fprintf(fp,"-------- -------- --- Thank You --- -------- --------\n\n");
582   fflush(fp);
583 }
584
585 #ifdef USE_VERSION_H
586 /* Version information generated at compile time. */
587 #include "version.h"
588 #else
589 /* Fall back to statically defined version. */
590 static const char _gmx_ver_string[]="VERSION " VERSION;
591 #endif
592
593 /* This routine only returns a static (constant) string, so we use a 
594  * mutex to initialize it. Since the string is only written to the
595  * first time, there is no risk with multiple calls overwriting the
596  * output for each other.
597  */
598 const char *GromacsVersion()
599 {
600   return _gmx_ver_string;
601 }
602
603
604 void gmx_print_version_info(FILE *fp)
605 {
606     fprintf(fp, "Version:          %s\n", _gmx_ver_string);
607 #ifdef USE_VERSION_H
608     fprintf(fp, "GIT SHA1 hash:    %s\n", _gmx_full_git_hash);
609     /* Only print out the branch information if present.
610      * The generating script checks whether the branch point actually
611      * coincides with the hash reported above, and produces an empty string
612      * in such cases. */
613     if (_gmx_central_base_hash[0] != 0)
614     {
615         fprintf(fp, "Branched from:    %s\n", _gmx_central_base_hash);
616     }
617 #endif
618
619 #ifdef GMX_DOUBLE
620     fprintf(fp, "Precision:        double\n");
621 #else
622     fprintf(fp, "Precision:        single\n");
623 #endif
624
625 #ifdef GMX_THREADS
626     fprintf(fp, "Parallellization: thread_mpi\n");
627 #elif defined(GMX_MPI)
628     fprintf(fp, "Parallellization: MPI\n");
629 #else
630     fprintf(fp, "Parallellization: none\n");
631 #endif
632
633 #ifdef GMX_FFT_FFTPACK
634     fprintf(fp, "FFT Library:      fftpack\n");
635 #elif defined(GMX_FFT_FFTW2)
636     fprintf(fp, "FFT Library:      fftw2\n");
637 #elif defined(GMX_FFT_FFTW3)
638     fprintf(fp, "FFT Library:      fftw3\n");
639 #elif defined(GMX_FFT_MKL)
640     fprintf(fp, "FFT Library:      MKL\n");
641 #else
642     fprintf(fp, "FFT Library:      unknown\n");
643 #endif
644 }