added Verlet scheme and NxN non-bonded functionality
[gromacs.git] / src / gmxlib / princ.c
blobf42ea0a719c9561cceaa8c06c64e8af518c66a6a
1 /*
2 *
3 * This source code is part of
4 *
5 * G R O M A C S
6 *
7 * GROningen MAchine for Chemical Simulations
8 *
9 * VERSION 3.2.0
10 * Written by David van der Spoel, Erik Lindahl, Berk Hess, and others.
11 * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
12 * Copyright (c) 2001-2004, The GROMACS development team,
13 * check out http://www.gromacs.org for more information.
15 * This program is free software; you can redistribute it and/or
16 * modify it under the terms of the GNU General Public License
17 * as published by the Free Software Foundation; either version 2
18 * of the License, or (at your option) any later version.
20 * If you want to redistribute modifications, please consider that
21 * scientific software is very special. Version control is crucial -
22 * bugs must be traceable. We will be happy to consider code for
23 * inclusion in the official distribution, but derived work must not
24 * be called official GROMACS. Details are found in the README & COPYING
25 * files - if they are missing, get the official version at www.gromacs.org.
27 * To help us fund GROMACS development, we humbly ask that you cite
28 * the papers on the package - you can find them in the top README file.
30 * For more info, check our website at http://www.gromacs.org
32 * And Hey:
33 * GROningen Mixture of Alchemy and Childrens' Stories
35 /* This file is completely threadsafe - keep it that way! */
36 #ifdef HAVE_CONFIG_H
37 #include <config.h>
38 #endif
40 #include "typedefs.h"
41 #include "vec.h"
42 #include "smalloc.h"
43 #include "gstat.h"
44 #include "nrjac.h"
45 #include "txtdump.h"
46 #include "princ.h"
48 static void m_op(matrix mat,rvec x)
50 rvec xp;
51 int m;
53 for(m=0; (m<DIM); m++)
54 xp[m]=mat[m][XX]*x[XX]+mat[m][YY]*x[YY]+mat[m][ZZ]*x[ZZ];
55 fprintf(stderr,"x %8.3f %8.3f %8.3f\n",x[XX],x[YY],x[ZZ]);
56 fprintf(stderr,"xp %8.3f %8.3f %8.3f\n",xp[XX],xp[YY],xp[ZZ]);
57 fprintf(stderr,"fac %8.3f %8.3f %8.3f\n",xp[XX]/x[XX],xp[YY]/x[YY],
58 xp[ZZ]/x[ZZ]);
61 #define NDIM 4
63 #ifdef DEBUG
64 static void ptrans(char *s,real **inten,real d[],real e[])
66 int m;
67 real n,x,y,z;
68 for(m=1; (m<NDIM); m++) {
69 x=inten[m][1];
70 y=inten[m][2];
71 z=inten[m][3];
72 n=x*x+y*y+z*z;
73 fprintf(stderr,"%8s %8.3f %8.3f %8.3f, norm:%8.3f, d:%8.3f, e:%8.3f\n",
74 s,x,y,z,sqrt(n),d[m],e[m]);
76 fprintf(stderr,"\n");
79 void t_trans(matrix trans,real d[],real **ev)
81 rvec x;
82 int j;
83 for(j=0; (j<DIM); j++) {
84 x[XX]=ev[1][j+1];
85 x[YY]=ev[2][j+1];
86 x[ZZ]=ev[3][j+1];
87 m_op(trans,x);
88 fprintf(stderr,"d[%d]=%g\n",j,d[j+1]);
91 #endif
93 void principal_comp(int n,atom_id index[],t_atom atom[],rvec x[],
94 matrix trans,rvec d)
96 int i,j,ai,m,nrot;
97 real mm,rx,ry,rz;
98 double **inten,dd[NDIM],tvec[NDIM],**ev;
99 #ifdef DEBUG
100 real e[NDIM];
101 #endif
102 real temp;
104 snew(inten,NDIM);
105 snew(ev,NDIM);
106 for(i=0; (i<NDIM); i++) {
107 snew(inten[i],NDIM);
108 snew(ev[i],NDIM);
109 dd[i]=0.0;
110 #ifdef DEBUG
111 e[i]=0.0;
112 #endif
115 for(i=0; (i<NDIM); i++)
116 for(m=0; (m<NDIM); m++)
117 inten[i][m]=0;
118 for(i=0; (i<n); i++) {
119 ai=index[i];
120 mm=atom[ai].m;
121 rx=x[ai][XX];
122 ry=x[ai][YY];
123 rz=x[ai][ZZ];
124 inten[0][0]+=mm*(sqr(ry)+sqr(rz));
125 inten[1][1]+=mm*(sqr(rx)+sqr(rz));
126 inten[2][2]+=mm*(sqr(rx)+sqr(ry));
127 inten[1][0]-=mm*(ry*rx);
128 inten[2][0]-=mm*(rx*rz);
129 inten[2][1]-=mm*(rz*ry);
131 inten[0][1]=inten[1][0];
132 inten[0][2]=inten[2][0];
133 inten[1][2]=inten[2][1];
134 #ifdef DEBUG
135 ptrans("initial",inten,dd,e);
136 #endif
138 for(i=0; (i<DIM); i++) {
139 for(m=0; (m<DIM); m++)
140 trans[i][m]=inten[i][m];
143 /* Call numerical recipe routines */
144 jacobi(inten,3,dd,ev,&nrot);
145 #ifdef DEBUG
146 ptrans("jacobi",ev,dd,e);
147 #endif
149 /* Sort eigenvalues in ascending order */
150 #define SWAPPER(i) \
151 if (fabs(dd[i+1]) < fabs(dd[i])) { \
152 temp=dd[i]; \
153 for(j=0; (j<NDIM); j++) tvec[j]=ev[j][i];\
154 dd[i]=dd[i+1]; \
155 for(j=0; (j<NDIM); j++) ev[j][i]=ev[j][i+1]; \
156 dd[i+1]=temp; \
157 for(j=0; (j<NDIM); j++) ev[j][i+1]=tvec[j]; \
159 SWAPPER(0)
160 SWAPPER(1)
161 SWAPPER(0)
162 #ifdef DEBUG
163 ptrans("swap",ev,dd,e);
164 t_trans(trans,dd,ev);
165 #endif
167 for(i=0; (i<DIM); i++) {
168 d[i]=dd[i];
169 for(m=0; (m<DIM); m++)
170 trans[i][m]=ev[m][i];
173 for(i=0; (i<NDIM); i++) {
174 sfree(inten[i]);
175 sfree(ev[i]);
177 sfree(inten);
178 sfree(ev);
181 void rotate_atoms(int gnx,atom_id *index,rvec x[],matrix trans)
183 real xt,yt,zt;
184 int i,ii;
186 for(i=0; (i<gnx); i++) {
187 ii=index ? index[i] : i;
188 xt=x[ii][XX];
189 yt=x[ii][YY];
190 zt=x[ii][ZZ];
191 x[ii][XX]=trans[XX][XX]*xt+trans[XX][YY]*yt+trans[XX][ZZ]*zt;
192 x[ii][YY]=trans[YY][XX]*xt+trans[YY][YY]*yt+trans[YY][ZZ]*zt;
193 x[ii][ZZ]=trans[ZZ][XX]*xt+trans[ZZ][YY]*yt+trans[ZZ][ZZ]*zt;
197 real calc_xcm(rvec x[],int gnx,atom_id *index,t_atom *atom,rvec xcm,
198 gmx_bool bQ)
200 int i,ii,m;
201 real m0,tm;
203 clear_rvec(xcm);
204 tm=0;
205 for(i=0; (i<gnx); i++) {
206 ii=index ? index[i] : i;
207 if (atom) {
208 if (bQ)
209 m0=fabs(atom[ii].q);
210 else
211 m0=atom[ii].m;
213 else
214 m0 = 1;
215 tm+=m0;
216 for(m=0; (m<DIM); m++)
217 xcm[m]+=m0*x[ii][m];
219 for(m=0; (m<DIM); m++)
220 xcm[m]/=tm;
222 return tm;
225 real sub_xcm(rvec x[],int gnx,atom_id *index,t_atom atom[],rvec xcm,
226 gmx_bool bQ)
228 int i,ii;
229 real tm;
231 tm=calc_xcm(x,gnx,index,atom,xcm,bQ);
232 for(i=0; (i<gnx); i++) {
233 ii=index ? index[i] : i;
234 rvec_dec(x[ii],xcm);
236 return tm;
239 void add_xcm(rvec x[],int gnx,atom_id *index,rvec xcm)
241 int i,ii;
243 for(i=0; (i<gnx); i++) {
244 ii=index ? index[i] : i;
245 rvec_inc(x[ii],xcm);
249 void orient_princ(t_atoms *atoms,int isize,atom_id *index,
250 int natoms, rvec x[], rvec *v, rvec d)
252 int i,m;
253 rvec xcm,prcomp;
254 matrix trans;
256 calc_xcm(x,isize,index,atoms->atom,xcm,FALSE);
257 for(i=0; i<natoms; i++)
258 rvec_dec(x[i],xcm);
259 principal_comp(isize,index,atoms->atom,x,trans,prcomp);
260 if (d)
261 copy_rvec(prcomp, d);
263 /* Check whether this trans matrix mirrors the molecule */
264 if (det(trans) < 0) {
265 for(m=0; (m<DIM); m++)
266 trans[ZZ][m] = -trans[ZZ][m];
268 rotate_atoms(natoms,NULL,x,trans);
269 if (v) rotate_atoms(natoms,NULL,v,trans);
271 for(i=0; i<natoms; i++)
272 rvec_inc(x[i],xcm);