Convert gmx_mtop_t to C++
[gromacs.git] / src / gromacs / tools / convert_tpr.cpp
blob7e574d9bc8a2b44e19951e8ddce8d257467d0e09
1 /*
2 * This file is part of the GROMACS molecular simulation package.
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,2018, 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.
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.
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.
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.
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.
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.
37 #include "gmxpre.h"
39 #include "convert_tpr.h"
41 #include <cmath>
43 #include "gromacs/commandline/pargs.h"
44 #include "gromacs/fileio/checkpoint.h"
45 #include "gromacs/fileio/enxio.h"
46 #include "gromacs/fileio/tpxio.h"
47 #include "gromacs/fileio/trrio.h"
48 #include "gromacs/math/vec.h"
49 #include "gromacs/mdtypes/inputrec.h"
50 #include "gromacs/mdtypes/md_enums.h"
51 #include "gromacs/mdtypes/state.h"
52 #include "gromacs/random/seed.h"
53 #include "gromacs/topology/ifunc.h"
54 #include "gromacs/topology/index.h"
55 #include "gromacs/topology/mtop_util.h"
56 #include "gromacs/topology/topology.h"
57 #include "gromacs/utility/arraysize.h"
58 #include "gromacs/utility/cstringutil.h"
59 #include "gromacs/utility/fatalerror.h"
60 #include "gromacs/utility/futil.h"
61 #include "gromacs/utility/real.h"
62 #include "gromacs/utility/smalloc.h"
63 #include "gromacs/utility/stringutil.h"
65 #define RANGECHK(i, n) if ((i) >= (n)) gmx_fatal(FARGS, "Your index file contains atomnumbers (e.g. %d)\nthat are larger than the number of atoms in the tpr file (%d)", (i), (n))
67 static gmx_bool *bKeepIt(int gnx, int natoms, int index[])
69 gmx_bool *b;
70 int i;
72 snew(b, natoms);
73 for (i = 0; (i < gnx); i++)
75 RANGECHK(index[i], natoms);
76 b[index[i]] = TRUE;
79 return b;
82 static int *invind(int gnx, int natoms, int index[])
84 int *inv;
85 int i;
87 snew(inv, natoms);
88 for (i = 0; (i < gnx); i++)
90 RANGECHK(index[i], natoms);
91 inv[index[i]] = i;
94 return inv;
97 static void reduce_block(gmx_bool bKeep[], t_block *block,
98 const char *name)
100 int *index;
101 int i, j, newi, newj;
103 snew(index, block->nr);
105 newi = newj = 0;
106 for (i = 0; (i < block->nr); i++)
108 for (j = block->index[i]; (j < block->index[i+1]); j++)
110 if (bKeep[j])
112 newj++;
115 if (newj > index[newi])
117 newi++;
118 index[newi] = newj;
122 fprintf(stderr, "Reduced block %8s from %6d to %6d index-, %6d to %6d a-entries\n",
123 name, block->nr, newi, block->index[block->nr], newj);
124 block->index = index;
125 block->nr = newi;
128 static void reduce_blocka(int invindex[], gmx_bool bKeep[], t_blocka *block,
129 const char *name)
131 int *index, *a;
132 int i, j, k, newi, newj;
134 snew(index, block->nr);
135 snew(a, block->nra);
137 newi = newj = 0;
138 for (i = 0; (i < block->nr); i++)
140 for (j = block->index[i]; (j < block->index[i+1]); j++)
142 k = block->a[j];
143 if (bKeep[k])
145 a[newj] = invindex[k];
146 newj++;
149 if (newj > index[newi])
151 newi++;
152 index[newi] = newj;
156 fprintf(stderr, "Reduced block %8s from %6d to %6d index-, %6d to %6d a-entries\n",
157 name, block->nr, newi, block->nra, newj);
158 block->index = index;
159 block->a = a;
160 block->nr = newi;
161 block->nra = newj;
164 static void reduce_rvec(int gnx, int index[], rvec vv[])
166 rvec *ptr;
167 int i;
169 snew(ptr, gnx);
170 for (i = 0; (i < gnx); i++)
172 copy_rvec(vv[index[i]], ptr[i]);
174 for (i = 0; (i < gnx); i++)
176 copy_rvec(ptr[i], vv[i]);
178 sfree(ptr);
181 static void reduce_atom(int gnx, int index[], t_atom atom[], char ***atomname,
182 int *nres, t_resinfo *resinfo)
184 t_atom *ptr;
185 char ***aname;
186 t_resinfo *rinfo;
187 int i, nr;
189 snew(ptr, gnx);
190 snew(aname, gnx);
191 snew(rinfo, atom[index[gnx-1]].resind+1);
192 for (i = 0; (i < gnx); i++)
194 ptr[i] = atom[index[i]];
195 aname[i] = atomname[index[i]];
197 nr = -1;
198 for (i = 0; (i < gnx); i++)
200 atom[i] = ptr[i];
201 atomname[i] = aname[i];
202 if ((i == 0) || (atom[i].resind != atom[i-1].resind))
204 nr++;
205 rinfo[nr] = resinfo[atom[i].resind];
207 atom[i].resind = nr;
209 nr++;
210 for (i = 0; (i < nr); i++)
212 resinfo[i] = rinfo[i];
214 *nres = nr;
216 sfree(aname);
217 sfree(ptr);
218 sfree(rinfo);
221 static void reduce_ilist(int invindex[], gmx_bool bKeep[],
222 t_ilist *il, int nratoms, const char *name)
224 t_iatom *ia;
225 int i, j, newnr;
226 gmx_bool bB;
228 if (il->nr)
230 snew(ia, il->nr);
231 newnr = 0;
232 for (i = 0; (i < il->nr); i += nratoms+1)
234 bB = TRUE;
235 for (j = 1; (j <= nratoms); j++)
237 bB = bB && bKeep[il->iatoms[i+j]];
239 if (bB)
241 ia[newnr++] = il->iatoms[i];
242 for (j = 1; (j <= nratoms); j++)
244 ia[newnr++] = invindex[il->iatoms[i+j]];
248 fprintf(stderr, "Reduced ilist %8s from %6d to %6d entries\n",
249 name, il->nr/(nratoms+1),
250 newnr/(nratoms+1));
252 il->nr = newnr;
253 for (i = 0; (i < newnr); i++)
255 il->iatoms[i] = ia[i];
258 sfree(ia);
262 static void reduce_topology_x(int gnx, int index[],
263 gmx_mtop_t *mtop, rvec x[], rvec v[])
265 t_topology top;
266 gmx_bool *bKeep;
267 int *invindex;
268 int i;
270 top = gmx_mtop_t_to_t_topology(mtop, false);
271 bKeep = bKeepIt(gnx, top.atoms.nr, index);
272 invindex = invind(gnx, top.atoms.nr, index);
274 reduce_block(bKeep, &(top.cgs), "cgs");
275 reduce_block(bKeep, &(top.mols), "mols");
276 reduce_blocka(invindex, bKeep, &(top.excls), "excls");
277 reduce_rvec(gnx, index, x);
278 reduce_rvec(gnx, index, v);
279 reduce_atom(gnx, index, top.atoms.atom, top.atoms.atomname,
280 &(top.atoms.nres), top.atoms.resinfo);
282 for (i = 0; (i < F_NRE); i++)
284 reduce_ilist(invindex, bKeep, &(top.idef.il[i]),
285 interaction_function[i].nratoms,
286 interaction_function[i].name);
289 top.atoms.nr = gnx;
291 mtop->moltype.resize(1);
292 mtop->moltype[0].name = mtop->name;
293 mtop->moltype[0].atoms = top.atoms;
294 for (i = 0; i < F_NRE; i++)
296 mtop->moltype[0].ilist[i] = top.idef.il[i];
298 mtop->moltype[0].atoms = top.atoms;
299 mtop->moltype[0].cgs = top.cgs;
300 mtop->moltype[0].excls = top.excls;
302 mtop->molblock.resize(1);
303 mtop->molblock[0].type = 0;
304 mtop->molblock[0].nmol = 1;
305 mtop->molblock[0].natoms_mol = top.atoms.nr;
306 mtop->molblock[0].nposres_xA = 0;
307 mtop->molblock[0].nposres_xB = 0;
309 mtop->natoms = top.atoms.nr;
312 static void zeroq(int index[], gmx_mtop_t *mtop)
314 for (gmx_moltype_t &moltype : mtop->moltype)
316 for (int i = 0; i < moltype.atoms.nr; i++)
318 moltype.atoms.atom[index[i]].q = 0;
319 moltype.atoms.atom[index[i]].qB = 0;
324 int gmx_convert_tpr(int argc, char *argv[])
326 const char *desc[] = {
327 "[THISMODULE] can edit run input files in three ways.[PAR]",
328 "[BB]1.[bb] by modifying the number of steps in a run input file",
329 "with options [TT]-extend[tt], [TT]-until[tt] or [TT]-nsteps[tt]",
330 "(nsteps=-1 means unlimited number of steps)[PAR]",
331 "[BB]2.[bb] by creating a [REF].tpx[ref] file for a subset of your original",
332 "tpx file, which is useful when you want to remove the solvent from",
333 "your [REF].tpx[ref] file, or when you want to make e.g. a pure C[GRK]alpha[grk] [REF].tpx[ref] file.",
334 "Note that you may need to use [TT]-nsteps -1[tt] (or similar) to get",
335 "this to work.",
336 "[BB]WARNING: this [REF].tpx[ref] file is not fully functional[bb].[PAR]",
337 "[BB]3.[bb] by setting the charges of a specified group",
338 "to zero. This is useful when doing free energy estimates",
339 "using the LIE (Linear Interaction Energy) method."
342 const char *top_fn;
343 int i;
344 gmx_int64_t nsteps_req, run_step;
345 double run_t, state_t;
346 gmx_bool bSel;
347 gmx_bool bNsteps, bExtend, bUntil;
348 gmx_mtop_t mtop;
349 t_atoms atoms;
350 t_state state;
351 int gnx;
352 char *grpname;
353 int *index = nullptr;
354 char buf[200], buf2[200];
355 gmx_output_env_t *oenv;
356 t_filenm fnm[] = {
357 { efTPR, nullptr, nullptr, ffREAD },
358 { efNDX, nullptr, nullptr, ffOPTRD },
359 { efTPR, "-o", "tprout", ffWRITE }
361 #define NFILE asize(fnm)
363 /* Command line options */
364 static int nsteps_req_int = 0;
365 static real extend_t = 0.0, until_t = 0.0;
366 static gmx_bool bZeroQ = FALSE;
367 static t_pargs pa[] = {
368 { "-extend", FALSE, etREAL, {&extend_t},
369 "Extend runtime by this amount (ps)" },
370 { "-until", FALSE, etREAL, {&until_t},
371 "Extend runtime until this ending time (ps)" },
372 { "-nsteps", FALSE, etINT, {&nsteps_req_int},
373 "Change the number of steps" },
374 { "-zeroq", FALSE, etBOOL, {&bZeroQ},
375 "Set the charges of a group (from the index) to zero" }
378 /* Parse the command line */
379 if (!parse_common_args(&argc, argv, 0, NFILE, fnm, asize(pa), pa,
380 asize(desc), desc, 0, nullptr, &oenv))
382 return 0;
385 /* Convert int to gmx_int64_t */
386 nsteps_req = nsteps_req_int;
387 bNsteps = opt2parg_bSet("-nsteps", asize(pa), pa);
388 bExtend = opt2parg_bSet("-extend", asize(pa), pa);
389 bUntil = opt2parg_bSet("-until", asize(pa), pa);
391 top_fn = ftp2fn(efTPR, NFILE, fnm);
392 fprintf(stderr, "Reading toplogy and stuff from %s\n", top_fn);
394 t_inputrec irInstance;
395 t_inputrec *ir = &irInstance;
396 read_tpx_state(top_fn, ir, &state, &mtop);
397 run_step = ir->init_step;
398 run_t = ir->init_step*ir->delta_t + ir->init_t;
400 if (bNsteps)
402 fprintf(stderr, "Setting nsteps to %s\n", gmx_step_str(nsteps_req, buf));
403 ir->nsteps = nsteps_req;
405 else
407 /* Determine total number of steps remaining */
408 if (bExtend)
410 ir->nsteps = ir->nsteps - (run_step - ir->init_step) + (gmx_int64_t)(extend_t/ir->delta_t + 0.5);
411 printf("Extending remaining runtime of by %g ps (now %s steps)\n",
412 extend_t, gmx_step_str(ir->nsteps, buf));
414 else if (bUntil)
416 printf("nsteps = %s, run_step = %s, current_t = %g, until = %g\n",
417 gmx_step_str(ir->nsteps, buf),
418 gmx_step_str(run_step, buf2),
419 run_t, until_t);
420 ir->nsteps = (gmx_int64_t)((until_t - run_t)/ir->delta_t + 0.5);
421 printf("Extending remaining runtime until %g ps (now %s steps)\n",
422 until_t, gmx_step_str(ir->nsteps, buf));
424 else
426 ir->nsteps -= run_step - ir->init_step;
427 /* Print message */
428 printf("%s steps (%g ps) remaining from first run.\n",
429 gmx_step_str(ir->nsteps, buf), ir->nsteps*ir->delta_t);
433 if (bNsteps || bZeroQ || (ir->nsteps > 0))
435 ir->init_step = run_step;
437 if (ftp2bSet(efNDX, NFILE, fnm) ||
438 !(bNsteps || bExtend || bUntil))
440 atoms = gmx_mtop_global_atoms(&mtop);
441 get_index(&atoms, ftp2fn_null(efNDX, NFILE, fnm), 1,
442 &gnx, &index, &grpname);
443 if (!bZeroQ)
445 bSel = (gnx != state.natoms);
446 for (i = 0; ((i < gnx) && (!bSel)); i++)
448 bSel = (i != index[i]);
451 else
453 bSel = FALSE;
455 if (bSel)
457 fprintf(stderr, "Will write subset %s of original tpx containing %d "
458 "atoms\n", grpname, gnx);
459 reduce_topology_x(gnx, index, &mtop, as_rvec_array(state.x.data()), as_rvec_array(state.v.data()));
460 state.natoms = gnx;
462 else if (bZeroQ)
464 zeroq(index, &mtop);
465 fprintf(stderr, "Zero-ing charges for group %s\n", grpname);
467 else
469 fprintf(stderr, "Will write full tpx file (no selection)\n");
473 state_t = ir->init_t + ir->init_step*ir->delta_t;
474 sprintf(buf, "Writing statusfile with starting step %s%s and length %s%s steps...\n", "%10", GMX_PRId64, "%10", GMX_PRId64);
475 fprintf(stderr, buf, ir->init_step, ir->nsteps);
476 fprintf(stderr, " time %10.3f and length %10.3f ps\n",
477 state_t, ir->nsteps*ir->delta_t);
478 write_tpx_state(opt2fn("-o", NFILE, fnm), ir, &state, &mtop);
480 else
482 printf("You've simulated long enough. Not writing tpr file\n");
485 return 0;