1 /* -*- mode: c; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4; c-file-style: "stroustrup"; -*-
4 * This source code is part of
8 * GROningen MAchine for Chemical Simulations
11 * Written by David van der Spoel, Erik Lindahl, Berk Hess, and others.
12 * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
13 * Copyright (c) 2001-2004, The GROMACS development team,
14 * check out http://www.gromacs.org for more information.
16 * This program is free software; you can redistribute it and/or
17 * modify it under the terms of the GNU General Public License
18 * as published by the Free Software Foundation; either version 2
19 * of the License, or (at your option) any later version.
21 * If you want to redistribute modifications, please consider that
22 * scientific software is very special. Version control is crucial -
23 * bugs must be traceable. We will be happy to consider code for
24 * inclusion in the official distribution, but derived work must not
25 * be called official GROMACS. Details are found in the README & COPYING
26 * files - if they are missing, get the official version at www.gromacs.org.
28 * To help us fund GROMACS development, we humbly ask that you cite
29 * the papers on the package - you can find them in the top README file.
31 * For more info, check our website at http://www.gromacs.org
34 * GROwing Monsters And Cloning Shrimps
59 #include "mtop_util.h"
61 #include "gmx_ga2la.h"
63 static void pull_print_x_grp(FILE *out
,bool bRef
,ivec dim
,t_pullgrp
*pgrp
)
71 fprintf(out
,"\t%g",bRef
? pgrp
->x
[m
] : pgrp
->dr
[m
]);
76 static void pull_print_x(FILE *out
,t_pull
*pull
,double t
)
80 fprintf(out
, "%.4f", t
);
84 for (g
=1; g
<1+pull
->ngrp
; g
++)
86 pull_print_x_grp(out
,TRUE
,pull
->dim
,&pull
->dyna
[g
]);
87 pull_print_x_grp(out
,FALSE
,pull
->dim
,&pull
->grp
[g
]);
92 for (g
=0; g
<1+pull
->ngrp
; g
++)
94 if (pull
->grp
[g
].nat
> 0)
96 pull_print_x_grp(out
,g
==0,pull
->dim
,&pull
->grp
[g
]);
103 static void pull_print_f(FILE *out
,t_pull
*pull
,double t
)
107 fprintf(out
, "%.4f", t
);
109 for(g
=1; g
<1+pull
->ngrp
; g
++)
111 if (pull
->eGeom
== epullgPOS
)
117 fprintf(out
,"\t%g",pull
->grp
[g
].f
[d
]);
123 fprintf(out
,"\t%g",pull
->grp
[g
].f_scal
);
129 void pull_print_output(t_pull
*pull
, gmx_large_int_t step
, double time
)
131 if ((pull
->nstxout
!= 0) && (step
% pull
->nstxout
== 0))
133 pull_print_x(pull
->out_x
,pull
,time
);
136 if ((pull
->nstfout
!= 0) && (step
% pull
->nstfout
== 0))
138 pull_print_f(pull
->out_f
,pull
,time
);
142 static FILE *open_pull_out(const char *fn
,t_pull
*pull
,const output_env_t oenv
,
143 bool bCoord
, unsigned long Flags
)
147 char **setname
,buf
[10];
149 if(Flags
& MD_APPENDFILES
)
151 fp
= gmx_fio_fopen(fn
,"a+");
155 fp
= gmx_fio_fopen(fn
,"w+");
158 xvgr_header(fp
,"Pull COM", "Time (ps)","Position (nm)",
163 xvgr_header(fp
,"Pull force","Time (ps)","Force (kJ/mol/nm)",
167 snew(setname
,(1+pull
->ngrp
)*DIM
);
169 for(g
=0; g
<1+pull
->ngrp
; g
++)
171 if (pull
->grp
[g
].nat
> 0 &&
172 (g
> 0 || (bCoord
&& !PULL_CYL(pull
))))
174 if (bCoord
|| pull
->eGeom
== epullgPOS
)
182 sprintf(buf
,"%d %s%c",g
,"c",'X'+m
);
183 setname
[nsets
] = strdup(buf
);
192 sprintf(buf
,"%d %s%c",
193 g
,(bCoord
&& g
> 0)?"d":"",'X'+m
);
194 setname
[nsets
] = strdup(buf
);
202 setname
[nsets
] = strdup(buf
);
207 if (bCoord
|| nsets
> 1)
209 xvgr_legend(fp
,nsets
,setname
,oenv
);
211 for(g
=0; g
<nsets
; g
++)
221 /* Apply forces in a mass weighted fashion */
222 static void apply_forces_grp(t_pullgrp
*pgrp
, t_mdatoms
* md
,
224 dvec f_pull
, int sign
, rvec
*f
)
226 int i
,ii
,m
,start
,end
;
230 end
= md
->homenr
+ start
;
232 inv_wm
= pgrp
->wscale
*pgrp
->invtm
;
234 for(i
=0; i
<pgrp
->nat_loc
; i
++)
236 ii
= pgrp
->ind_loc
[i
];
237 wmass
= md
->massT
[ii
];
238 if (pgrp
->weight_loc
)
240 wmass
*= pgrp
->weight_loc
[i
];
245 f
[ii
][m
] += sign
* wmass
* f_pull
[m
] * inv_wm
;
250 /* Apply forces in a mass weighted fashion */
251 static void apply_forces(t_pull
* pull
, t_mdatoms
* md
, gmx_ga2la_t ga2la
,
257 for(i
=1; i
<pull
->ngrp
+1; i
++)
259 pgrp
= &(pull
->grp
[i
]);
260 apply_forces_grp(pgrp
,md
,ga2la
,pgrp
->f
,1,f
);
261 if (pull
->grp
[0].nat
)
265 apply_forces_grp(&(pull
->dyna
[i
]),md
,ga2la
,pgrp
->f
,-1,f
);
269 apply_forces_grp(&(pull
->grp
[0]),md
,ga2la
,pgrp
->f
,-1,f
);
275 static double max_pull_distance2(const t_pull
*pull
,const t_pbc
*pbc
)
280 max_d2
= GMX_DOUBLE_MAX
;
282 if (pull
->eGeom
!= epullgDIRPBC
)
284 for(m
=0; m
<pbc
->ndim_ePBC
; m
++)
286 if (pull
->dim
[m
] != 0)
288 max_d2
= min(max_d2
,norm2(pbc
->box
[m
]));
296 static void get_pullgrps_dr(const t_pull
*pull
,const t_pbc
*pbc
,int g
,double t
,
297 dvec xg
,dvec xref
,double max_dist2
,
300 t_pullgrp
*pref
,*pgrp
;
302 dvec xrefr
,dref
={0,0,0};
305 pgrp
= &pull
->grp
[g
];
307 copy_dvec(xref
,xrefr
);
309 if (pull
->eGeom
== epullgDIRPBC
)
313 dref
[m
] = (pgrp
->init
[0] + pgrp
->rate
*t
)*pull
->grp
[g
].vec
[m
];
315 /* Add the reference position, so we use the correct periodic image */
316 dvec_inc(xrefr
,dref
);
319 pbc_dx_d(pbc
, xg
, xrefr
, dr
);
323 dr
[m
] *= pull
->dim
[m
];
326 if (max_dist2
>= 0 && dr2
> 0.98*0.98*max_dist2
)
328 gmx_fatal(FARGS
,"Distance of pull group %d (%f nm) is larger than 0.49 times the box size (%f)",g
,sqrt(dr2
),max_dist2
);
331 if (pull
->eGeom
== epullgDIRPBC
)
337 static void get_pullgrp_dr(const t_pull
*pull
,const t_pbc
*pbc
,int g
,double t
,
342 if (pull
->eGeom
== epullgDIRPBC
)
348 md2
= max_pull_distance2(pull
,pbc
);
351 get_pullgrps_dr(pull
,pbc
,g
,t
,
353 PULL_CYL(pull
) ? pull
->dyna
[g
].x
: pull
->grp
[0].x
,
358 void get_pullgrp_distance(t_pull
*pull
,t_pbc
*pbc
,int g
,double t
,
361 static bool bWarned
=FALSE
; /* TODO: this should be fixed for thread-safety,
362 but is fairly benign */
368 pgrp
= &pull
->grp
[g
];
370 get_pullgrp_dr(pull
,pbc
,g
,t
,dr
);
372 if (pull
->eGeom
== epullgPOS
)
376 ref
[m
] = pgrp
->init
[m
] + pgrp
->rate
*t
*pgrp
->vec
[m
];
381 ref
[0] = pgrp
->init
[0] + pgrp
->rate
*t
;
387 /* Pull along the vector between the com's */
388 if (ref
[0] < 0 && !bWarned
)
390 fprintf(stderr
,"\nPull reference distance for group %d is negative (%f)\n",g
,ref
[0]);
396 /* With no vector we can not determine the direction for the force,
397 * so we set the force to zero.
403 /* Determine the deviation */
404 dev
[0] = drs
- ref
[0];
414 inpr
+= pgrp
->vec
[m
]*dr
[m
];
416 dev
[0] = inpr
- ref
[0];
419 /* Determine the difference of dr and ref along each dimension */
422 dev
[m
] = (dr
[m
] - ref
[m
])*pull
->dim
[m
];
428 void clear_pull_forces(t_pull
*pull
)
432 /* Zeroing the forces is only required for constraint pulling.
433 * It can happen that multiple constraint steps need to be applied
434 * and therefore the constraint forces need to be accumulated.
436 for(i
=0; i
<1+pull
->ngrp
; i
++)
438 clear_dvec(pull
->grp
[i
].f
);
439 pull
->grp
[i
].f_scal
= 0;
443 /* Apply constraint using SHAKE */
444 static void do_constraint(t_pull
*pull
, t_mdatoms
*md
, t_pbc
*pbc
,
446 bool bMaster
, tensor vir
,
450 dvec
*r_ij
; /* x[i] com of i in prev. step. Obeys constr. -> r_ij[i] */
451 dvec unc_ij
; /* xp[i] com of i this step, before constr. -> unc_ij */
453 dvec
*rinew
; /* current 'new' position of group i */
454 dvec
*rjnew
; /* current 'new' position of group j */
457 double lambda
, rm
, mass
, invdt
=0;
458 bool bConverged
= FALSE
;
459 int niter
=0,g
,ii
,j
,m
,max_iter
=100;
460 double q
,a
,b
,c
; /* for solving the quadratic equation,
461 see Num. Recipes in C ed 2 p. 184 */
462 dvec
*dr
; /* correction for group i */
463 dvec ref_dr
; /* correction for group j */
464 dvec f
; /* the pull force */
466 t_pullgrp
*pdyna
,*pgrp
,*pref
;
468 snew(r_ij
,pull
->ngrp
+1);
471 snew(rjnew
,pull
->ngrp
+1);
477 snew(dr
,pull
->ngrp
+1);
478 snew(rinew
,pull
->ngrp
+1);
480 /* copy the current unconstrained positions for use in iterations. We
481 iterate until rinew[i] and rjnew[j] obey the constraints. Then
482 rinew - pull.x_unc[i] is the correction dr to group i */
483 for(g
=1; g
<1+pull
->ngrp
; g
++)
485 copy_dvec(pull
->grp
[g
].xp
,rinew
[g
]);
489 for(g
=1; g
<1+pull
->ngrp
; g
++)
491 copy_dvec(pull
->dyna
[g
].xp
,rjnew
[g
]);
496 copy_dvec(pull
->grp
[0].xp
,rjnew
[0]);
499 /* Determine the constraint directions from the old positions */
500 for(g
=1; g
<1+pull
->ngrp
; g
++)
502 get_pullgrp_dr(pull
,pbc
,g
,t
,r_ij
[g
]);
503 /* Store the difference vector at time t for printing */
504 copy_dvec(r_ij
[g
],pull
->grp
[g
].dr
);
507 fprintf(debug
,"Pull group %d dr %f %f %f\n",
508 g
,r_ij
[g
][XX
],r_ij
[g
][YY
],r_ij
[g
][ZZ
]);
511 if (pull
->eGeom
== epullgDIR
|| pull
->eGeom
== epullgDIRPBC
)
513 /* Select the component along vec */
517 a
+= pull
->grp
[g
].vec
[m
]*r_ij
[g
][m
];
521 r_ij
[g
][m
] = a
*pull
->grp
[g
].vec
[m
];
526 while (!bConverged
&& niter
< max_iter
)
528 /* loop over all constraints */
529 for(g
=1; g
<1+pull
->ngrp
; g
++)
531 pgrp
= &pull
->grp
[g
];
533 pref
= &pull
->dyna
[g
];
535 pref
= &pull
->grp
[0];
537 /* Get the current difference vector */
538 get_pullgrps_dr(pull
,pbc
,g
,t
,rinew
[g
],rjnew
[PULL_CYL(pull
) ? g
: 0],
541 if (pull
->eGeom
== epullgPOS
)
545 ref
[m
] = pgrp
->init
[m
] + pgrp
->rate
*t
*pgrp
->vec
[m
];
550 ref
[0] = pgrp
->init
[0] + pgrp
->rate
*t
;
551 /* Keep the compiler happy */
558 fprintf(debug
,"Pull group %d, iteration %d\n",g
,niter
);
561 rm
= 1.0/(pull
->grp
[g
].invtm
+ pref
->invtm
);
568 gmx_fatal(FARGS
,"The pull constraint reference distance for group %d is <= 0 (%f)",g
,ref
[0]);
571 a
= diprod(r_ij
[g
],r_ij
[g
]);
572 b
= diprod(unc_ij
,r_ij
[g
])*2;
573 c
= diprod(unc_ij
,unc_ij
) - dsqr(ref
[0]);
577 q
= -0.5*(b
- sqrt(b
*b
- 4*a
*c
));
582 q
= -0.5*(b
+ sqrt(b
*b
- 4*a
*c
));
589 "Pull ax^2+bx+c=0: a=%e b=%e c=%e lambda=%e\n",
593 /* The position corrections dr due to the constraints */
594 dsvmul(-lambda
*rm
*pgrp
->invtm
, r_ij
[g
], dr
[g
]);
595 dsvmul( lambda
*rm
*pref
->invtm
, r_ij
[g
], ref_dr
);
600 /* A 1-dimensional constraint along a vector */
604 vec
[m
] = pgrp
->vec
[m
];
605 a
+= unc_ij
[m
]*vec
[m
];
607 /* Select only the component along the vector */
608 dsvmul(a
,vec
,unc_ij
);
612 fprintf(debug
,"Pull inpr %e lambda: %e\n",a
,lambda
);
615 /* The position corrections dr due to the constraints */
616 dsvmul(-lambda
*rm
*pull
->grp
[g
].invtm
, vec
, dr
[g
]);
617 dsvmul( lambda
*rm
* pref
->invtm
, vec
,ref_dr
);
624 lambda
= r_ij
[g
][m
] - ref
[m
];
625 /* The position corrections dr due to the constraints */
626 dr
[g
][m
] = -lambda
*rm
*pull
->grp
[g
].invtm
;
627 ref_dr
[m
] = lambda
*rm
*pref
->invtm
;
641 j
= (PULL_CYL(pull
) ? g
: 0);
642 get_pullgrps_dr(pull
,pbc
,g
,t
,rinew
[g
],rjnew
[j
],-1,tmp
);
643 get_pullgrps_dr(pull
,pbc
,g
,t
,dr
[g
] ,ref_dr
,-1,tmp3
);
645 "Pull cur %8.5f %8.5f %8.5f j:%8.5f %8.5f %8.5f d: %8.5f\n",
646 rinew
[g
][0],rinew
[g
][1],rinew
[g
][2],
647 rjnew
[j
][0],rjnew
[j
][1],rjnew
[j
][2], dnorm(tmp
));
648 if (pull
->eGeom
== epullgPOS
)
651 "Pull ref %8.5f %8.5f %8.5f\n",
652 pgrp
->vec
[0],pgrp
->vec
[1],pgrp
->vec
[2]);
657 "Pull ref %8s %8s %8s %8s %8s %8s d: %8.5f %8.5f %8.5f\n",
658 "","","","","","",ref
[0],ref
[1],ref
[2]);
661 "Pull cor %8.5f %8.5f %8.5f j:%8.5f %8.5f %8.5f d: %8.5f\n",
662 dr
[g
][0],dr
[g
][1],dr
[g
][2],
663 ref_dr
[0],ref_dr
[1],ref_dr
[2],
666 "Pull cor %10.7f %10.7f %10.7f\n",
667 dr
[g
][0],dr
[g
][1],dr
[g
][2]);
670 /* Update the COMs with dr */
671 dvec_inc(rinew
[g
], dr
[g
]);
672 dvec_inc(rjnew
[PULL_CYL(pull
) ? g
: 0],ref_dr
);
675 /* Check if all constraints are fullfilled now */
676 for(g
=1; g
<1+pull
->ngrp
; g
++)
678 pgrp
= &pull
->grp
[g
];
680 get_pullgrps_dr(pull
,pbc
,g
,t
,rinew
[g
],rjnew
[PULL_CYL(pull
) ? g
: 0],
686 bConverged
= fabs(dnorm(unc_ij
) - ref
[0]) < pull
->constr_tol
;
693 vec
[m
] = pgrp
->vec
[m
];
695 inpr
= diprod(unc_ij
,vec
);
696 dsvmul(inpr
,vec
,unc_ij
);
698 fabs(diprod(unc_ij
,vec
) - ref
[0]) < pull
->constr_tol
;
705 fabs(unc_ij
[m
] - ref
[m
]) >= pull
->constr_tol
)
718 fprintf(debug
,"NOT CONVERGED YET: Group %d:"
719 "d_ref = %f %f %f, current d = %f\n",
720 g
,ref
[0],ref
[1],ref
[2],dnorm(unc_ij
));
726 /* if after all constraints are dealt with and bConverged is still TRUE
727 we're finished, if not we do another iteration */
729 if (niter
> max_iter
)
731 gmx_fatal(FARGS
,"Too many iterations for constraint run: %d",niter
);
734 /* DONE ITERATING, NOW UPDATE COORDINATES AND CALC. CONSTRAINT FORCES */
741 /* update the normal groups */
742 for(g
=1; g
<1+pull
->ngrp
; g
++)
744 pgrp
= &pull
->grp
[g
];
745 /* get the final dr and constraint force for group i */
746 dvec_sub(rinew
[g
],pgrp
->xp
,dr
[g
]);
747 /* select components of dr */
750 dr
[g
][m
] *= pull
->dim
[m
];
752 dsvmul(1.0/(pgrp
->invtm
*dt
*dt
),dr
[g
],f
);
759 pgrp
->f_scal
+= r_ij
[g
][m
]*f
[m
]/dnorm(r_ij
[g
]);
767 pgrp
->f_scal
+= pgrp
->vec
[m
]*f
[m
];
774 if (vir
&& bMaster
) {
775 /* Add the pull contribution to the virial */
780 vir
[j
][m
] -= 0.5*f
[j
]*r_ij
[g
][m
];
785 /* update the atom positions */
786 copy_dvec(dr
[g
],tmp
);
787 for(j
=0;j
<pgrp
->nat_loc
;j
++)
789 ii
= pgrp
->ind_loc
[j
];
790 if (pgrp
->weight_loc
)
792 dsvmul(pgrp
->wscale
*pgrp
->weight_loc
[j
],dr
[g
],tmp
);
802 v
[ii
][m
] += invdt
*tmp
[m
];
808 /* update the reference groups */
811 /* update the dynamic reference groups */
812 for(g
=1; g
<1+pull
->ngrp
; g
++)
814 pdyna
= &pull
->dyna
[g
];
815 dvec_sub(rjnew
[g
],pdyna
->xp
,ref_dr
);
816 /* select components of ref_dr */
819 ref_dr
[m
] *= pull
->dim
[m
];
822 for(j
=0;j
<pdyna
->nat_loc
;j
++)
824 /* reset the atoms with dr, weighted by w_i */
825 dsvmul(pdyna
->wscale
*pdyna
->weight_loc
[j
],ref_dr
,tmp
);
826 ii
= pdyna
->ind_loc
[j
];
835 v
[ii
][m
] += invdt
*tmp
[m
];
843 pgrp
= &pull
->grp
[0];
844 /* update the reference group */
845 dvec_sub(rjnew
[0],pgrp
->xp
, ref_dr
);
846 /* select components of ref_dr */
849 ref_dr
[m
] *= pull
->dim
[m
];
852 copy_dvec(ref_dr
,tmp
);
853 for(j
=0; j
<pgrp
->nat_loc
;j
++)
855 ii
= pgrp
->ind_loc
[j
];
856 if (pgrp
->weight_loc
)
858 dsvmul(pgrp
->wscale
*pgrp
->weight_loc
[j
],ref_dr
,tmp
);
868 v
[ii
][m
] += invdt
*tmp
[m
];
874 /* finished! I hope. Give back some memory */
881 /* Pulling with a harmonic umbrella potential or constant force */
882 static void do_pull_pot(int ePull
,
883 t_pull
*pull
, t_pbc
*pbc
, double t
, real lambda
,
884 real
*V
, tensor vir
, real
*dVdl
)
892 /* loop over the groups that are being pulled */
895 for(g
=1; g
<1+pull
->ngrp
; g
++)
897 pgrp
= &pull
->grp
[g
];
898 get_pullgrp_distance(pull
,pbc
,g
,t
,pgrp
->dr
,dev
);
900 k
= (1.0 - lambda
)*pgrp
->k
+ lambda
*pgrp
->kB
;
901 dkdl
= pgrp
->kB
- pgrp
->k
;
906 ndr
= dnorm(pgrp
->dr
);
908 if (ePull
== epullUMBRELLA
)
910 pgrp
->f_scal
= -k
*dev
[0];
911 *V
+= 0.5* k
*dsqr(dev
[0]);
912 *dVdl
+= 0.5*dkdl
*dsqr(dev
[0]);
922 pgrp
->f
[m
] = pgrp
->f_scal
*pgrp
->dr
[m
]*invdr
;
928 if (ePull
== epullUMBRELLA
)
930 pgrp
->f_scal
= -k
*dev
[0];
931 *V
+= 0.5* k
*dsqr(dev
[0]);
932 *dVdl
+= 0.5*dkdl
*dsqr(dev
[0]);
939 ndr
+= pgrp
->vec
[m
]*pgrp
->dr
[m
];
947 pgrp
->f
[m
] = pgrp
->f_scal
*pgrp
->vec
[m
];
953 if (ePull
== epullUMBRELLA
)
955 pgrp
->f
[m
] = -k
*dev
[m
];
956 *V
+= 0.5* k
*dsqr(dev
[m
]);
957 *dVdl
+= 0.5*dkdl
*dsqr(dev
[m
]);
961 pgrp
->f
[m
] = -k
*pull
->dim
[m
];
962 *V
+= k
*pgrp
->dr
[m
]*pull
->dim
[m
];
963 *dVdl
+= dkdl
*pgrp
->dr
[m
]*pull
->dim
[m
];
971 /* Add the pull contribution to the virial */
976 vir
[j
][m
] -= 0.5*pgrp
->f
[j
]*pgrp
->dr
[m
];
983 real
pull_potential(int ePull
,t_pull
*pull
, t_mdatoms
*md
, t_pbc
*pbc
,
984 t_commrec
*cr
, double t
, real lambda
,
985 rvec
*x
, rvec
*f
, tensor vir
, real
*dvdlambda
)
989 pull_calc_coms(cr
,pull
,md
,pbc
,t
,x
,NULL
);
991 do_pull_pot(ePull
,pull
,pbc
,t
,lambda
,
992 &V
,pull
->bVirial
&& MASTER(cr
) ? vir
: NULL
,&dVdl
);
994 /* Distribute forces over pulled groups */
995 apply_forces(pull
, md
, DOMAINDECOMP(cr
) ? cr
->dd
->ga2la
: NULL
, f
);
1001 return (MASTER(cr
) ? V
: 0.0);
1004 void pull_constraint(t_pull
*pull
, t_mdatoms
*md
, t_pbc
*pbc
,
1005 t_commrec
*cr
, double dt
, double t
,
1006 rvec
*x
, rvec
*xp
, rvec
*v
, tensor vir
)
1008 pull_calc_coms(cr
,pull
,md
,pbc
,t
,x
,xp
);
1010 do_constraint(pull
,md
,pbc
,xp
,v
,pull
->bVirial
&& MASTER(cr
),vir
,dt
,t
);
1013 static void make_local_pull_group(gmx_ga2la_t ga2la
,
1014 t_pullgrp
*pg
,int start
,int end
)
1019 for(i
=0; i
<pg
->nat
; i
++) {
1022 if (!ga2la_get_home(ga2la
,ii
,&ii
)) {
1026 if (ii
>= start
&& ii
< end
) {
1027 /* This is a home atom, add it to the local pull group */
1028 if (pg
->nat_loc
>= pg
->nalloc_loc
) {
1029 pg
->nalloc_loc
= over_alloc_dd(pg
->nat_loc
+1);
1030 srenew(pg
->ind_loc
,pg
->nalloc_loc
);
1031 if (pg
->epgrppbc
== epgrppbcCOS
|| pg
->weight
) {
1032 srenew(pg
->weight_loc
,pg
->nalloc_loc
);
1035 pg
->ind_loc
[pg
->nat_loc
] = ii
;
1037 pg
->weight_loc
[pg
->nat_loc
] = pg
->weight
[i
];
1044 void dd_make_local_pull_groups(gmx_domdec_t
*dd
,t_pull
*pull
,t_mdatoms
*md
)
1055 if (pull
->grp
[0].nat
> 0)
1056 make_local_pull_group(ga2la
,&pull
->grp
[0],md
->start
,md
->start
+md
->homenr
);
1057 for(g
=1; g
<1+pull
->ngrp
; g
++)
1058 make_local_pull_group(ga2la
,&pull
->grp
[g
],md
->start
,md
->start
+md
->homenr
);
1061 static void init_pull_group_index(FILE *fplog
,t_commrec
*cr
,
1063 int g
,t_pullgrp
*pg
,ivec pulldims
,
1064 gmx_mtop_t
*mtop
,t_inputrec
*ir
)
1066 int i
,ii
,d
,nfrozen
,ndim
;
1068 double tmass
,wmass
,wwmass
;
1070 gmx_ga2la_t ga2la
=NULL
;
1071 gmx_groups_t
*groups
;
1074 bDomDec
= (cr
&& DOMAINDECOMP(cr
));
1076 ga2la
= cr
->dd
->ga2la
;
1079 if (EI_ENERGY_MINIMIZATION(ir
->eI
) || ir
->eI
== eiBD
) {
1080 /* There are no masses in the integrator.
1081 * But we still want to have the correct mass-weighted COMs.
1082 * So we store the real masses in the weights.
1083 * We do not set nweight, so these weights do not end up in the tpx file.
1085 if (pg
->nweight
== 0) {
1086 snew(pg
->weight
,pg
->nat
);
1090 if (cr
&& PAR(cr
)) {
1094 pg
->weight_loc
= NULL
;
1096 pg
->nat_loc
= pg
->nat
;
1097 pg
->ind_loc
= pg
->ind
;
1098 if (pg
->epgrppbc
== epgrppbcCOS
) {
1099 snew(pg
->weight_loc
,pg
->nat
);
1101 pg
->weight_loc
= pg
->weight
;
1105 groups
= &mtop
->groups
;
1111 for(i
=0; i
<pg
->nat
; i
++) {
1113 gmx_mtop_atomnr_to_atom(mtop
,ii
,&atom
);
1114 if (cr
&& PAR(cr
) && !bDomDec
&& ii
>= start
&& ii
< end
)
1115 pg
->ind_loc
[pg
->nat_loc
++] = ii
;
1116 if (ir
->opts
.nFreeze
) {
1117 for(d
=0; d
<DIM
; d
++)
1118 if (pulldims
[d
] && ir
->opts
.nFreeze
[ggrpnr(groups
,egcFREEZE
,ii
)][d
])
1121 if (ir
->efep
== efepNO
) {
1124 m
= (1 - ir
->init_lambda
)*atom
->m
+ ir
->init_lambda
*atom
->mB
;
1126 if (pg
->nweight
> 0) {
1131 if (EI_ENERGY_MINIMIZATION(ir
->eI
)) {
1132 /* Move the mass to the weight */
1136 } else if (ir
->eI
== eiBD
) {
1138 mbd
= ir
->bd_fric
*ir
->delta_t
;
1140 if (groups
->grpnr
[egcTC
] == NULL
) {
1141 mbd
= ir
->delta_t
/ir
->opts
.tau_t
[0];
1143 mbd
= ir
->delta_t
/ir
->opts
.tau_t
[groups
->grpnr
[egcTC
][ii
]];
1156 gmx_fatal(FARGS
,"The total%s mass of pull group %d is zero",
1157 pg
->weight
? " weighted" : "",g
);
1161 "Pull group %d: %5d atoms, mass %9.3f",g
,pg
->nat
,tmass
);
1162 if (pg
->weight
|| EI_ENERGY_MINIMIZATION(ir
->eI
) || ir
->eI
== eiBD
) {
1163 fprintf(fplog
,", weighted mass %9.3f",wmass
*wmass
/wwmass
);
1165 if (pg
->epgrppbc
== epgrppbcCOS
) {
1166 fprintf(fplog
,", cosine weighting will be used");
1168 fprintf(fplog
,"\n");
1172 /* A value > 0 signals not frozen, it is updated later */
1176 for(d
=0; d
<DIM
; d
++)
1177 ndim
+= pulldims
[d
]*pg
->nat
;
1178 if (fplog
&& nfrozen
> 0 && nfrozen
< ndim
) {
1180 "\nWARNING: In pull group %d some, but not all of the degrees of freedom\n"
1181 " that are subject to pulling are frozen.\n"
1182 " For pulling the whole group will be frozen.\n\n",
1190 void init_pull(FILE *fplog
,t_inputrec
*ir
,int nfile
,const t_filenm fnm
[],
1191 gmx_mtop_t
*mtop
,t_commrec
*cr
,const output_env_t oenv
,
1192 bool bOutFile
, unsigned long Flags
)
1196 int g
,start
=0,end
=0,m
;
1200 pull
->ePBC
= ir
->ePBC
;
1203 case epbcNONE
: pull
->npbcdim
= 0; break;
1204 case epbcXY
: pull
->npbcdim
= 2; break;
1205 default: pull
->npbcdim
= 3; break;
1210 fprintf(fplog
,"\nWill apply %s COM pulling in geometry '%s'\n",
1211 EPULLTYPE(ir
->ePull
),EPULLGEOM(pull
->eGeom
));
1212 if (pull
->grp
[0].nat
> 0)
1214 fprintf(fplog
,"between a reference group and %d group%s\n",
1215 pull
->ngrp
,pull
->ngrp
==1 ? "" : "s");
1219 fprintf(fplog
,"with an absolute reference on %d group%s\n",
1220 pull
->ngrp
,pull
->ngrp
==1 ? "" : "s");
1224 /* We always add the virial contribution,
1225 * except for geometry = direction_periodic where this is impossible.
1227 pull
->bVirial
= (pull
->eGeom
!= epullgDIRPBC
);
1228 if (getenv("GMX_NO_PULLVIR") != NULL
)
1232 fprintf(fplog
,"Found env. var., will not add the virial contribution of the COM pull forces\n");
1234 pull
->bVirial
= FALSE
;
1237 if (cr
&& PARTDECOMP(cr
))
1239 pd_at_range(cr
,&start
,&end
);
1243 pull
->dbuf_cyl
=NULL
;
1244 pull
->bRefAt
= FALSE
;
1246 for(g
=0; g
<pull
->ngrp
+1; g
++)
1248 pgrp
= &pull
->grp
[g
];
1249 pgrp
->epgrppbc
= epgrppbcNONE
;
1252 /* Determine if we need to take PBC into account for calculating
1253 * the COM's of the pull groups.
1255 for(m
=0; m
<pull
->npbcdim
; m
++)
1257 if (pull
->dim
[m
] && pgrp
->nat
> 1)
1259 if (pgrp
->pbcatom
>= 0)
1261 pgrp
->epgrppbc
= epgrppbcREFAT
;
1262 pull
->bRefAt
= TRUE
;
1268 gmx_fatal(FARGS
,"Pull groups can not have relative weights and cosine weighting at same time");
1270 pgrp
->epgrppbc
= epgrppbcCOS
;
1271 if (pull
->cosdim
>= 0 && pull
->cosdim
!= m
)
1273 gmx_fatal(FARGS
,"Can only use cosine weighting with pulling in one dimension (use mdp option pull_dim)");
1279 /* Set the indices */
1280 init_pull_group_index(fplog
,cr
,start
,end
,g
,pgrp
,pull
->dim
,mtop
,ir
);
1281 if (PULL_CYL(pull
) && pgrp
->invtm
== 0)
1283 gmx_fatal(FARGS
,"Can not have frozen atoms in a cylinder pull group");
1288 /* Absolute reference, set the inverse mass to zero */
1294 /* if we use dynamic reference groups, do some initialising for them */
1297 if (pull
->grp
[0].nat
== 0)
1299 gmx_fatal(FARGS
, "Dynamic reference groups are not supported when using absolute reference!\n");
1301 snew(pull
->dyna
,pull
->ngrp
+1);
1304 /* Only do I/O when we are doing dynamics and if we are the MASTER */
1309 if (pull
->nstxout
> 0)
1311 pull
->out_x
= open_pull_out(opt2fn("-px",nfile
,fnm
),pull
,oenv
,TRUE
,Flags
);
1313 if (pull
->nstfout
> 0)
1315 pull
->out_f
= open_pull_out(opt2fn("-pf",nfile
,fnm
),pull
,oenv
,
1321 void finish_pull(FILE *fplog
,t_pull
*pull
)
1325 gmx_fio_fclose(pull
->out_x
);
1329 gmx_fio_fclose(pull
->out_f
);