2 * This file is part of the GROMACS molecular simulation package.
4 * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
5 * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
6 * and including many others, as listed in the AUTHORS file in the
7 * top-level source directory and at http://www.gromacs.org.
9 * GROMACS is free software; you can redistribute it and/or
10 * modify it under the terms of the GNU Lesser General Public License
11 * as published by the Free Software Foundation; either version 2.1
12 * of the License, or (at your option) any later version.
14 * GROMACS is distributed in the hope that it will be useful,
15 * but WITHOUT ANY WARRANTY; without even the implied warranty of
16 * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
17 * Lesser General Public License for more details.
19 * You should have received a copy of the GNU Lesser General Public
20 * License along with GROMACS; if not, see
21 * http://www.gnu.org/licenses, or write to the Free Software Foundation,
22 * Inc., 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA.
24 * If you want to redistribute modifications to GROMACS, please
25 * consider that scientific software is very special. Version
26 * control is crucial - bugs must be traceable. We will be happy to
27 * consider code for inclusion in the official distribution, but
28 * derived work must not be called official GROMACS. Details are found
29 * in the README & COPYING files - if they are missing, get the
30 * official version at http://www.gromacs.org.
32 * To help us fund GROMACS development, we humbly ask that you cite
33 * the research papers on the package. Check out http://www.gromacs.org.
39 * Implements functions of imd.h.
41 * Re-implementation of basic IMD functions from NAMD/VMD from scratch,
42 * see imdsocket.h for references to the IMD API.
44 * \author Martin Hoefling, Carsten Kutzner <ckutzne@gwdg.de>
57 #if GMX_NATIVE_WINDOWS
63 #include "gromacs/commandline/filenm.h"
64 #include "gromacs/domdec/domdec_struct.h"
65 #include "gromacs/domdec/ga2la.h"
66 #include "gromacs/fileio/confio.h"
67 #include "gromacs/fileio/gmxfio.h"
68 #include "gromacs/fileio/xvgr.h"
69 #include "gromacs/gmxlib/network.h"
70 #include "gromacs/imd/imdsocket.h"
71 #include "gromacs/math/units.h"
72 #include "gromacs/math/vec.h"
73 #include "gromacs/mdlib/broadcaststructs.h"
74 #include "gromacs/mdlib/groupcoord.h"
75 #include "gromacs/mdlib/mdrun.h"
76 #include "gromacs/mdlib/sighandler.h"
77 #include "gromacs/mdlib/sim_util.h"
78 #include "gromacs/mdtypes/inputrec.h"
79 #include "gromacs/mdtypes/md_enums.h"
80 #include "gromacs/mdtypes/state.h"
81 #include "gromacs/pbcutil/pbc.h"
82 #include "gromacs/timing/wallcycle.h"
83 #include "gromacs/topology/mtop_util.h"
84 #include "gromacs/topology/topology.h"
85 #include "gromacs/utility/fatalerror.h"
86 #include "gromacs/utility/smalloc.h"
88 /*! \brief How long shall we wait in seconds until we check for a connection again? */
91 /*! \brief How long shall we check for the IMD_GO? */
92 #define IMDCONNECTWAIT 2
94 /*! \brief IMD Header Size. */
96 /*! \brief IMD Protocol Version. */
102 * IMD (interactive molecular dynamics) energy record.
104 * As in the original IMD implementation. Energies in kcal/mol.
105 * NOTE: We return the energies in GROMACS / SI units,
106 * so they also show up as SI in VMD.
111 int32_t tstep
; /**< time step */
112 float T_abs
; /**< absolute temperature */
113 float E_tot
; /**< total energy */
114 float E_pot
; /**< potential energy */
115 float E_vdw
; /**< van der Waals energy */
116 float E_coul
; /**< Coulomb interaction energy */
117 float E_bond
; /**< bonds energy */
118 float E_angle
; /**< angles energy */
119 float E_dihe
; /**< dihedrals energy */
120 float E_impr
; /**< improper dihedrals energy */
125 * \brief IMD (interactive molecular dynamics) communication structure.
127 * This structure defines the IMD communication message header & protocol version.
131 int32_t type
; /**< Type of IMD message, see IMDType_t above */
132 int32_t length
; /**< Length */
137 * \brief IMD (interactive molecular dynamics) main data structure.
139 * Contains private IMD data
141 typedef struct t_gmx_IMD
143 FILE *outf
; /**< Output file for IMD data, mainly forces. */
145 int nat
; /**< Number of atoms that can be pulled via IMD. */
146 int nat_loc
; /**< Part of the atoms that are local. */
147 int *ind
; /**< Global indices of the IMD atoms. */
148 int *ind_loc
; /**< Local indices of the IMD atoms. */
149 int nalloc_loc
; /**< Allocation size for ind_loc. */
150 rvec
*xa
; /**< Positions for all IMD atoms assembled on
152 ivec
*xa_shifts
; /**< Shifts for all IMD atoms, to make
153 molecule(s) whole. */
154 ivec
*xa_eshifts
; /**< Extra shifts since last DD step. */
155 rvec
*xa_old
; /**< Old positions for all IMD atoms on master. */
156 int *xa_ind
; /**< Position of each local atom in the
159 int nstimd
; /**< Global IMD frequency, known to all nodes. */
160 int nstimd_new
; /**< New frequency from IMD client, master only. */
161 int nstimd_def
; /**< Default IMD frequency when disconnected. */
163 int port
; /**< Port to use for network socket. */
164 IMDSocket
*socket
; /**< The IMD socket on the master node. */
165 IMDSocket
*clientsocket
; /**< The IMD socket on the client. */
166 int length
; /**< Length we got with last header. */
168 gmx_bool bWConnect
; /**< Shall we block and wait for connection? */
169 gmx_bool bTerminated
; /**< Set if MD is terminated. */
170 gmx_bool bTerminatable
; /**< Set if MD can be terminated. */
171 gmx_bool bConnected
; /**< Set if connection is present. */
172 gmx_bool bNewForces
; /**< Set if we received new forces. */
173 gmx_bool bForceActivated
; /**< Set if pulling from VMD is allowed. */
175 IMDEnergyBlock
*energies
; /**< Pointer to energies we send back. */
177 int32_t vmd_nforces
; /**< Number of VMD forces. */
178 int32_t *vmd_f_ind
; /**< VMD forces indices. */
179 float *vmd_forces
; /**< The VMD forces flat in memory. */
180 int nforces
; /**< Number of actual MD forces;
181 this gets communicated to the clients. */
182 int *f_ind
; /**< Force indices. */
183 rvec
*f
; /**< The IMD pulling forces. */
185 char *forcesendbuf
; /**< Buffer for force sending. */
186 char *coordsendbuf
; /**< Buffer for coordinate sending. */
187 char *energysendbuf
; /**< Send buffer for energies. */
188 rvec
*sendxbuf
; /**< Buffer to make molecules whole before
191 t_block mols
; /**< Molecules block in IMD group. */
193 /* The next block is used on the master node only to reduce the output
194 * without sacrificing information. If any of these values changes,
195 * we need to write output */
196 int old_nforces
; /**< Old value for nforces. */
197 int *old_f_ind
; /**< Old values for force indices. */
198 rvec
*old_forces
; /**< Old values for IMD pulling forces. */
204 * \brief Enum for types of IMD messages.
206 * We use the same records as the NAMD/VMD IMD implementation.
208 typedef enum IMDType_t
210 IMD_DISCONNECT
, /**< client disconnect */
211 IMD_ENERGIES
, /**< energy data */
212 IMD_FCOORDS
, /**< atomic coordinates */
213 IMD_GO
, /**< start command for the simulation */
214 IMD_HANDSHAKE
, /**< handshake to determine little/big endianness */
215 IMD_KILL
, /**< terminates the simulation */
216 IMD_MDCOMM
, /**< force data */
217 IMD_PAUSE
, /**< pauses the simulation */
218 IMD_TRATE
, /**< sets the IMD transmission and processing rate */
219 IMD_IOERROR
, /**< I/O error */
220 IMD_NR
/**< number of entries */
225 * \brief Names of the IMDType for error messages.
227 static const char *eIMDType_names
[IMD_NR
+ 1] = {
245 /*! \brief Fills the header with message and the length argument. */
246 static void fill_header(IMDHeader
*header
, IMDMessageType type
, int32_t length
)
248 /* We (ab-)use htonl network function for the correct endianness */
249 header
->type
= htonl((int32_t) type
);
250 header
->length
= htonl(length
);
254 /*! \brief Swaps the endianess of the header. */
255 static void swap_header(IMDHeader
*header
)
257 /* and vice versa... */
258 header
->type
= ntohl(header
->type
);
259 header
->length
= ntohl(header
->length
);
263 /*! \brief Reads multiple bytes from socket. */
264 static int32_t imd_read_multiple(IMDSocket
*socket
, char *datptr
, int32_t toread
)
266 int32_t leftcount
, countread
;
270 /* Try to read while we haven't reached toread */
271 while (leftcount
!= 0)
273 if ((countread
= imdsock_read(socket
, datptr
, leftcount
)) < 0)
275 /* interrupted function call, try again... */
280 /* this is an unexpected error, return what we got */
283 return toread
- leftcount
;
286 /* nothing read, finished */
288 else if (countread
== 0)
292 leftcount
-= countread
;
296 /* return nr of bytes read */
297 return toread
- leftcount
;
301 /*! \brief Writes multiple bytes to socket in analogy to imd_read_multiple. */
302 static int32_t imd_write_multiple(IMDSocket
*socket
, const char *datptr
, int32_t towrite
)
304 int32_t leftcount
, countwritten
;
308 while (leftcount
!= 0)
310 if ((countwritten
= imdsock_write(socket
, datptr
, leftcount
)) <= 0)
318 return towrite
- leftcount
;
321 leftcount
-= countwritten
;
322 datptr
+= countwritten
;
325 return towrite
- leftcount
;
329 /*! \brief Handshake with IMD client. */
330 static int imd_handshake(IMDSocket
*socket
)
335 fill_header(&header
, IMD_HANDSHAKE
, 1);
336 header
.length
= IMDVERSION
; /* client wants unswapped version */
338 return (imd_write_multiple(socket
, (char *) &header
, HEADERSIZE
) != HEADERSIZE
);
342 /*! \brief Send energies using the energy block and the send buffer. */
343 static int imd_send_energies(IMDSocket
*socket
, const IMDEnergyBlock
*energies
, char *buffer
)
348 recsize
= HEADERSIZE
+ sizeof(IMDEnergyBlock
);
349 fill_header((IMDHeader
*) buffer
, IMD_ENERGIES
, 1);
350 memcpy(buffer
+ HEADERSIZE
, energies
, sizeof(IMDEnergyBlock
));
352 return (imd_write_multiple(socket
, buffer
, recsize
) != recsize
);
356 /*! \brief Receive IMD header from socket, sets the length and returns the IMD message. */
357 static IMDMessageType
imd_recv_header(IMDSocket
*socket
, int32_t *length
)
362 if (imd_read_multiple(socket
, (char *) &header
, HEADERSIZE
) != HEADERSIZE
)
366 swap_header(&header
);
367 *length
= header
.length
;
369 return (IMDMessageType
) header
.type
;
373 /*! \brief Receive force indices and forces.
375 * The number of forces was previously communicated via the header.
377 static int imd_recv_mdcomm(IMDSocket
*socket
, int32_t nforces
, int32_t *forcendx
, float *forces
)
379 int retsize
, retbytes
;
382 /* reading indices */
383 retsize
= sizeof(int32_t) * nforces
;
384 retbytes
= imd_read_multiple(socket
, (char *) forcendx
, retsize
);
385 if (retbytes
!= retsize
)
390 /* reading forces as float array */
391 retsize
= 3 * sizeof(float) * nforces
;
392 retbytes
= imd_read_multiple(socket
, (char *) forces
, retsize
);
393 if (retbytes
!= retsize
)
403 /* GROMACS specific functions for the IMD implementation */
404 void write_IMDgroup_to_file(gmx_bool bIMD
, t_inputrec
*ir
, t_state
*state
,
405 gmx_mtop_t
*sys
, int nfile
, const t_filenm fnm
[])
412 IMDatoms
= gmx_mtop_global_atoms(sys
);
413 write_sto_conf_indexed(opt2fn("-imd", nfile
, fnm
), "IMDgroup", &IMDatoms
,
414 as_rvec_array(state
->x
.data()), as_rvec_array(state
->v
.data()), ir
->ePBC
, state
->box
, ir
->imd
->nat
, ir
->imd
->ind
);
419 void dd_make_local_IMD_atoms(gmx_bool bIMD
, gmx_domdec_t
*dd
, t_IMD
*imd
)
422 t_gmx_IMD_setup
*IMDsetup
;
426 IMDsetup
= imd
->setup
;
429 dd_make_local_group_indices(
430 ga2la
, IMDsetup
->nat
, IMDsetup
->ind
, &IMDsetup
->nat_loc
,
431 &IMDsetup
->ind_loc
, &IMDsetup
->nalloc_loc
, IMDsetup
->xa_ind
);
437 /*! \brief Send positions from rvec.
439 * We need a separate send buffer and conversion to Angstrom.
441 static int imd_send_rvecs(IMDSocket
*socket
, int nat
, rvec
*x
, char *buffer
)
446 int tuplesize
= 3 * sizeof(float);
449 /* Required size for the send buffer */
450 size
= HEADERSIZE
+ 3 * sizeof(float) * nat
;
453 fill_header((IMDHeader
*) buffer
, IMD_FCOORDS
, (int32_t) nat
);
454 for (i
= 0; i
< nat
; i
++)
456 sendx
[0] = (float) x
[i
][0] * NM2A
;
457 sendx
[1] = (float) x
[i
][1] * NM2A
;
458 sendx
[2] = (float) x
[i
][2] * NM2A
;
459 memcpy(buffer
+ HEADERSIZE
+ i
* tuplesize
, sendx
, tuplesize
);
462 return (imd_write_multiple(socket
, buffer
, size
) != size
);
466 /*! \brief Initializes the IMD private data. */
467 static t_gmx_IMD_setup
* imd_create(int imdatoms
, int nstimddef
, int imdport
)
469 t_gmx_IMD_setup
*IMDsetup
= nullptr;
473 IMDsetup
->nat
= imdatoms
;
474 IMDsetup
->bTerminated
= FALSE
;
475 IMDsetup
->bTerminatable
= FALSE
;
476 IMDsetup
->bWConnect
= FALSE
;
477 IMDsetup
->bConnected
= FALSE
;
478 IMDsetup
->bForceActivated
= FALSE
;
479 IMDsetup
->bNewForces
= FALSE
;
480 IMDsetup
->bForceActivated
= FALSE
;
481 IMDsetup
->nstimd
= 1;
482 IMDsetup
->nstimd_new
= 1;
483 IMDsetup
->nstimd_def
= nstimddef
;
487 fprintf(stderr
, "%s You chose a port number < 1. Will automatically assign a free port.\n", IMDstr
);
491 IMDsetup
->port
= imdport
;
498 /*! \brief Prepare the socket on the MASTER. */
499 static void imd_prepare_master_socket(t_gmx_IMD_setup
*IMDsetup
)
504 #if GMX_NATIVE_WINDOWS
505 /* Winsock requires separate initialization */
506 fprintf(stderr
, "%s Initializing winsock.\n", IMDstr
);
507 #ifdef GMX_HAVE_WINSOCK
508 if (imdsock_winsockinit())
510 gmx_fatal(FARGS
, "%s Failed to initialize winsock.\n", IMDstr
);
515 /* The rest is identical, first create and bind a socket and set to listen then. */
516 fprintf(stderr
, "%s Setting up incoming socket.\n", IMDstr
);
517 IMDsetup
->socket
= imdsock_create();
518 if (!IMDsetup
->socket
)
520 gmx_fatal(FARGS
, "%s Failed to create socket.", IMDstr
);
524 ret
= imdsock_bind(IMDsetup
->socket
, IMDsetup
->port
);
527 gmx_fatal(FARGS
, "%s binding socket to port %d failed with error %d.\n", IMDstr
, IMDsetup
->port
, ret
);
530 if (imd_sock_listen(IMDsetup
->socket
))
532 gmx_fatal(FARGS
, "%s socket listen failed with error %d.\n", IMDstr
, ret
);
535 if (imdsock_getport(IMDsetup
->socket
, &IMDsetup
->port
))
537 gmx_fatal(FARGS
, "%s Could not determine port number.\n", IMDstr
, ret
);
540 fprintf(stderr
, "%s Listening for IMD connection on port %d.\n", IMDstr
, IMDsetup
->port
);
544 /*! \brief Disconnect the client. */
545 static void imd_disconnect(t_gmx_IMD_setup
*IMDsetup
)
547 /* Write out any buffered pulling data */
548 fflush(IMDsetup
->outf
);
550 /* we first try to shut down the clientsocket */
551 imdsock_shutdown(IMDsetup
->clientsocket
);
552 if (!imdsock_destroy(IMDsetup
->clientsocket
))
554 fprintf(stderr
, "%s Failed to destroy socket.\n", IMDstr
);
557 /* then we reset the IMD step to its default, and reset the connection boolean */
558 IMDsetup
->nstimd_new
= IMDsetup
->nstimd_def
;
559 IMDsetup
->clientsocket
= nullptr;
560 IMDsetup
->bConnected
= FALSE
;
564 /*! \brief Prints an error message and disconnects the client.
566 * Does not terminate mdrun!
568 static void imd_fatal(t_gmx_IMD_setup
*IMDsetup
, const char *msg
)
570 fprintf(stderr
, "%s %s", IMDstr
, msg
);
571 imd_disconnect(IMDsetup
);
572 fprintf(stderr
, "%s disconnected.\n", IMDstr
);
576 /*! \brief Check whether we got an incoming connection. */
577 static gmx_bool
imd_tryconnect(t_gmx_IMD_setup
*IMDsetup
)
579 if (imdsock_tryread(IMDsetup
->socket
, 0, 0) > 0)
581 /* yes, we got something, accept on clientsocket */
582 IMDsetup
->clientsocket
= imdsock_accept(IMDsetup
->socket
);
583 if (!IMDsetup
->clientsocket
)
585 fprintf(stderr
, "%s Accepting the connection on the socket failed.\n", IMDstr
);
589 /* handshake with client */
590 if (imd_handshake(IMDsetup
->clientsocket
))
592 imd_fatal(IMDsetup
, "Connection failed.\n");
596 fprintf(stderr
, "%s Connection established, checking if I got IMD_GO orders.\n", IMDstr
);
598 /* Check if we get the proper "GO" command from client. */
599 if (imdsock_tryread(IMDsetup
->clientsocket
, IMDCONNECTWAIT
, 0) != 1 || imd_recv_header(IMDsetup
->clientsocket
, &(IMDsetup
->length
)) != IMD_GO
)
601 imd_fatal(IMDsetup
, "No IMD_GO order received. IMD connection failed.\n");
605 IMDsetup
->bConnected
= TRUE
;
614 /*! \brief Wrap imd_tryconnect in order to make it blocking.
616 * Used when the simulation should wait for an incoming connection.
618 static void imd_blockconnect(t_gmx_IMD_setup
*IMDsetup
)
620 /* do not wait for connection, when e.g. ctrl+c is pressed and we will terminate anyways. */
621 if (!((int) gmx_get_stop_condition() == gmx_stop_cond_none
))
626 fprintf(stderr
, "%s Will wait until I have a connection and IMD_GO orders.\n", IMDstr
);
628 /* while we have no clientsocket... 2nd part: we should still react on ctrl+c */
629 while ((!IMDsetup
->clientsocket
) && ((int) gmx_get_stop_condition() == gmx_stop_cond_none
))
631 imd_tryconnect(IMDsetup
);
632 #if GMX_NATIVE_WINDOWS
633 /* for whatever reason, it is called Sleep on windows */
642 /*! \brief Make sure that our array holding the forces received via IMD is large enough. */
643 static void imd_prepare_vmd_Forces(t_gmx_IMD_setup
*IMDsetup
)
645 srenew((IMDsetup
->vmd_f_ind
), IMDsetup
->vmd_nforces
);
646 srenew((IMDsetup
->vmd_forces
), 3*IMDsetup
->vmd_nforces
);
650 /*! \brief Reads forces received via IMD. */
651 static void imd_read_vmd_Forces(t_gmx_IMD_setup
*IMDsetup
)
653 /* the length of the previously received header tells us the nr of forces we will receive */
654 IMDsetup
->vmd_nforces
= IMDsetup
->length
;
655 /* prepare the arrays */
656 imd_prepare_vmd_Forces(IMDsetup
);
657 /* Now we read the forces... */
658 if (!(imd_recv_mdcomm(IMDsetup
->clientsocket
, IMDsetup
->vmd_nforces
, IMDsetup
->vmd_f_ind
, IMDsetup
->vmd_forces
)))
660 imd_fatal(IMDsetup
, "Error while reading forces from remote. Disconnecting\n");
665 /*! \brief Prepares the MD force arrays. */
666 static void imd_prepare_MD_Forces(t_gmx_IMD_setup
*IMDsetup
)
668 srenew((IMDsetup
->f_ind
), IMDsetup
->nforces
);
669 srenew((IMDsetup
->f
), IMDsetup
->nforces
);
673 /*! \brief Copy IMD forces to MD forces.
675 * Do conversion from Cal->Joule and from
676 * Angstrom -> nm and from a pointer array to arrays to 3*N array.
678 static void imd_copyto_MD_Forces(t_gmx_IMD_setup
*IMDsetup
)
681 real conversion
= CAL2JOULE
* NM2A
;
684 for (i
= 0; i
< IMDsetup
->nforces
; i
++)
686 /* Copy the indices, a copy is important because we may update the incoming forces
687 * whenever we receive new forces while the MD forces are only communicated upon
688 * IMD communication.*/
689 IMDsetup
->f_ind
[i
] = IMDsetup
->vmd_f_ind
[i
];
691 /* Convert to rvecs and do a proper unit conversion */
692 IMDsetup
->f
[i
][0] = IMDsetup
->vmd_forces
[3*i
] * conversion
;
693 IMDsetup
->f
[i
][1] = IMDsetup
->vmd_forces
[3*i
+ 1] * conversion
;
694 IMDsetup
->f
[i
][2] = IMDsetup
->vmd_forces
[3*i
+ 2] * conversion
;
699 /*! \brief Return TRUE if any of the forces or indices changed. */
700 static gmx_bool
bForcesChanged(t_gmx_IMD_setup
*IMDsetup
)
705 /* First, check whether the number of pulled atoms changed */
706 if (IMDsetup
->nforces
!= IMDsetup
->old_nforces
)
711 /* Second, check whether any of the involved atoms changed */
712 for (i
= 0; i
< IMDsetup
->nforces
; i
++)
714 if (IMDsetup
->f_ind
[i
] != IMDsetup
->old_f_ind
[i
])
720 /* Third, check whether all forces are the same */
721 for (i
= 0; i
< IMDsetup
->nforces
; i
++)
723 if (IMDsetup
->f
[i
][XX
] != IMDsetup
->old_forces
[i
][XX
])
727 if (IMDsetup
->f
[i
][YY
] != IMDsetup
->old_forces
[i
][YY
])
731 if (IMDsetup
->f
[i
][ZZ
] != IMDsetup
->old_forces
[i
][ZZ
])
737 /* All old and new forces are identical! */
742 /*! \brief Fill the old_f_ind and old_forces arrays with the new, old values. */
743 static void keep_old_values(t_gmx_IMD_setup
*IMDsetup
)
748 IMDsetup
->old_nforces
= IMDsetup
->nforces
;
750 for (i
= 0; i
< IMDsetup
->nforces
; i
++)
752 IMDsetup
->old_f_ind
[i
] = IMDsetup
->f_ind
[i
];
753 copy_rvec(IMDsetup
->f
[i
], IMDsetup
->old_forces
[i
]);
758 /*! \brief Returns TRUE if any component of the two rvecs differs. */
759 static inline gmx_bool
rvecs_differ(const rvec v1
, const rvec v2
)
764 for (i
= 0; i
< DIM
; i
++)
776 /*! \brief Write the applied pull forces to logfile.
778 * Call on master only!
780 static void output_imd_forces(t_inputrec
*ir
, double time
)
782 t_gmx_IMD_setup
*IMDsetup
;
786 IMDsetup
= ir
->imd
->setup
;
788 if (bForcesChanged(IMDsetup
))
790 /* Write time and total number of applied IMD forces */
791 fprintf(IMDsetup
->outf
, "%14.6e%6d", time
, IMDsetup
->nforces
);
793 /* Write out the global atom indices of the pulled atoms and the forces itself,
794 * write out a force only if it has changed since the last output */
795 for (i
= 0; i
< IMDsetup
->nforces
; i
++)
797 if (rvecs_differ(IMDsetup
->f
[i
], IMDsetup
->old_forces
[i
]))
799 fprintf(IMDsetup
->outf
, "%9d", IMDsetup
->ind
[IMDsetup
->f_ind
[i
]] + 1);
800 fprintf(IMDsetup
->outf
, "%12.4e%12.4e%12.4e", IMDsetup
->f
[i
][0], IMDsetup
->f
[i
][1], IMDsetup
->f
[i
][2]);
803 fprintf(IMDsetup
->outf
, "\n");
805 keep_old_values(IMDsetup
);
810 /*! \brief Synchronize the nodes. */
811 static void imd_sync_nodes(t_inputrec
*ir
, const t_commrec
*cr
, double t
)
814 t_gmx_IMD_setup
*IMDsetup
;
817 IMDsetup
= ir
->imd
->setup
;
819 /* Notify the other nodes whether we are still connected. */
822 block_bc(cr
, IMDsetup
->bConnected
);
825 /* ...if not connected, the job is done here. */
826 if (!IMDsetup
->bConnected
)
831 /* Let the other nodes know whether we got a new IMD synchronization frequency. */
834 block_bc(cr
, IMDsetup
->nstimd_new
);
837 /* Now we all set the (new) nstimd communication time step */
838 IMDsetup
->nstimd
= IMDsetup
->nstimd_new
;
840 /* We're done if we don't allow pulling at all */
841 if (!(IMDsetup
->bForceActivated
))
846 /* OK, let's check if we have received forces which we need to communicate
847 * to the other nodes */
850 if (IMDsetup
->bNewForces
)
852 new_nforces
= IMDsetup
->vmd_nforces
;
854 /* make the "new_forces" negative, when we did not receive new ones */
857 new_nforces
= IMDsetup
->vmd_nforces
* -1;
861 /* make new_forces known to the clients */
864 block_bc(cr
, new_nforces
);
867 /* When new_natoms < 0 then we know that these are still the same forces
868 * so we don't communicate them, otherwise... */
869 if (new_nforces
>= 0)
871 /* set local VMD and nforces */
872 IMDsetup
->vmd_nforces
= new_nforces
;
873 IMDsetup
->nforces
= IMDsetup
->vmd_nforces
;
875 /* now everybody knows the number of forces in f_ind, so we can prepare
876 * the target arrays for indices and forces */
877 imd_prepare_MD_Forces(IMDsetup
);
879 /* we first update the MD forces on the master by converting the VMD forces */
882 imd_copyto_MD_Forces(IMDsetup
);
883 /* We also write out forces on every update, so that we know which
884 * forces are applied for every step */
887 output_imd_forces(ir
, t
);
891 /* In parallel mode we communicate the to-be-applied forces to the other nodes */
894 nblock_bc(cr
, IMDsetup
->nforces
, IMDsetup
->f_ind
);
895 nblock_bc(cr
, IMDsetup
->nforces
, IMDsetup
->f
);
898 /* done communicating the forces, reset bNewForces */
899 IMDsetup
->bNewForces
= FALSE
;
904 /*! \brief Reads header from the client and decides what to do. */
905 static void imd_readcommand(t_gmx_IMD_setup
*IMDsetup
)
907 gmx_bool IMDpaused
= FALSE
;
908 IMDMessageType itype
;
911 while (IMDsetup
->clientsocket
&& (imdsock_tryread(IMDsetup
->clientsocket
, 0, 0) > 0 || IMDpaused
))
913 itype
= imd_recv_header(IMDsetup
->clientsocket
, &(IMDsetup
->length
));
914 /* let's see what we got: */
917 /* IMD asks us to terminate the simulation, check if the user allowed this */
919 if (IMDsetup
->bTerminatable
)
921 fprintf(stderr
, " %s Terminating connection and running simulation (if supported by integrator).\n", IMDstr
);
922 IMDsetup
->bTerminated
= TRUE
;
923 IMDsetup
->bWConnect
= FALSE
;
924 gmx_set_stop_condition(gmx_stop_cond_next
);
928 fprintf(stderr
, " %s Set -imdterm command line switch to allow mdrun termination from within IMD.\n", IMDstr
);
933 /* the client doen't want to talk to us anymore */
935 fprintf(stderr
, " %s Disconnecting client.\n", IMDstr
);
936 imd_disconnect(IMDsetup
);
939 /* we got new forces, read them and set bNewForces flag */
941 imd_read_vmd_Forces(IMDsetup
);
942 IMDsetup
->bNewForces
= TRUE
;
945 /* the client asks us to (un)pause the simulation. So we toggle the IMDpaused state */
949 fprintf(stderr
, " %s Un-pause command received.\n", IMDstr
);
954 fprintf(stderr
, " %s Pause command received.\n", IMDstr
);
960 /* the client sets a new transfer rate, if we get 0, we reset the rate
961 * to the default. VMD filters 0 however */
963 IMDsetup
->nstimd_new
= (IMDsetup
->length
> 0) ? IMDsetup
->length
: IMDsetup
->nstimd_def
;
964 fprintf(stderr
, " %s Update frequency will be set to %d.\n", IMDstr
, IMDsetup
->nstimd_new
);
967 /* Catch all rule for the remaining IMD types which we don't expect */
969 fprintf(stderr
, " %s Received unexpected %s.\n", IMDstr
, enum_name((int)itype
, IMD_NR
, eIMDType_names
));
970 imd_fatal(IMDsetup
, "Terminating connection\n");
977 /*! \brief Open IMD output file and write header information.
979 * Call on master only.
981 static FILE *open_imd_out(const char *fn
,
982 t_gmx_IMD_setup
*IMDsetup
,
984 const gmx_output_env_t
*oenv
,
985 const ContinuationOptions
&continuationOptions
)
990 /* Open log file of applied IMD forces if requested */
993 /* If we append to an existing file, all the header information is already there */
994 if (continuationOptions
.appendFiles
)
996 fp
= gmx_fio_fopen(fn
, "a+");
1000 fp
= gmx_fio_fopen(fn
, "w+");
1001 if (IMDsetup
->nat
== nat_total
)
1003 fprintf(fp
, "# Note that you can select an IMD index group in the .mdp file if a subset of the atoms suffices.\n");
1006 xvgr_header(fp
, "IMD Pull Forces", "Time (ps)", "# of Forces / Atom IDs / Forces (kJ/mol)", exvggtNONE
, oenv
);
1008 fprintf(fp
, "# Can display and manipulate %d (of a total of %d) atoms via IMD.\n", IMDsetup
->nat
, nat_total
);
1009 fprintf(fp
, "# column 1 : time (ps)\n");
1010 fprintf(fp
, "# column 2 : total number of atoms feeling an IMD pulling force at that time\n");
1011 fprintf(fp
, "# cols. 3.-6 : global atom number of pulled atom, x-force, y-force, z-force (kJ/mol)\n");
1012 fprintf(fp
, "# then follow : atom-ID, f[x], f[y], f[z] for more atoms in case the force on multiple atoms is changed simultaneously.\n");
1013 fprintf(fp
, "# Note that the force on any atom is always equal to the last value for that atom-ID found in the data.\n");
1017 /* To reduce the output file size we remember the old values and output only
1018 * when something changed */
1019 snew(IMDsetup
->old_f_ind
, IMDsetup
->nat
); /* One can never pull on more atoms */
1020 snew(IMDsetup
->old_forces
, IMDsetup
->nat
);
1025 fprintf(stdout
, "%s For a log of the IMD pull forces explicitly specify '-if' on the command line.\n"
1026 "%s (Not possible with energy minimization.)\n", IMDstr
, IMDstr
);
1033 void IMD_finalize(gmx_bool bIMD
, t_IMD
*imd
)
1037 if (imd
->setup
->outf
)
1039 gmx_fio_fclose(imd
->setup
->outf
);
1046 /*! \brief Creates the molecule start-end position array of molecules in the IMD group. */
1047 static void init_imd_prepare_mols_in_imdgroup(t_gmx_IMD_setup
*IMDsetup
, gmx_mtop_t
*top_global
)
1054 nat
= IMDsetup
->nat
;
1055 ind
= IMDsetup
->ind
;
1059 /* check whether index is sorted */
1060 for (i
= 0; i
< nat
-1; i
++)
1062 if (ind
[i
] > ind
[i
+1])
1064 gmx_fatal(FARGS
, "%s IMD index is not sorted. This is currently not supported.\n", IMDstr
);
1068 gmx::RangePartitioning gmols
= gmx_mtop_molecules(*top_global
);
1069 snew(lmols
.index
, gmols
.numBlocks() + 1);
1072 for (i
= 0; i
< gmols
.numBlocks(); i
++)
1074 auto mol
= gmols
.block(i
);
1076 for (ii
= 0; ii
< nat
; ii
++)
1078 if (mol
.inRange(ind
[ii
]))
1085 lmols
.index
[lmols
.nr
+1] = lmols
.index
[lmols
.nr
]+count
;
1089 srenew(lmols
.index
, lmols
.nr
+1);
1090 lmols
.nalloc_index
= lmols
.nr
+1;
1091 IMDsetup
->mols
= lmols
;
1095 /*! \brief Copied and modified from groupcoord.c shift_positions_group(). */
1096 static void shift_positions(
1098 rvec x
[], /* The positions [0..nr] */
1099 const ivec is
, /* The shift [0..nr] */
1100 int nr
) /* The number of positions */
1104 /* Loop over the group's atoms */
1107 for (i
= 0; i
< nr
; i
++)
1113 x
[i
][XX
] = x
[i
][XX
]-tx
*box
[XX
][XX
]-ty
*box
[YY
][XX
]-tz
*box
[ZZ
][XX
];
1114 x
[i
][YY
] = x
[i
][YY
]-ty
*box
[YY
][YY
]-tz
*box
[ZZ
][YY
];
1115 x
[i
][ZZ
] = x
[i
][ZZ
]-tz
*box
[ZZ
][ZZ
];
1120 for (i
= 0; i
< nr
; i
++)
1126 x
[i
][XX
] = x
[i
][XX
]-tx
*box
[XX
][XX
];
1127 x
[i
][YY
] = x
[i
][YY
]-ty
*box
[YY
][YY
];
1128 x
[i
][ZZ
] = x
[i
][ZZ
]-tz
*box
[ZZ
][ZZ
];
1134 /*! \brief Removes shifts of molecules diffused outside of the box. */
1135 static void imd_remove_molshifts(t_gmx_IMD_setup
*IMDsetup
, matrix box
)
1138 ivec largest
, smallest
, shift
;
1142 mols
= IMDsetup
->mols
;
1144 /* for each molecule also present in IMD group */
1145 for (i
= 0; i
< mols
.nr
; i
++)
1147 /* first we determine the minimum and maximum shifts for each molecule */
1149 clear_ivec(largest
);
1150 clear_ivec(smallest
);
1153 copy_ivec(IMDsetup
->xa_shifts
[mols
.index
[i
]], largest
);
1154 copy_ivec(IMDsetup
->xa_shifts
[mols
.index
[i
]], smallest
);
1156 for (ii
= mols
.index
[i
]+1; ii
< mols
.index
[i
+1]; ii
++)
1158 if (IMDsetup
->xa_shifts
[ii
][XX
] > largest
[XX
])
1160 largest
[XX
] = IMDsetup
->xa_shifts
[ii
][XX
];
1162 if (IMDsetup
->xa_shifts
[ii
][XX
] < smallest
[XX
])
1164 smallest
[XX
] = IMDsetup
->xa_shifts
[ii
][XX
];
1167 if (IMDsetup
->xa_shifts
[ii
][YY
] > largest
[YY
])
1169 largest
[YY
] = IMDsetup
->xa_shifts
[ii
][YY
];
1171 if (IMDsetup
->xa_shifts
[ii
][YY
] < smallest
[YY
])
1173 smallest
[YY
] = IMDsetup
->xa_shifts
[ii
][YY
];
1176 if (IMDsetup
->xa_shifts
[ii
][ZZ
] > largest
[ZZ
])
1178 largest
[ZZ
] = IMDsetup
->xa_shifts
[ii
][ZZ
];
1180 if (IMDsetup
->xa_shifts
[ii
][ZZ
] < smallest
[ZZ
])
1182 smallest
[ZZ
] = IMDsetup
->xa_shifts
[ii
][ZZ
];
1187 /* check if we what we can subtract/add to the positions
1188 * to put them back into the central box */
1189 if (smallest
[XX
] > 0)
1191 shift
[XX
] = smallest
[XX
];
1193 if (smallest
[YY
] > 0)
1195 shift
[YY
] = smallest
[YY
];
1197 if (smallest
[ZZ
] > 0)
1199 shift
[ZZ
] = smallest
[ZZ
];
1202 if (largest
[XX
] < 0)
1204 shift
[XX
] = largest
[XX
];
1206 if (largest
[YY
] < 0)
1208 shift
[YY
] = largest
[YY
];
1210 if (largest
[ZZ
] < 0)
1212 shift
[ZZ
] = largest
[ZZ
];
1215 /* is there a shift at all? */
1216 if ((shift
[XX
]) || (shift
[YY
]) || (shift
[ZZ
]))
1218 molsize
= mols
.index
[i
+1]-mols
.index
[i
];
1219 /* shift the positions */
1220 shift_positions(box
, &(IMDsetup
->xa
[mols
.index
[i
]]), shift
, molsize
);
1227 /*! \brief Initialize arrays used to assemble the positions from the other nodes. */
1228 static void init_imd_prepare_for_x_assembly(const t_commrec
*cr
, rvec x
[], t_gmx_IMD_setup
*IMDsetup
)
1233 snew(IMDsetup
->xa
, IMDsetup
->nat
);
1234 snew(IMDsetup
->xa_ind
, IMDsetup
->nat
);
1235 snew(IMDsetup
->xa_shifts
, IMDsetup
->nat
);
1236 snew(IMDsetup
->xa_eshifts
, IMDsetup
->nat
);
1237 snew(IMDsetup
->xa_old
, IMDsetup
->nat
);
1239 /* Save the original (whole) set of positions such that later the
1240 * molecule can always be made whole again */
1243 for (i
= 0; i
< IMDsetup
->nat
; i
++)
1245 ii
= IMDsetup
->ind
[i
];
1246 copy_rvec(x
[ii
], IMDsetup
->xa_old
[i
]);
1252 IMDsetup
->nat_loc
= IMDsetup
->nat
;
1253 IMDsetup
->ind_loc
= IMDsetup
->ind
;
1255 /* xa_ind[i] needs to be set to i for serial runs */
1256 for (i
= 0; i
< IMDsetup
->nat
; i
++)
1258 IMDsetup
->xa_ind
[i
] = i
;
1262 /* Communicate initial coordinates xa_old to all processes */
1266 gmx_bcast(IMDsetup
->nat
* sizeof(IMDsetup
->xa_old
[0]), IMDsetup
->xa_old
, cr
);
1273 /*! \brief Check for non-working integrator / parallel options. */
1274 static void imd_check_integrator_parallel(t_inputrec
*ir
, const t_commrec
*cr
)
1278 if (((ir
->eI
) == eiSteep
) || ((ir
->eI
) == eiCG
) || ((ir
->eI
) == eiLBFGS
) || ((ir
->eI
) == eiNM
))
1280 gmx_fatal(FARGS
, "%s Energy minimization via steep, CG, lbfgs and nm in parallel is currently not supported by IMD.\n", IMDstr
);
1285 void init_IMD(t_inputrec
*ir
,
1286 const t_commrec
*cr
,
1287 const gmx_multisim_t
*ms
,
1288 gmx_mtop_t
*top_global
,
1293 const t_filenm fnm
[],
1294 const gmx_output_env_t
*oenv
,
1295 const MdrunOptions
&mdrunOptions
)
1299 t_gmx_IMD_setup
*IMDsetup
;
1301 gmx_bool bIMD
= FALSE
;
1304 /* We will allow IMD sessions only if explicitly enabled in the .tpr file */
1305 if (FALSE
== ir
->bIMD
)
1309 // TODO many of these error conditions were we can't do what the
1310 // user asked for should be handled with a fatal error, not just a
1313 const ImdOptions
&options
= mdrunOptions
.imdOptions
;
1315 /* It seems we have a .tpr file that defines an IMD group and thus allows IMD sessions.
1316 * Check whether we can actually provide the IMD functionality for this setting: */
1319 /* Check whether IMD was enabled by one of the command line switches: */
1320 if (options
.wait
|| options
.terminatable
|| options
.pull
)
1322 /* Multiple simulations or replica exchange */
1325 fprintf(stderr
, "%s Cannot use IMD for multiple simulations or replica exchange.\n", IMDstr
);
1327 /* OK, IMD seems to be allowed and turned on... */
1330 fprintf(stderr
, "%s Enabled. This simulation will accept incoming IMD connections.\n", IMDstr
);
1336 fprintf(stderr
, "%s None of the -imd switches was used.\n"
1337 "%s This run will not accept incoming IMD connections\n", IMDstr
, IMDstr
);
1339 } /* end master only */
1341 /* Disable IMD if not all the needed functionality is there! */
1342 #if GMX_NATIVE_WINDOWS && !defined(GMX_HAVE_WINSOCK)
1344 fprintf(stderr
, "Disabling IMD because the winsock library was not found at compile time.\n");
1347 /* Let the other nodes know whether we want IMD */
1352 /* ... and update our local inputrec accordingly. */
1355 /*... if not we are done.*/
1362 /* check if we're using a sane integrator / parallel combination */
1363 imd_check_integrator_parallel(ir
, cr
);
1367 *****************************************************
1368 * From here on we assume that IMD is turned on *
1369 *****************************************************
1373 nat_total
= top_global
->natoms
;
1375 /* Initialize IMD setup structure. If we read in a pre-IMD .tpr file, imd->nat
1376 * will be zero. For those cases we transfer _all_ atomic positions */
1377 ir
->imd
->setup
= imd_create(ir
->imd
->nat
> 0 ? ir
->imd
->nat
: nat_total
,
1378 defnstimd
, options
.port
);
1379 IMDsetup
= ir
->imd
->setup
;
1381 /* We might need to open an output file for IMD forces data */
1384 IMDsetup
->outf
= open_imd_out(opt2fn("-if", nfile
, fnm
), ir
->imd
->setup
, nat_total
, oenv
, mdrunOptions
.continuationOptions
);
1387 /* Make sure that we operate with a valid atom index array for the IMD atoms */
1388 if (ir
->imd
->nat
> 0)
1390 /* Point to the user-supplied array of atom numbers */
1391 IMDsetup
->ind
= ir
->imd
->ind
;
1395 /* Make a dummy (ind[i] = i) array of all atoms */
1396 snew(IMDsetup
->ind
, nat_total
);
1397 for (i
= 0; i
< nat_total
; i
++)
1399 IMDsetup
->ind
[i
] = i
;
1403 /* read environment on master and prepare socket for incoming connections */
1406 /* we allocate memory for our IMD energy structure */
1407 int32_t recsize
= HEADERSIZE
+ sizeof(IMDEnergyBlock
);
1408 snew(IMDsetup
->energysendbuf
, recsize
);
1410 /* Shall we wait for a connection? */
1413 IMDsetup
->bWConnect
= TRUE
;
1414 fprintf(stderr
, "%s Pausing simulation while no IMD connection present (-imdwait).\n", IMDstr
);
1417 /* Will the IMD clients be able to terminate the simulation? */
1418 if (options
.terminatable
)
1420 IMDsetup
->bTerminatable
= TRUE
;
1421 fprintf(stderr
, "%s Allow termination of the simulation from IMD client (-imdterm).\n", IMDstr
);
1424 /* Is pulling from IMD client allowed? */
1427 IMDsetup
->bForceActivated
= TRUE
;
1428 fprintf(stderr
, "%s Pulling from IMD remote is enabled (-imdpull).\n", IMDstr
);
1431 /* Initialize send buffers with constant size */
1432 snew(IMDsetup
->sendxbuf
, IMDsetup
->nat
);
1433 snew(IMDsetup
->energies
, 1);
1434 bufxsize
= HEADERSIZE
+ 3 * sizeof(float) * IMDsetup
->nat
;
1435 snew(IMDsetup
->coordsendbuf
, bufxsize
);
1438 /* do we allow interactive pulling? If so let the other nodes know. */
1441 block_bc(cr
, IMDsetup
->bForceActivated
);
1444 /* setup the listening socket on master process */
1447 fprintf(fplog
, "%s Setting port for connection requests to %d.\n", IMDstr
, IMDsetup
->port
);
1448 fprintf(stderr
, "%s Turning on IMD - port for incoming requests is %d.\n", IMDstr
, IMDsetup
->port
);
1449 imd_prepare_master_socket(IMDsetup
);
1450 /* Wait until we have a connection if specified before */
1451 if (IMDsetup
->bWConnect
)
1453 imd_blockconnect(IMDsetup
);
1457 fprintf(stderr
, "%s -imdwait not set, starting simulation.\n", IMDstr
);
1460 /* Let the other nodes know whether we are connected */
1461 imd_sync_nodes(ir
, cr
, 0);
1463 /* Initialize arrays used to assemble the positions from the other nodes */
1464 init_imd_prepare_for_x_assembly(cr
, x
, IMDsetup
);
1466 /* Initialize molecule blocks to make them whole later...*/
1469 init_imd_prepare_mols_in_imdgroup(IMDsetup
, top_global
);
1472 gmx_incons("init_IMD: this GROMACS version was not compiled with IMD support!");
1477 gmx_bool
do_IMD(gmx_bool bIMD
,
1479 const t_commrec
*cr
,
1485 gmx_wallcycle
*wcycle
)
1487 gmx_bool imdstep
= FALSE
;
1488 t_gmx_IMD_setup
*IMDsetup
;
1498 wallcycle_start(wcycle
, ewcIMD
);
1500 IMDsetup
= ir
->imd
->setup
;
1502 /* read command from client and check if new incoming connection */
1505 /* If not already connected, check for new connections */
1506 if (!IMDsetup
->clientsocket
)
1508 if (IMDsetup
->bWConnect
)
1510 imd_blockconnect(IMDsetup
);
1514 imd_tryconnect(IMDsetup
);
1518 /* Let's see if we have new IMD messages for us */
1519 if (IMDsetup
->clientsocket
)
1521 imd_readcommand(IMDsetup
);
1525 /* is this an IMD communication step? */
1526 imdstep
= do_per_step(step
, IMDsetup
->nstimd
);
1528 /* OK so this is an IMD step ... */
1531 /* First we sync all nodes to let everybody know whether we are connected to VMD */
1532 imd_sync_nodes(ir
, cr
, t
);
1535 /* If a client is connected, we collect the positions
1536 * and put molecules back into the box before transfer */
1537 if ((imdstep
&& IMDsetup
->bConnected
)
1538 || bNS
) /* independent of imdstep, we communicate positions at each NS step */
1540 /* Transfer the IMD positions to the master node. Every node contributes
1541 * its local positions x and stores them in the assembled xa array. */
1542 communicate_group_positions(cr
, IMDsetup
->xa
, IMDsetup
->xa_shifts
, IMDsetup
->xa_eshifts
,
1543 TRUE
, x
, IMDsetup
->nat
, IMDsetup
->nat_loc
,
1544 IMDsetup
->ind_loc
, IMDsetup
->xa_ind
, IMDsetup
->xa_old
, box
);
1546 /* If connected and master -> remove shifts */
1547 if ((imdstep
&& IMDsetup
->bConnected
) && MASTER(cr
))
1549 imd_remove_molshifts(IMDsetup
, box
);
1553 wallcycle_stop(wcycle
, ewcIMD
);
1555 gmx_incons("do_IMD called without IMD support!");
1562 void IMD_fill_energy_record(gmx_bool bIMD
, t_IMD
*imd
, gmx_enerdata_t
*enerd
,
1563 int64_t step
, gmx_bool bHaveNewEnergies
)
1565 IMDEnergyBlock
*ene
;
1566 t_gmx_IMD
*IMDsetup
;
1572 IMDsetup
= imd
->setup
;
1574 if (IMDsetup
->clientsocket
)
1576 ene
= IMDsetup
->energies
;
1580 /* In MPI-parallel simulations the energies are not accessible a at every time step.
1581 * We update them if we have new values, otherwise, the energy values from the
1582 * last global communication step are still on display in the viewer. */
1583 if (bHaveNewEnergies
)
1585 ene
->T_abs
= (float) enerd
->term
[F_TEMP
];
1586 ene
->E_pot
= (float) enerd
->term
[F_EPOT
];
1587 ene
->E_tot
= (float) enerd
->term
[F_ETOT
];
1588 ene
->E_bond
= (float) enerd
->term
[F_BONDS
];
1589 ene
->E_angle
= (float) enerd
->term
[F_ANGLES
];
1590 ene
->E_dihe
= (float) enerd
->term
[F_PDIHS
];
1591 ene
->E_impr
= (float) enerd
->term
[F_IDIHS
];
1592 ene
->E_vdw
= (float) enerd
->term
[F_LJ
];
1593 ene
->E_coul
= (float) enerd
->term
[F_COUL_SR
];
1597 gmx_incons("IMD_fill_energy_record called without IMD support.");
1603 void IMD_send_positions(t_IMD
*imd
)
1606 t_gmx_IMD
*IMDsetup
;
1609 IMDsetup
= imd
->setup
;
1611 if (IMDsetup
->clientsocket
)
1614 if (imd_send_energies(IMDsetup
->clientsocket
, IMDsetup
->energies
, IMDsetup
->energysendbuf
))
1616 imd_fatal(IMDsetup
, "Error sending updated energies. Disconnecting client.\n");
1619 if (imd_send_rvecs(IMDsetup
->clientsocket
, IMDsetup
->nat
, IMDsetup
->xa
, IMDsetup
->coordsendbuf
))
1621 imd_fatal(IMDsetup
, "Error sending updated positions. Disconnecting client.\n");
1625 gmx_incons("IMD_send_positions called without IMD support.");
1630 void IMD_prep_energies_send_positions(gmx_bool bIMD
, gmx_bool bIMDstep
,
1631 t_IMD
*imd
, gmx_enerdata_t
*enerd
,
1632 int64_t step
, gmx_bool bHaveNewEnergies
,
1633 gmx_wallcycle
*wcycle
)
1638 wallcycle_start(wcycle
, ewcIMD
);
1640 /* Update time step for IMD and prepare IMD energy record if we have new energies. */
1641 IMD_fill_energy_record(TRUE
, imd
, enerd
, step
, bHaveNewEnergies
);
1645 /* Send positions and energies to VMD client via IMD */
1646 IMD_send_positions(imd
);
1649 wallcycle_stop(wcycle
, ewcIMD
);
1651 gmx_incons("IMD_prep_energies_send_positions called without IMD support.");
1656 int IMD_get_step(t_gmx_IMD
*IMDsetup
)
1658 return IMDsetup
->nstimd
;
1662 void IMD_apply_forces(gmx_bool bIMD
, t_IMD
*imd
, const t_commrec
*cr
, rvec
*f
,
1663 gmx_wallcycle
*wcycle
)
1667 t_gmx_IMD_setup
*IMDsetup
;
1673 wallcycle_start(wcycle
, ewcIMD
);
1675 IMDsetup
= imd
->setup
;
1677 /* Are forces allowed at all? If not we're done */
1678 if (!IMDsetup
->bForceActivated
)
1683 for (i
= 0; i
< IMDsetup
->nforces
; i
++)
1685 /* j are the indices in the "System group".*/
1686 j
= IMDsetup
->ind
[IMDsetup
->f_ind
[i
]];
1688 /* check if this is a local atom and find out locndx */
1689 if (PAR(cr
) && ga2la_get_home(cr
->dd
->ga2la
, j
, &locndx
))
1694 rvec_inc(f
[j
], IMDsetup
->f
[i
]);
1697 wallcycle_start(wcycle
, ewcIMD
);
1699 gmx_incons("IMD_apply_forces called without IMD support.");