Allow gmxapi.commandline.cli to check GMXBIN.
[alexxy/gromacs.git] / src / gromacs / utility / pleasecite.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,2015,2016,2017 by the GROMACS development team.
7  * Copyright (c) 2018,2019,2020,2021, by the GROMACS development team, led by
8  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
9  * and including many others, as listed in the AUTHORS file in the
10  * top-level source directory and at http://www.gromacs.org.
11  *
12  * GROMACS is free software; you can redistribute it and/or
13  * modify it under the terms of the GNU Lesser General Public License
14  * as published by the Free Software Foundation; either version 2.1
15  * of the License, or (at your option) any later version.
16  *
17  * GROMACS is distributed in the hope that it will be useful,
18  * but WITHOUT ANY WARRANTY; without even the implied warranty of
19  * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the GNU
20  * Lesser General Public License for more details.
21  *
22  * You should have received a copy of the GNU Lesser General Public
23  * License along with GROMACS; if not, see
24  * http://www.gnu.org/licenses, or write to the Free Software Foundation,
25  * Inc., 51 Franklin Street, Fifth Floor, Boston, MA  02110-1301  USA.
26  *
27  * If you want to redistribute modifications to GROMACS, please
28  * consider that scientific software is very special. Version
29  * control is crucial - bugs must be traceable. We will be happy to
30  * consider code for inclusion in the official distribution, but
31  * derived work must not be called official GROMACS. Details are found
32  * in the README & COPYING files - if they are missing, get the
33  * official version at http://www.gromacs.org.
34  *
35  * To help us fund GROMACS development, we humbly ask that you cite
36  * the research papers on the package. Check out http://www.gromacs.org.
37  */
38 #include "gmxpre.h"
39
40 #include "pleasecite.h"
41
42 #include <cstring>
43
44 #include "gromacs/utility/arraysize.h"
45 #include "gromacs/utility/baseversion.h"
46 #include "gromacs/utility/cstringutil.h"
47 #include "gromacs/utility/smalloc.h"
48 #include "gromacs/utility/stringutil.h"
49
50 typedef struct
51 {
52     const char* key;
53     const char* author;
54     const char* title;
55     const char* journal;
56     int         volume, year;
57     const char* pages;
58 } t_citerec;
59
60 static constexpr int sc_lineWidth = 79;
61
62 void please_cite(FILE* fp, const char* key)
63 {
64     static const t_citerec citedb[] = {
65         { "Allen1987a",
66           "M. P. Allen and D. J. Tildesley",
67           "Computer simulation of liquids",
68           "Oxford Science Publications",
69           1,
70           1987,
71           "1" },
72         { "Berendsen95a",
73           "H. J. C. Berendsen, D. van der Spoel and R. van Drunen",
74           "GROMACS: A message-passing parallel molecular dynamics implementation",
75           "Comp. Phys. Comm.",
76           91,
77           1995,
78           "43-56" },
79         { "Berendsen84a",
80           "H. J. C. Berendsen, J. P. M. Postma, A. DiNola and J. R. Haak",
81           "Molecular dynamics with coupling to an external bath",
82           "J. Chem. Phys.",
83           81,
84           1984,
85           "3684-3690" },
86         { "Ryckaert77a",
87           "J. P. Ryckaert and G. Ciccotti and H. J. C. Berendsen",
88           "Numerical Integration of the Cartesian Equations of Motion of a System with "
89           "Constraints; Molecular Dynamics of n-Alkanes",
90           "J. Comp. Phys.",
91           23,
92           1977,
93           "327-341" },
94         { "Miyamoto92a",
95           "S. Miyamoto and P. A. Kollman",
96           "SETTLE: An Analytical Version of the SHAKE and RATTLE Algorithms for Rigid Water Models",
97           "J. Comp. Chem.",
98           13,
99           1992,
100           "952-962" },
101         { "Cromer1968a",
102           "D. T. Cromer & J. B. Mann",
103           "X-ray scattering factors computed from numerical Hartree-Fock wave functions",
104           "Acta Cryst. A",
105           24,
106           1968,
107           "321" },
108         { "Barth95a",
109           "E. Barth and K. Kuczera and B. Leimkuhler and R. D. Skeel",
110           "Algorithms for Constrained Molecular Dynamics",
111           "J. Comp. Chem.",
112           16,
113           1995,
114           "1192-1209" },
115         { "Essmann95a",
116           "U. Essmann, L. Perera, M. L. Berkowitz, T. Darden, H. Lee and L. G. Pedersen ",
117           "A smooth particle mesh Ewald method",
118           "J. Chem. Phys.",
119           103,
120           1995,
121           "8577-8592" },
122         { "Torda89a",
123           "A. E. Torda and R. M. Scheek and W. F. van Gunsteren",
124           "Time-dependent distance restraints in molecular dynamics simulations",
125           "Chem. Phys. Lett.",
126           157,
127           1989,
128           "289-294" },
129         { "Tironi95a",
130           "I. G. Tironi and R. Sperb and P. E. Smith and W. F. van Gunsteren",
131           "Generalized reaction field method for molecular dynamics simulations",
132           "J. Chem. Phys",
133           102,
134           1995,
135           "5451-5459" },
136         { "Hess97a",
137           "B. Hess and H. Bekker and H. J. C. Berendsen and J. G. E. M. Fraaije",
138           "LINCS: A Linear Constraint Solver for molecular simulations",
139           "J. Comp. Chem.",
140           18,
141           1997,
142           "1463-1472" },
143         { "Hess2008a",
144           "B. Hess",
145           "P-LINCS: A Parallel Linear Constraint Solver for molecular simulation",
146           "J. Chem. Theory Comput.",
147           4,
148           2008,
149           "116-122" },
150         { "Hess2008b",
151           "B. Hess and C. Kutzner and D. van der Spoel and E. Lindahl",
152           "GROMACS 4: Algorithms for highly efficient, load-balanced, and scalable molecular "
153           "simulation",
154           "J. Chem. Theory Comput.",
155           4,
156           2008,
157           "435-447" },
158         { "Hub2010",
159           "J. S. Hub, B. L. de Groot and D. van der Spoel",
160           "g_wham - A free weighted histogram analysis implementation including robust error and "
161           "autocorrelation estimates",
162           "J. Chem. Theory Comput.",
163           6,
164           2010,
165           "3713-3720" },
166         { "In-Chul99a",
167           "Y. In-Chul and M. L. Berkowitz",
168           "Ewald summation for systems with slab geometry",
169           "J. Chem. Phys.",
170           111,
171           1999,
172           "3155-3162" },
173         { "DeGroot97a",
174           "B. L. de Groot and D. M. F. van Aalten and R. M. Scheek and A. Amadei and G. Vriend and "
175           "H. J. C. Berendsen",
176           "Prediction of Protein Conformational Freedom From Distance Constrains",
177           "Proteins",
178           29,
179           1997,
180           "240-251" },
181         { "Spoel98a",
182           "D. van der Spoel and P. J. van Maaren and H. J. C. Berendsen",
183           "A systematic study of water models for molecular simulation. Derivation of models "
184           "optimized for use with a reaction-field.",
185           "J. Chem. Phys.",
186           108,
187           1998,
188           "10220-10230" },
189         { "Wishart98a",
190           "D. S. Wishart and A. M. Nip",
191           "Protein Chemical Shift Analysis: A Practical Guide",
192           "Biochem. Cell Biol.",
193           76,
194           1998,
195           "153-163" },
196         { "Maiorov95",
197           "V. N. Maiorov and G. M. Crippen",
198           "Size-Independent Comparison of Protein Three-Dimensional Structures",
199           "PROTEINS: Struct. Funct. Gen.",
200           22,
201           1995,
202           "273-283" },
203         { "Feenstra99",
204           "K. A. Feenstra and B. Hess and H. J. C. Berendsen",
205           "Improving Efficiency of Large Time-scale Molecular Dynamics Simulations of "
206           "Hydrogen-rich Systems",
207           "J. Comput. Chem.",
208           20,
209           1999,
210           "786-798" },
211         { "Lourenco2013a",
212           "Tuanan C. Lourenco and Mariny F. C. Coelho and Teodorico C. Ramalho and David van der "
213           "Spoel and Luciano T. Costa",
214           "Insights on the Solubility of CO2 in 1-Ethyl-3-methylimidazolium "
215           "Bis(trifluoromethylsulfonyl)imide from the Microscopic Point of View",
216           "Environ. Sci. Technol.",
217           47,
218           2013,
219           "7421-7429" },
220         { "Timneanu2004a",
221           "N. Timneanu and C. Caleman and J. Hajdu and D. van der Spoel",
222           "Auger Electron Cascades in Water and Ice",
223           "Chem. Phys.",
224           299,
225           2004,
226           "277-283" },
227         { "Pascal2011a",
228           "T. A. Pascal and S. T. Lin and W. A. Goddard III",
229           "Thermodynamics of liquids: standard molar entropies and heat capacities of common "
230           "solvents from 2PT molecular dynamics",
231           "Phys. Chem. Chem. Phys.",
232           13,
233           2011,
234           "169-181" },
235         { "Caleman2008a",
236           "C. Caleman and D. van der Spoel",
237           "Picosecond Melting of Ice by an Infrared Laser Pulse: A Simulation Study",
238           "Angew. Chem. Int. Ed",
239           47,
240           2008,
241           "1417-1420" },
242         { "Caleman2011b",
243           "C. Caleman and P. J. van Maaren and M. Hong and J. S. Hub and L. T. da Costa and D. van "
244           "der Spoel",
245           "Force Field Benchmark of Organic Liquids: Density, Enthalpy of Vaporization, Heat "
246           "Capacities, Surface Tension, Isothermal Compressibility, Volumetric Expansion "
247           "Coefficient, and Dielectric Constant",
248           "J. Chem. Theo. Comp.",
249           8,
250           2012,
251           "61" },
252         { "Lindahl2001a",
253           "E. Lindahl and B. Hess and D. van der Spoel",
254           "GROMACS 3.0: A package for molecular simulation and trajectory analysis",
255           "J. Mol. Mod.",
256           7,
257           2001,
258           "306-317" },
259         { "Wang2001a",
260           "J. Wang and W. Wang and S. Huo and M. Lee and P. A. Kollman",
261           "Solvation model based on weighted solvent accessible surface area",
262           "J. Phys. Chem. B",
263           105,
264           2001,
265           "5055-5067" },
266         { "Eisenberg86a",
267           "D. Eisenberg and A. D. McLachlan",
268           "Solvation energy in protein folding and binding",
269           "Nature",
270           319,
271           1986,
272           "199-203" },
273         { "Bondi1964a",
274           "A. Bondi",
275           "van der Waals Volumes and Radii",
276           "J. Phys. Chem.",
277           68,
278           1964,
279           "441-451" },
280         { "Eisenhaber95",
281           "Frank Eisenhaber and Philip Lijnzaad and Patrick Argos and Chris Sander and Michael "
282           "Scharf",
283           "The Double Cube Lattice Method: Efficient Approaches to Numerical Integration of "
284           "Surface Area and Volume and to Dot Surface Contouring of Molecular Assemblies",
285           "J. Comp. Chem.",
286           16,
287           1995,
288           "273-284" },
289         { "Hess2002",
290           "B. Hess, H. Saint-Martin and H.J.C. Berendsen",
291           "Flexible constraints: an adiabatic treatment of quantum degrees of freedom, with "
292           "application to the flexible and polarizable MCDHO model for water",
293           "J. Chem. Phys.",
294           116,
295           2002,
296           "9602-9610" },
297         { "Hess2003",
298           "B. Hess and R.M. Scheek",
299           "Orientation restraints in molecular dynamics simulations using time and ensemble "
300           "averaging",
301           "J. Magn. Res.",
302           164,
303           2003,
304           "19-27" },
305         { "Rappe1991a",
306           "A. K. Rappe and W. A. Goddard III",
307           "Charge Equillibration for Molecular Dynamics Simulations",
308           "J. Phys. Chem.",
309           95,
310           1991,
311           "3358-3363" },
312         { "Mu2005a",
313           "Y. Mu, P. H. Nguyen and G. Stock",
314           "Energy landscape of a small peptide revelaed by dihedral angle principal component "
315           "analysis",
316           "Prot. Struct. Funct. Bioinf.",
317           58,
318           2005,
319           "45-52" },
320         { "Okabe2001a",
321           "T. Okabe and M. Kawata and Y. Okamoto and M. Mikami",
322           "Replica-exchange {M}onte {C}arlo method for the isobaric-isothermal ensemble",
323           "Chem. Phys. Lett.",
324           335,
325           2001,
326           "435-439" },
327         { "Hukushima96a",
328           "K. Hukushima and K. Nemoto",
329           "Exchange Monte Carlo Method and Application to Spin Glass Simulations",
330           "J. Phys. Soc. Jpn.",
331           65,
332           1996,
333           "1604-1608" },
334         { "Tropp80a",
335           "J. Tropp",
336           "Dipolar Relaxation and Nuclear Overhauser effects in nonrigid molecules: The effect of "
337           "fluctuating internuclear distances",
338           "J. Chem. Phys.",
339           72,
340           1980,
341           "6035-6043" },
342         { "Bultinck2002a",
343           "P. Bultinck and W. Langenaeker and P. Lahorte and F. De Proft and P. Geerlings and M. "
344           "Waroquier and J. P. Tollenaere",
345           "The electronegativity equalization method I: Parametrization and validation for atomic "
346           "charge calculations",
347           "J. Phys. Chem. A",
348           106,
349           2002,
350           "7887-7894" },
351         { "Yang2006b",
352           "Q. Y. Yang and K. A. Sharp",
353           "Atomic charge parameters for the finite difference Poisson-Boltzmann method using "
354           "electronegativity neutralization",
355           "J. Chem. Theory Comput.",
356           2,
357           2006,
358           "1152-1167" },
359         { "Spoel2005a",
360           "D. van der Spoel, E. Lindahl, B. Hess, G. Groenhof, A. E. Mark and H. J. C. Berendsen",
361           "GROMACS: Fast, Flexible and Free",
362           "J. Comp. Chem.",
363           26,
364           2005,
365           "1701-1719" },
366         { "Spoel2006b",
367           "D. van der Spoel, P. J. van Maaren, P. Larsson and N. Timneanu",
368           "Thermodynamics of hydrogen bonding in hydrophilic and hydrophobic media",
369           "J. Phys. Chem. B",
370           110,
371           2006,
372           "4393-4398" },
373         { "Spoel2006d",
374           "D. van der Spoel and M. M. Seibert",
375           "Protein folding kinetics and thermodynamics from atomistic simulations",
376           "Phys. Rev. Letters",
377           96,
378           2006,
379           "238102" },
380         { "Palmer94a",
381           "B. J. Palmer",
382           "Transverse-current autocorrelation-function calculations of the shear viscosity for "
383           "molecular liquids",
384           "Phys. Rev. E",
385           49,
386           1994,
387           "359-366" },
388         { "Bussi2007a",
389           "G. Bussi, D. Donadio and M. Parrinello",
390           "Canonical sampling through velocity rescaling",
391           "J. Chem. Phys.",
392           126,
393           2007,
394           "014101" },
395         { "Hub2006",
396           "J. S. Hub and B. L. de Groot",
397           "Does CO2 permeate through Aquaporin-1?",
398           "Biophys. J.",
399           91,
400           2006,
401           "842-848" },
402         { "Hub2008",
403           "J. S. Hub and B. L. de Groot",
404           "Mechanism of selectivity in aquaporins and aquaglyceroporins",
405           "PNAS",
406           105,
407           2008,
408           "1198-1203" },
409         { "Friedrich2009",
410           "M. S. Friedrichs, P. Eastman, V. Vaidyanathan, M. Houston, S. LeGrand, A. L. Beberg, D. "
411           "L. Ensign, C. M. Bruns, and V. S. Pande",
412           "Accelerating Molecular Dynamic Simulation on Graphics Processing Units",
413           "J. Comp. Chem.",
414           30,
415           2009,
416           "864-872" },
417         { "Engin2010",
418           "O. Engin, A. Villa, M. Sayar and B. Hess",
419           "Driving Forces for Adsorption of Amphiphilic Peptides to Air-Water Interface",
420           "J. Phys. Chem. B",
421           114,
422           2010,
423           "11093" },
424         { "Wang2010",
425           "H. Wang, F. Dommert, C.Holm",
426           "Optimizing working parameters of the smooth particle mesh Ewald algorithm in terms of "
427           "accuracy and efficiency",
428           "J. Chem. Phys. B",
429           133,
430           2010,
431           "034117" },
432         { "Sugita1999a",
433           "Y. Sugita, Y. Okamoto",
434           "Replica-exchange molecular dynamics method for protein folding",
435           "Chem. Phys. Lett.",
436           314,
437           1999,
438           "141-151" },
439         { "Kutzner2011",
440           "C. Kutzner and J. Czub and H. Grubmuller",
441           "Keep it Flexible: Driving Macromolecular Rotary Motions in Atomistic Simulations with "
442           "GROMACS",
443           "J. Chem. Theory Comput.",
444           7,
445           2011,
446           "1381-1393" },
447         { "Hoefling2011",
448           "M. Hoefling, N. Lima, D. Haenni, C.A.M. Seidel, B. Schuler, H. Grubmuller",
449           "Structural Heterogeneity and Quantitative FRET Efficiency Distributions of Polyprolines "
450           "through a Hybrid Atomistic Simulation and Monte Carlo Approach",
451           "PLoS ONE",
452           6,
453           2011,
454           "e19791" },
455         { "Hockney1988",
456           "R. W. Hockney and J. W. Eastwood",
457           "Computer simulation using particles",
458           "IOP, Bristol",
459           1,
460           1988,
461           "1" },
462         { "Ballenegger2012",
463           "V. Ballenegger, J.J. Cerda, and C. Holm",
464           "How to Convert SPME to P3M: Influence Functions and Error Estimates",
465           "J. Chem. Theory Comput.",
466           8,
467           2012,
468           "936-947" },
469         { "Garmay2012",
470           "Garmay Yu, Shvetsov A, Karelov D, Lebedev D, Radulescu A, Petukhov M, Isaev-Ivanov V",
471           "Correlated motion of protein subdomains and large-scale conformational flexibility of "
472           "RecA protein filament",
473           "Journal of Physics: Conference Series",
474           340,
475           2012,
476           "012094" },
477         { "Kutzner2011b",
478           "C. Kutzner, H. Grubmuller, B. L. de Groot, and U. Zachariae",
479           "Computational Electrophysiology: The Molecular Dynamics of Ion Channel Permeation and "
480           "Selectivity in Atomistic Detail",
481           "Biophys. J.",
482           101,
483           2011,
484           "809-817" },
485         { "Lundborg2014",
486           "M. Lundborg, R. Apostolov, D. Spangberg, A. Gardenas, D. van der Spoel and E. Lindahl",
487           "An efficient and extensible format, library, and API for binary trajectory data from "
488           "molecular simulations",
489           "J. Comput. Chem.",
490           35,
491           2014,
492           "260-269" },
493         { "Goga2012",
494           "N. Goga and A. J. Rzepiela and A. H. de Vries and S. J. Marrink and H. J. C. Berendsen",
495           "Efficient Algorithms for Langevin and DPD Dynamics",
496           "J. Chem. Theory Comput.",
497           8,
498           2012,
499           "3637--3649" },
500         { "Pronk2013",
501           "S. Pronk, S. Páll, R. Schulz, P. Larsson, P. Bjelkmar, R. Apostolov, M. R. Shirts, J. "
502           "C. Smith, P. M. Kasson, D. van der Spoel, B. Hess, and E. Lindahl",
503           "GROMACS 4.5: a high-throughput and highly parallel open source molecular simulation "
504           "toolkit",
505           "Bioinformatics",
506           29,
507           2013,
508           "845-54" },
509         { "Pall2015",
510           "S. Páll, M. J. Abraham, C. Kutzner, B. Hess, E. Lindahl",
511           "Tackling Exascale Software Challenges in Molecular Dynamics Simulations with GROMACS",
512           "In S. Markidis & E. Laure (Eds.), Solving Software Challenges for Exascale",
513           8759,
514           2015,
515           "3-27" },
516         { "Abraham2015",
517           "M. J. Abraham, T. Murtola, R. Schulz, S. Páll, J. C. Smith, B. Hess, E. Lindahl",
518           "GROMACS: High performance molecular simulations through multi-level parallelism from "
519           "laptops to supercomputers",
520           "SoftwareX",
521           1,
522           2015,
523           "19-25" },
524         { "Ballenegger2009",
525           "V. Ballenegger, A. Arnold, J. J. Cerdà",
526           "Simulations of non-neutral slab systems with long-range electrostatic interactions in "
527           "two-dimensional periodic boundary conditions",
528           "J. Chem. Phys",
529           131,
530           2009,
531           "094107" },
532         { "Hub2014a",
533           "J. S. Hub, B. L. de Groot, H. Grubmueller, G. Groenhof",
534           "Quantifying Artifacts in Ewald Simulations of Inhomogeneous Systems with a Net Charge",
535           "J. Chem. Theory Comput.",
536           10,
537           2014,
538           "381-393" },
539         { "Spoel2018a",
540           "D. van der Spoel, M. M. Ghahremanpour, J. Lemkul",
541           "Small Molecule Thermochemistry: A Tool For Empirical Force Field Development",
542           "J. Phys. Chem. A",
543           122,
544           2018,
545           "8982-8988" },
546         { "Lindahl2014",
547           "V. Lindahl, J. Lidmar, B. Hess",
548           "Accelerated weight histogram method for exploring free energy landscapes",
549           "J. Chem. Phys.",
550           141,
551           2014,
552           "044110" },
553         { "Bernetti2020",
554           "M. Bernetti, G. Bussi",
555           "Pressure control using stochastic cell rescaling",
556           "J. Chem. Phys.",
557           153,
558           2020,
559           "114107" },
560     };
561 #define NSTR static_cast<int>(asize(citedb))
562
563     if (fp == nullptr)
564     {
565         return;
566     }
567
568     int index = 0;
569     for (; index < NSTR && (strcmp(citedb[index].key, key) != 0); index++) {}
570
571     fprintf(fp, "\n++++ PLEASE READ AND CITE THE FOLLOWING REFERENCE ++++\n");
572     if (index < NSTR)
573     {
574         /* Insert newlines */
575         char* author = wrap_lines(citedb[index].author, sc_lineWidth, 0, FALSE);
576         char* title  = wrap_lines(citedb[index].title, sc_lineWidth, 0, FALSE);
577         fprintf(fp,
578                 "%s\n%s\n%s %d (%d) pp. %s\n",
579                 author,
580                 title,
581                 citedb[index].journal,
582                 citedb[index].volume,
583                 citedb[index].year,
584                 citedb[index].pages);
585         sfree(author);
586         sfree(title);
587     }
588     else
589     {
590         fprintf(fp, "Entry %s not found in citation database\n", key);
591     }
592     fprintf(fp, "-------- -------- --- Thank You --- -------- --------\n\n");
593     fflush(fp);
594 }
595
596 namespace
597 {
598
599 //! Write a message to \c fp to request citation also of the source-code DOI.
600 void writeSourceDoi(FILE* fp)
601 {
602     /* Check if we are in release mode or not.
603      * TODO The check should properly target something else than
604      * the string being empty
605      */
606     if (strlen(gmxDOI()) == 0)
607     {
608         /* Not a release build, return without printing anything */
609         return;
610     }
611     gmx::TextLineWrapper wrapper;
612     wrapper.settings().setLineLength(sc_lineWidth);
613     wrapper.settings().setFirstLineIndent(0);
614     const std::string doiString = wrapper.wrapToString(gmxDOI());
615
616     if (fp == nullptr)
617     {
618         return;
619     }
620     fprintf(fp, "\n++++ PLEASE CITE THE DOI FOR THIS VERSION OF GROMACS ++++\n");
621     fprintf(fp, "%s%s\n", "https://doi.org/", doiString.c_str());
622     fprintf(fp, "-------- -------- --- Thank You --- -------- --------\n\n");
623     fflush(fp);
624 }
625
626 } // namespace
627
628 void pleaseCiteGromacs(FILE* fplog)
629 {
630     if (fplog == nullptr)
631     {
632         return;
633     }
634
635     please_cite(fplog, "Abraham2015");
636     please_cite(fplog, "Pall2015");
637     please_cite(fplog, "Pronk2013");
638     please_cite(fplog, "Hess2008b");
639     please_cite(fplog, "Spoel2005a");
640     please_cite(fplog, "Lindahl2001a");
641     please_cite(fplog, "Berendsen95a");
642     writeSourceDoi(fplog);
643 }