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