Sort all includes in src/gromacs
[alexxy/gromacs.git] / src / gromacs / pulling / pull_rotation.c
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-2008, The GROMACS development team.
6  * Copyright (c) 2013,2014, 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.
10  *
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.
15  *
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.
20  *
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.
25  *
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.
33  *
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.
36  */
37 #include "gmxpre.h"
38
39 #include "pull_rotation.h"
40
41 #include "config.h"
42
43 #include <stdio.h>
44 #include <stdlib.h>
45 #include <string.h>
46
47 #include "gromacs/fileio/gmxfio.h"
48 #include "gromacs/fileio/trnio.h"
49 #include "gromacs/fileio/xvgr.h"
50 #include "gromacs/legacyheaders/copyrite.h"
51 #include "gromacs/legacyheaders/domdec.h"
52 #include "gromacs/legacyheaders/gmx_ga2la.h"
53 #include "gromacs/legacyheaders/macros.h"
54 #include "gromacs/legacyheaders/mdrun.h"
55 #include "gromacs/legacyheaders/names.h"
56 #include "gromacs/legacyheaders/network.h"
57 #include "gromacs/legacyheaders/txtdump.h"
58 #include "gromacs/linearalgebra/nrjac.h"
59 #include "gromacs/math/utilities.h"
60 #include "gromacs/math/vec.h"
61 #include "gromacs/mdlib/groupcoord.h"
62 #include "gromacs/pbcutil/pbc.h"
63 #include "gromacs/timing/cyclecounter.h"
64 #include "gromacs/timing/wallcycle.h"
65 #include "gromacs/topology/mtop_util.h"
66 #include "gromacs/utility/futil.h"
67 #include "gromacs/utility/qsort_threadsafe.h"
68 #include "gromacs/utility/smalloc.h"
69
70 static char *RotStr = {"Enforced rotation:"};
71
72 /* Set the minimum weight for the determination of the slab centers */
73 #define WEIGHT_MIN (10*GMX_FLOAT_MIN)
74
75 /* Helper structure for sorting positions along rotation vector             */
76 typedef struct {
77     real xcproj;            /* Projection of xc on the rotation vector        */
78     int  ind;               /* Index of xc                                    */
79     real m;                 /* Mass                                           */
80     rvec x;                 /* Position                                       */
81     rvec x_ref;             /* Reference position                             */
82 } sort_along_vec_t;
83
84
85 /* Enforced rotation / flexible: determine the angle of each slab             */
86 typedef struct gmx_slabdata
87 {
88     int   nat;              /* Number of atoms belonging to this slab         */
89     rvec *x;                /* The positions belonging to this slab. In
90                                general, this should be all positions of the
91                                whole rotation group, but we leave those away
92                                that have a small enough weight                */
93     rvec *ref;              /* Same for reference                             */
94     real *weight;           /* The weight for each atom                       */
95 } t_gmx_slabdata;
96
97
98 /* Helper structure for potential fitting */
99 typedef struct gmx_potfit
100 {
101     real   *degangle;       /* Set of angles for which the potential is
102                                calculated. The optimum fit is determined as
103                                the angle for with the potential is minimal    */
104     real   *V;              /* Potential for the different angles             */
105     matrix *rotmat;         /* Rotation matrix corresponding to the angles    */
106 } t_gmx_potfit;
107
108
109 /* Enforced rotation data for all groups                                      */
110 typedef struct gmx_enfrot
111 {
112     FILE             *out_rot;     /* Output file for rotation data                  */
113     FILE             *out_torque;  /* Output file for torque data                    */
114     FILE             *out_angles;  /* Output file for slab angles for flexible type  */
115     FILE             *out_slabs;   /* Output file for slab centers                   */
116     int               bufsize;     /* Allocation size of buf                         */
117     rvec             *xbuf;        /* Coordinate buffer variable for sorting         */
118     real             *mbuf;        /* Masses buffer variable for sorting             */
119     sort_along_vec_t *data;        /* Buffer variable needed for position sorting    */
120     real             *mpi_inbuf;   /* MPI buffer                                     */
121     real             *mpi_outbuf;  /* MPI buffer                                     */
122     int               mpi_bufsize; /* Allocation size of in & outbuf                 */
123     unsigned long     Flags;       /* mdrun flags                                    */
124     gmx_bool          bOut;        /* Used to skip first output when appending to
125                                     * avoid duplicate entries in rotation outfiles   */
126 } t_gmx_enfrot;
127
128
129 /* Global enforced rotation data for a single rotation group                  */
130 typedef struct gmx_enfrotgrp
131 {
132     real     degangle;      /* Rotation angle in degrees                      */
133     matrix   rotmat;        /* Rotation matrix                                */
134     atom_id *ind_loc;       /* Local rotation indices                         */
135     int      nat_loc;       /* Number of local group atoms                    */
136     int      nalloc_loc;    /* Allocation size for ind_loc and weight_loc     */
137
138     real     V;             /* Rotation potential for this rotation group     */
139     rvec    *f_rot_loc;     /* Array to store the forces on the local atoms
140                                resulting from enforced rotation potential     */
141
142     /* Collective coordinates for the whole rotation group */
143     real  *xc_ref_length;   /* Length of each x_rotref vector after x_rotref
144                                has been put into origin                       */
145     int   *xc_ref_ind;      /* Position of each local atom in the collective
146                                array                                          */
147     rvec   xc_center;       /* Center of the rotation group positions, may
148                                be mass weighted                               */
149     rvec   xc_ref_center;   /* dito, for the reference positions              */
150     rvec  *xc;              /* Current (collective) positions                 */
151     ivec  *xc_shifts;       /* Current (collective) shifts                    */
152     ivec  *xc_eshifts;      /* Extra shifts since last DD step                */
153     rvec  *xc_old;          /* Old (collective) positions                     */
154     rvec  *xc_norm;         /* Normalized form of the current positions       */
155     rvec  *xc_ref_sorted;   /* Reference positions (sorted in the same order
156                                as xc when sorted)                             */
157     int   *xc_sortind;      /* Where is a position found after sorting?       */
158     real  *mc;              /* Collective masses                              */
159     real  *mc_sorted;
160     real   invmass;         /* one over the total mass of the rotation group  */
161
162     real   torque_v;        /* Torque in the direction of rotation vector     */
163     real   angle_v;         /* Actual angle of the whole rotation group       */
164     /* Fixed rotation only */
165     real   weight_v;        /* Weights for angle determination                */
166     rvec  *xr_loc;          /* Local reference coords, correctly rotated      */
167     rvec  *x_loc_pbc;       /* Local current coords, correct PBC image        */
168     real  *m_loc;           /* Masses of the current local atoms              */
169
170     /* Flexible rotation only */
171     int    nslabs_alloc;              /* For this many slabs memory is allocated        */
172     int    slab_first;                /* Lowermost slab for that the calculation needs
173                                          to be performed at a given time step           */
174     int    slab_last;                 /* Uppermost slab ...                             */
175     int    slab_first_ref;            /* First slab for which ref. center is stored     */
176     int    slab_last_ref;             /* Last ...                                       */
177     int    slab_buffer;               /* Slab buffer region around reference slabs      */
178     int   *firstatom;                 /* First relevant atom for a slab                 */
179     int   *lastatom;                  /* Last relevant atom for a slab                  */
180     rvec  *slab_center;               /* Gaussian-weighted slab center                  */
181     rvec  *slab_center_ref;           /* Gaussian-weighted slab center for the
182                                          reference positions                            */
183     real  *slab_weights;              /* Sum of gaussian weights in a slab              */
184     real  *slab_torque_v;             /* Torque T = r x f for each slab.                */
185                                       /* torque_v = m.v = angular momentum in the
186                                          direction of v                                 */
187     real  max_beta;                   /* min_gaussian from inputrec->rotgrp is the
188                                          minimum value the gaussian must have so that
189                                          the force is actually evaluated max_beta is
190                                          just another way to put it                     */
191     real           *gn_atom;          /* Precalculated gaussians for a single atom      */
192     int            *gn_slabind;       /* Tells to which slab each precalculated gaussian
193                                          belongs                                        */
194     rvec           *slab_innersumvec; /* Inner sum of the flexible2 potential per slab;
195                                          this is precalculated for optimization reasons */
196     t_gmx_slabdata *slab_data;        /* Holds atom positions and gaussian weights
197                                          of atoms belonging to a slab                   */
198
199     /* For potential fits with varying angle: */
200     t_gmx_potfit *PotAngleFit;  /* Used for fit type 'potential'              */
201 } t_gmx_enfrotgrp;
202
203
204 /* Activate output of forces for correctness checks */
205 /* #define PRINT_FORCES */
206 #ifdef PRINT_FORCES
207 #define PRINT_FORCE_J  fprintf(stderr, "f%d = %15.8f %15.8f %15.8f\n", erg->xc_ref_ind[j], erg->f_rot_loc[j][XX], erg->f_rot_loc[j][YY], erg->f_rot_loc[j][ZZ]);
208 #define PRINT_POT_TAU  if (MASTER(cr)) { \
209         fprintf(stderr, "potential = %15.8f\n" "torque    = %15.8f\n", erg->V, erg->torque_v); \
210 }
211 #else
212 #define PRINT_FORCE_J
213 #define PRINT_POT_TAU
214 #endif
215
216 /* Shortcuts for often used queries */
217 #define ISFLEX(rg) ( (rg->eType == erotgFLEX) || (rg->eType == erotgFLEXT) || (rg->eType == erotgFLEX2) || (rg->eType == erotgFLEX2T) )
218 #define ISCOLL(rg) ( (rg->eType == erotgFLEX) || (rg->eType == erotgFLEXT) || (rg->eType == erotgFLEX2) || (rg->eType == erotgFLEX2T) || (rg->eType == erotgRMPF) || (rg->eType == erotgRM2PF) )
219
220
221 /* Does any of the rotation groups use slab decomposition? */
222 static gmx_bool HaveFlexibleGroups(t_rot *rot)
223 {
224     int       g;
225     t_rotgrp *rotg;
226
227
228     for (g = 0; g < rot->ngrp; g++)
229     {
230         rotg = &rot->grp[g];
231         if (ISFLEX(rotg))
232         {
233             return TRUE;
234         }
235     }
236
237     return FALSE;
238 }
239
240
241 /* Is for any group the fit angle determined by finding the minimum of the
242  * rotation potential? */
243 static gmx_bool HavePotFitGroups(t_rot *rot)
244 {
245     int       g;
246     t_rotgrp *rotg;
247
248
249     for (g = 0; g < rot->ngrp; g++)
250     {
251         rotg = &rot->grp[g];
252         if (erotgFitPOT == rotg->eFittype)
253         {
254             return TRUE;
255         }
256     }
257
258     return FALSE;
259 }
260
261
262 static double** allocate_square_matrix(int dim)
263 {
264     int      i;
265     double** mat = NULL;
266
267
268     snew(mat, dim);
269     for (i = 0; i < dim; i++)
270     {
271         snew(mat[i], dim);
272     }
273
274     return mat;
275 }
276
277
278 static void free_square_matrix(double** mat, int dim)
279 {
280     int i;
281
282
283     for (i = 0; i < dim; i++)
284     {
285         sfree(mat[i]);
286     }
287     sfree(mat);
288 }
289
290
291 /* Return the angle for which the potential is minimal */
292 static real get_fitangle(t_rotgrp *rotg, gmx_enfrotgrp_t erg)
293 {
294     int           i;
295     real          fitangle = -999.9;
296     real          pot_min  = GMX_FLOAT_MAX;
297     t_gmx_potfit *fit;
298
299
300     fit = erg->PotAngleFit;
301
302     for (i = 0; i < rotg->PotAngle_nstep; i++)
303     {
304         if (fit->V[i] < pot_min)
305         {
306             pot_min  = fit->V[i];
307             fitangle = fit->degangle[i];
308         }
309     }
310
311     return fitangle;
312 }
313
314
315 /* Reduce potential angle fit data for this group at this time step? */
316 static gmx_inline gmx_bool bPotAngle(t_rot *rot, t_rotgrp *rotg, gmx_int64_t step)
317 {
318     return ( (erotgFitPOT == rotg->eFittype) && (do_per_step(step, rot->nstsout) || do_per_step(step, rot->nstrout)) );
319 }
320
321 /* Reduce slab torqe data for this group at this time step? */
322 static gmx_inline gmx_bool bSlabTau(t_rot *rot, t_rotgrp *rotg, gmx_int64_t step)
323 {
324     return ( (ISFLEX(rotg)) && do_per_step(step, rot->nstsout) );
325 }
326
327 /* Output rotation energy, torques, etc. for each rotation group */
328 static void reduce_output(t_commrec *cr, t_rot *rot, real t, gmx_int64_t step)
329 {
330     int             g, i, islab, nslabs = 0;
331     int             count; /* MPI element counter                               */
332     t_rotgrp       *rotg;
333     gmx_enfrot_t    er;    /* Pointer to the enforced rotation buffer variables */
334     gmx_enfrotgrp_t erg;   /* Pointer to enforced rotation group data           */
335     real            fitangle;
336     gmx_bool        bFlex;
337
338
339     er = rot->enfrot;
340
341     /* Fill the MPI buffer with stuff to reduce. If items are added for reduction
342      * here, the MPI buffer size has to be enlarged also in calc_mpi_bufsize() */
343     if (PAR(cr))
344     {
345         count = 0;
346         for (g = 0; g < rot->ngrp; g++)
347         {
348             rotg                   = &rot->grp[g];
349             erg                    = rotg->enfrotgrp;
350             nslabs                 = erg->slab_last - erg->slab_first + 1;
351             er->mpi_inbuf[count++] = erg->V;
352             er->mpi_inbuf[count++] = erg->torque_v;
353             er->mpi_inbuf[count++] = erg->angle_v;
354             er->mpi_inbuf[count++] = erg->weight_v; /* weights are not needed for flex types, but this is just a single value */
355
356             if (bPotAngle(rot, rotg, step))
357             {
358                 for (i = 0; i < rotg->PotAngle_nstep; i++)
359                 {
360                     er->mpi_inbuf[count++] = erg->PotAngleFit->V[i];
361                 }
362             }
363             if (bSlabTau(rot, rotg, step))
364             {
365                 for (i = 0; i < nslabs; i++)
366                 {
367                     er->mpi_inbuf[count++] = erg->slab_torque_v[i];
368                 }
369             }
370         }
371         if (count > er->mpi_bufsize)
372         {
373             gmx_fatal(FARGS, "%s MPI buffer overflow, please report this error.", RotStr);
374         }
375
376 #ifdef GMX_MPI
377         MPI_Reduce(er->mpi_inbuf, er->mpi_outbuf, count, GMX_MPI_REAL, MPI_SUM, MASTERRANK(cr), cr->mpi_comm_mygroup);
378 #endif
379
380         /* Copy back the reduced data from the buffer on the master */
381         if (MASTER(cr))
382         {
383             count = 0;
384             for (g = 0; g < rot->ngrp; g++)
385             {
386                 rotg          = &rot->grp[g];
387                 erg           = rotg->enfrotgrp;
388                 nslabs        = erg->slab_last - erg->slab_first + 1;
389                 erg->V        = er->mpi_outbuf[count++];
390                 erg->torque_v = er->mpi_outbuf[count++];
391                 erg->angle_v  = er->mpi_outbuf[count++];
392                 erg->weight_v = er->mpi_outbuf[count++];
393
394                 if (bPotAngle(rot, rotg, step))
395                 {
396                     for (i = 0; i < rotg->PotAngle_nstep; i++)
397                     {
398                         erg->PotAngleFit->V[i] = er->mpi_outbuf[count++];
399                     }
400                 }
401                 if (bSlabTau(rot, rotg, step))
402                 {
403                     for (i = 0; i < nslabs; i++)
404                     {
405                         erg->slab_torque_v[i] = er->mpi_outbuf[count++];
406                     }
407                 }
408             }
409         }
410     }
411
412     /* Output */
413     if (MASTER(cr))
414     {
415         /* Angle and torque for each rotation group */
416         for (g = 0; g < rot->ngrp; g++)
417         {
418             rotg  = &rot->grp[g];
419             bFlex = ISFLEX(rotg);
420
421             erg = rotg->enfrotgrp;
422
423             /* Output to main rotation output file: */
424             if (do_per_step(step, rot->nstrout) )
425             {
426                 if (erotgFitPOT == rotg->eFittype)
427                 {
428                     fitangle = get_fitangle(rotg, erg);
429                 }
430                 else
431                 {
432                     if (bFlex)
433                     {
434                         fitangle = erg->angle_v; /* RMSD fit angle */
435                     }
436                     else
437                     {
438                         fitangle = (erg->angle_v/erg->weight_v)*180.0*M_1_PI;
439                     }
440                 }
441                 fprintf(er->out_rot, "%12.4f", fitangle);
442                 fprintf(er->out_rot, "%12.3e", erg->torque_v);
443                 fprintf(er->out_rot, "%12.3e", erg->V);
444             }
445
446             if (do_per_step(step, rot->nstsout) )
447             {
448                 /* Output to torque log file: */
449                 if (bFlex)
450                 {
451                     fprintf(er->out_torque, "%12.3e%6d", t, g);
452                     for (i = erg->slab_first; i <= erg->slab_last; i++)
453                     {
454                         islab = i - erg->slab_first;  /* slab index */
455                         /* Only output if enough weight is in slab */
456                         if (erg->slab_weights[islab] > rotg->min_gaussian)
457                         {
458                             fprintf(er->out_torque, "%6d%12.3e", i, erg->slab_torque_v[islab]);
459                         }
460                     }
461                     fprintf(er->out_torque, "\n");
462                 }
463
464                 /* Output to angles log file: */
465                 if (erotgFitPOT == rotg->eFittype)
466                 {
467                     fprintf(er->out_angles, "%12.3e%6d%12.4f", t, g, erg->degangle);
468                     /* Output energies at a set of angles around the reference angle */
469                     for (i = 0; i < rotg->PotAngle_nstep; i++)
470                     {
471                         fprintf(er->out_angles, "%12.3e", erg->PotAngleFit->V[i]);
472                     }
473                     fprintf(er->out_angles, "\n");
474                 }
475             }
476         }
477         if (do_per_step(step, rot->nstrout) )
478         {
479             fprintf(er->out_rot, "\n");
480         }
481     }
482 }
483
484
485 /* Add the forces from enforced rotation potential to the local forces.
486  * Should be called after the SR forces have been evaluated */
487 extern real add_rot_forces(t_rot *rot, rvec f[], t_commrec *cr, gmx_int64_t step, real t)
488 {
489     int             g, l, ii;
490     t_rotgrp       *rotg;
491     gmx_enfrot_t    er;         /* Pointer to the enforced rotation buffer variables */
492     gmx_enfrotgrp_t erg;        /* Pointer to enforced rotation group data           */
493     real            Vrot = 0.0; /* If more than one rotation group is present, Vrot
494                                    assembles the local parts from all groups         */
495
496
497     er = rot->enfrot;
498
499     /* Loop over enforced rotation groups (usually 1, though)
500      * Apply the forces from rotation potentials */
501     for (g = 0; g < rot->ngrp; g++)
502     {
503         rotg  = &rot->grp[g];
504         erg   = rotg->enfrotgrp;
505         Vrot += erg->V;  /* add the local parts from the nodes */
506         for (l = 0; l < erg->nat_loc; l++)
507         {
508             /* Get the right index of the local force */
509             ii = erg->ind_loc[l];
510             /* Add */
511             rvec_inc(f[ii], erg->f_rot_loc[l]);
512         }
513     }
514
515     /* Reduce energy,torque, angles etc. to get the sum values (per rotation group)
516      * on the master and output these values to file. */
517     if ( (do_per_step(step, rot->nstrout) || do_per_step(step, rot->nstsout)) && er->bOut)
518     {
519         reduce_output(cr, rot, t, step);
520     }
521
522     /* When appending, er->bOut is FALSE the first time to avoid duplicate entries */
523     er->bOut = TRUE;
524
525     PRINT_POT_TAU
526
527     return Vrot;
528 }
529
530
531 /* The Gaussian norm is chosen such that the sum of the gaussian functions
532  * over the slabs is approximately 1.0 everywhere */
533 #define GAUSS_NORM   0.569917543430618
534
535
536 /* Calculate the maximum beta that leads to a gaussian larger min_gaussian,
537  * also does some checks
538  */
539 static double calc_beta_max(real min_gaussian, real slab_dist)
540 {
541     double sigma;
542     double arg;
543
544
545     /* Actually the next two checks are already made in grompp */
546     if (slab_dist <= 0)
547     {
548         gmx_fatal(FARGS, "Slab distance of flexible rotation groups must be >=0 !");
549     }
550     if (min_gaussian <= 0)
551     {
552         gmx_fatal(FARGS, "Cutoff value for Gaussian must be > 0. (You requested %f)");
553     }
554
555     /* Define the sigma value */
556     sigma = 0.7*slab_dist;
557
558     /* Calculate the argument for the logarithm and check that the log() result is negative or 0 */
559     arg = min_gaussian/GAUSS_NORM;
560     if (arg > 1.0)
561     {
562         gmx_fatal(FARGS, "min_gaussian of flexible rotation groups must be <%g", GAUSS_NORM);
563     }
564
565     return sqrt(-2.0*sigma*sigma*log(min_gaussian/GAUSS_NORM));
566 }
567
568
569 static gmx_inline real calc_beta(rvec curr_x, t_rotgrp *rotg, int n)
570 {
571     return iprod(curr_x, rotg->vec) - rotg->slab_dist * n;
572 }
573
574
575 static gmx_inline real gaussian_weight(rvec curr_x, t_rotgrp *rotg, int n)
576 {
577     const real norm = GAUSS_NORM;
578     real       sigma;
579
580
581     /* Define the sigma value */
582     sigma = 0.7*rotg->slab_dist;
583     /* Calculate the Gaussian value of slab n for position curr_x */
584     return norm * exp( -0.5 * sqr( calc_beta(curr_x, rotg, n)/sigma ) );
585 }
586
587
588 /* Returns the weight in a single slab, also calculates the Gaussian- and mass-
589  * weighted sum of positions for that slab */
590 static real get_slab_weight(int j, t_rotgrp *rotg, rvec xc[], real mc[], rvec *x_weighted_sum)
591 {
592     rvec            curr_x;           /* The position of an atom                      */
593     rvec            curr_x_weighted;  /* The gaussian-weighted position               */
594     real            gaussian;         /* A single gaussian weight                     */
595     real            wgauss;           /* gaussian times current mass                  */
596     real            slabweight = 0.0; /* The sum of weights in the slab               */
597     int             i, islab;
598     gmx_enfrotgrp_t erg;              /* Pointer to enforced rotation group data      */
599
600
601     erg = rotg->enfrotgrp;
602     clear_rvec(*x_weighted_sum);
603
604     /* Slab index */
605     islab = j - erg->slab_first;
606
607     /* Loop over all atoms in the rotation group */
608     for (i = 0; i < rotg->nat; i++)
609     {
610         copy_rvec(xc[i], curr_x);
611         gaussian = gaussian_weight(curr_x, rotg, j);
612         wgauss   = gaussian * mc[i];
613         svmul(wgauss, curr_x, curr_x_weighted);
614         rvec_add(*x_weighted_sum, curr_x_weighted, *x_weighted_sum);
615         slabweight += wgauss;
616     }  /* END of loop over rotation group atoms */
617
618     return slabweight;
619 }
620
621
622 static void get_slab_centers(
623         t_rotgrp  *rotg,       /* The rotation group information               */
624         rvec      *xc,         /* The rotation group positions; will
625                                   typically be enfrotgrp->xc, but at first call
626                                   it is enfrotgrp->xc_ref                      */
627         real      *mc,         /* The masses of the rotation group atoms       */
628         int        g,          /* The number of the rotation group             */
629         real       time,       /* Used for output only                         */
630         FILE      *out_slabs,  /* For outputting center per slab information   */
631         gmx_bool   bOutStep,   /* Is this an output step?                      */
632         gmx_bool   bReference) /* If this routine is called from
633                                   init_rot_group we need to store
634                                   the reference slab centers                   */
635 {
636     int             j, islab;
637     gmx_enfrotgrp_t erg;      /* Pointer to enforced rotation group data */
638
639
640     erg = rotg->enfrotgrp;
641
642     /* Loop over slabs */
643     for (j = erg->slab_first; j <= erg->slab_last; j++)
644     {
645         islab                    = j - erg->slab_first;
646         erg->slab_weights[islab] = get_slab_weight(j, rotg, xc, mc, &erg->slab_center[islab]);
647
648         /* We can do the calculations ONLY if there is weight in the slab! */
649         if (erg->slab_weights[islab] > WEIGHT_MIN)
650         {
651             svmul(1.0/erg->slab_weights[islab], erg->slab_center[islab], erg->slab_center[islab]);
652         }
653         else
654         {
655             /* We need to check this here, since we divide through slab_weights
656              * in the flexible low-level routines! */
657             gmx_fatal(FARGS, "Not enough weight in slab %d. Slab center cannot be determined!", j);
658         }
659
660         /* At first time step: save the centers of the reference structure */
661         if (bReference)
662         {
663             copy_rvec(erg->slab_center[islab], erg->slab_center_ref[islab]);
664         }
665     } /* END of loop over slabs */
666
667     /* Output on the master */
668     if ( (NULL != out_slabs) && bOutStep)
669     {
670         fprintf(out_slabs, "%12.3e%6d", time, g);
671         for (j = erg->slab_first; j <= erg->slab_last; j++)
672         {
673             islab = j - erg->slab_first;
674             fprintf(out_slabs, "%6d%12.3e%12.3e%12.3e",
675                     j, erg->slab_center[islab][XX], erg->slab_center[islab][YY], erg->slab_center[islab][ZZ]);
676         }
677         fprintf(out_slabs, "\n");
678     }
679 }
680
681
682 static void calc_rotmat(
683         rvec   vec,
684         real   degangle,      /* Angle alpha of rotation at time t in degrees       */
685         matrix rotmat)        /* Rotation matrix                                    */
686 {
687     real radangle;            /* Rotation angle in radians */
688     real cosa;                /* cosine alpha              */
689     real sina;                /* sine alpha                */
690     real OMcosa;              /* 1 - cos(alpha)            */
691     real dumxy, dumxz, dumyz; /* save computations         */
692     rvec rot_vec;             /* Rotate around rot_vec ... */
693
694
695     radangle = degangle * M_PI/180.0;
696     copy_rvec(vec, rot_vec );
697
698     /* Precompute some variables: */
699     cosa   = cos(radangle);
700     sina   = sin(radangle);
701     OMcosa = 1.0 - cosa;
702     dumxy  = rot_vec[XX]*rot_vec[YY]*OMcosa;
703     dumxz  = rot_vec[XX]*rot_vec[ZZ]*OMcosa;
704     dumyz  = rot_vec[YY]*rot_vec[ZZ]*OMcosa;
705
706     /* Construct the rotation matrix for this rotation group: */
707     /* 1st column: */
708     rotmat[XX][XX] = cosa  + rot_vec[XX]*rot_vec[XX]*OMcosa;
709     rotmat[YY][XX] = dumxy + rot_vec[ZZ]*sina;
710     rotmat[ZZ][XX] = dumxz - rot_vec[YY]*sina;
711     /* 2nd column: */
712     rotmat[XX][YY] = dumxy - rot_vec[ZZ]*sina;
713     rotmat[YY][YY] = cosa  + rot_vec[YY]*rot_vec[YY]*OMcosa;
714     rotmat[ZZ][YY] = dumyz + rot_vec[XX]*sina;
715     /* 3rd column: */
716     rotmat[XX][ZZ] = dumxz + rot_vec[YY]*sina;
717     rotmat[YY][ZZ] = dumyz - rot_vec[XX]*sina;
718     rotmat[ZZ][ZZ] = cosa  + rot_vec[ZZ]*rot_vec[ZZ]*OMcosa;
719
720 #ifdef PRINTMATRIX
721     int iii, jjj;
722
723     for (iii = 0; iii < 3; iii++)
724     {
725         for (jjj = 0; jjj < 3; jjj++)
726         {
727             fprintf(stderr, " %10.8f ",  rotmat[iii][jjj]);
728         }
729         fprintf(stderr, "\n");
730     }
731 #endif
732 }
733
734
735 /* Calculates torque on the rotation axis tau = position x force */
736 static gmx_inline real torque(
737         rvec rotvec,  /* rotation vector; MUST be normalized!                 */
738         rvec force,   /* force                                                */
739         rvec x,       /* position of atom on which the force acts             */
740         rvec pivot)   /* pivot point of rotation axis                         */
741 {
742     rvec vectmp, tau;
743
744
745     /* Subtract offset */
746     rvec_sub(x, pivot, vectmp);
747
748     /* position x force */
749     cprod(vectmp, force, tau);
750
751     /* Return the part of the torque which is parallel to the rotation vector */
752     return iprod(tau, rotvec);
753 }
754
755
756 /* Right-aligned output of value with standard width */
757 static void print_aligned(FILE *fp, char *str)
758 {
759     fprintf(fp, "%12s", str);
760 }
761
762
763 /* Right-aligned output of value with standard short width */
764 static void print_aligned_short(FILE *fp, char *str)
765 {
766     fprintf(fp, "%6s", str);
767 }
768
769
770 static FILE *open_output_file(const char *fn, int steps, const char what[])
771 {
772     FILE *fp;
773
774
775     fp = gmx_ffopen(fn, "w");
776
777     fprintf(fp, "# Output of %s is written in intervals of %d time step%s.\n#\n",
778             what, steps, steps > 1 ? "s" : "");
779
780     return fp;
781 }
782
783
784 /* Open output file for slab center data. Call on master only */
785 static FILE *open_slab_out(const char *fn, t_rot *rot)
786 {
787     FILE      *fp;
788     int        g, i;
789     t_rotgrp  *rotg;
790
791
792     if (rot->enfrot->Flags & MD_APPENDFILES)
793     {
794         fp = gmx_fio_fopen(fn, "a");
795     }
796     else
797     {
798         fp = open_output_file(fn, rot->nstsout, "gaussian weighted slab centers");
799
800         for (g = 0; g < rot->ngrp; g++)
801         {
802             rotg = &rot->grp[g];
803             if (ISFLEX(rotg))
804             {
805                 fprintf(fp, "# Rotation group %d (%s), slab distance %f nm, %s.\n",
806                         g, erotg_names[rotg->eType], rotg->slab_dist,
807                         rotg->bMassW ? "centers of mass" : "geometrical centers");
808             }
809         }
810
811         fprintf(fp, "# Reference centers are listed first (t=-1).\n");
812         fprintf(fp, "# The following columns have the syntax:\n");
813         fprintf(fp, "#     ");
814         print_aligned_short(fp, "t");
815         print_aligned_short(fp, "grp");
816         /* Print legend for the first two entries only ... */
817         for (i = 0; i < 2; i++)
818         {
819             print_aligned_short(fp, "slab");
820             print_aligned(fp, "X center");
821             print_aligned(fp, "Y center");
822             print_aligned(fp, "Z center");
823         }
824         fprintf(fp, " ...\n");
825         fflush(fp);
826     }
827
828     return fp;
829 }
830
831
832 /* Adds 'buf' to 'str' */
833 static void add_to_string(char **str, char *buf)
834 {
835     int len;
836
837
838     len = strlen(*str) + strlen(buf) + 1;
839     srenew(*str, len);
840     strcat(*str, buf);
841 }
842
843
844 static void add_to_string_aligned(char **str, char *buf)
845 {
846     char buf_aligned[STRLEN];
847
848     sprintf(buf_aligned, "%12s", buf);
849     add_to_string(str, buf_aligned);
850 }
851
852
853 /* Open output file and print some general information about the rotation groups.
854  * Call on master only */
855 static FILE *open_rot_out(const char *fn, t_rot *rot, const output_env_t oenv)
856 {
857     FILE           *fp;
858     int             g, nsets;
859     t_rotgrp       *rotg;
860     const char    **setname;
861     char            buf[50], buf2[75];
862     gmx_enfrotgrp_t erg;       /* Pointer to enforced rotation group data */
863     gmx_bool        bFlex;
864     char           *LegendStr = NULL;
865
866
867     if (rot->enfrot->Flags & MD_APPENDFILES)
868     {
869         fp = gmx_fio_fopen(fn, "a");
870     }
871     else
872     {
873         fp = xvgropen(fn, "Rotation angles and energy", "Time (ps)", "angles (degrees) and energies (kJ/mol)", oenv);
874         fprintf(fp, "# Output of enforced rotation data is written in intervals of %d time step%s.\n#\n", rot->nstrout, rot->nstrout > 1 ? "s" : "");
875         fprintf(fp, "# The scalar tau is the torque (kJ/mol) in the direction of the rotation vector v.\n");
876         fprintf(fp, "# To obtain the vectorial torque, multiply tau with the group's rot_vec.\n");
877         fprintf(fp, "# For flexible groups, tau(t,n) from all slabs n have been summed in a single value tau(t) here.\n");
878         fprintf(fp, "# The torques tau(t,n) are found in the rottorque.log (-rt) output file\n");
879
880         for (g = 0; g < rot->ngrp; g++)
881         {
882             rotg  = &rot->grp[g];
883             erg   = rotg->enfrotgrp;
884             bFlex = ISFLEX(rotg);
885
886             fprintf(fp, "#\n");
887             fprintf(fp, "# ROTATION GROUP %d, potential type '%s':\n", g, erotg_names[rotg->eType]);
888             fprintf(fp, "# rot_massw%d          %s\n", g, yesno_names[rotg->bMassW]);
889             fprintf(fp, "# rot_vec%d            %12.5e %12.5e %12.5e\n", g, rotg->vec[XX], rotg->vec[YY], rotg->vec[ZZ]);
890             fprintf(fp, "# rot_rate%d           %12.5e degrees/ps\n", g, rotg->rate);
891             fprintf(fp, "# rot_k%d              %12.5e kJ/(mol*nm^2)\n", g, rotg->k);
892             if (rotg->eType == erotgISO || rotg->eType == erotgPM || rotg->eType == erotgRM || rotg->eType == erotgRM2)
893             {
894                 fprintf(fp, "# rot_pivot%d          %12.5e %12.5e %12.5e  nm\n", g, rotg->pivot[XX], rotg->pivot[YY], rotg->pivot[ZZ]);
895             }
896
897             if (bFlex)
898             {
899                 fprintf(fp, "# rot_slab_distance%d   %f nm\n", g, rotg->slab_dist);
900                 fprintf(fp, "# rot_min_gaussian%d   %12.5e\n", g, rotg->min_gaussian);
901             }
902
903             /* Output the centers of the rotation groups for the pivot-free potentials */
904             if ((rotg->eType == erotgISOPF) || (rotg->eType == erotgPMPF) || (rotg->eType == erotgRMPF) || (rotg->eType == erotgRM2PF
905                                                                                                             || (rotg->eType == erotgFLEXT) || (rotg->eType == erotgFLEX2T)) )
906             {
907                 fprintf(fp, "# ref. grp. %d center  %12.5e %12.5e %12.5e\n", g,
908                         erg->xc_ref_center[XX], erg->xc_ref_center[YY], erg->xc_ref_center[ZZ]);
909
910                 fprintf(fp, "# grp. %d init.center  %12.5e %12.5e %12.5e\n", g,
911                         erg->xc_center[XX], erg->xc_center[YY], erg->xc_center[ZZ]);
912             }
913
914             if ( (rotg->eType == erotgRM2) || (rotg->eType == erotgFLEX2) || (rotg->eType == erotgFLEX2T) )
915             {
916                 fprintf(fp, "# rot_eps%d            %12.5e nm^2\n", g, rotg->eps);
917             }
918             if (erotgFitPOT == rotg->eFittype)
919             {
920                 fprintf(fp, "#\n");
921                 fprintf(fp, "# theta_fit%d is determined by first evaluating the potential for %d angles around theta_ref%d.\n",
922                         g, rotg->PotAngle_nstep, g);
923                 fprintf(fp, "# The fit angle is the one with the smallest potential. It is given as the deviation\n");
924                 fprintf(fp, "# from the reference angle, i.e. if theta_ref=X and theta_fit=Y, then the angle with\n");
925                 fprintf(fp, "# minimal value of the potential is X+Y. Angular resolution is %g degrees.\n", rotg->PotAngle_step);
926             }
927         }
928
929         /* Print a nice legend */
930         snew(LegendStr, 1);
931         LegendStr[0] = '\0';
932         sprintf(buf, "#     %6s", "time");
933         add_to_string_aligned(&LegendStr, buf);
934
935         nsets = 0;
936         snew(setname, 4*rot->ngrp);
937
938         for (g = 0; g < rot->ngrp; g++)
939         {
940             rotg = &rot->grp[g];
941             sprintf(buf, "theta_ref%d", g);
942             add_to_string_aligned(&LegendStr, buf);
943
944             sprintf(buf2, "%s (degrees)", buf);
945             setname[nsets] = gmx_strdup(buf2);
946             nsets++;
947         }
948         for (g = 0; g < rot->ngrp; g++)
949         {
950             rotg  = &rot->grp[g];
951             bFlex = ISFLEX(rotg);
952
953             /* For flexible axis rotation we use RMSD fitting to determine the
954              * actual angle of the rotation group */
955             if (bFlex || erotgFitPOT == rotg->eFittype)
956             {
957                 sprintf(buf, "theta_fit%d", g);
958             }
959             else
960             {
961                 sprintf(buf, "theta_av%d", g);
962             }
963             add_to_string_aligned(&LegendStr, buf);
964             sprintf(buf2, "%s (degrees)", buf);
965             setname[nsets] = gmx_strdup(buf2);
966             nsets++;
967
968             sprintf(buf, "tau%d", g);
969             add_to_string_aligned(&LegendStr, buf);
970             sprintf(buf2, "%s (kJ/mol)", buf);
971             setname[nsets] = gmx_strdup(buf2);
972             nsets++;
973
974             sprintf(buf, "energy%d", g);
975             add_to_string_aligned(&LegendStr, buf);
976             sprintf(buf2, "%s (kJ/mol)", buf);
977             setname[nsets] = gmx_strdup(buf2);
978             nsets++;
979         }
980         fprintf(fp, "#\n");
981
982         if (nsets > 1)
983         {
984             xvgr_legend(fp, nsets, setname, oenv);
985         }
986         sfree(setname);
987
988         fprintf(fp, "#\n# Legend for the following data columns:\n");
989         fprintf(fp, "%s\n", LegendStr);
990         sfree(LegendStr);
991
992         fflush(fp);
993     }
994
995     return fp;
996 }
997
998
999 /* Call on master only */
1000 static FILE *open_angles_out(const char *fn, t_rot *rot)
1001 {
1002     int             g, i;
1003     FILE           *fp;
1004     t_rotgrp       *rotg;
1005     gmx_enfrotgrp_t erg;        /* Pointer to enforced rotation group data */
1006     char            buf[100];
1007
1008
1009     if (rot->enfrot->Flags & MD_APPENDFILES)
1010     {
1011         fp = gmx_fio_fopen(fn, "a");
1012     }
1013     else
1014     {
1015         /* Open output file and write some information about it's structure: */
1016         fp = open_output_file(fn, rot->nstsout, "rotation group angles");
1017         fprintf(fp, "# All angles given in degrees, time in ps.\n");
1018         for (g = 0; g < rot->ngrp; g++)
1019         {
1020             rotg = &rot->grp[g];
1021             erg  = rotg->enfrotgrp;
1022
1023             /* Output for this group happens only if potential type is flexible or
1024              * if fit type is potential! */
1025             if (ISFLEX(rotg) || (erotgFitPOT == rotg->eFittype) )
1026             {
1027                 if (ISFLEX(rotg))
1028                 {
1029                     sprintf(buf, " slab distance %f nm, ", rotg->slab_dist);
1030                 }
1031                 else
1032                 {
1033                     buf[0] = '\0';
1034                 }
1035
1036                 fprintf(fp, "#\n# ROTATION GROUP %d '%s',%s fit type '%s'.\n",
1037                         g, erotg_names[rotg->eType], buf, erotg_fitnames[rotg->eFittype]);
1038
1039                 /* Special type of fitting using the potential minimum. This is
1040                  * done for the whole group only, not for the individual slabs. */
1041                 if (erotgFitPOT == rotg->eFittype)
1042                 {
1043                     fprintf(fp, "#    To obtain theta_fit%d, the potential is evaluated for %d angles around theta_ref%d\n", g, rotg->PotAngle_nstep, g);
1044                     fprintf(fp, "#    The fit angle in the rotation standard outfile is the one with minimal energy E(theta_fit) [kJ/mol].\n");
1045                     fprintf(fp, "#\n");
1046                 }
1047
1048                 fprintf(fp, "# Legend for the group %d data columns:\n", g);
1049                 fprintf(fp, "#     ");
1050                 print_aligned_short(fp, "time");
1051                 print_aligned_short(fp, "grp");
1052                 print_aligned(fp, "theta_ref");
1053
1054                 if (erotgFitPOT == rotg->eFittype)
1055                 {
1056                     /* Output the set of angles around the reference angle */
1057                     for (i = 0; i < rotg->PotAngle_nstep; i++)
1058                     {
1059                         sprintf(buf, "E(%g)", erg->PotAngleFit->degangle[i]);
1060                         print_aligned(fp, buf);
1061                     }
1062                 }
1063                 else
1064                 {
1065                     /* Output fit angle for each slab */
1066                     print_aligned_short(fp, "slab");
1067                     print_aligned_short(fp, "atoms");
1068                     print_aligned(fp, "theta_fit");
1069                     print_aligned_short(fp, "slab");
1070                     print_aligned_short(fp, "atoms");
1071                     print_aligned(fp, "theta_fit");
1072                     fprintf(fp, " ...");
1073                 }
1074                 fprintf(fp, "\n");
1075             }
1076         }
1077         fflush(fp);
1078     }
1079
1080     return fp;
1081 }
1082
1083
1084 /* Open torque output file and write some information about it's structure.
1085  * Call on master only */
1086 static FILE *open_torque_out(const char *fn, t_rot *rot)
1087 {
1088     FILE      *fp;
1089     int        g;
1090     t_rotgrp  *rotg;
1091
1092
1093     if (rot->enfrot->Flags & MD_APPENDFILES)
1094     {
1095         fp = gmx_fio_fopen(fn, "a");
1096     }
1097     else
1098     {
1099         fp = open_output_file(fn, rot->nstsout, "torques");
1100
1101         for (g = 0; g < rot->ngrp; g++)
1102         {
1103             rotg = &rot->grp[g];
1104             if (ISFLEX(rotg))
1105             {
1106                 fprintf(fp, "# Rotation group %d (%s), slab distance %f nm.\n", g, erotg_names[rotg->eType], rotg->slab_dist);
1107                 fprintf(fp, "# The scalar tau is the torque (kJ/mol) in the direction of the rotation vector.\n");
1108                 fprintf(fp, "# To obtain the vectorial torque, multiply tau with\n");
1109                 fprintf(fp, "# rot_vec%d            %10.3e %10.3e %10.3e\n", g, rotg->vec[XX], rotg->vec[YY], rotg->vec[ZZ]);
1110                 fprintf(fp, "#\n");
1111             }
1112         }
1113         fprintf(fp, "# Legend for the following data columns: (tau=torque for that slab):\n");
1114         fprintf(fp, "#     ");
1115         print_aligned_short(fp, "t");
1116         print_aligned_short(fp, "grp");
1117         print_aligned_short(fp, "slab");
1118         print_aligned(fp, "tau");
1119         print_aligned_short(fp, "slab");
1120         print_aligned(fp, "tau");
1121         fprintf(fp, " ...\n");
1122         fflush(fp);
1123     }
1124
1125     return fp;
1126 }
1127
1128
1129 static void swap_val(double* vec, int i, int j)
1130 {
1131     double tmp = vec[j];
1132
1133
1134     vec[j] = vec[i];
1135     vec[i] = tmp;
1136 }
1137
1138
1139 static void swap_col(double **mat, int i, int j)
1140 {
1141     double tmp[3] = {mat[0][j], mat[1][j], mat[2][j]};
1142
1143
1144     mat[0][j] = mat[0][i];
1145     mat[1][j] = mat[1][i];
1146     mat[2][j] = mat[2][i];
1147
1148     mat[0][i] = tmp[0];
1149     mat[1][i] = tmp[1];
1150     mat[2][i] = tmp[2];
1151 }
1152
1153
1154 /* Eigenvectors are stored in columns of eigen_vec */
1155 static void diagonalize_symmetric(
1156         double **matrix,
1157         double **eigen_vec,
1158         double   eigenval[3])
1159 {
1160     int n_rot;
1161
1162
1163     jacobi(matrix, 3, eigenval, eigen_vec, &n_rot);
1164
1165     /* sort in ascending order */
1166     if (eigenval[0] > eigenval[1])
1167     {
1168         swap_val(eigenval, 0, 1);
1169         swap_col(eigen_vec, 0, 1);
1170     }
1171     if (eigenval[1] > eigenval[2])
1172     {
1173         swap_val(eigenval, 1, 2);
1174         swap_col(eigen_vec, 1, 2);
1175     }
1176     if (eigenval[0] > eigenval[1])
1177     {
1178         swap_val(eigenval, 0, 1);
1179         swap_col(eigen_vec, 0, 1);
1180     }
1181 }
1182
1183
1184 static void align_with_z(
1185         rvec* s,           /* Structure to align */
1186         int   natoms,
1187         rvec  axis)
1188 {
1189     int     i, j, k;
1190     rvec    zet         = {0.0, 0.0, 1.0};
1191     rvec    rot_axis    = {0.0, 0.0, 0.0};
1192     rvec   *rotated_str = NULL;
1193     real    ooanorm;
1194     real    angle;
1195     matrix  rotmat;
1196
1197
1198     snew(rotated_str, natoms);
1199
1200     /* Normalize the axis */
1201     ooanorm = 1.0/norm(axis);
1202     svmul(ooanorm, axis, axis);
1203
1204     /* Calculate the angle for the fitting procedure */
1205     cprod(axis, zet, rot_axis);
1206     angle = acos(axis[2]);
1207     if (angle < 0.0)
1208     {
1209         angle += M_PI;
1210     }
1211
1212     /* Calculate the rotation matrix */
1213     calc_rotmat(rot_axis, angle*180.0/M_PI, rotmat);
1214
1215     /* Apply the rotation matrix to s */
1216     for (i = 0; i < natoms; i++)
1217     {
1218         for (j = 0; j < 3; j++)
1219         {
1220             for (k = 0; k < 3; k++)
1221             {
1222                 rotated_str[i][j] += rotmat[j][k]*s[i][k];
1223             }
1224         }
1225     }
1226
1227     /* Rewrite the rotated structure to s */
1228     for (i = 0; i < natoms; i++)
1229     {
1230         for (j = 0; j < 3; j++)
1231         {
1232             s[i][j] = rotated_str[i][j];
1233         }
1234     }
1235
1236     sfree(rotated_str);
1237 }
1238
1239
1240 static void calc_correl_matrix(rvec* Xstr, rvec* Ystr, double** Rmat, int natoms)
1241 {
1242     int i, j, k;
1243
1244
1245     for (i = 0; i < 3; i++)
1246     {
1247         for (j = 0; j < 3; j++)
1248         {
1249             Rmat[i][j] = 0.0;
1250         }
1251     }
1252
1253     for (i = 0; i < 3; i++)
1254     {
1255         for (j = 0; j < 3; j++)
1256         {
1257             for (k = 0; k < natoms; k++)
1258             {
1259                 Rmat[i][j] += Ystr[k][i] * Xstr[k][j];
1260             }
1261         }
1262     }
1263 }
1264
1265
1266 static void weigh_coords(rvec* str, real* weight, int natoms)
1267 {
1268     int i, j;
1269
1270
1271     for (i = 0; i < natoms; i++)
1272     {
1273         for (j = 0; j < 3; j++)
1274         {
1275             str[i][j] *= sqrt(weight[i]);
1276         }
1277     }
1278 }
1279
1280
1281 static real opt_angle_analytic(
1282         rvec* ref_s,
1283         rvec* act_s,
1284         real* weight,
1285         int   natoms,
1286         rvec  ref_com,
1287         rvec  act_com,
1288         rvec  axis)
1289 {
1290     int      i, j, k;
1291     rvec    *ref_s_1 = NULL;
1292     rvec    *act_s_1 = NULL;
1293     rvec     shift;
1294     double **Rmat, **RtR, **eigvec;
1295     double   eigval[3];
1296     double   V[3][3], WS[3][3];
1297     double   rot_matrix[3][3];
1298     double   opt_angle;
1299
1300
1301     /* Do not change the original coordinates */
1302     snew(ref_s_1, natoms);
1303     snew(act_s_1, natoms);
1304     for (i = 0; i < natoms; i++)
1305     {
1306         copy_rvec(ref_s[i], ref_s_1[i]);
1307         copy_rvec(act_s[i], act_s_1[i]);
1308     }
1309
1310     /* Translate the structures to the origin */
1311     shift[XX] = -ref_com[XX];
1312     shift[YY] = -ref_com[YY];
1313     shift[ZZ] = -ref_com[ZZ];
1314     translate_x(ref_s_1, natoms, shift);
1315
1316     shift[XX] = -act_com[XX];
1317     shift[YY] = -act_com[YY];
1318     shift[ZZ] = -act_com[ZZ];
1319     translate_x(act_s_1, natoms, shift);
1320
1321     /* Align rotation axis with z */
1322     align_with_z(ref_s_1, natoms, axis);
1323     align_with_z(act_s_1, natoms, axis);
1324
1325     /* Correlation matrix */
1326     Rmat = allocate_square_matrix(3);
1327
1328     for (i = 0; i < natoms; i++)
1329     {
1330         ref_s_1[i][2] = 0.0;
1331         act_s_1[i][2] = 0.0;
1332     }
1333
1334     /* Weight positions with sqrt(weight) */
1335     if (NULL != weight)
1336     {
1337         weigh_coords(ref_s_1, weight, natoms);
1338         weigh_coords(act_s_1, weight, natoms);
1339     }
1340
1341     /* Calculate correlation matrices R=YXt (X=ref_s; Y=act_s) */
1342     calc_correl_matrix(ref_s_1, act_s_1, Rmat, natoms);
1343
1344     /* Calculate RtR */
1345     RtR = allocate_square_matrix(3);
1346     for (i = 0; i < 3; i++)
1347     {
1348         for (j = 0; j < 3; j++)
1349         {
1350             for (k = 0; k < 3; k++)
1351             {
1352                 RtR[i][j] += Rmat[k][i] * Rmat[k][j];
1353             }
1354         }
1355     }
1356     /* Diagonalize RtR */
1357     snew(eigvec, 3);
1358     for (i = 0; i < 3; i++)
1359     {
1360         snew(eigvec[i], 3);
1361     }
1362
1363     diagonalize_symmetric(RtR, eigvec, eigval);
1364     swap_col(eigvec, 0, 1);
1365     swap_col(eigvec, 1, 2);
1366     swap_val(eigval, 0, 1);
1367     swap_val(eigval, 1, 2);
1368
1369     /* Calculate V */
1370     for (i = 0; i < 3; i++)
1371     {
1372         for (j = 0; j < 3; j++)
1373         {
1374             V[i][j]  = 0.0;
1375             WS[i][j] = 0.0;
1376         }
1377     }
1378
1379     for (i = 0; i < 2; i++)
1380     {
1381         for (j = 0; j < 2; j++)
1382         {
1383             WS[i][j] = eigvec[i][j] / sqrt(eigval[j]);
1384         }
1385     }
1386
1387     for (i = 0; i < 3; i++)
1388     {
1389         for (j = 0; j < 3; j++)
1390         {
1391             for (k = 0; k < 3; k++)
1392             {
1393                 V[i][j] += Rmat[i][k]*WS[k][j];
1394             }
1395         }
1396     }
1397     free_square_matrix(Rmat, 3);
1398
1399     /* Calculate optimal rotation matrix */
1400     for (i = 0; i < 3; i++)
1401     {
1402         for (j = 0; j < 3; j++)
1403         {
1404             rot_matrix[i][j] = 0.0;
1405         }
1406     }
1407
1408     for (i = 0; i < 3; i++)
1409     {
1410         for (j = 0; j < 3; j++)
1411         {
1412             for (k = 0; k < 3; k++)
1413             {
1414                 rot_matrix[i][j] += eigvec[i][k]*V[j][k];
1415             }
1416         }
1417     }
1418     rot_matrix[2][2] = 1.0;
1419
1420     /* In some cases abs(rot_matrix[0][0]) can be slighly larger
1421      * than unity due to numerical inacurracies. To be able to calculate
1422      * the acos function, we put these values back in range. */
1423     if (rot_matrix[0][0] > 1.0)
1424     {
1425         rot_matrix[0][0] = 1.0;
1426     }
1427     else if (rot_matrix[0][0] < -1.0)
1428     {
1429         rot_matrix[0][0] = -1.0;
1430     }
1431
1432     /* Determine the optimal rotation angle: */
1433     opt_angle = (-1.0)*acos(rot_matrix[0][0])*180.0/M_PI;
1434     if (rot_matrix[0][1] < 0.0)
1435     {
1436         opt_angle = (-1.0)*opt_angle;
1437     }
1438
1439     /* Give back some memory */
1440     free_square_matrix(RtR, 3);
1441     sfree(ref_s_1);
1442     sfree(act_s_1);
1443     for (i = 0; i < 3; i++)
1444     {
1445         sfree(eigvec[i]);
1446     }
1447     sfree(eigvec);
1448
1449     return (real) opt_angle;
1450 }
1451
1452
1453 /* Determine angle of the group by RMSD fit to the reference */
1454 /* Not parallelized, call this routine only on the master */
1455 static real flex_fit_angle(t_rotgrp *rotg)
1456 {
1457     int             i;
1458     rvec           *fitcoords = NULL;
1459     rvec            center;     /* Center of positions passed to the fit routine */
1460     real            fitangle;   /* Angle of the rotation group derived by fitting */
1461     rvec            coord;
1462     real            scal;
1463     gmx_enfrotgrp_t erg;        /* Pointer to enforced rotation group data */
1464
1465
1466     erg = rotg->enfrotgrp;
1467
1468     /* Get the center of the rotation group.
1469      * Note, again, erg->xc has been sorted in do_flexible */
1470     get_center(erg->xc, erg->mc_sorted, rotg->nat, center);
1471
1472     /* === Determine the optimal fit angle for the rotation group === */
1473     if (rotg->eFittype == erotgFitNORM)
1474     {
1475         /* Normalize every position to it's reference length */
1476         for (i = 0; i < rotg->nat; i++)
1477         {
1478             /* Put the center of the positions into the origin */
1479             rvec_sub(erg->xc[i], center, coord);
1480             /* Determine the scaling factor for the length: */
1481             scal = erg->xc_ref_length[erg->xc_sortind[i]] / norm(coord);
1482             /* Get position, multiply with the scaling factor and save  */
1483             svmul(scal, coord, erg->xc_norm[i]);
1484         }
1485         fitcoords = erg->xc_norm;
1486     }
1487     else
1488     {
1489         fitcoords = erg->xc;
1490     }
1491     /* From the point of view of the current positions, the reference has rotated
1492      * backwards. Since we output the angle relative to the fixed reference,
1493      * we need the minus sign. */
1494     fitangle = -opt_angle_analytic(erg->xc_ref_sorted, fitcoords, erg->mc_sorted,
1495                                    rotg->nat, erg->xc_ref_center, center, rotg->vec);
1496
1497     return fitangle;
1498 }
1499
1500
1501 /* Determine actual angle of each slab by RMSD fit to the reference */
1502 /* Not parallelized, call this routine only on the master */
1503 static void flex_fit_angle_perslab(
1504         int       g,
1505         t_rotgrp *rotg,
1506         double    t,
1507         real      degangle,
1508         FILE     *fp)
1509 {
1510     int             i, l, n, islab, ind;
1511     rvec            curr_x, ref_x;
1512     rvec            act_center; /* Center of actual positions that are passed to the fit routine */
1513     rvec            ref_center; /* Same for the reference positions */
1514     real            fitangle;   /* Angle of a slab derived from an RMSD fit to
1515                                  * the reference structure at t=0  */
1516     t_gmx_slabdata *sd;
1517     gmx_enfrotgrp_t erg;        /* Pointer to enforced rotation group data */
1518     real            OOm_av;     /* 1/average_mass of a rotation group atom */
1519     real            m_rel;      /* Relative mass of a rotation group atom  */
1520
1521
1522     erg = rotg->enfrotgrp;
1523
1524     /* Average mass of a rotation group atom: */
1525     OOm_av = erg->invmass*rotg->nat;
1526
1527     /**********************************/
1528     /* First collect the data we need */
1529     /**********************************/
1530
1531     /* Collect the data for the individual slabs */
1532     for (n = erg->slab_first; n <= erg->slab_last; n++)
1533     {
1534         islab   = n - erg->slab_first; /* slab index */
1535         sd      = &(rotg->enfrotgrp->slab_data[islab]);
1536         sd->nat = erg->lastatom[islab]-erg->firstatom[islab]+1;
1537         ind     = 0;
1538
1539         /* Loop over the relevant atoms in the slab */
1540         for (l = erg->firstatom[islab]; l <= erg->lastatom[islab]; l++)
1541         {
1542             /* Current position of this atom: x[ii][XX/YY/ZZ] */
1543             copy_rvec(erg->xc[l], curr_x);
1544
1545             /* The (unrotated) reference position of this atom is copied to ref_x.
1546              * Beware, the xc coords have been sorted in do_flexible */
1547             copy_rvec(erg->xc_ref_sorted[l], ref_x);
1548
1549             /* Save data for doing angular RMSD fit later */
1550             /* Save the current atom position */
1551             copy_rvec(curr_x, sd->x[ind]);
1552             /* Save the corresponding reference position */
1553             copy_rvec(ref_x, sd->ref[ind]);
1554
1555             /* Maybe also mass-weighting was requested. If yes, additionally
1556              * multiply the weights with the relative mass of the atom. If not,
1557              * multiply with unity. */
1558             m_rel = erg->mc_sorted[l]*OOm_av;
1559
1560             /* Save the weight for this atom in this slab */
1561             sd->weight[ind] = gaussian_weight(curr_x, rotg, n) * m_rel;
1562
1563             /* Next atom in this slab */
1564             ind++;
1565         }
1566     }
1567
1568     /******************************/
1569     /* Now do the fit calculation */
1570     /******************************/
1571
1572     fprintf(fp, "%12.3e%6d%12.3f", t, g, degangle);
1573
1574     /* === Now do RMSD fitting for each slab === */
1575     /* We require at least SLAB_MIN_ATOMS in a slab, such that the fit makes sense. */
1576 #define SLAB_MIN_ATOMS 4
1577
1578     for (n = erg->slab_first; n <= erg->slab_last; n++)
1579     {
1580         islab = n - erg->slab_first; /* slab index */
1581         sd    = &(rotg->enfrotgrp->slab_data[islab]);
1582         if (sd->nat >= SLAB_MIN_ATOMS)
1583         {
1584             /* Get the center of the slabs reference and current positions */
1585             get_center(sd->ref, sd->weight, sd->nat, ref_center);
1586             get_center(sd->x, sd->weight, sd->nat, act_center);
1587             if (rotg->eFittype == erotgFitNORM)
1588             {
1589                 /* Normalize every position to it's reference length
1590                  * prior to performing the fit */
1591                 for (i = 0; i < sd->nat; i++) /* Center */
1592                 {
1593                     rvec_dec(sd->ref[i], ref_center);
1594                     rvec_dec(sd->x[i], act_center);
1595                     /* Normalize x_i such that it gets the same length as ref_i */
1596                     svmul( norm(sd->ref[i])/norm(sd->x[i]), sd->x[i], sd->x[i] );
1597                 }
1598                 /* We already subtracted the centers */
1599                 clear_rvec(ref_center);
1600                 clear_rvec(act_center);
1601             }
1602             fitangle = -opt_angle_analytic(sd->ref, sd->x, sd->weight, sd->nat,
1603                                            ref_center, act_center, rotg->vec);
1604             fprintf(fp, "%6d%6d%12.3f", n, sd->nat, fitangle);
1605         }
1606     }
1607     fprintf(fp, "\n");
1608
1609 #undef SLAB_MIN_ATOMS
1610 }
1611
1612
1613 /* Shift x with is */
1614 static gmx_inline void shift_single_coord(matrix box, rvec x, const ivec is)
1615 {
1616     int tx, ty, tz;
1617
1618
1619     tx = is[XX];
1620     ty = is[YY];
1621     tz = is[ZZ];
1622
1623     if (TRICLINIC(box))
1624     {
1625         x[XX] += tx*box[XX][XX]+ty*box[YY][XX]+tz*box[ZZ][XX];
1626         x[YY] += ty*box[YY][YY]+tz*box[ZZ][YY];
1627         x[ZZ] += tz*box[ZZ][ZZ];
1628     }
1629     else
1630     {
1631         x[XX] += tx*box[XX][XX];
1632         x[YY] += ty*box[YY][YY];
1633         x[ZZ] += tz*box[ZZ][ZZ];
1634     }
1635 }
1636
1637
1638 /* Determine the 'home' slab of this atom which is the
1639  * slab with the highest Gaussian weight of all */
1640 #define round(a) (int)(a+0.5)
1641 static gmx_inline int get_homeslab(
1642         rvec curr_x,   /* The position for which the home slab shall be determined */
1643         rvec rotvec,   /* The rotation vector */
1644         real slabdist) /* The slab distance */
1645 {
1646     real dist;
1647
1648
1649     /* The distance of the atom to the coordinate center (where the
1650      * slab with index 0) is */
1651     dist = iprod(rotvec, curr_x);
1652
1653     return round(dist / slabdist);
1654 }
1655
1656
1657 /* For a local atom determine the relevant slabs, i.e. slabs in
1658  * which the gaussian is larger than min_gaussian
1659  */
1660 static int get_single_atom_gaussians(
1661         rvec       curr_x,
1662         t_rotgrp  *rotg)
1663 {
1664     int             slab, homeslab;
1665     real            g;
1666     int             count = 0;
1667     gmx_enfrotgrp_t erg;      /* Pointer to enforced rotation group data */
1668
1669
1670     erg = rotg->enfrotgrp;
1671
1672     /* Determine the 'home' slab of this atom: */
1673     homeslab = get_homeslab(curr_x, rotg->vec, rotg->slab_dist);
1674
1675     /* First determine the weight in the atoms home slab: */
1676     g = gaussian_weight(curr_x, rotg, homeslab);
1677
1678     erg->gn_atom[count]    = g;
1679     erg->gn_slabind[count] = homeslab;
1680     count++;
1681
1682
1683     /* Determine the max slab */
1684     slab = homeslab;
1685     while (g > rotg->min_gaussian)
1686     {
1687         slab++;
1688         g = gaussian_weight(curr_x, rotg, slab);
1689         erg->gn_slabind[count] = slab;
1690         erg->gn_atom[count]    = g;
1691         count++;
1692     }
1693     count--;
1694
1695     /* Determine the min slab */
1696     slab = homeslab;
1697     do
1698     {
1699         slab--;
1700         g = gaussian_weight(curr_x, rotg, slab);
1701         erg->gn_slabind[count] = slab;
1702         erg->gn_atom[count]    = g;
1703         count++;
1704     }
1705     while (g > rotg->min_gaussian);
1706     count--;
1707
1708     return count;
1709 }
1710
1711
1712 static void flex2_precalc_inner_sum(t_rotgrp *rotg)
1713 {
1714     int             i, n, islab;
1715     rvec            xi;       /* positions in the i-sum                        */
1716     rvec            xcn, ycn; /* the current and the reference slab centers    */
1717     real            gaussian_xi;
1718     rvec            yi0;
1719     rvec            rin;     /* Helper variables                              */
1720     real            fac, fac2;
1721     rvec            innersumvec;
1722     real            OOpsii, OOpsiistar;
1723     real            sin_rin; /* s_ii.r_ii */
1724     rvec            s_in, tmpvec, tmpvec2;
1725     real            mi, wi;  /* Mass-weighting of the positions                 */
1726     real            N_M;     /* N/M                                             */
1727     gmx_enfrotgrp_t erg;     /* Pointer to enforced rotation group data */
1728
1729
1730     erg = rotg->enfrotgrp;
1731     N_M = rotg->nat * erg->invmass;
1732
1733     /* Loop over all slabs that contain something */
1734     for (n = erg->slab_first; n <= erg->slab_last; n++)
1735     {
1736         islab = n - erg->slab_first; /* slab index */
1737
1738         /* The current center of this slab is saved in xcn: */
1739         copy_rvec(erg->slab_center[islab], xcn);
1740         /* ... and the reference center in ycn: */
1741         copy_rvec(erg->slab_center_ref[islab+erg->slab_buffer], ycn);
1742
1743         /*** D. Calculate the whole inner sum used for second and third sum */
1744         /* For slab n, we need to loop over all atoms i again. Since we sorted
1745          * the atoms with respect to the rotation vector, we know that it is sufficient
1746          * to calculate from firstatom to lastatom only. All other contributions will
1747          * be very small. */
1748         clear_rvec(innersumvec);
1749         for (i = erg->firstatom[islab]; i <= erg->lastatom[islab]; i++)
1750         {
1751             /* Coordinate xi of this atom */
1752             copy_rvec(erg->xc[i], xi);
1753
1754             /* The i-weights */
1755             gaussian_xi = gaussian_weight(xi, rotg, n);
1756             mi          = erg->mc_sorted[i]; /* need the sorted mass here */
1757             wi          = N_M*mi;
1758
1759             /* Calculate rin */
1760             copy_rvec(erg->xc_ref_sorted[i], yi0); /* Reference position yi0   */
1761             rvec_sub(yi0, ycn, tmpvec2);           /* tmpvec2 = yi0 - ycn      */
1762             mvmul(erg->rotmat, tmpvec2, rin);      /* rin = Omega.(yi0 - ycn)  */
1763
1764             /* Calculate psi_i* and sin */
1765             rvec_sub(xi, xcn, tmpvec2);           /* tmpvec2 = xi - xcn       */
1766             cprod(rotg->vec, tmpvec2, tmpvec);    /* tmpvec = v x (xi - xcn)  */
1767             OOpsiistar = norm2(tmpvec)+rotg->eps; /* OOpsii* = 1/psii* = |v x (xi-xcn)|^2 + eps */
1768             OOpsii     = norm(tmpvec);            /* OOpsii = 1 / psii = |v x (xi - xcn)| */
1769
1770             /*                           *         v x (xi - xcn)          */
1771             unitv(tmpvec, s_in);        /*  sin = ----------------         */
1772                                         /*        |v x (xi - xcn)|         */
1773
1774             sin_rin = iprod(s_in, rin); /* sin_rin = sin . rin             */
1775
1776             /* Now the whole sum */
1777             fac = OOpsii/OOpsiistar;
1778             svmul(fac, rin, tmpvec);
1779             fac2 = fac*fac*OOpsii;
1780             svmul(fac2*sin_rin, s_in, tmpvec2);
1781             rvec_dec(tmpvec, tmpvec2);
1782
1783             svmul(wi*gaussian_xi*sin_rin, tmpvec, tmpvec2);
1784
1785             rvec_inc(innersumvec, tmpvec2);
1786         } /* now we have the inner sum, used both for sum2 and sum3 */
1787
1788         /* Save it to be used in do_flex2_lowlevel */
1789         copy_rvec(innersumvec, erg->slab_innersumvec[islab]);
1790     } /* END of loop over slabs */
1791 }
1792
1793
1794 static void flex_precalc_inner_sum(t_rotgrp *rotg)
1795 {
1796     int             i, n, islab;
1797     rvec            xi;       /* position                                      */
1798     rvec            xcn, ycn; /* the current and the reference slab centers    */
1799     rvec            qin, rin; /* q_i^n and r_i^n                               */
1800     real            bin;
1801     rvec            tmpvec;
1802     rvec            innersumvec; /* Inner part of sum_n2                          */
1803     real            gaussian_xi; /* Gaussian weight gn(xi)                        */
1804     real            mi, wi;      /* Mass-weighting of the positions               */
1805     real            N_M;         /* N/M                                           */
1806
1807     gmx_enfrotgrp_t erg;         /* Pointer to enforced rotation group data */
1808
1809
1810     erg = rotg->enfrotgrp;
1811     N_M = rotg->nat * erg->invmass;
1812
1813     /* Loop over all slabs that contain something */
1814     for (n = erg->slab_first; n <= erg->slab_last; n++)
1815     {
1816         islab = n - erg->slab_first; /* slab index */
1817
1818         /* The current center of this slab is saved in xcn: */
1819         copy_rvec(erg->slab_center[islab], xcn);
1820         /* ... and the reference center in ycn: */
1821         copy_rvec(erg->slab_center_ref[islab+erg->slab_buffer], ycn);
1822
1823         /* For slab n, we need to loop over all atoms i again. Since we sorted
1824          * the atoms with respect to the rotation vector, we know that it is sufficient
1825          * to calculate from firstatom to lastatom only. All other contributions will
1826          * be very small. */
1827         clear_rvec(innersumvec);
1828         for (i = erg->firstatom[islab]; i <= erg->lastatom[islab]; i++)
1829         {
1830             /* Coordinate xi of this atom */
1831             copy_rvec(erg->xc[i], xi);
1832
1833             /* The i-weights */
1834             gaussian_xi = gaussian_weight(xi, rotg, n);
1835             mi          = erg->mc_sorted[i]; /* need the sorted mass here */
1836             wi          = N_M*mi;
1837
1838             /* Calculate rin and qin */
1839             rvec_sub(erg->xc_ref_sorted[i], ycn, tmpvec); /* tmpvec = yi0-ycn */
1840             mvmul(erg->rotmat, tmpvec, rin);              /* rin = Omega.(yi0 - ycn)  */
1841             cprod(rotg->vec, rin, tmpvec);                /* tmpvec = v x Omega*(yi0-ycn) */
1842
1843             /*                                *        v x Omega*(yi0-ycn)    */
1844             unitv(tmpvec, qin);              /* qin = ---------------------   */
1845                                              /*       |v x Omega*(yi0-ycn)|   */
1846
1847             /* Calculate bin */
1848             rvec_sub(xi, xcn, tmpvec);            /* tmpvec = xi-xcn          */
1849             bin = iprod(qin, tmpvec);             /* bin  = qin*(xi-xcn)      */
1850
1851             svmul(wi*gaussian_xi*bin, qin, tmpvec);
1852
1853             /* Add this contribution to the inner sum: */
1854             rvec_add(innersumvec, tmpvec, innersumvec);
1855         } /* now we have the inner sum vector S^n for this slab */
1856           /* Save it to be used in do_flex_lowlevel */
1857         copy_rvec(innersumvec, erg->slab_innersumvec[islab]);
1858     }
1859 }
1860
1861
1862 static real do_flex2_lowlevel(
1863         t_rotgrp  *rotg,
1864         real       sigma,   /* The Gaussian width sigma */
1865         rvec       x[],
1866         gmx_bool   bOutstepRot,
1867         gmx_bool   bOutstepSlab,
1868         matrix     box)
1869 {
1870     int             count, ic, ii, j, m, n, islab, iigrp, ifit;
1871     rvec            xj;          /* position in the i-sum                         */
1872     rvec            yj0;         /* the reference position in the j-sum           */
1873     rvec            xcn, ycn;    /* the current and the reference slab centers    */
1874     real            V;           /* This node's part of the rotation pot. energy  */
1875     real            gaussian_xj; /* Gaussian weight                               */
1876     real            beta;
1877
1878     real            numerator, fit_numerator;
1879     rvec            rjn, fit_rjn; /* Helper variables                              */
1880     real            fac, fac2;
1881
1882     real            OOpsij, OOpsijstar;
1883     real            OOsigma2; /* 1/(sigma^2)                                   */
1884     real            sjn_rjn;
1885     real            betasigpsi;
1886     rvec            sjn, tmpvec, tmpvec2, yj0_ycn;
1887     rvec            sum1vec_part, sum1vec, sum2vec_part, sum2vec, sum3vec, sum4vec, innersumvec;
1888     real            sum3, sum4;
1889     gmx_enfrotgrp_t erg;     /* Pointer to enforced rotation group data       */
1890     real            mj, wj;  /* Mass-weighting of the positions               */
1891     real            N_M;     /* N/M                                           */
1892     real            Wjn;     /* g_n(x_j) m_j / Mjn                            */
1893     gmx_bool        bCalcPotFit;
1894
1895     /* To calculate the torque per slab */
1896     rvec slab_force;         /* Single force from slab n on one atom          */
1897     rvec slab_sum1vec_part;
1898     real slab_sum3part, slab_sum4part;
1899     rvec slab_sum1vec, slab_sum2vec, slab_sum3vec, slab_sum4vec;
1900
1901
1902     erg = rotg->enfrotgrp;
1903
1904     /* Pre-calculate the inner sums, so that we do not have to calculate
1905      * them again for every atom */
1906     flex2_precalc_inner_sum(rotg);
1907
1908     bCalcPotFit = (bOutstepRot || bOutstepSlab) && (erotgFitPOT == rotg->eFittype);
1909
1910     /********************************************************/
1911     /* Main loop over all local atoms of the rotation group */
1912     /********************************************************/
1913     N_M      = rotg->nat * erg->invmass;
1914     V        = 0.0;
1915     OOsigma2 = 1.0 / (sigma*sigma);
1916     for (j = 0; j < erg->nat_loc; j++)
1917     {
1918         /* Local index of a rotation group atom  */
1919         ii = erg->ind_loc[j];
1920         /* Position of this atom in the collective array */
1921         iigrp = erg->xc_ref_ind[j];
1922         /* Mass-weighting */
1923         mj = erg->mc[iigrp];  /* need the unsorted mass here */
1924         wj = N_M*mj;
1925
1926         /* Current position of this atom: x[ii][XX/YY/ZZ]
1927          * Note that erg->xc_center contains the center of mass in case the flex2-t
1928          * potential was chosen. For the flex2 potential erg->xc_center must be
1929          * zero. */
1930         rvec_sub(x[ii], erg->xc_center, xj);
1931
1932         /* Shift this atom such that it is near its reference */
1933         shift_single_coord(box, xj, erg->xc_shifts[iigrp]);
1934
1935         /* Determine the slabs to loop over, i.e. the ones with contributions
1936          * larger than min_gaussian */
1937         count = get_single_atom_gaussians(xj, rotg);
1938
1939         clear_rvec(sum1vec_part);
1940         clear_rvec(sum2vec_part);
1941         sum3 = 0.0;
1942         sum4 = 0.0;
1943         /* Loop over the relevant slabs for this atom */
1944         for (ic = 0; ic < count; ic++)
1945         {
1946             n = erg->gn_slabind[ic];
1947
1948             /* Get the precomputed Gaussian value of curr_slab for curr_x */
1949             gaussian_xj = erg->gn_atom[ic];
1950
1951             islab = n - erg->slab_first; /* slab index */
1952
1953             /* The (unrotated) reference position of this atom is copied to yj0: */
1954             copy_rvec(rotg->x_ref[iigrp], yj0);
1955
1956             beta = calc_beta(xj, rotg, n);
1957
1958             /* The current center of this slab is saved in xcn: */
1959             copy_rvec(erg->slab_center[islab], xcn);
1960             /* ... and the reference center in ycn: */
1961             copy_rvec(erg->slab_center_ref[islab+erg->slab_buffer], ycn);
1962
1963             rvec_sub(yj0, ycn, yj0_ycn);          /* yj0_ycn = yj0 - ycn      */
1964
1965             /* Rotate: */
1966             mvmul(erg->rotmat, yj0_ycn, rjn);     /* rjn = Omega.(yj0 - ycn)  */
1967
1968             /* Subtract the slab center from xj */
1969             rvec_sub(xj, xcn, tmpvec2);           /* tmpvec2 = xj - xcn       */
1970
1971             /* In rare cases, when an atom position coincides with a slab center
1972              * (tmpvec2 == 0) we cannot compute the vector product for sjn.
1973              * However, since the atom is located directly on the pivot, this
1974              * slab's contribution to the force on that atom will be zero
1975              * anyway. Therefore, we directly move on to the next slab.       */
1976             if (gmx_numzero(norm(tmpvec2))) /* 0 == norm(xj - xcn) */
1977             {
1978                 continue;
1979             }
1980
1981             /* Calculate sjn */
1982             cprod(rotg->vec, tmpvec2, tmpvec);    /* tmpvec = v x (xj - xcn)  */
1983
1984             OOpsijstar = norm2(tmpvec)+rotg->eps; /* OOpsij* = 1/psij* = |v x (xj-xcn)|^2 + eps */
1985
1986             numerator = sqr(iprod(tmpvec, rjn));
1987
1988             /*********************************/
1989             /* Add to the rotation potential */
1990             /*********************************/
1991             V += 0.5*rotg->k*wj*gaussian_xj*numerator/OOpsijstar;
1992
1993             /* If requested, also calculate the potential for a set of angles
1994              * near the current reference angle */
1995             if (bCalcPotFit)
1996             {
1997                 for (ifit = 0; ifit < rotg->PotAngle_nstep; ifit++)
1998                 {
1999                     mvmul(erg->PotAngleFit->rotmat[ifit], yj0_ycn, fit_rjn);
2000                     fit_numerator              = sqr(iprod(tmpvec, fit_rjn));
2001                     erg->PotAngleFit->V[ifit] += 0.5*rotg->k*wj*gaussian_xj*fit_numerator/OOpsijstar;
2002                 }
2003             }
2004
2005             /*************************************/
2006             /* Now calculate the force on atom j */
2007             /*************************************/
2008
2009             OOpsij = norm(tmpvec);    /* OOpsij = 1 / psij = |v x (xj - xcn)| */
2010
2011             /*                              *         v x (xj - xcn)          */
2012             unitv(tmpvec, sjn);            /*  sjn = ----------------         */
2013                                            /*        |v x (xj - xcn)|         */
2014
2015             sjn_rjn = iprod(sjn, rjn);     /* sjn_rjn = sjn . rjn             */
2016
2017
2018             /*** A. Calculate the first of the four sum terms: ****************/
2019             fac = OOpsij/OOpsijstar;
2020             svmul(fac, rjn, tmpvec);
2021             fac2 = fac*fac*OOpsij;
2022             svmul(fac2*sjn_rjn, sjn, tmpvec2);
2023             rvec_dec(tmpvec, tmpvec2);
2024             fac2 = wj*gaussian_xj; /* also needed for sum4 */
2025             svmul(fac2*sjn_rjn, tmpvec, slab_sum1vec_part);
2026             /********************/
2027             /*** Add to sum1: ***/
2028             /********************/
2029             rvec_inc(sum1vec_part, slab_sum1vec_part); /* sum1 still needs to vector multiplied with v */
2030
2031             /*** B. Calculate the forth of the four sum terms: ****************/
2032             betasigpsi = beta*OOsigma2*OOpsij; /* this is also needed for sum3 */
2033             /********************/
2034             /*** Add to sum4: ***/
2035             /********************/
2036             slab_sum4part = fac2*betasigpsi*fac*sjn_rjn*sjn_rjn; /* Note that fac is still valid from above */
2037             sum4         += slab_sum4part;
2038
2039             /*** C. Calculate Wjn for second and third sum */
2040             /* Note that we can safely divide by slab_weights since we check in
2041              * get_slab_centers that it is non-zero. */
2042             Wjn = gaussian_xj*mj/erg->slab_weights[islab];
2043
2044             /* We already have precalculated the inner sum for slab n */
2045             copy_rvec(erg->slab_innersumvec[islab], innersumvec);
2046
2047             /* Weigh the inner sum vector with Wjn */
2048             svmul(Wjn, innersumvec, innersumvec);
2049
2050             /*** E. Calculate the second of the four sum terms: */
2051             /********************/
2052             /*** Add to sum2: ***/
2053             /********************/
2054             rvec_inc(sum2vec_part, innersumvec); /* sum2 still needs to be vector crossproduct'ed with v */
2055
2056             /*** F. Calculate the third of the four sum terms: */
2057             slab_sum3part = betasigpsi * iprod(sjn, innersumvec);
2058             sum3         += slab_sum3part; /* still needs to be multiplied with v */
2059
2060             /*** G. Calculate the torque on the local slab's axis: */
2061             if (bOutstepRot)
2062             {
2063                 /* Sum1 */
2064                 cprod(slab_sum1vec_part, rotg->vec, slab_sum1vec);
2065                 /* Sum2 */
2066                 cprod(innersumvec, rotg->vec, slab_sum2vec);
2067                 /* Sum3 */
2068                 svmul(slab_sum3part, rotg->vec, slab_sum3vec);
2069                 /* Sum4 */
2070                 svmul(slab_sum4part, rotg->vec, slab_sum4vec);
2071
2072                 /* The force on atom ii from slab n only: */
2073                 for (m = 0; m < DIM; m++)
2074                 {
2075                     slab_force[m] = rotg->k * (-slab_sum1vec[m] + slab_sum2vec[m] - slab_sum3vec[m] + 0.5*slab_sum4vec[m]);
2076                 }
2077
2078                 erg->slab_torque_v[islab] += torque(rotg->vec, slab_force, xj, xcn);
2079             }
2080         } /* END of loop over slabs */
2081
2082         /* Construct the four individual parts of the vector sum: */
2083         cprod(sum1vec_part, rotg->vec, sum1vec);      /* sum1vec =   { } x v  */
2084         cprod(sum2vec_part, rotg->vec, sum2vec);      /* sum2vec =   { } x v  */
2085         svmul(sum3, rotg->vec, sum3vec);              /* sum3vec =   { } . v  */
2086         svmul(sum4, rotg->vec, sum4vec);              /* sum4vec =   { } . v  */
2087
2088         /* Store the additional force so that it can be added to the force
2089          * array after the normal forces have been evaluated */
2090         for (m = 0; m < DIM; m++)
2091         {
2092             erg->f_rot_loc[j][m] = rotg->k * (-sum1vec[m] + sum2vec[m] - sum3vec[m] + 0.5*sum4vec[m]);
2093         }
2094
2095 #ifdef SUM_PARTS
2096         fprintf(stderr, "sum1: %15.8f %15.8f %15.8f\n",    -rotg->k*sum1vec[XX],    -rotg->k*sum1vec[YY],    -rotg->k*sum1vec[ZZ]);
2097         fprintf(stderr, "sum2: %15.8f %15.8f %15.8f\n",     rotg->k*sum2vec[XX],     rotg->k*sum2vec[YY],     rotg->k*sum2vec[ZZ]);
2098         fprintf(stderr, "sum3: %15.8f %15.8f %15.8f\n",    -rotg->k*sum3vec[XX],    -rotg->k*sum3vec[YY],    -rotg->k*sum3vec[ZZ]);
2099         fprintf(stderr, "sum4: %15.8f %15.8f %15.8f\n", 0.5*rotg->k*sum4vec[XX], 0.5*rotg->k*sum4vec[YY], 0.5*rotg->k*sum4vec[ZZ]);
2100 #endif
2101
2102         PRINT_FORCE_J
2103
2104     } /* END of loop over local atoms */
2105
2106     return V;
2107 }
2108
2109
2110 static real do_flex_lowlevel(
2111         t_rotgrp *rotg,
2112         real      sigma,     /* The Gaussian width sigma                      */
2113         rvec      x[],
2114         gmx_bool  bOutstepRot,
2115         gmx_bool  bOutstepSlab,
2116         matrix    box)
2117 {
2118     int             count, ic, ifit, ii, j, m, n, islab, iigrp;
2119     rvec            xj, yj0;                /* current and reference position                */
2120     rvec            xcn, ycn;               /* the current and the reference slab centers    */
2121     rvec            yj0_ycn;                /* yj0 - ycn                                     */
2122     rvec            xj_xcn;                 /* xj - xcn                                      */
2123     rvec            qjn, fit_qjn;           /* q_i^n                                         */
2124     rvec            sum_n1, sum_n2;         /* Two contributions to the rotation force       */
2125     rvec            innersumvec;            /* Inner part of sum_n2                          */
2126     rvec            s_n;
2127     rvec            force_n;                /* Single force from slab n on one atom          */
2128     rvec            force_n1, force_n2;     /* First and second part of force_n              */
2129     rvec            tmpvec, tmpvec2, tmp_f; /* Helper variables                              */
2130     real            V;                      /* The rotation potential energy                 */
2131     real            OOsigma2;               /* 1/(sigma^2)                                   */
2132     real            beta;                   /* beta_n(xj)                                    */
2133     real            bjn, fit_bjn;           /* b_j^n                                         */
2134     real            gaussian_xj;            /* Gaussian weight gn(xj)                        */
2135     real            betan_xj_sigma2;
2136     real            mj, wj;                 /* Mass-weighting of the positions               */
2137     real            N_M;                    /* N/M                                           */
2138     gmx_enfrotgrp_t erg;                    /* Pointer to enforced rotation group data       */
2139     gmx_bool        bCalcPotFit;
2140
2141
2142     erg = rotg->enfrotgrp;
2143
2144     /* Pre-calculate the inner sums, so that we do not have to calculate
2145      * them again for every atom */
2146     flex_precalc_inner_sum(rotg);
2147
2148     bCalcPotFit = (bOutstepRot || bOutstepSlab) && (erotgFitPOT == rotg->eFittype);
2149
2150     /********************************************************/
2151     /* Main loop over all local atoms of the rotation group */
2152     /********************************************************/
2153     OOsigma2 = 1.0/(sigma*sigma);
2154     N_M      = rotg->nat * erg->invmass;
2155     V        = 0.0;
2156     for (j = 0; j < erg->nat_loc; j++)
2157     {
2158         /* Local index of a rotation group atom  */
2159         ii = erg->ind_loc[j];
2160         /* Position of this atom in the collective array */
2161         iigrp = erg->xc_ref_ind[j];
2162         /* Mass-weighting */
2163         mj = erg->mc[iigrp];  /* need the unsorted mass here */
2164         wj = N_M*mj;
2165
2166         /* Current position of this atom: x[ii][XX/YY/ZZ]
2167          * Note that erg->xc_center contains the center of mass in case the flex-t
2168          * potential was chosen. For the flex potential erg->xc_center must be
2169          * zero. */
2170         rvec_sub(x[ii], erg->xc_center, xj);
2171
2172         /* Shift this atom such that it is near its reference */
2173         shift_single_coord(box, xj, erg->xc_shifts[iigrp]);
2174
2175         /* Determine the slabs to loop over, i.e. the ones with contributions
2176          * larger than min_gaussian */
2177         count = get_single_atom_gaussians(xj, rotg);
2178
2179         clear_rvec(sum_n1);
2180         clear_rvec(sum_n2);
2181
2182         /* Loop over the relevant slabs for this atom */
2183         for (ic = 0; ic < count; ic++)
2184         {
2185             n = erg->gn_slabind[ic];
2186
2187             /* Get the precomputed Gaussian for xj in slab n */
2188             gaussian_xj = erg->gn_atom[ic];
2189
2190             islab = n - erg->slab_first; /* slab index */
2191
2192             /* The (unrotated) reference position of this atom is saved in yj0: */
2193             copy_rvec(rotg->x_ref[iigrp], yj0);
2194
2195             beta = calc_beta(xj, rotg, n);
2196
2197             /* The current center of this slab is saved in xcn: */
2198             copy_rvec(erg->slab_center[islab], xcn);
2199             /* ... and the reference center in ycn: */
2200             copy_rvec(erg->slab_center_ref[islab+erg->slab_buffer], ycn);
2201
2202             rvec_sub(yj0, ycn, yj0_ycn); /* yj0_ycn = yj0 - ycn */
2203
2204             /* In rare cases, when an atom position coincides with a reference slab
2205              * center (yj0_ycn == 0) we cannot compute the normal vector qjn.
2206              * However, since the atom is located directly on the pivot, this
2207              * slab's contribution to the force on that atom will be zero
2208              * anyway. Therefore, we directly move on to the next slab.       */
2209             if (gmx_numzero(norm(yj0_ycn))) /* 0 == norm(yj0 - ycn) */
2210             {
2211                 continue;
2212             }
2213
2214             /* Rotate: */
2215             mvmul(erg->rotmat, yj0_ycn, tmpvec2); /* tmpvec2= Omega.(yj0-ycn) */
2216
2217             /* Subtract the slab center from xj */
2218             rvec_sub(xj, xcn, xj_xcn);           /* xj_xcn = xj - xcn         */
2219
2220             /* Calculate qjn */
2221             cprod(rotg->vec, tmpvec2, tmpvec); /* tmpvec= v x Omega.(yj0-ycn) */
2222
2223             /*                         *         v x Omega.(yj0-ycn)    */
2224             unitv(tmpvec, qjn);       /*  qjn = ---------------------   */
2225                                       /*        |v x Omega.(yj0-ycn)|   */
2226
2227             bjn = iprod(qjn, xj_xcn); /* bjn = qjn * (xj - xcn) */
2228
2229             /*********************************/
2230             /* Add to the rotation potential */
2231             /*********************************/
2232             V += 0.5*rotg->k*wj*gaussian_xj*sqr(bjn);
2233
2234             /* If requested, also calculate the potential for a set of angles
2235              * near the current reference angle */
2236             if (bCalcPotFit)
2237             {
2238                 for (ifit = 0; ifit < rotg->PotAngle_nstep; ifit++)
2239                 {
2240                     /* As above calculate Omega.(yj0-ycn), now for the other angles */
2241                     mvmul(erg->PotAngleFit->rotmat[ifit], yj0_ycn, tmpvec2); /* tmpvec2= Omega.(yj0-ycn) */
2242                     /* As above calculate qjn */
2243                     cprod(rotg->vec, tmpvec2, tmpvec);                       /* tmpvec= v x Omega.(yj0-ycn) */
2244                     /*                                                        *             v x Omega.(yj0-ycn)    */
2245                     unitv(tmpvec, fit_qjn);                                  /*  fit_qjn = ---------------------   */
2246                                                                              /*            |v x Omega.(yj0-ycn)|   */
2247                     fit_bjn = iprod(fit_qjn, xj_xcn);                        /* fit_bjn = fit_qjn * (xj - xcn) */
2248                     /* Add to the rotation potential for this angle */
2249                     erg->PotAngleFit->V[ifit] += 0.5*rotg->k*wj*gaussian_xj*sqr(fit_bjn);
2250                 }
2251             }
2252
2253             /****************************************************************/
2254             /* sum_n1 will typically be the main contribution to the force: */
2255             /****************************************************************/
2256             betan_xj_sigma2 = beta*OOsigma2;  /*  beta_n(xj)/sigma^2  */
2257
2258             /* The next lines calculate
2259              *  qjn - (bjn*beta(xj)/(2sigma^2))v  */
2260             svmul(bjn*0.5*betan_xj_sigma2, rotg->vec, tmpvec2);
2261             rvec_sub(qjn, tmpvec2, tmpvec);
2262
2263             /* Multiply with gn(xj)*bjn: */
2264             svmul(gaussian_xj*bjn, tmpvec, tmpvec2);
2265
2266             /* Sum over n: */
2267             rvec_inc(sum_n1, tmpvec2);
2268
2269             /* We already have precalculated the Sn term for slab n */
2270             copy_rvec(erg->slab_innersumvec[islab], s_n);
2271             /*                                                             *          beta_n(xj)              */
2272             svmul(betan_xj_sigma2*iprod(s_n, xj_xcn), rotg->vec, tmpvec); /* tmpvec = ---------- s_n (xj-xcn) */
2273                                                                           /*            sigma^2               */
2274
2275             rvec_sub(s_n, tmpvec, innersumvec);
2276
2277             /* We can safely divide by slab_weights since we check in get_slab_centers
2278              * that it is non-zero. */
2279             svmul(gaussian_xj/erg->slab_weights[islab], innersumvec, innersumvec);
2280
2281             rvec_add(sum_n2, innersumvec, sum_n2);
2282
2283             /* Calculate the torque: */
2284             if (bOutstepRot)
2285             {
2286                 /* The force on atom ii from slab n only: */
2287                 svmul(-rotg->k*wj, tmpvec2, force_n1);     /* part 1 */
2288                 svmul( rotg->k*mj, innersumvec, force_n2); /* part 2 */
2289                 rvec_add(force_n1, force_n2, force_n);
2290                 erg->slab_torque_v[islab] += torque(rotg->vec, force_n, xj, xcn);
2291             }
2292         } /* END of loop over slabs */
2293
2294         /* Put both contributions together: */
2295         svmul(wj, sum_n1, sum_n1);
2296         svmul(mj, sum_n2, sum_n2);
2297         rvec_sub(sum_n2, sum_n1, tmp_f); /* F = -grad V */
2298
2299         /* Store the additional force so that it can be added to the force
2300          * array after the normal forces have been evaluated */
2301         for (m = 0; m < DIM; m++)
2302         {
2303             erg->f_rot_loc[j][m] = rotg->k*tmp_f[m];
2304         }
2305
2306         PRINT_FORCE_J
2307
2308     } /* END of loop over local atoms */
2309
2310     return V;
2311 }
2312
2313 #ifdef PRINT_COORDS
2314 static void print_coordinates(t_rotgrp *rotg, rvec x[], matrix box, int step)
2315 {
2316     int             i;
2317     static FILE    *fp;
2318     static char     buf[STRLEN];
2319     static gmx_bool bFirst = 1;
2320
2321
2322     if (bFirst)
2323     {
2324         sprintf(buf, "coords%d.txt", cr->nodeid);
2325         fp     = fopen(buf, "w");
2326         bFirst = 0;
2327     }
2328
2329     fprintf(fp, "\nStep %d\n", step);
2330     fprintf(fp, "box: %f %f %f %f %f %f %f %f %f\n",
2331             box[XX][XX], box[XX][YY], box[XX][ZZ],
2332             box[YY][XX], box[YY][YY], box[YY][ZZ],
2333             box[ZZ][XX], box[ZZ][ZZ], box[ZZ][ZZ]);
2334     for (i = 0; i < rotg->nat; i++)
2335     {
2336         fprintf(fp, "%4d  %f %f %f\n", i,
2337                 erg->xc[i][XX], erg->xc[i][YY], erg->xc[i][ZZ]);
2338     }
2339     fflush(fp);
2340
2341 }
2342 #endif
2343
2344
2345 static int projection_compare(const void *a, const void *b)
2346 {
2347     sort_along_vec_t *xca, *xcb;
2348
2349
2350     xca = (sort_along_vec_t *)a;
2351     xcb = (sort_along_vec_t *)b;
2352
2353     if (xca->xcproj < xcb->xcproj)
2354     {
2355         return -1;
2356     }
2357     else if (xca->xcproj > xcb->xcproj)
2358     {
2359         return 1;
2360     }
2361     else
2362     {
2363         return 0;
2364     }
2365 }
2366
2367
2368 static void sort_collective_coordinates(
2369         t_rotgrp         *rotg, /* Rotation group */
2370         sort_along_vec_t *data) /* Buffer for sorting the positions */
2371 {
2372     int             i;
2373     gmx_enfrotgrp_t erg;       /* Pointer to enforced rotation group data */
2374
2375
2376     erg = rotg->enfrotgrp;
2377
2378     /* The projection of the position vector on the rotation vector is
2379      * the relevant value for sorting. Fill the 'data' structure */
2380     for (i = 0; i < rotg->nat; i++)
2381     {
2382         data[i].xcproj = iprod(erg->xc[i], rotg->vec);  /* sort criterium */
2383         data[i].m      = erg->mc[i];
2384         data[i].ind    = i;
2385         copy_rvec(erg->xc[i], data[i].x    );
2386         copy_rvec(rotg->x_ref[i], data[i].x_ref);
2387     }
2388     /* Sort the 'data' structure */
2389     gmx_qsort(data, rotg->nat, sizeof(sort_along_vec_t), projection_compare);
2390
2391     /* Copy back the sorted values */
2392     for (i = 0; i < rotg->nat; i++)
2393     {
2394         copy_rvec(data[i].x, erg->xc[i]           );
2395         copy_rvec(data[i].x_ref, erg->xc_ref_sorted[i]);
2396         erg->mc_sorted[i]  = data[i].m;
2397         erg->xc_sortind[i] = data[i].ind;
2398     }
2399 }
2400
2401
2402 /* For each slab, get the first and the last index of the sorted atom
2403  * indices */
2404 static void get_firstlast_atom_per_slab(t_rotgrp *rotg)
2405 {
2406     int             i, islab, n;
2407     real            beta;
2408     gmx_enfrotgrp_t erg;     /* Pointer to enforced rotation group data */
2409
2410
2411     erg = rotg->enfrotgrp;
2412
2413     /* Find the first atom that needs to enter the calculation for each slab */
2414     n = erg->slab_first; /* slab */
2415     i = 0;               /* start with the first atom */
2416     do
2417     {
2418         /* Find the first atom that significantly contributes to this slab */
2419         do /* move forward in position until a large enough beta is found */
2420         {
2421             beta = calc_beta(erg->xc[i], rotg, n);
2422             i++;
2423         }
2424         while ((beta < -erg->max_beta) && (i < rotg->nat));
2425         i--;
2426         islab                 = n - erg->slab_first; /* slab index */
2427         erg->firstatom[islab] = i;
2428         /* Proceed to the next slab */
2429         n++;
2430     }
2431     while (n <= erg->slab_last);
2432
2433     /* Find the last atom for each slab */
2434     n = erg->slab_last; /* start with last slab */
2435     i = rotg->nat-1;    /* start with the last atom */
2436     do
2437     {
2438         do  /* move backward in position until a large enough beta is found */
2439         {
2440             beta = calc_beta(erg->xc[i], rotg, n);
2441             i--;
2442         }
2443         while ((beta > erg->max_beta) && (i > -1));
2444         i++;
2445         islab                = n - erg->slab_first; /* slab index */
2446         erg->lastatom[islab] = i;
2447         /* Proceed to the next slab */
2448         n--;
2449     }
2450     while (n >= erg->slab_first);
2451 }
2452
2453
2454 /* Determine the very first and very last slab that needs to be considered
2455  * For the first slab that needs to be considered, we have to find the smallest
2456  * n that obeys:
2457  *
2458  * x_first * v - n*Delta_x <= beta_max
2459  *
2460  * slab index n, slab distance Delta_x, rotation vector v. For the last slab we
2461  * have to find the largest n that obeys
2462  *
2463  * x_last * v - n*Delta_x >= -beta_max
2464  *
2465  */
2466 static gmx_inline int get_first_slab(
2467         t_rotgrp *rotg,      /* The rotation group (inputrec data) */
2468         real      max_beta,  /* The max_beta value, instead of min_gaussian */
2469         rvec      firstatom) /* First atom after sorting along the rotation vector v */
2470 {
2471     /* Find the first slab for the first atom */
2472     return ceil((iprod(firstatom, rotg->vec) - max_beta)/rotg->slab_dist);
2473 }
2474
2475
2476 static gmx_inline int get_last_slab(
2477         t_rotgrp *rotg,     /* The rotation group (inputrec data) */
2478         real      max_beta, /* The max_beta value, instead of min_gaussian */
2479         rvec      lastatom) /* Last atom along v */
2480 {
2481     /* Find the last slab for the last atom */
2482     return floor((iprod(lastatom, rotg->vec) + max_beta)/rotg->slab_dist);
2483 }
2484
2485
2486 static void get_firstlast_slab_check(
2487         t_rotgrp        *rotg,      /* The rotation group (inputrec data) */
2488         t_gmx_enfrotgrp *erg,       /* The rotation group (data only accessible in this file) */
2489         rvec             firstatom, /* First atom after sorting along the rotation vector v */
2490         rvec             lastatom)  /* Last atom along v */
2491 {
2492     erg->slab_first = get_first_slab(rotg, erg->max_beta, firstatom);
2493     erg->slab_last  = get_last_slab(rotg, erg->max_beta, lastatom);
2494
2495     /* Calculate the slab buffer size, which changes when slab_first changes */
2496     erg->slab_buffer = erg->slab_first - erg->slab_first_ref;
2497
2498     /* Check whether we have reference data to compare against */
2499     if (erg->slab_first < erg->slab_first_ref)
2500     {
2501         gmx_fatal(FARGS, "%s No reference data for first slab (n=%d), unable to proceed.",
2502                   RotStr, erg->slab_first);
2503     }
2504
2505     /* Check whether we have reference data to compare against */
2506     if (erg->slab_last > erg->slab_last_ref)
2507     {
2508         gmx_fatal(FARGS, "%s No reference data for last slab (n=%d), unable to proceed.",
2509                   RotStr, erg->slab_last);
2510     }
2511 }
2512
2513
2514 /* Enforced rotation with a flexible axis */
2515 static void do_flexible(
2516         gmx_bool        bMaster,
2517         gmx_enfrot_t    enfrot,       /* Other rotation data                        */
2518         t_rotgrp       *rotg,         /* The rotation group                         */
2519         int             g,            /* Group number                               */
2520         rvec            x[],          /* The local positions                        */
2521         matrix          box,
2522         double          t,            /* Time in picoseconds                        */
2523         gmx_bool        bOutstepRot,  /* Output to main rotation output file        */
2524         gmx_bool        bOutstepSlab) /* Output per-slab data                       */
2525 {
2526     int             l, nslabs;
2527     real            sigma;    /* The Gaussian width sigma */
2528     gmx_enfrotgrp_t erg;      /* Pointer to enforced rotation group data */
2529
2530
2531     erg = rotg->enfrotgrp;
2532
2533     /* Define the sigma value */
2534     sigma = 0.7*rotg->slab_dist;
2535
2536     /* Sort the collective coordinates erg->xc along the rotation vector. This is
2537      * an optimization for the inner loop. */
2538     sort_collective_coordinates(rotg, enfrot->data);
2539
2540     /* Determine the first relevant slab for the first atom and the last
2541      * relevant slab for the last atom */
2542     get_firstlast_slab_check(rotg, erg, erg->xc[0], erg->xc[rotg->nat-1]);
2543
2544     /* Determine for each slab depending on the min_gaussian cutoff criterium,
2545      * a first and a last atom index inbetween stuff needs to be calculated */
2546     get_firstlast_atom_per_slab(rotg);
2547
2548     /* Determine the gaussian-weighted center of positions for all slabs */
2549     get_slab_centers(rotg, erg->xc, erg->mc_sorted, g, t, enfrot->out_slabs, bOutstepSlab, FALSE);
2550
2551     /* Clear the torque per slab from last time step: */
2552     nslabs = erg->slab_last - erg->slab_first + 1;
2553     for (l = 0; l < nslabs; l++)
2554     {
2555         erg->slab_torque_v[l] = 0.0;
2556     }
2557
2558     /* Call the rotational forces kernel */
2559     if (rotg->eType == erotgFLEX || rotg->eType == erotgFLEXT)
2560     {
2561         erg->V = do_flex_lowlevel(rotg, sigma, x, bOutstepRot, bOutstepSlab, box);
2562     }
2563     else if (rotg->eType == erotgFLEX2 || rotg->eType == erotgFLEX2T)
2564     {
2565         erg->V = do_flex2_lowlevel(rotg, sigma, x, bOutstepRot, bOutstepSlab, box);
2566     }
2567     else
2568     {
2569         gmx_fatal(FARGS, "Unknown flexible rotation type");
2570     }
2571
2572     /* Determine angle by RMSD fit to the reference - Let's hope this */
2573     /* only happens once in a while, since this is not parallelized! */
2574     if (bMaster && (erotgFitPOT != rotg->eFittype) )
2575     {
2576         if (bOutstepRot)
2577         {
2578             /* Fit angle of the whole rotation group */
2579             erg->angle_v = flex_fit_angle(rotg);
2580         }
2581         if (bOutstepSlab)
2582         {
2583             /* Fit angle of each slab */
2584             flex_fit_angle_perslab(g, rotg, t, erg->degangle, enfrot->out_angles);
2585         }
2586     }
2587
2588     /* Lump together the torques from all slabs: */
2589     erg->torque_v = 0.0;
2590     for (l = 0; l < nslabs; l++)
2591     {
2592         erg->torque_v += erg->slab_torque_v[l];
2593     }
2594 }
2595
2596
2597 /* Calculate the angle between reference and actual rotation group atom,
2598  * both projected into a plane perpendicular to the rotation vector: */
2599 static void angle(t_rotgrp *rotg,
2600                   rvec      x_act,
2601                   rvec      x_ref,
2602                   real     *alpha,
2603                   real     *weight) /* atoms near the rotation axis should count less than atoms far away */
2604 {
2605     rvec xp, xrp;                   /* current and reference positions projected on a plane perpendicular to pg->vec */
2606     rvec dum;
2607
2608
2609     /* Project x_ref and x into a plane through the origin perpendicular to rot_vec: */
2610     /* Project x_ref: xrp = x_ref - (vec * x_ref) * vec */
2611     svmul(iprod(rotg->vec, x_ref), rotg->vec, dum);
2612     rvec_sub(x_ref, dum, xrp);
2613     /* Project x_act: */
2614     svmul(iprod(rotg->vec, x_act), rotg->vec, dum);
2615     rvec_sub(x_act, dum, xp);
2616
2617     /* Retrieve information about which vector precedes. gmx_angle always
2618      * returns a positive angle. */
2619     cprod(xp, xrp, dum); /* if reference precedes, this is pointing into the same direction as vec */
2620
2621     if (iprod(rotg->vec, dum) >= 0)
2622     {
2623         *alpha = -gmx_angle(xrp, xp);
2624     }
2625     else
2626     {
2627         *alpha = +gmx_angle(xrp, xp);
2628     }
2629
2630     /* Also return the weight */
2631     *weight = norm(xp);
2632 }
2633
2634
2635 /* Project first vector onto a plane perpendicular to the second vector
2636  * dr = dr - (dr.v)v
2637  * Note that v must be of unit length.
2638  */
2639 static gmx_inline void project_onto_plane(rvec dr, const rvec v)
2640 {
2641     rvec tmp;
2642
2643
2644     svmul(iprod(dr, v), v, tmp); /* tmp = (dr.v)v */
2645     rvec_dec(dr, tmp);           /* dr = dr - (dr.v)v */
2646 }
2647
2648
2649 /* Fixed rotation: The rotation reference group rotates around the v axis. */
2650 /* The atoms of the actual rotation group are attached with imaginary  */
2651 /* springs to the reference atoms.                                     */
2652 static void do_fixed(
2653         t_rotgrp       *rotg,         /* The rotation group                         */
2654         gmx_bool        bOutstepRot,  /* Output to main rotation output file        */
2655         gmx_bool        bOutstepSlab) /* Output per-slab data                       */
2656 {
2657     int             ifit, j, jj, m;
2658     rvec            dr;
2659     rvec            tmp_f;     /* Force */
2660     real            alpha;     /* a single angle between an actual and a reference position */
2661     real            weight;    /* single weight for a single angle */
2662     gmx_enfrotgrp_t erg;       /* Pointer to enforced rotation group data */
2663     rvec            xi_xc;     /* xi - xc */
2664     gmx_bool        bCalcPotFit;
2665     rvec            fit_xr_loc;
2666
2667     /* for mass weighting: */
2668     real      wi;              /* Mass-weighting of the positions */
2669     real      N_M;             /* N/M */
2670     real      k_wi;            /* k times wi */
2671
2672     gmx_bool  bProject;
2673
2674
2675     erg         = rotg->enfrotgrp;
2676     bProject    = (rotg->eType == erotgPM) || (rotg->eType == erotgPMPF);
2677     bCalcPotFit = (bOutstepRot || bOutstepSlab) && (erotgFitPOT == rotg->eFittype);
2678
2679     N_M = rotg->nat * erg->invmass;
2680
2681     /* Each process calculates the forces on its local atoms */
2682     for (j = 0; j < erg->nat_loc; j++)
2683     {
2684         /* Calculate (x_i-x_c) resp. (x_i-u) */
2685         rvec_sub(erg->x_loc_pbc[j], erg->xc_center, xi_xc);
2686
2687         /* Calculate Omega*(y_i-y_c)-(x_i-x_c) */
2688         rvec_sub(erg->xr_loc[j], xi_xc, dr);
2689
2690         if (bProject)
2691         {
2692             project_onto_plane(dr, rotg->vec);
2693         }
2694
2695         /* Mass-weighting */
2696         wi = N_M*erg->m_loc[j];
2697
2698         /* Store the additional force so that it can be added to the force
2699          * array after the normal forces have been evaluated */
2700         k_wi = rotg->k*wi;
2701         for (m = 0; m < DIM; m++)
2702         {
2703             tmp_f[m]             = k_wi*dr[m];
2704             erg->f_rot_loc[j][m] = tmp_f[m];
2705             erg->V              += 0.5*k_wi*sqr(dr[m]);
2706         }
2707
2708         /* If requested, also calculate the potential for a set of angles
2709          * near the current reference angle */
2710         if (bCalcPotFit)
2711         {
2712             for (ifit = 0; ifit < rotg->PotAngle_nstep; ifit++)
2713             {
2714                 /* Index of this rotation group atom with respect to the whole rotation group */
2715                 jj = erg->xc_ref_ind[j];
2716
2717                 /* Rotate with the alternative angle. Like rotate_local_reference(),
2718                  * just for a single local atom */
2719                 mvmul(erg->PotAngleFit->rotmat[ifit], rotg->x_ref[jj], fit_xr_loc); /* fit_xr_loc = Omega*(y_i-y_c) */
2720
2721                 /* Calculate Omega*(y_i-y_c)-(x_i-x_c) */
2722                 rvec_sub(fit_xr_loc, xi_xc, dr);
2723
2724                 if (bProject)
2725                 {
2726                     project_onto_plane(dr, rotg->vec);
2727                 }
2728
2729                 /* Add to the rotation potential for this angle: */
2730                 erg->PotAngleFit->V[ifit] += 0.5*k_wi*norm2(dr);
2731             }
2732         }
2733
2734         if (bOutstepRot)
2735         {
2736             /* Add to the torque of this rotation group */
2737             erg->torque_v += torque(rotg->vec, tmp_f, erg->x_loc_pbc[j], erg->xc_center);
2738
2739             /* Calculate the angle between reference and actual rotation group atom. */
2740             angle(rotg, xi_xc, erg->xr_loc[j], &alpha, &weight);  /* angle in rad, weighted */
2741             erg->angle_v  += alpha * weight;
2742             erg->weight_v += weight;
2743         }
2744         /* If you want enforced rotation to contribute to the virial,
2745          * activate the following lines:
2746             if (MASTER(cr))
2747             {
2748                Add the rotation contribution to the virial
2749               for(j=0; j<DIM; j++)
2750                 for(m=0;m<DIM;m++)
2751                   vir[j][m] += 0.5*f[ii][j]*dr[m];
2752             }
2753          */
2754
2755         PRINT_FORCE_J
2756
2757     } /* end of loop over local rotation group atoms */
2758 }
2759
2760
2761 /* Calculate the radial motion potential and forces */
2762 static void do_radial_motion(
2763         t_rotgrp       *rotg,         /* The rotation group                         */
2764         gmx_bool        bOutstepRot,  /* Output to main rotation output file        */
2765         gmx_bool        bOutstepSlab) /* Output per-slab data                       */
2766 {
2767     int             j, jj, ifit;
2768     rvec            tmp_f;     /* Force */
2769     real            alpha;     /* a single angle between an actual and a reference position */
2770     real            weight;    /* single weight for a single angle */
2771     gmx_enfrotgrp_t erg;       /* Pointer to enforced rotation group data */
2772     rvec            xj_u;      /* xj - u */
2773     rvec            tmpvec, fit_tmpvec;
2774     real            fac, fac2, sum = 0.0;
2775     rvec            pj;
2776     gmx_bool        bCalcPotFit;
2777
2778     /* For mass weighting: */
2779     real      wj;              /* Mass-weighting of the positions */
2780     real      N_M;             /* N/M */
2781
2782
2783     erg         = rotg->enfrotgrp;
2784     bCalcPotFit = (bOutstepRot || bOutstepSlab) && (erotgFitPOT == rotg->eFittype);
2785
2786     N_M = rotg->nat * erg->invmass;
2787
2788     /* Each process calculates the forces on its local atoms */
2789     for (j = 0; j < erg->nat_loc; j++)
2790     {
2791         /* Calculate (xj-u) */
2792         rvec_sub(erg->x_loc_pbc[j], erg->xc_center, xj_u);  /* xj_u = xj-u */
2793
2794         /* Calculate Omega.(yj0-u) */
2795         cprod(rotg->vec, erg->xr_loc[j], tmpvec);  /* tmpvec = v x Omega.(yj0-u) */
2796
2797         /*                       *         v x Omega.(yj0-u)     */
2798         unitv(tmpvec, pj);      /*  pj = ---------------------   */
2799                                 /*       | v x Omega.(yj0-u) |   */
2800
2801         fac  = iprod(pj, xj_u); /* fac = pj.(xj-u) */
2802         fac2 = fac*fac;
2803
2804         /* Mass-weighting */
2805         wj = N_M*erg->m_loc[j];
2806
2807         /* Store the additional force so that it can be added to the force
2808          * array after the normal forces have been evaluated */
2809         svmul(-rotg->k*wj*fac, pj, tmp_f);
2810         copy_rvec(tmp_f, erg->f_rot_loc[j]);
2811         sum += wj*fac2;
2812
2813         /* If requested, also calculate the potential for a set of angles
2814          * near the current reference angle */
2815         if (bCalcPotFit)
2816         {
2817             for (ifit = 0; ifit < rotg->PotAngle_nstep; ifit++)
2818             {
2819                 /* Index of this rotation group atom with respect to the whole rotation group */
2820                 jj = erg->xc_ref_ind[j];
2821
2822                 /* Rotate with the alternative angle. Like rotate_local_reference(),
2823                  * just for a single local atom */
2824                 mvmul(erg->PotAngleFit->rotmat[ifit], rotg->x_ref[jj], fit_tmpvec); /* fit_tmpvec = Omega*(yj0-u) */
2825
2826                 /* Calculate Omega.(yj0-u) */
2827                 cprod(rotg->vec, fit_tmpvec, tmpvec); /* tmpvec = v x Omega.(yj0-u) */
2828                 /*                                     *         v x Omega.(yj0-u)     */
2829                 unitv(tmpvec, pj);                    /*  pj = ---------------------   */
2830                                                       /*       | v x Omega.(yj0-u) |   */
2831
2832                 fac  = iprod(pj, xj_u);               /* fac = pj.(xj-u) */
2833                 fac2 = fac*fac;
2834
2835                 /* Add to the rotation potential for this angle: */
2836                 erg->PotAngleFit->V[ifit] += 0.5*rotg->k*wj*fac2;
2837             }
2838         }
2839
2840         if (bOutstepRot)
2841         {
2842             /* Add to the torque of this rotation group */
2843             erg->torque_v += torque(rotg->vec, tmp_f, erg->x_loc_pbc[j], erg->xc_center);
2844
2845             /* Calculate the angle between reference and actual rotation group atom. */
2846             angle(rotg, xj_u, erg->xr_loc[j], &alpha, &weight);  /* angle in rad, weighted */
2847             erg->angle_v  += alpha * weight;
2848             erg->weight_v += weight;
2849         }
2850
2851         PRINT_FORCE_J
2852
2853     } /* end of loop over local rotation group atoms */
2854     erg->V = 0.5*rotg->k*sum;
2855 }
2856
2857
2858 /* Calculate the radial motion pivot-free potential and forces */
2859 static void do_radial_motion_pf(
2860         t_rotgrp       *rotg,         /* The rotation group                         */
2861         rvec            x[],          /* The positions                              */
2862         matrix          box,          /* The simulation box                         */
2863         gmx_bool        bOutstepRot,  /* Output to main rotation output file        */
2864         gmx_bool        bOutstepSlab) /* Output per-slab data                       */
2865 {
2866     int             i, ii, iigrp, ifit, j;
2867     rvec            xj;          /* Current position */
2868     rvec            xj_xc;       /* xj  - xc  */
2869     rvec            yj0_yc0;     /* yj0 - yc0 */
2870     rvec            tmp_f;       /* Force */
2871     real            alpha;       /* a single angle between an actual and a reference position */
2872     real            weight;      /* single weight for a single angle */
2873     gmx_enfrotgrp_t erg;         /* Pointer to enforced rotation group data */
2874     rvec            tmpvec, tmpvec2;
2875     rvec            innersumvec; /* Precalculation of the inner sum */
2876     rvec            innersumveckM;
2877     real            fac, fac2, V = 0.0;
2878     rvec            qi, qj;
2879     gmx_bool        bCalcPotFit;
2880
2881     /* For mass weighting: */
2882     real      mj, wi, wj;      /* Mass-weighting of the positions */
2883     real      N_M;             /* N/M */
2884
2885
2886     erg         = rotg->enfrotgrp;
2887     bCalcPotFit = (bOutstepRot || bOutstepSlab) && (erotgFitPOT == rotg->eFittype);
2888
2889     N_M = rotg->nat * erg->invmass;
2890
2891     /* Get the current center of the rotation group: */
2892     get_center(erg->xc, erg->mc, rotg->nat, erg->xc_center);
2893
2894     /* Precalculate Sum_i [ wi qi.(xi-xc) qi ] which is needed for every single j */
2895     clear_rvec(innersumvec);
2896     for (i = 0; i < rotg->nat; i++)
2897     {
2898         /* Mass-weighting */
2899         wi = N_M*erg->mc[i];
2900
2901         /* Calculate qi. Note that xc_ref_center has already been subtracted from
2902          * x_ref in init_rot_group.*/
2903         mvmul(erg->rotmat, rotg->x_ref[i], tmpvec); /* tmpvec  = Omega.(yi0-yc0) */
2904
2905         cprod(rotg->vec, tmpvec, tmpvec2);          /* tmpvec2 = v x Omega.(yi0-yc0) */
2906
2907         /*                                             *         v x Omega.(yi0-yc0)     */
2908         unitv(tmpvec2, qi);                           /*  qi = -----------------------   */
2909                                                       /*       | v x Omega.(yi0-yc0) |   */
2910
2911         rvec_sub(erg->xc[i], erg->xc_center, tmpvec); /* tmpvec = xi-xc */
2912
2913         svmul(wi*iprod(qi, tmpvec), qi, tmpvec2);
2914
2915         rvec_inc(innersumvec, tmpvec2);
2916     }
2917     svmul(rotg->k*erg->invmass, innersumvec, innersumveckM);
2918
2919     /* Each process calculates the forces on its local atoms */
2920     for (j = 0; j < erg->nat_loc; j++)
2921     {
2922         /* Local index of a rotation group atom  */
2923         ii = erg->ind_loc[j];
2924         /* Position of this atom in the collective array */
2925         iigrp = erg->xc_ref_ind[j];
2926         /* Mass-weighting */
2927         mj = erg->mc[iigrp];  /* need the unsorted mass here */
2928         wj = N_M*mj;
2929
2930         /* Current position of this atom: x[ii][XX/YY/ZZ] */
2931         copy_rvec(x[ii], xj);
2932
2933         /* Shift this atom such that it is near its reference */
2934         shift_single_coord(box, xj, erg->xc_shifts[iigrp]);
2935
2936         /* The (unrotated) reference position is yj0. yc0 has already
2937          * been subtracted in init_rot_group */
2938         copy_rvec(rotg->x_ref[iigrp], yj0_yc0);   /* yj0_yc0 = yj0 - yc0      */
2939
2940         /* Calculate Omega.(yj0-yc0) */
2941         mvmul(erg->rotmat, yj0_yc0, tmpvec2); /* tmpvec2 = Omega.(yj0 - yc0)  */
2942
2943         cprod(rotg->vec, tmpvec2, tmpvec);    /* tmpvec = v x Omega.(yj0-yc0) */
2944
2945         /*                     *         v x Omega.(yj0-yc0)     */
2946         unitv(tmpvec, qj);    /*  qj = -----------------------   */
2947                               /*       | v x Omega.(yj0-yc0) |   */
2948
2949         /* Calculate (xj-xc) */
2950         rvec_sub(xj, erg->xc_center, xj_xc); /* xj_xc = xj-xc */
2951
2952         fac  = iprod(qj, xj_xc);             /* fac = qj.(xj-xc) */
2953         fac2 = fac*fac;
2954
2955         /* Store the additional force so that it can be added to the force
2956          * array after the normal forces have been evaluated */
2957         svmul(-rotg->k*wj*fac, qj, tmp_f); /* part 1 of force */
2958         svmul(mj, innersumveckM, tmpvec);  /* part 2 of force */
2959         rvec_inc(tmp_f, tmpvec);
2960         copy_rvec(tmp_f, erg->f_rot_loc[j]);
2961         V += wj*fac2;
2962
2963         /* If requested, also calculate the potential for a set of angles
2964          * near the current reference angle */
2965         if (bCalcPotFit)
2966         {
2967             for (ifit = 0; ifit < rotg->PotAngle_nstep; ifit++)
2968             {
2969                 /* Rotate with the alternative angle. Like rotate_local_reference(),
2970                  * just for a single local atom */
2971                 mvmul(erg->PotAngleFit->rotmat[ifit], yj0_yc0, tmpvec2); /* tmpvec2 = Omega*(yj0-yc0) */
2972
2973                 /* Calculate Omega.(yj0-u) */
2974                 cprod(rotg->vec, tmpvec2, tmpvec); /* tmpvec = v x Omega.(yj0-yc0) */
2975                 /*                                  *         v x Omega.(yj0-yc0)     */
2976                 unitv(tmpvec, qj);                 /*  qj = -----------------------   */
2977                                                    /*       | v x Omega.(yj0-yc0) |   */
2978
2979                 fac  = iprod(qj, xj_xc);           /* fac = qj.(xj-xc) */
2980                 fac2 = fac*fac;
2981
2982                 /* Add to the rotation potential for this angle: */
2983                 erg->PotAngleFit->V[ifit] += 0.5*rotg->k*wj*fac2;
2984             }
2985         }
2986
2987         if (bOutstepRot)
2988         {
2989             /* Add to the torque of this rotation group */
2990             erg->torque_v += torque(rotg->vec, tmp_f, xj, erg->xc_center);
2991
2992             /* Calculate the angle between reference and actual rotation group atom. */
2993             angle(rotg, xj_xc, yj0_yc0, &alpha, &weight);  /* angle in rad, weighted */
2994             erg->angle_v  += alpha * weight;
2995             erg->weight_v += weight;
2996         }
2997
2998         PRINT_FORCE_J
2999
3000     } /* end of loop over local rotation group atoms */
3001     erg->V = 0.5*rotg->k*V;
3002 }
3003
3004
3005 /* Precalculate the inner sum for the radial motion 2 forces */
3006 static void radial_motion2_precalc_inner_sum(t_rotgrp  *rotg, rvec innersumvec)
3007 {
3008     int             i;
3009     gmx_enfrotgrp_t erg;       /* Pointer to enforced rotation group data */
3010     rvec            xi_xc;     /* xj - xc */
3011     rvec            tmpvec, tmpvec2;
3012     real            fac, fac2;
3013     rvec            ri, si;
3014     real            siri;
3015     rvec            v_xi_xc;   /* v x (xj - u) */
3016     real            psii, psiistar;
3017     real            wi;        /* Mass-weighting of the positions */
3018     real            N_M;       /* N/M */
3019     rvec            sumvec;
3020
3021     erg = rotg->enfrotgrp;
3022     N_M = rotg->nat * erg->invmass;
3023
3024     /* Loop over the collective set of positions */
3025     clear_rvec(sumvec);
3026     for (i = 0; i < rotg->nat; i++)
3027     {
3028         /* Mass-weighting */
3029         wi = N_M*erg->mc[i];
3030
3031         rvec_sub(erg->xc[i], erg->xc_center, xi_xc); /* xi_xc = xi-xc         */
3032
3033         /* Calculate ri. Note that xc_ref_center has already been subtracted from
3034          * x_ref in init_rot_group.*/
3035         mvmul(erg->rotmat, rotg->x_ref[i], ri);      /* ri  = Omega.(yi0-yc0) */
3036
3037         cprod(rotg->vec, xi_xc, v_xi_xc);            /* v_xi_xc = v x (xi-u)  */
3038
3039         fac = norm2(v_xi_xc);
3040         /*                                 *                      1           */
3041         psiistar = 1.0/(fac + rotg->eps); /* psiistar = --------------------- */
3042                                           /*            |v x (xi-xc)|^2 + eps */
3043
3044         psii = gmx_invsqrt(fac);          /*                 1                */
3045                                           /*  psii    = -------------         */
3046                                           /*            |v x (xi-xc)|         */
3047
3048         svmul(psii, v_xi_xc, si);         /*  si = psii * (v x (xi-xc) )     */
3049
3050         fac  = iprod(v_xi_xc, ri);        /* fac = (v x (xi-xc)).ri */
3051         fac2 = fac*fac;
3052
3053         siri = iprod(si, ri);                       /* siri = si.ri           */
3054
3055         svmul(psiistar/psii, ri, tmpvec);
3056         svmul(psiistar*psiistar/(psii*psii*psii) * siri, si, tmpvec2);
3057         rvec_dec(tmpvec, tmpvec2);
3058         cprod(tmpvec, rotg->vec, tmpvec2);
3059
3060         svmul(wi*siri, tmpvec2, tmpvec);
3061
3062         rvec_inc(sumvec, tmpvec);
3063     }
3064     svmul(rotg->k*erg->invmass, sumvec, innersumvec);
3065 }
3066
3067
3068 /* Calculate the radial motion 2 potential and forces */
3069 static void do_radial_motion2(
3070         t_rotgrp       *rotg,         /* The rotation group                         */
3071         rvec            x[],          /* The positions                              */
3072         matrix          box,          /* The simulation box                         */
3073         gmx_bool        bOutstepRot,  /* Output to main rotation output file        */
3074         gmx_bool        bOutstepSlab) /* Output per-slab data                       */
3075 {
3076     int             ii, iigrp, ifit, j;
3077     rvec            xj;        /* Position */
3078     real            alpha;     /* a single angle between an actual and a reference position */
3079     real            weight;    /* single weight for a single angle */
3080     gmx_enfrotgrp_t erg;       /* Pointer to enforced rotation group data */
3081     rvec            xj_u;      /* xj - u */
3082     rvec            yj0_yc0;   /* yj0 -yc0 */
3083     rvec            tmpvec, tmpvec2;
3084     real            fac, fit_fac, fac2, Vpart = 0.0;
3085     rvec            rj, fit_rj, sj;
3086     real            sjrj;
3087     rvec            v_xj_u;    /* v x (xj - u) */
3088     real            psij, psijstar;
3089     real            mj, wj;    /* For mass-weighting of the positions */
3090     real            N_M;       /* N/M */
3091     gmx_bool        bPF;
3092     rvec            innersumvec;
3093     gmx_bool        bCalcPotFit;
3094
3095
3096     erg = rotg->enfrotgrp;
3097
3098     bPF         = rotg->eType == erotgRM2PF;
3099     bCalcPotFit = (bOutstepRot || bOutstepSlab) && (erotgFitPOT == rotg->eFittype);
3100
3101
3102     clear_rvec(yj0_yc0); /* Make the compiler happy */
3103
3104     clear_rvec(innersumvec);
3105     if (bPF)
3106     {
3107         /* For the pivot-free variant we have to use the current center of
3108          * mass of the rotation group instead of the pivot u */
3109         get_center(erg->xc, erg->mc, rotg->nat, erg->xc_center);
3110
3111         /* Also, we precalculate the second term of the forces that is identical
3112          * (up to the weight factor mj) for all forces */
3113         radial_motion2_precalc_inner_sum(rotg, innersumvec);
3114     }
3115
3116     N_M = rotg->nat * erg->invmass;
3117
3118     /* Each process calculates the forces on its local atoms */
3119     for (j = 0; j < erg->nat_loc; j++)
3120     {
3121         if (bPF)
3122         {
3123             /* Local index of a rotation group atom  */
3124             ii = erg->ind_loc[j];
3125             /* Position of this atom in the collective array */
3126             iigrp = erg->xc_ref_ind[j];
3127             /* Mass-weighting */
3128             mj = erg->mc[iigrp];
3129
3130             /* Current position of this atom: x[ii] */
3131             copy_rvec(x[ii], xj);
3132
3133             /* Shift this atom such that it is near its reference */
3134             shift_single_coord(box, xj, erg->xc_shifts[iigrp]);
3135
3136             /* The (unrotated) reference position is yj0. yc0 has already
3137              * been subtracted in init_rot_group */
3138             copy_rvec(rotg->x_ref[iigrp], yj0_yc0);   /* yj0_yc0 = yj0 - yc0  */
3139
3140             /* Calculate Omega.(yj0-yc0) */
3141             mvmul(erg->rotmat, yj0_yc0, rj);         /* rj = Omega.(yj0-yc0)  */
3142         }
3143         else
3144         {
3145             mj = erg->m_loc[j];
3146             copy_rvec(erg->x_loc_pbc[j], xj);
3147             copy_rvec(erg->xr_loc[j], rj);           /* rj = Omega.(yj0-u)    */
3148         }
3149         /* Mass-weighting */
3150         wj = N_M*mj;
3151
3152         /* Calculate (xj-u) resp. (xj-xc) */
3153         rvec_sub(xj, erg->xc_center, xj_u);          /* xj_u = xj-u           */
3154
3155         cprod(rotg->vec, xj_u, v_xj_u);              /* v_xj_u = v x (xj-u)   */
3156
3157         fac = norm2(v_xj_u);
3158         /*                                 *                      1           */
3159         psijstar = 1.0/(fac + rotg->eps); /*  psistar = --------------------  */
3160                                           /*            |v x (xj-u)|^2 + eps  */
3161
3162         psij = gmx_invsqrt(fac);          /*                 1                */
3163                                           /*  psij    = ------------          */
3164                                           /*            |v x (xj-u)|          */
3165
3166         svmul(psij, v_xj_u, sj);          /*  sj = psij * (v x (xj-u) )       */
3167
3168         fac  = iprod(v_xj_u, rj);         /* fac = (v x (xj-u)).rj */
3169         fac2 = fac*fac;
3170
3171         sjrj = iprod(sj, rj);                        /* sjrj = sj.rj          */
3172
3173         svmul(psijstar/psij, rj, tmpvec);
3174         svmul(psijstar*psijstar/(psij*psij*psij) * sjrj, sj, tmpvec2);
3175         rvec_dec(tmpvec, tmpvec2);
3176         cprod(tmpvec, rotg->vec, tmpvec2);
3177
3178         /* Store the additional force so that it can be added to the force
3179          * array after the normal forces have been evaluated */
3180         svmul(-rotg->k*wj*sjrj, tmpvec2, tmpvec);
3181         svmul(mj, innersumvec, tmpvec2);  /* This is != 0 only for the pivot-free variant */
3182
3183         rvec_add(tmpvec2, tmpvec, erg->f_rot_loc[j]);
3184         Vpart += wj*psijstar*fac2;
3185
3186         /* If requested, also calculate the potential for a set of angles
3187          * near the current reference angle */
3188         if (bCalcPotFit)
3189         {
3190             for (ifit = 0; ifit < rotg->PotAngle_nstep; ifit++)
3191             {
3192                 if (bPF)
3193                 {
3194                     mvmul(erg->PotAngleFit->rotmat[ifit], yj0_yc0, fit_rj); /* fit_rj = Omega.(yj0-yc0) */
3195                 }
3196                 else
3197                 {
3198                     /* Position of this atom in the collective array */
3199                     iigrp = erg->xc_ref_ind[j];
3200                     /* Rotate with the alternative angle. Like rotate_local_reference(),
3201                      * just for a single local atom */
3202                     mvmul(erg->PotAngleFit->rotmat[ifit], rotg->x_ref[iigrp], fit_rj); /* fit_rj = Omega*(yj0-u) */
3203                 }
3204                 fit_fac = iprod(v_xj_u, fit_rj);                                       /* fac = (v x (xj-u)).fit_rj */
3205                 /* Add to the rotation potential for this angle: */
3206                 erg->PotAngleFit->V[ifit] += 0.5*rotg->k*wj*psijstar*fit_fac*fit_fac;
3207             }
3208         }
3209
3210         if (bOutstepRot)
3211         {
3212             /* Add to the torque of this rotation group */
3213             erg->torque_v += torque(rotg->vec, erg->f_rot_loc[j], xj, erg->xc_center);
3214
3215             /* Calculate the angle between reference and actual rotation group atom. */
3216             angle(rotg, xj_u, rj, &alpha, &weight);  /* angle in rad, weighted */
3217             erg->angle_v  += alpha * weight;
3218             erg->weight_v += weight;
3219         }
3220
3221         PRINT_FORCE_J
3222
3223     } /* end of loop over local rotation group atoms */
3224     erg->V = 0.5*rotg->k*Vpart;
3225 }
3226
3227
3228 /* Determine the smallest and largest position vector (with respect to the
3229  * rotation vector) for the reference group */
3230 static void get_firstlast_atom_ref(
3231         t_rotgrp  *rotg,
3232         int       *firstindex,
3233         int       *lastindex)
3234 {
3235     gmx_enfrotgrp_t erg;              /* Pointer to enforced rotation group data */
3236     int             i;
3237     real            xcproj;           /* The projection of a reference position on the
3238                                          rotation vector */
3239     real            minproj, maxproj; /* Smallest and largest projection on v */
3240
3241
3242
3243     erg = rotg->enfrotgrp;
3244
3245     /* Start with some value */
3246     minproj = iprod(rotg->x_ref[0], rotg->vec);
3247     maxproj = minproj;
3248
3249     /* This is just to ensure that it still works if all the atoms of the
3250      * reference structure are situated in a plane perpendicular to the rotation
3251      * vector */
3252     *firstindex = 0;
3253     *lastindex  = rotg->nat-1;
3254
3255     /* Loop over all atoms of the reference group,
3256      * project them on the rotation vector to find the extremes */
3257     for (i = 0; i < rotg->nat; i++)
3258     {
3259         xcproj = iprod(rotg->x_ref[i], rotg->vec);
3260         if (xcproj < minproj)
3261         {
3262             minproj     = xcproj;
3263             *firstindex = i;
3264         }
3265         if (xcproj > maxproj)
3266         {
3267             maxproj    = xcproj;
3268             *lastindex = i;
3269         }
3270     }
3271 }
3272
3273
3274 /* Allocate memory for the slabs */
3275 static void allocate_slabs(
3276         t_rotgrp  *rotg,
3277         FILE      *fplog,
3278         int        g,
3279         gmx_bool   bVerbose)
3280 {
3281     gmx_enfrotgrp_t erg;      /* Pointer to enforced rotation group data */
3282     int             i, nslabs;
3283
3284
3285     erg = rotg->enfrotgrp;
3286
3287     /* More slabs than are defined for the reference are never needed */
3288     nslabs = erg->slab_last_ref - erg->slab_first_ref + 1;
3289
3290     /* Remember how many we allocated */
3291     erg->nslabs_alloc = nslabs;
3292
3293     if ( (NULL != fplog) && bVerbose)
3294     {
3295         fprintf(fplog, "%s allocating memory to store data for %d slabs (rotation group %d).\n",
3296                 RotStr, nslabs, g);
3297     }
3298     snew(erg->slab_center, nslabs);
3299     snew(erg->slab_center_ref, nslabs);
3300     snew(erg->slab_weights, nslabs);
3301     snew(erg->slab_torque_v, nslabs);
3302     snew(erg->slab_data, nslabs);
3303     snew(erg->gn_atom, nslabs);
3304     snew(erg->gn_slabind, nslabs);
3305     snew(erg->slab_innersumvec, nslabs);
3306     for (i = 0; i < nslabs; i++)
3307     {
3308         snew(erg->slab_data[i].x, rotg->nat);
3309         snew(erg->slab_data[i].ref, rotg->nat);
3310         snew(erg->slab_data[i].weight, rotg->nat);
3311     }
3312     snew(erg->xc_ref_sorted, rotg->nat);
3313     snew(erg->xc_sortind, rotg->nat);
3314     snew(erg->firstatom, nslabs);
3315     snew(erg->lastatom, nslabs);
3316 }
3317
3318
3319 /* From the extreme positions of the reference group, determine the first
3320  * and last slab of the reference. We can never have more slabs in the real
3321  * simulation than calculated here for the reference.
3322  */
3323 static void get_firstlast_slab_ref(t_rotgrp *rotg, real mc[], int ref_firstindex, int ref_lastindex)
3324 {
3325     gmx_enfrotgrp_t erg;      /* Pointer to enforced rotation group data */
3326     int             first, last;
3327     rvec            dummy;
3328
3329
3330     erg        = rotg->enfrotgrp;
3331     first      = get_first_slab(rotg, erg->max_beta, rotg->x_ref[ref_firstindex]);
3332     last       = get_last_slab( rotg, erg->max_beta, rotg->x_ref[ref_lastindex ]);
3333
3334     while (get_slab_weight(first, rotg, rotg->x_ref, mc, &dummy) > WEIGHT_MIN)
3335     {
3336         first--;
3337     }
3338     erg->slab_first_ref = first+1;
3339     while (get_slab_weight(last, rotg, rotg->x_ref, mc, &dummy) > WEIGHT_MIN)
3340     {
3341         last++;
3342     }
3343     erg->slab_last_ref  = last-1;
3344 }
3345
3346
3347 /* Special version of copy_rvec:
3348  * During the copy procedure of xcurr to b, the correct PBC image is chosen
3349  * such that the copied vector ends up near its reference position xref */
3350 static gmx_inline void copy_correct_pbc_image(
3351         const rvec  xcurr,  /* copy vector xcurr ...                */
3352         rvec        b,      /* ... to b ...                         */
3353         const rvec  xref,   /* choosing the PBC image such that b ends up near xref */
3354         matrix      box,
3355         int         npbcdim)
3356 {
3357     rvec  dx;
3358     int   d, m;
3359     ivec  shift;
3360
3361
3362     /* Shortest PBC distance between the atom and its reference */
3363     rvec_sub(xcurr, xref, dx);
3364
3365     /* Determine the shift for this atom */
3366     clear_ivec(shift);
3367     for (m = npbcdim-1; m >= 0; m--)
3368     {
3369         while (dx[m] < -0.5*box[m][m])
3370         {
3371             for (d = 0; d < DIM; d++)
3372             {
3373                 dx[d] += box[m][d];
3374             }
3375             shift[m]++;
3376         }
3377         while (dx[m] >= 0.5*box[m][m])
3378         {
3379             for (d = 0; d < DIM; d++)
3380             {
3381                 dx[d] -= box[m][d];
3382             }
3383             shift[m]--;
3384         }
3385     }
3386
3387     /* Apply the shift to the position */
3388     copy_rvec(xcurr, b);
3389     shift_single_coord(box, b, shift);
3390 }
3391
3392
3393 static void init_rot_group(FILE *fplog, t_commrec *cr, int g, t_rotgrp *rotg,
3394                            rvec *x, gmx_mtop_t *mtop, gmx_bool bVerbose, FILE *out_slabs, matrix box,
3395                            t_inputrec *ir, gmx_bool bOutputCenters)
3396 {
3397     int                   i, ii;
3398     rvec                  coord, xref, *xdum;
3399     gmx_bool              bFlex, bColl;
3400     t_atom               *atom;
3401     gmx_enfrotgrp_t       erg; /* Pointer to enforced rotation group data */
3402     int                   ref_firstindex, ref_lastindex;
3403     gmx_mtop_atomlookup_t alook = NULL;
3404     real                  mass, totalmass;
3405     real                  start = 0.0;
3406     double                t_start;
3407
3408
3409     /* Do we have a flexible axis? */
3410     bFlex = ISFLEX(rotg);
3411     /* Do we use a global set of coordinates? */
3412     bColl = ISCOLL(rotg);
3413
3414     erg = rotg->enfrotgrp;
3415
3416     /* Allocate space for collective coordinates if needed */
3417     if (bColl)
3418     {
3419         snew(erg->xc, rotg->nat);
3420         snew(erg->xc_shifts, rotg->nat);
3421         snew(erg->xc_eshifts, rotg->nat);
3422         snew(erg->xc_old, rotg->nat);
3423
3424         if (rotg->eFittype == erotgFitNORM)
3425         {
3426             snew(erg->xc_ref_length, rotg->nat); /* in case fit type NORM is chosen */
3427             snew(erg->xc_norm, rotg->nat);
3428         }
3429     }
3430     else
3431     {
3432         snew(erg->xr_loc, rotg->nat);
3433         snew(erg->x_loc_pbc, rotg->nat);
3434     }
3435
3436     snew(erg->f_rot_loc, rotg->nat);
3437     snew(erg->xc_ref_ind, rotg->nat);
3438
3439     /* Make space for the calculation of the potential at other angles (used
3440      * for fitting only) */
3441     if (erotgFitPOT == rotg->eFittype)
3442     {
3443         snew(erg->PotAngleFit, 1);
3444         snew(erg->PotAngleFit->degangle, rotg->PotAngle_nstep);
3445         snew(erg->PotAngleFit->V, rotg->PotAngle_nstep);
3446         snew(erg->PotAngleFit->rotmat, rotg->PotAngle_nstep);
3447
3448         /* Get the set of angles around the reference angle */
3449         start = -0.5 * (rotg->PotAngle_nstep - 1)*rotg->PotAngle_step;
3450         for (i = 0; i < rotg->PotAngle_nstep; i++)
3451         {
3452             erg->PotAngleFit->degangle[i] = start + i*rotg->PotAngle_step;
3453         }
3454     }
3455     else
3456     {
3457         erg->PotAngleFit = NULL;
3458     }
3459
3460     /* xc_ref_ind needs to be set to identity in the serial case */
3461     if (!PAR(cr))
3462     {
3463         for (i = 0; i < rotg->nat; i++)
3464         {
3465             erg->xc_ref_ind[i] = i;
3466         }
3467     }
3468
3469     /* Copy the masses so that the center can be determined. For all types of
3470      * enforced rotation, we store the masses in the erg->mc array. */
3471     if (rotg->bMassW)
3472     {
3473         alook = gmx_mtop_atomlookup_init(mtop);
3474     }
3475     snew(erg->mc, rotg->nat);
3476     if (bFlex)
3477     {
3478         snew(erg->mc_sorted, rotg->nat);
3479     }
3480     if (!bColl)
3481     {
3482         snew(erg->m_loc, rotg->nat);
3483     }
3484     totalmass = 0.0;
3485     for (i = 0; i < rotg->nat; i++)
3486     {
3487         if (rotg->bMassW)
3488         {
3489             gmx_mtop_atomnr_to_atom(alook, rotg->ind[i], &atom);
3490             mass = atom->m;
3491         }
3492         else
3493         {
3494             mass = 1.0;
3495         }
3496         erg->mc[i] = mass;
3497         totalmass += mass;
3498     }
3499     erg->invmass = 1.0/totalmass;
3500
3501     if (rotg->bMassW)
3502     {
3503         gmx_mtop_atomlookup_destroy(alook);
3504     }
3505
3506     /* Set xc_ref_center for any rotation potential */
3507     if ((rotg->eType == erotgISO) || (rotg->eType == erotgPM) || (rotg->eType == erotgRM) || (rotg->eType == erotgRM2))
3508     {
3509         /* Set the pivot point for the fixed, stationary-axis potentials. This
3510          * won't change during the simulation */
3511         copy_rvec(rotg->pivot, erg->xc_ref_center);
3512         copy_rvec(rotg->pivot, erg->xc_center    );
3513     }
3514     else
3515     {
3516         /* Center of the reference positions */
3517         get_center(rotg->x_ref, erg->mc, rotg->nat, erg->xc_ref_center);
3518
3519         /* Center of the actual positions */
3520         if (MASTER(cr))
3521         {
3522             snew(xdum, rotg->nat);
3523             for (i = 0; i < rotg->nat; i++)
3524             {
3525                 ii = rotg->ind[i];
3526                 copy_rvec(x[ii], xdum[i]);
3527             }
3528             get_center(xdum, erg->mc, rotg->nat, erg->xc_center);
3529             sfree(xdum);
3530         }
3531 #ifdef GMX_MPI
3532         if (PAR(cr))
3533         {
3534             gmx_bcast(sizeof(erg->xc_center), erg->xc_center, cr);
3535         }
3536 #endif
3537     }
3538
3539     if (bColl)
3540     {
3541         /* Save the original (whole) set of positions in xc_old such that at later
3542          * steps the rotation group can always be made whole again. If the simulation is
3543          * restarted, we compute the starting reference positions (given the time)
3544          * and assume that the correct PBC image of each position is the one nearest
3545          * to the current reference */
3546         if (MASTER(cr))
3547         {
3548             /* Calculate the rotation matrix for this angle: */
3549             t_start       = ir->init_t + ir->init_step*ir->delta_t;
3550             erg->degangle = rotg->rate * t_start;
3551             calc_rotmat(rotg->vec, erg->degangle, erg->rotmat);
3552
3553             for (i = 0; i < rotg->nat; i++)
3554             {
3555                 ii = rotg->ind[i];
3556
3557                 /* Subtract pivot, rotate, and add pivot again. This will yield the
3558                  * reference position for time t */
3559                 rvec_sub(rotg->x_ref[i], erg->xc_ref_center, coord);
3560                 mvmul(erg->rotmat, coord, xref);
3561                 rvec_inc(xref, erg->xc_ref_center);
3562
3563                 copy_correct_pbc_image(x[ii], erg->xc_old[i], xref, box, 3);
3564             }
3565         }
3566 #ifdef GMX_MPI
3567         if (PAR(cr))
3568         {
3569             gmx_bcast(rotg->nat*sizeof(erg->xc_old[0]), erg->xc_old, cr);
3570         }
3571 #endif
3572     }
3573
3574     if ( (rotg->eType != erotgFLEX) && (rotg->eType != erotgFLEX2) )
3575     {
3576         /* Put the reference positions into origin: */
3577         for (i = 0; i < rotg->nat; i++)
3578         {
3579             rvec_dec(rotg->x_ref[i], erg->xc_ref_center);
3580         }
3581     }
3582
3583     /* Enforced rotation with flexible axis */
3584     if (bFlex)
3585     {
3586         /* Calculate maximum beta value from minimum gaussian (performance opt.) */
3587         erg->max_beta = calc_beta_max(rotg->min_gaussian, rotg->slab_dist);
3588
3589         /* Determine the smallest and largest coordinate with respect to the rotation vector */
3590         get_firstlast_atom_ref(rotg, &ref_firstindex, &ref_lastindex);
3591
3592         /* From the extreme positions of the reference group, determine the first
3593          * and last slab of the reference. */
3594         get_firstlast_slab_ref(rotg, erg->mc, ref_firstindex, ref_lastindex);
3595
3596         /* Allocate memory for the slabs */
3597         allocate_slabs(rotg, fplog, g, bVerbose);
3598
3599         /* Flexible rotation: determine the reference centers for the rest of the simulation */
3600         erg->slab_first = erg->slab_first_ref;
3601         erg->slab_last  = erg->slab_last_ref;
3602         get_slab_centers(rotg, rotg->x_ref, erg->mc, g, -1, out_slabs, bOutputCenters, TRUE);
3603
3604         /* Length of each x_rotref vector from center (needed if fit routine NORM is chosen): */
3605         if (rotg->eFittype == erotgFitNORM)
3606         {
3607             for (i = 0; i < rotg->nat; i++)
3608             {
3609                 rvec_sub(rotg->x_ref[i], erg->xc_ref_center, coord);
3610                 erg->xc_ref_length[i] = norm(coord);
3611             }
3612         }
3613     }
3614 }
3615
3616
3617 extern void dd_make_local_rotation_groups(gmx_domdec_t *dd, t_rot *rot)
3618 {
3619     gmx_ga2la_t     ga2la;
3620     int             g;
3621     t_rotgrp       *rotg;
3622     gmx_enfrotgrp_t erg;      /* Pointer to enforced rotation group data */
3623
3624     ga2la = dd->ga2la;
3625
3626     for (g = 0; g < rot->ngrp; g++)
3627     {
3628         rotg = &rot->grp[g];
3629         erg  = rotg->enfrotgrp;
3630
3631
3632         dd_make_local_group_indices(ga2la, rotg->nat, rotg->ind,
3633                                     &erg->nat_loc, &erg->ind_loc, &erg->nalloc_loc, erg->xc_ref_ind);
3634     }
3635 }
3636
3637
3638 /* Calculate the size of the MPI buffer needed in reduce_output() */
3639 static int calc_mpi_bufsize(t_rot *rot)
3640 {
3641     int             g;
3642     int             count_group, count_total;
3643     t_rotgrp       *rotg;
3644     gmx_enfrotgrp_t erg;      /* Pointer to enforced rotation group data */
3645
3646
3647     count_total = 0;
3648     for (g = 0; g < rot->ngrp; g++)
3649     {
3650         rotg = &rot->grp[g];
3651         erg  = rotg->enfrotgrp;
3652
3653         /* Count the items that are transferred for this group: */
3654         count_group = 4; /* V, torque, angle, weight */
3655
3656         /* Add the maximum number of slabs for flexible groups */
3657         if (ISFLEX(rotg))
3658         {
3659             count_group += erg->slab_last_ref - erg->slab_first_ref + 1;
3660         }
3661
3662         /* Add space for the potentials at different angles: */
3663         if (erotgFitPOT == rotg->eFittype)
3664         {
3665             count_group += rotg->PotAngle_nstep;
3666         }
3667
3668         /* Add to the total number: */
3669         count_total += count_group;
3670     }
3671
3672     return count_total;
3673 }
3674
3675
3676 extern void init_rot(FILE *fplog, t_inputrec *ir, int nfile, const t_filenm fnm[],
3677                      t_commrec *cr, rvec *x, matrix box, gmx_mtop_t *mtop, const output_env_t oenv,
3678                      gmx_bool bVerbose, unsigned long Flags)
3679 {
3680     t_rot          *rot;
3681     t_rotgrp       *rotg;
3682     int             g;
3683     int             nat_max = 0;  /* Size of biggest rotation group */
3684     gmx_enfrot_t    er;           /* Pointer to the enforced rotation buffer variables */
3685     gmx_enfrotgrp_t erg;          /* Pointer to enforced rotation group data */
3686     rvec           *x_pbc = NULL; /* Space for the pbc-correct atom positions */
3687
3688
3689     if (MASTER(cr) && bVerbose)
3690     {
3691         fprintf(stdout, "%s Initializing ...\n", RotStr);
3692     }
3693
3694     rot = ir->rot;
3695     snew(rot->enfrot, 1);
3696     er        = rot->enfrot;
3697     er->Flags = Flags;
3698
3699     /* When appending, skip first output to avoid duplicate entries in the data files */
3700     if (er->Flags & MD_APPENDFILES)
3701     {
3702         er->bOut = FALSE;
3703     }
3704     else
3705     {
3706         er->bOut = TRUE;
3707     }
3708
3709     if (MASTER(cr) && er->bOut)
3710     {
3711         please_cite(fplog, "Kutzner2011");
3712     }
3713
3714     /* Output every step for reruns */
3715     if (er->Flags & MD_RERUN)
3716     {
3717         if (NULL != fplog)
3718         {
3719             fprintf(fplog, "%s rerun - will write rotation output every available step.\n", RotStr);
3720         }
3721         rot->nstrout = 1;
3722         rot->nstsout = 1;
3723     }
3724
3725     er->out_slabs = NULL;
3726     if (MASTER(cr) && HaveFlexibleGroups(rot) )
3727     {
3728         er->out_slabs = open_slab_out(opt2fn("-rs", nfile, fnm), rot);
3729     }
3730
3731     if (MASTER(cr))
3732     {
3733         /* Remove pbc, make molecule whole.
3734          * When ir->bContinuation=TRUE this has already been done, but ok. */
3735         snew(x_pbc, mtop->natoms);
3736         m_rveccopy(mtop->natoms, x, x_pbc);
3737         do_pbc_first_mtop(NULL, ir->ePBC, box, mtop, x_pbc);
3738         /* All molecules will be whole now, but not necessarily in the home box.
3739          * Additionally, if a rotation group consists of more than one molecule
3740          * (e.g. two strands of DNA), each one of them can end up in a different
3741          * periodic box. This is taken care of in init_rot_group.  */
3742     }
3743
3744     for (g = 0; g < rot->ngrp; g++)
3745     {
3746         rotg = &rot->grp[g];
3747
3748         if (NULL != fplog)
3749         {
3750             fprintf(fplog, "%s group %d type '%s'\n", RotStr, g, erotg_names[rotg->eType]);
3751         }
3752
3753         if (rotg->nat > 0)
3754         {
3755             /* Allocate space for the rotation group's data: */
3756             snew(rotg->enfrotgrp, 1);
3757             erg  = rotg->enfrotgrp;
3758
3759             nat_max = max(nat_max, rotg->nat);
3760
3761             if (PAR(cr))
3762             {
3763                 erg->nat_loc    = 0;
3764                 erg->nalloc_loc = 0;
3765                 erg->ind_loc    = NULL;
3766             }
3767             else
3768             {
3769                 erg->nat_loc = rotg->nat;
3770                 erg->ind_loc = rotg->ind;
3771             }
3772             init_rot_group(fplog, cr, g, rotg, x_pbc, mtop, bVerbose, er->out_slabs, box, ir,
3773                            !(er->Flags & MD_APPENDFILES) ); /* Do not output the reference centers
3774                                                              * again if we are appending */
3775         }
3776     }
3777
3778     /* Allocate space for enforced rotation buffer variables */
3779     er->bufsize = nat_max;
3780     snew(er->data, nat_max);
3781     snew(er->xbuf, nat_max);
3782     snew(er->mbuf, nat_max);
3783
3784     /* Buffers for MPI reducing torques, angles, weights (for each group), and V */
3785     if (PAR(cr))
3786     {
3787         er->mpi_bufsize = calc_mpi_bufsize(rot) + 100; /* larger to catch errors */
3788         snew(er->mpi_inbuf, er->mpi_bufsize);
3789         snew(er->mpi_outbuf, er->mpi_bufsize);
3790     }
3791     else
3792     {
3793         er->mpi_bufsize = 0;
3794         er->mpi_inbuf   = NULL;
3795         er->mpi_outbuf  = NULL;
3796     }
3797
3798     /* Only do I/O on the MASTER */
3799     er->out_angles  = NULL;
3800     er->out_rot     = NULL;
3801     er->out_torque  = NULL;
3802     if (MASTER(cr))
3803     {
3804         er->out_rot = open_rot_out(opt2fn("-ro", nfile, fnm), rot, oenv);
3805
3806         if (rot->nstsout > 0)
3807         {
3808             if (HaveFlexibleGroups(rot) || HavePotFitGroups(rot) )
3809             {
3810                 er->out_angles  = open_angles_out(opt2fn("-ra", nfile, fnm), rot);
3811             }
3812             if (HaveFlexibleGroups(rot) )
3813             {
3814                 er->out_torque  = open_torque_out(opt2fn("-rt", nfile, fnm), rot);
3815             }
3816         }
3817
3818         sfree(x_pbc);
3819     }
3820 }
3821
3822
3823 extern void finish_rot(t_rot *rot)
3824 {
3825     gmx_enfrot_t er;        /* Pointer to the enforced rotation buffer variables */
3826
3827
3828     er = rot->enfrot;
3829     if (er->out_rot)
3830     {
3831         gmx_fio_fclose(er->out_rot);
3832     }
3833     if (er->out_slabs)
3834     {
3835         gmx_fio_fclose(er->out_slabs);
3836     }
3837     if (er->out_angles)
3838     {
3839         gmx_fio_fclose(er->out_angles);
3840     }
3841     if (er->out_torque)
3842     {
3843         gmx_fio_fclose(er->out_torque);
3844     }
3845 }
3846
3847
3848 /* Rotate the local reference positions and store them in
3849  * erg->xr_loc[0...(nat_loc-1)]
3850  *
3851  * Note that we already subtracted u or y_c from the reference positions
3852  * in init_rot_group().
3853  */
3854 static void rotate_local_reference(t_rotgrp *rotg)
3855 {
3856     gmx_enfrotgrp_t erg;
3857     int             i, ii;
3858
3859
3860     erg = rotg->enfrotgrp;
3861
3862     for (i = 0; i < erg->nat_loc; i++)
3863     {
3864         /* Index of this rotation group atom with respect to the whole rotation group */
3865         ii = erg->xc_ref_ind[i];
3866         /* Rotate */
3867         mvmul(erg->rotmat, rotg->x_ref[ii], erg->xr_loc[i]);
3868     }
3869 }
3870
3871
3872 /* Select the PBC representation for each local x position and store that
3873  * for later usage. We assume the right PBC image of an x is the one nearest to
3874  * its rotated reference */
3875 static void choose_pbc_image(rvec x[], t_rotgrp *rotg, matrix box, int npbcdim)
3876 {
3877     int             i, ii;
3878     gmx_enfrotgrp_t erg;       /* Pointer to enforced rotation group data */
3879     rvec            xref;
3880
3881
3882     erg = rotg->enfrotgrp;
3883
3884     for (i = 0; i < erg->nat_loc; i++)
3885     {
3886         /* Index of a rotation group atom  */
3887         ii = erg->ind_loc[i];
3888
3889         /* Get the correctly rotated reference position. The pivot was already
3890          * subtracted in init_rot_group() from the reference positions. Also,
3891          * the reference positions have already been rotated in
3892          * rotate_local_reference(). For the current reference position we thus
3893          * only need to add the pivot again. */
3894         copy_rvec(erg->xr_loc[i], xref);
3895         rvec_inc(xref, erg->xc_ref_center);
3896
3897         copy_correct_pbc_image(x[ii], erg->x_loc_pbc[i], xref, box, npbcdim);
3898     }
3899 }
3900
3901
3902 extern void do_rotation(
3903         t_commrec      *cr,
3904         t_inputrec     *ir,
3905         matrix          box,
3906         rvec            x[],
3907         real            t,
3908         gmx_int64_t     step,
3909         gmx_wallcycle_t wcycle,
3910         gmx_bool        bNS)
3911 {
3912     int             g, i, ii;
3913     t_rot          *rot;
3914     t_rotgrp       *rotg;
3915     gmx_bool        outstep_slab, outstep_rot;
3916     gmx_bool        bFlex, bColl;
3917     gmx_enfrot_t    er;         /* Pointer to the enforced rotation buffer variables */
3918     gmx_enfrotgrp_t erg;        /* Pointer to enforced rotation group data           */
3919     rvec            transvec;
3920     t_gmx_potfit   *fit = NULL; /* For fit type 'potential' determine the fit
3921                                    angle via the potential minimum            */
3922
3923     /* Enforced rotation cycle counting: */
3924     gmx_cycles_t cycles_comp;   /* Cycles for the enf. rotation computation
3925                                    only, does not count communication. This
3926                                    counter is used for load-balancing         */
3927
3928 #ifdef TAKETIME
3929     double t0;
3930 #endif
3931
3932     rot = ir->rot;
3933     er  = rot->enfrot;
3934
3935     /* When to output in main rotation output file */
3936     outstep_rot  = do_per_step(step, rot->nstrout) && er->bOut;
3937     /* When to output per-slab data */
3938     outstep_slab = do_per_step(step, rot->nstsout) && er->bOut;
3939
3940     /* Output time into rotation output file */
3941     if (outstep_rot && MASTER(cr))
3942     {
3943         fprintf(er->out_rot, "%12.3e", t);
3944     }
3945
3946     /**************************************************************************/
3947     /* First do ALL the communication! */
3948     for (g = 0; g < rot->ngrp; g++)
3949     {
3950         rotg = &rot->grp[g];
3951         erg  = rotg->enfrotgrp;
3952
3953         /* Do we have a flexible axis? */
3954         bFlex = ISFLEX(rotg);
3955         /* Do we use a collective (global) set of coordinates? */
3956         bColl = ISCOLL(rotg);
3957
3958         /* Calculate the rotation matrix for this angle: */
3959         erg->degangle = rotg->rate * t;
3960         calc_rotmat(rotg->vec, erg->degangle, erg->rotmat);
3961
3962         if (bColl)
3963         {
3964             /* Transfer the rotation group's positions such that every node has
3965              * all of them. Every node contributes its local positions x and stores
3966              * it in the collective erg->xc array. */
3967             communicate_group_positions(cr, erg->xc, erg->xc_shifts, erg->xc_eshifts, bNS,
3968                                         x, rotg->nat, erg->nat_loc, erg->ind_loc, erg->xc_ref_ind, erg->xc_old, box);
3969         }
3970         else
3971         {
3972             /* Fill the local masses array;
3973              * this array changes in DD/neighborsearching steps */
3974             if (bNS)
3975             {
3976                 for (i = 0; i < erg->nat_loc; i++)
3977                 {
3978                     /* Index of local atom w.r.t. the collective rotation group */
3979                     ii            = erg->xc_ref_ind[i];
3980                     erg->m_loc[i] = erg->mc[ii];
3981                 }
3982             }
3983
3984             /* Calculate Omega*(y_i-y_c) for the local positions */
3985             rotate_local_reference(rotg);
3986
3987             /* Choose the nearest PBC images of the group atoms with respect
3988              * to the rotated reference positions */
3989             choose_pbc_image(x, rotg, box, 3);
3990
3991             /* Get the center of the rotation group */
3992             if ( (rotg->eType == erotgISOPF) || (rotg->eType == erotgPMPF) )
3993             {
3994                 get_center_comm(cr, erg->x_loc_pbc, erg->m_loc, erg->nat_loc, rotg->nat, erg->xc_center);
3995             }
3996         }
3997
3998     } /* End of loop over rotation groups */
3999
4000     /**************************************************************************/
4001     /* Done communicating, we can start to count cycles for the load balancing now ... */
4002     cycles_comp = gmx_cycles_read();
4003
4004
4005 #ifdef TAKETIME
4006     t0 = MPI_Wtime();
4007 #endif
4008
4009     for (g = 0; g < rot->ngrp; g++)
4010     {
4011         rotg = &rot->grp[g];
4012         erg  = rotg->enfrotgrp;
4013
4014         bFlex = ISFLEX(rotg);
4015         bColl = ISCOLL(rotg);
4016
4017         if (outstep_rot && MASTER(cr))
4018         {
4019             fprintf(er->out_rot, "%12.4f", erg->degangle);
4020         }
4021
4022         /* Calculate angles and rotation matrices for potential fitting: */
4023         if ( (outstep_rot || outstep_slab) && (erotgFitPOT == rotg->eFittype) )
4024         {
4025             fit = erg->PotAngleFit;
4026             for (i = 0; i < rotg->PotAngle_nstep; i++)
4027             {
4028                 calc_rotmat(rotg->vec, erg->degangle + fit->degangle[i], fit->rotmat[i]);
4029
4030                 /* Clear value from last step */
4031                 erg->PotAngleFit->V[i] = 0.0;
4032             }
4033         }
4034
4035         /* Clear values from last time step */
4036         erg->V        = 0.0;
4037         erg->torque_v = 0.0;
4038         erg->angle_v  = 0.0;
4039         erg->weight_v = 0.0;
4040
4041         switch (rotg->eType)
4042         {
4043             case erotgISO:
4044             case erotgISOPF:
4045             case erotgPM:
4046             case erotgPMPF:
4047                 do_fixed(rotg, outstep_rot, outstep_slab);
4048                 break;
4049             case erotgRM:
4050                 do_radial_motion(rotg, outstep_rot, outstep_slab);
4051                 break;
4052             case erotgRMPF:
4053                 do_radial_motion_pf(rotg, x, box, outstep_rot, outstep_slab);
4054                 break;
4055             case erotgRM2:
4056             case erotgRM2PF:
4057                 do_radial_motion2(rotg, x, box, outstep_rot, outstep_slab);
4058                 break;
4059             case erotgFLEXT:
4060             case erotgFLEX2T:
4061                 /* Subtract the center of the rotation group from the collective positions array
4062                  * Also store the center in erg->xc_center since it needs to be subtracted
4063                  * in the low level routines from the local coordinates as well */
4064                 get_center(erg->xc, erg->mc, rotg->nat, erg->xc_center);
4065                 svmul(-1.0, erg->xc_center, transvec);
4066                 translate_x(erg->xc, rotg->nat, transvec);
4067                 do_flexible(MASTER(cr), er, rotg, g, x, box, t, outstep_rot, outstep_slab);
4068                 break;
4069             case erotgFLEX:
4070             case erotgFLEX2:
4071                 /* Do NOT subtract the center of mass in the low level routines! */
4072                 clear_rvec(erg->xc_center);
4073                 do_flexible(MASTER(cr), er, rotg, g, x, box, t, outstep_rot, outstep_slab);
4074                 break;
4075             default:
4076                 gmx_fatal(FARGS, "No such rotation potential.");
4077                 break;
4078         }
4079     }
4080
4081 #ifdef TAKETIME
4082     if (MASTER(cr))
4083     {
4084         fprintf(stderr, "%s calculation (step %d) took %g seconds.\n", RotStr, step, MPI_Wtime()-t0);
4085     }
4086 #endif
4087
4088     /* Stop the enforced rotation cycle counter and add the computation-only
4089      * cycles to the force cycles for load balancing */
4090     cycles_comp  = gmx_cycles_read() - cycles_comp;
4091
4092     if (DOMAINDECOMP(cr) && wcycle)
4093     {
4094         dd_cycles_add(cr->dd, cycles_comp, ddCyclF);
4095     }
4096 }