4 * This source code is part of
8 * GROningen MAchine for Chemical Simulations
12 * Copyright (c) 1991-1999
13 * BIOSON Research Institute, Dept. of Biophysical Chemistry
14 * University of Groningen, The Netherlands
17 * GROMACS: A message-passing parallel molecular dynamics implementation
18 * H.J.C. Berendsen, D. van der Spoel and R. van Drunen
19 * Comp. Phys. Comm. 91, 43-56 (1995)
21 * Also check out our WWW page:
22 * http://md.chem.rug.nl/~gmx
27 * GRowing Old MAkes el Chrono Sweat
29 static char *SRCID_nmrun_c
= "$Id$";
39 int main(int argc
,char *argv
[])
41 static char *desc
[] = {
42 "nmrun builds a Hessian matrix from single conformation.",
43 "For usual Normal Modes-like calculations, make sure that",
44 "the structure provided is properly energy-minimised.",
45 "The generated matrix can be diagonalized by g_nmeig."
49 { efTPX
, NULL
, NULL
, ffREAD
},
50 { efMTX
, "-m", "hessian", ffWRITE
},
51 { efLOG
, "-g", "nm", ffWRITE
},
53 #define NFILE asize(fnm)
55 /* Command line options ! */
56 static bool bVerbose
=FALSE
,bCompact
=TRUE
;
60 static int nDLB
=0,nstepout
=10;
61 static t_pargs pa
[] = {
63 { "-np", FALSE
, etINT
, {&nprocs
},
64 "Number of processors, must be the same as used for grompp" },
66 { "-v", FALSE
, etBOOL
,{&bVerbose
}, "Verbose mode" },
67 { "-compact", FALSE
, etBOOL
,{&bCompact
},
68 "Write a compact log file" },
69 { "-dlb", FALSE
, etINT
, {&nDLB
},
70 "HIDDENFrequency of dynamic load balancing. BUGGY do not use" },
71 { "-stepout", FALSE
, etINT
, {&nstepout
},
72 "HIDDENFrequency of writing the remaining runtime" }
76 cr
= init_par(&argc
,&argv
);
77 bVerbose
= bVerbose
&& MASTER(cr
);
81 CopyRight(stderr
,argv
[0]);
83 parse_common_args(&argc
,argv
,
84 PCA_KEEP_ARGS
| PCA_NOEXIT_ON_ARGS
| PCA_SET_NPRI
|
85 (MASTER(cr
) ? 0 : PCA_QUIET
),
86 TRUE
,NFILE
,fnm
,asize(pa
),pa
,asize(desc
),desc
,0,NULL
);
88 open_log(ftp2fn(efLOG
,NFILE
,fnm
),cr
);
91 CopyRight(stdlog
,argv
[0]);
92 please_cite(stdlog
,"Berendsen95a");
95 mdrunner(cr
,NFILE
,fnm
,bVerbose
,bCompact
,nDLB
,TRUE
,nstepout
,&edyn
);