Home
last modified time | relevance | path

Searched refs:vmat (Results 1 – 25 of 203) sorted by relevance

123456789

/dports/graphics/libGLU/glu-9.0.2/src/libnurbs/interface/
H A Dglrenderer.cc131 GLfloat vmat[4][4]; in loadGLMatrices() local
145 GLfloat vmat[4][4]; in useGLMatrices() local
218 smat[0][3] = vmat[0][3]; in loadSamplingMatrix()
219 smat[1][3] = vmat[1][3]; in loadSamplingMatrix()
220 smat[2][3] = vmat[2][3]; in loadSamplingMatrix()
221 smat[3][3] = vmat[3][3]; in loadSamplingMatrix()
241 cmat[0][0] = vmat[0][0]; in loadCullingMatrix()
242 cmat[0][1] = vmat[0][1]; in loadCullingMatrix()
243 cmat[0][2] = vmat[0][2]; in loadCullingMatrix()
244 cmat[0][3] = vmat[0][3]; in loadCullingMatrix()
[all …]
/dports/science/py-pyscf/pyscf-2.0.1/pyscf/pbc/eph/
H A Deph_fd.py80 vmat=[]
113 vmat.append(vfull)
115 vmat= np.asarray(vmat)
117 return vmat[:,0]
119 return vmat[:,:,0]
142 vmat = get_vmat(mf, mfset, disp) # extracting <u|dV|v>/dR
149 vmat = np.einsum('xuv,up,vq->xpq', vmat, mo_coeff[0].conj(), mo_coeff[0])
151 vmat = np.einsum('xsuv,sup,svq->xspq', vmat, mo_coeff[:,0].conj(), mo_coeff[:,0])
154 mat = np.einsum('xJ,xpq->Jpq', vec, vmat)
156 mat = np.einsum('xJ,xspq->sJpq', vec, vmat)
[all …]
/dports/science/py-pyscf/pyscf-2.0.1/pyscf/hessian/
H A Drks.py192 vmat = numpy.zeros((6,nao,nao))
236 vmat = vmat[[0,1,2,
239 return vmat.reshape(3,3,nao,nao)
295 vmat = numpy.zeros((mol.natm,3,3,nao,nao))
320 vmat[ia,:,:,:,p0:p1] += ipip[:,:,:,p0:p1]
360 return vmat
380 vmat = numpy.zeros((mol.natm,3,nao,nao))
402 vmat[ia] = -vmat[ia] - vmat[ia].transpose(0,2,1)
428 vmat[ia,:,p0:p1] += v_ip[:,p0:p1]
429 vmat[ia] = -vmat[ia] - vmat[ia].transpose(0,2,1)
[all …]
/dports/science/elk/elk-7.2.42/src/
H A Dgenvmatk.f9047 vmat(ist,jst)=vmat(ist,jst)+zdotc(npc,wfmt(:,ias,ispn,ist),1,wfmt1,1)
82 vmat(ist,jst)=vmat(ist,jst)+zdotc(ngp(jspn),wfgp(:,ispn,ist),1,z,1)
93 vmat(ist,jst)=conjg(vmat(jst,ist))
H A Dgenzvmatk.f9048 vmat(ist,jst)=vmat(ist,jst)+zdotc(npc,wfmt(:,ias,ispn,ist),1,wfmt1,1)
73 vmat(ist,jst)=vmat(ist,jst)+zdotc(ngp,wfgp(:,ispn,ist),1,z,1)
H A Dgenhmlu.f9072 bsqir(:,:,ifq),ngk0,igkig(:,1,ik),wfmt,wfir,wfgk,vmat)
75 wfgk,vmat)
87 call zcopy(nstsv,vmat(:,jst),1,h(i,j),1)
91 h(i,j)=conjg(vmat(jst,ist))
99 call zcopy(jst,vmat(:,jst),1,h(i,j),1)
/dports/science/quantum-espresso/q-e-qe-6.7.0/GWW/pw4gww/
H A Dv_basis.f9041 REAL(kind=DP), ALLOCATABLE :: vmat(:,:) local
76 allocate(vmat(numpw,numpw))
84 call dgemm('T','N',numpw,numpw,2*npw,2.d0,o_basis,2*npw,vo_basis,2*npw,0.d0,vmat,numpw)
88 vmat(jj,ii)=vmat(jj,ii)-dble(conjg(o_basis(1,jj))*vo_basis(1,ii))
93 call mp_sum(vmat(:,ii),world_comm)
102 call DSYEVR('V','V','U',numpw,vmat,numpw,cutoff,1.d5,1,1,0.d0,n_found,eigen,&
109 call DSYEVR('V','V','U',numpw,vmat,numpw, cutoff,1.d5,1,1,0.d0,n_found,eigen,&
128 deallocate(vmat)
/dports/science/py-pyscf/pyscf-2.0.1/pyscf/grad/
H A Drks.py88 vmat = numpy.zeros((nset,3,nao,nao))
119 vmat = vmat.reshape(3,nao,nao)
121 return exc, -vmat
150 def _gga_grad_sum_(vmat, mol, ao, wv, mask, ao_loc): argument
152 _d1_dot_(vmat, mol, ao[1:4], aow, mask, ao_loc, True)
154 _d1_dot_(vmat, mol, aow, ao[0], mask, ao_loc, True)
155 return vmat
166 vmat = numpy.zeros((3,nao,nao))
181 vmat += vtmp
201 vmat += vtmp
[all …]
H A Duks.py88 vmat = numpy.zeros((2,3,nao,nao))
99 rks_grad._d1_dot_(vmat[0], mol, ao[1:4], aow, mask, ao_loc, True)
114 rks_grad._gga_grad_sum_(vmat[0], mol, ao, wva, mask, ao_loc)
115 rks_grad._gga_grad_sum_(vmat[1], mol, ao, wvb, mask, ao_loc)
125 return exc, -vmat
137 vmat = numpy.zeros((2,3,nao,nao))
154 vmat[0] += vtmp
161 vmat[1] += vtmp
180 vmat[0] += vtmp
186 vmat[1] += vtmp
[all …]
/dports/cad/gmsh/gmsh-4.9.2-source/contrib/Netgen/libsrc/csg/
H A Dgencyl.cpp107 Mat<3,2> vmat; in CalcHesse() local
122 vmat(0,0) = planee1(0); in CalcHesse()
123 vmat(1,0) = planee1(1); in CalcHesse()
124 vmat(2,0) = planee1(2); in CalcHesse()
125 vmat(0,1) = planee2(0); in CalcHesse()
126 vmat(1,1) = planee2(1); in CalcHesse()
127 vmat(2,1) = planee2(2); in CalcHesse()
135 val += vmat(i,k) * h2d(k,l) * vmat(j,l); in CalcHesse()
/dports/cad/netgen/netgen-6.2.2105/libsrc/csg/
H A Dgencyl.cpp107 Mat<3,2> vmat; in CalcHesse() local
122 vmat(0,0) = planee1(0); in CalcHesse()
123 vmat(1,0) = planee1(1); in CalcHesse()
124 vmat(2,0) = planee1(2); in CalcHesse()
125 vmat(0,1) = planee2(0); in CalcHesse()
126 vmat(1,1) = planee2(1); in CalcHesse()
127 vmat(2,1) = planee2(2); in CalcHesse()
135 val += vmat(i,k) * h2d(k,l) * vmat(j,l); in CalcHesse()
/dports/science/R-cran-bayesm/bayesm/R/
H A Dllnhlogit.R28 vmat=matrix(v,ncol=m,byrow=TRUE) functionVar
29 vmat=tau*vmat
31 vchosen=vmat[cbind(ind,choice)]
32 lnprob=vchosen-log((exp(vmat))%*%iotam)
H A Dsimnhlogit.R27 vmat=matrix(v,ncol=m,byrow=TRUE) functionVar
28 vmat=tau*vmat
29 Prob=exp(vmat)
/dports/graphics/gnash/gnash-2b3bdede0305c4fc3ad21a0a4197330606c9b880/librender/openvg/
H A DOpenVGBitmap.cpp309 VGfloat vmat[9]; in applyPatternBitmap() local
318 memset(vmat, 0, sizeof(vmat)); in applyPatternBitmap()
320 vmat[0] = nsm.a() / 65536.0f; in applyPatternBitmap()
321 vmat[1] = nsm.b() / 65536.0f; in applyPatternBitmap()
322 vmat[3] = nsm.c() / 65536.0f; in applyPatternBitmap()
323 vmat[4] = nsm.d() / 65536.0f; in applyPatternBitmap()
324 vmat[6] = nsm.tx(); in applyPatternBitmap()
325 vmat[7] = nsm.ty(); in applyPatternBitmap()
330 vgLoadMatrix (vmat); in applyPatternBitmap()
332 vgLoadMatrix (vmat); in applyPatternBitmap()
/dports/science/py-pyscf/pyscf-2.0.1/pyscf/eph/
H A Drks.py53 vmat = np.zeros((mol.natm,3,nao,nao))
54 max_memory = max(2000, max_memory-vmat.size*8/1e6)
67 rks_grad._d1_dot_(vmat[ia], mol, aow, ao[0], mask, ao_loc, True)
71 vmat[ia] = -vmat[ia] - vmat[ia].transpose(0,2,1)
91 rks_grad._d1_dot_(vmat[ia], mol, aow, ao[0], mask, ao_loc, True)
95 vmat[ia] = -vmat[ia] - vmat[ia].transpose(0,2,1)
100 return vmat
H A Deph_fd.py75 vmat=[]
92 vmat.append(vfull)
94 return np.asarray(vmat)
106 vmat = get_vmat(mf, mfset, disp) # extracting <p|dV|q>/dR
109 vmat = np.einsum('xuv,up,vq->xpq', vmat, mf.mo_coeff.conj(), mf.mo_coeff)
111 vmat = np.einsum('xsuv,sup,svq->xspq', vmat, mf.mo_coeff.conj(), mf.mo_coeff)
114 mat = np.einsum('xJ,xpq->Jpq', vec, vmat)
116 mat = np.einsum('xJ,xspq->sJpq', vec, vmat)
/dports/science/elmerfem/elmerfem-release-9.0/ElmerGUI/netgen/libsrc/csg/
H A Dgencyl.cpp107 Mat<3,2> vmat; in CalcHesse() local
122 vmat(0,0) = planee1(0); in CalcHesse()
123 vmat(1,0) = planee1(1); in CalcHesse()
124 vmat(2,0) = planee1(2); in CalcHesse()
125 vmat(0,1) = planee2(0); in CalcHesse()
126 vmat(1,1) = planee2(1); in CalcHesse()
127 vmat(2,1) = planee2(2); in CalcHesse()
135 val += vmat(i,k) * h2d(k,l) * vmat(j,l); in CalcHesse()
/dports/science/py-pyscf/pyscf-2.0.1/pyscf/dft/
H A Dnumint.py772 vmat = vmat + vmat.conj().T
943 vmat[i] = vmat[i] + vmat[i].conj().T
947 vmat = vmat[0]
1108 vmat[0,i] = vmat[0,i] + vmat[0,i].conj().T
1109 vmat[1,i] = vmat[1,i] + vmat[1,i].conj().T
1111 vmat = vmat[:,0]
1243 vmat[i] = vmat[i] + vmat[i].T.conj()
1251 vmat = vmat[0]
1358 vmat[i] = vmat[i] + vmat[i].T.conj()
1366 vmat = vmat[0]
[all …]
/dports/math/cglm/cglm-0.8.4/include/cglm/simd/neon/
H A Daffine.h88 float32x4x4_t vmat; in glm_inv_tr_neon() local
91 vmat = vld4q_f32(mat[0]); in glm_inv_tr_neon()
92 r0 = vmat.val[0]; in glm_inv_tr_neon()
93 r1 = vmat.val[1]; in glm_inv_tr_neon()
94 r2 = vmat.val[2]; in glm_inv_tr_neon()
95 r3 = vmat.val[3]; in glm_inv_tr_neon()
/dports/math/gretl/gretl-2021d/gui/
H A Dguiprint.c1061 int n = vmat->t2 - vmat->t1 + 1; in rtfprint_vmatrix()
1075 if (vmat->missing) { in rtfprint_vmatrix()
1090 li2 = vmat->dim - nf; in rtfprint_vmatrix()
1094 pad = (vmat->dim > FIELDS)? FIELDS - p : vmat->dim - p; in rtfprint_vmatrix()
1112 if (vmat->ci == CORR) { in rtfprint_vmatrix()
1128 if (vmat->ci == CORR) { in rtfprint_vmatrix()
1149 int n = vmat->t2 - vmat->t1 + 1; in texprint_vmatrix()
1154 lo = vmat->dim; in texprint_vmatrix()
1166 if (vmat->missing) { in texprint_vmatrix()
1209 if (vmat->ci == CORR) { in texprint_vmatrix()
[all …]
/dports/databases/percona57-server/percona-server-5.7.36-39/plugin/audit_log/tests/mtr/
H A Daudit_log_filter_db_events.inc14 CREATE VIEW vmat AS SELECT SUM(a) AS s FROM db1.t;
16 CREATE VIEW vjoin AS SELECT * FROM vmat JOIN vup ON vmat.s=vup.a;
89 SELECT * FROM vmat JOIN vup ON vmat.s=vup.a;
90 SELECT * FROM vmat;
94 SELECT s FROM vmat;
113 DROP VIEW db1.vmat;
/dports/databases/percona57-client/percona-server-5.7.36-39/plugin/audit_log/tests/mtr/
H A Daudit_log_filter_db_events.inc14 CREATE VIEW vmat AS SELECT SUM(a) AS s FROM db1.t;
16 CREATE VIEW vjoin AS SELECT * FROM vmat JOIN vup ON vmat.s=vup.a;
89 SELECT * FROM vmat JOIN vup ON vmat.s=vup.a;
90 SELECT * FROM vmat;
94 SELECT s FROM vmat;
113 DROP VIEW db1.vmat;
/dports/databases/mysqlwsrep57-server/mysql-wsrep-wsrep_5.7.35-25.27/mysql-test/t/
H A Daudit_log_filter_db_events.inc14 CREATE VIEW vmat AS SELECT SUM(a) AS s FROM db1.t;
16 CREATE VIEW vjoin AS SELECT * FROM vmat JOIN vup ON vmat.s=vup.a;
89 SELECT * FROM vmat JOIN vup ON vmat.s=vup.a;
90 SELECT * FROM vmat;
94 SELECT s FROM vmat;
113 DROP VIEW db1.vmat;
/dports/databases/percona57-pam-for-mysql/percona-server-5.7.36-39/plugin/audit_log/tests/mtr/
H A Daudit_log_filter_db_events.inc14 CREATE VIEW vmat AS SELECT SUM(a) AS s FROM db1.t;
16 CREATE VIEW vjoin AS SELECT * FROM vmat JOIN vup ON vmat.s=vup.a;
89 SELECT * FROM vmat JOIN vup ON vmat.s=vup.a;
90 SELECT * FROM vmat;
94 SELECT s FROM vmat;
113 DROP VIEW db1.vmat;
/dports/games/openspades/openspades-0.1.3/Sources/Client/
H A DFallingBlock.cpp109 Matrix4 vmat = lastMatrix; in Update() local
110 vmat = vmat * Matrix4::Translate(vmodel->GetOrigin()); in Update()
113 Vector3 vmOrigin = vmat.GetOrigin(); in Update()
114 Vector3 vmAxis1 = vmat.GetAxis(0); in Update()
115 Vector3 vmAxis2 = vmat.GetAxis(1); in Update()
116 Vector3 vmAxis3 = vmat.GetAxis(2); in Update()

123456789