Home
last modified time | relevance | path

Searched refs:matb (Results 1 – 25 of 47) sorted by relevance

12

/dports/astro/kstars/kstars-3.5.6/packaging/android/apk/src/org/kde/kstars/math/
H A DMatrix3.java422 private static void mul (float[] mata, float[] matb) { in mul() argument
423 float v00 = mata[M00] * matb[M00] + mata[M01] * matb[M10] + mata[M02] * matb[M20]; in mul()
424 float v01 = mata[M00] * matb[M01] + mata[M01] * matb[M11] + mata[M02] * matb[M21]; in mul()
425 float v02 = mata[M00] * matb[M02] + mata[M01] * matb[M12] + mata[M02] * matb[M22]; in mul()
427 float v10 = mata[M10] * matb[M00] + mata[M11] * matb[M10] + mata[M12] * matb[M20]; in mul()
428 float v11 = mata[M10] * matb[M01] + mata[M11] * matb[M11] + mata[M12] * matb[M21]; in mul()
429 float v12 = mata[M10] * matb[M02] + mata[M11] * matb[M12] + mata[M12] * matb[M22]; in mul()
431 float v20 = mata[M20] * matb[M00] + mata[M21] * matb[M10] + mata[M22] * matb[M20]; in mul()
432 float v21 = mata[M20] * matb[M01] + mata[M21] * matb[M11] + mata[M22] * matb[M21]; in mul()
433 float v22 = mata[M20] * matb[M02] + mata[M21] * matb[M12] + mata[M22] * matb[M22]; in mul()
/dports/science/nwchem-data/nwchem-7.0.2-release/src/hessian/analytic/
H A Donedd_calc.F6 * g_wdens,g_dens,geom,basis,nat,ndens,dens,wdens,matb,
32 integer matb ! [input] max. atom buffer space needed
33 double precision dens(matb,matb,ndens) ! [input] scratch for density blocks
34 double precision wdens(matb,matb) ! [input] scratch for wdensity blocks
86 * dens,matb)
89 * dens(1,1,2),matb)
95 call daxpy(matb*matb,1.0d+00,dens(1,1,2),1,dens,1)
100 call ga_get(g_wdens,iab1f,iab1l,iab2f,iab2l,wdens,matb)
H A Donedd_cont.F25 integer matb, lsqatom, l_dens, k_dens, l_wdens, k_wdens
84 if (.not. bas_nbf_ce_max(basis,matb))
86 lsqatom = matb * matb
122 * dbl_mb(k_dens),dbl_mb(k_wdens),matb,ecp_channels)
/dports/science/nwchem/nwchem-7b21660b82ebd85ef659f6fba7e1e73433b0bd0a/src/hessian/analytic/
H A Donedd_calc.F6 * g_wdens,g_dens,geom,basis,nat,ndens,dens,wdens,matb,
32 integer matb ! [input] max. atom buffer space needed
33 double precision dens(matb,matb,ndens) ! [input] scratch for density blocks
34 double precision wdens(matb,matb) ! [input] scratch for wdensity blocks
86 * dens,matb)
89 * dens(1,1,2),matb)
95 call daxpy(matb*matb,1.0d+00,dens(1,1,2),1,dens,1)
100 call ga_get(g_wdens,iab1f,iab1l,iab2f,iab2l,wdens,matb)
H A Donedd_cont.F25 integer matb, lsqatom, l_dens, k_dens, l_wdens, k_wdens
84 if (.not. bas_nbf_ce_max(basis,matb))
86 lsqatom = matb * matb
122 * dbl_mb(k_dens),dbl_mb(k_wdens),matb,ecp_channels)
/dports/graphics/photivo/photivo/Sources/
H A DptRefocusMatrix.cpp118 const ptCMat* const matb) { in ConvolveMatrix() argument
123 const int ya_low = MAX (-mata->Radius, yr - matb->Radius); in ConvolveMatrix()
124 const int ya_high = MIN (mata->Radius, yr + matb->Radius); in ConvolveMatrix()
125 const int xa_low = MAX (-mata->Radius, xr - matb->Radius); in ConvolveMatrix()
126 const int xa_high = MIN (mata->Radius, xr + matb->Radius); in ConvolveMatrix()
132 c_mat_elt (matb, xr - xa, yr - ya); in ConvolveMatrix()
143 const ptCMat* const matb) { in ConvolveStarMatrix() argument
148 const int ya_low = MAX (-mata->Radius, -matb->Radius - yr); in ConvolveStarMatrix()
149 const int ya_high = MIN (mata->Radius, matb->Radius - yr); in ConvolveStarMatrix()
151 const int xa_high = MIN (mata->Radius, matb->Radius - xr); in ConvolveStarMatrix()
[all …]
/dports/graphics/digikam/digikam-7.4.0/core/libs/dimg/filters/sharp/
H A Drefocusmatrix.cpp185 void RefocusMatrix::convolve_mat(CMat* const result, const CMat* const mata, const CMat* const matb) in convolve_mat() argument
193 const int ya_low = qMax(-mata->radius, yr - matb->radius); in convolve_mat()
194 const int ya_high = qMin(mata->radius, yr + matb->radius); in convolve_mat()
195 const int xa_low = qMax(-mata->radius, xr - matb->radius); in convolve_mat()
196 const int xa_high = qMin(mata->radius, xr + matb->radius); in convolve_mat()
204 c_mat_elt(matb, xr - xa, yr - ya); in convolve_mat()
221 const int ya_low = qMax(-mata->radius, -matb->radius - yr); in convolve_star_mat()
222 const int ya_high = qMin(mata->radius, matb->radius - yr); in convolve_star_mat()
223 const int xa_low = qMax(-mata->radius, -matb->radius - xr); in convolve_star_mat()
224 const int xa_high = qMin(mata->radius, matb->radius - xr); in convolve_star_mat()
[all …]
H A Drefocusmatrix.h108 … static void convolve_star_mat(CMat* const result, const CMat* const mata, const CMat* const matb);
131 static void convolve_mat(CMat* const result, const CMat* const mata, const CMat* const matb);
/dports/graphics/gimp-refocus-plugin/refocus-0.9.0/src/
H A Dmatrix.c138 const gint ya_low = MAX (-mata->radius, yr - matb->radius); in convolve_mat()
139 const gint ya_high = MIN (mata->radius, yr + matb->radius); in convolve_mat()
140 const gint xa_low = MAX (-mata->radius, xr - matb->radius); in convolve_mat()
141 const gint xa_high = MIN (mata->radius, xr + matb->radius); in convolve_mat()
149 c_mat_elt (matb, xr - xa, yr - ya); in convolve_mat()
159 const CMat * const matb) in convolve_star_mat() argument
167 const gint ya_low = MAX (-mata->radius, -matb->radius - yr); in convolve_star_mat()
168 const gint ya_high = MIN (mata->radius, matb->radius - yr); in convolve_star_mat()
169 const gint xa_low = MAX (-mata->radius, -matb->radius - xr); in convolve_star_mat()
170 const gint xa_high = MIN (mata->radius, matb->radius - xr); in convolve_star_mat()
[all …]
H A Dmatrix.h75 const CMat * const matb);
/dports/graphics/cimg/CImg-v.2.9.7/examples/
H A Duse_tinymatwriter.cpp113 bool matb[4*3*2] = { in main() local
129 cimg_library::CImg<bool> ciB(matb, 3,2,4); in main()
/dports/graphics/gmic-qt/CImg-v.2.9.8/examples/
H A Duse_tinymatwriter.cpp113 bool matb[4*3*2] = { in main() local
129 cimg_library::CImg<bool> ciB(matb, 3,2,4); in main()
/dports/science/py-pyscf/pyscf-2.0.1/pyscf/eph/
H A Duhf.py105 matb = np.einsum('xJ,xuv->Juv', vec, vcoreb)
108matb = np.einsum('Juv,up,vq->Jpq', matb, mf.mo_coeff[1].conj(), mf.mo_coeff[1], optimize=True)
109 return np.asarray([mata,matb])
H A Duks.py200 matb = np.einsum('xJ,xuv->Juv', vec, vcoreb)
203matb = np.einsum('Juv,up,vq->Jpq', matb, mf.mo_coeff[1].conj(), mf.mo_coeff[1], optimize=True)
204 return np.asarray([mata,matb])
/dports/science/ergo/ergo-3.8/source/dft/
H A Dxc_matrix.cc457 Dft::FullMatrix mata(nbast), matb(nbast); in dft_get_uxc() local
462 UksData<Dft::FullMatrix> ds(&mata, &matb, DFT_MAX_BLLEN); in dft_get_uxc()
483 real * e = imat ? mata.mat : matb.mat; in dft_get_uxc()
500 mat::axpy(&nbast2, &ONER, matb.mat, &ONEI, xcb, &ONEI); in dft_get_uxc()
504 output_matrix(nbast, matb.mat, "Unrestricted xc_alpha matrix"); in dft_get_uxc()
H A Dxc_matrix_sparse.cc380 SparseMatrix mata(*pattern), matb(*pattern); in getXC() local
381 struct UksData<Dft::SparseMatrix> ds(&mata, &matb, DFT_MAX_BLLEN); in getXC()
401 matb.addSymmetrizedTo(xcb, aoMap, permutationHML); in getXC()
/dports/graphics/gimp-refocus-plugin/refocus-0.9.0/gtk-doc/sgml/
H A Dmatrix.sgml25 const <link linkend="CMat">CMat</link> *const matb);
110 … const <link linkend="CMat">CMat</link> *const matb);</programlisting>
124 <row><entry align="right"><parameter>matb</parameter>&nbsp;:</entry>
/dports/math/scilab/scilab-6.1.1/scilab/modules/cacsd/macros/
H A Dnarsimul.sci69 matb= b*((s.^[bdeg-1:-1:0]).*.eye(mmu,mmu))';
71 num=matb*s**(adeg-1)
/dports/math/pari/pari-2.13.3/src/basemath/
H A Dhnf_snf.c401 matb = cgetg(co,t_MAT); /* bottom part (complement of matt) */ in hnfspec_i()
405 p1 = cgetg(li-k0,t_COL); gel(matb,j) = p1; in hnfspec_i()
417 GEN Bk = gel(matb,k); in hnfspec_i()
420 GEN Bj = gel(matb,j), v = gel(Bj,i0); in hnfspec_i()
440 gerepileall(av, T? 2: 1, &matb, &T); in hnfspec_i()
444 gerepileall(av, T? 2: 1, &matb, &T); in hnfspec_i()
454 GEN t = (gel(matb,j)) + nlze - k0; in hnfspec_i()
509 GEN z = gel(matb,j); in hnfspec_i()
612 GEN matb, extratop, Cnew, permpro, B = *ptB, C = *ptC, dep = *ptdep; in hnfadd_i() local
650 matb = rowslice(extramat, nlze+1, lig); in hnfadd_i()
[all …]
/dports/science/code_saturne/code_saturne-7.1.0/src/cdo/
H A Dcs_sdm.c1271 const cs_sdm_block_t *matb = mat->block_desc; in cs_sdm_block_square_asymm() local
1272 if (matb->n_row_blocks < 1) in cs_sdm_block_square_asymm()
1274 assert(matb->n_row_blocks == matb->n_col_blocks); in cs_sdm_block_square_asymm()
1276 for (int bi = 0; bi < matb->n_row_blocks; bi++) { in cs_sdm_block_square_asymm()
1283 for (int bj = bi+1; bj < matb->n_col_blocks; bj++) { in cs_sdm_block_square_asymm()
/dports/math/p5-Math-Pari/pari-2.3.5/src/basemath/
H A Dalglin2.c1945 matb = cgetg(co,t_MAT); /* bottom part (complement of matt) */ in hnfspec_i()
1948 p1 = cgetg(li-k0,t_COL); gel(matb,j) = p1; in hnfspec_i()
1960 GEN Bk = gel(matb,k); in hnfspec_i()
1963 GEN Bj = gel(matb,j), v = gel(Bj,i0); in hnfspec_i()
1982 gerepileall(av, T? 2: 1, &matb, &T); in hnfspec_i()
1983 Bk = gel(matb,k); in hnfspec_i()
1988 gerepileall(av, T? 2: 1, &matb, &T); in hnfspec_i()
1998 GEN t = (gel(matb,j)) + nlze - k0; in hnfspec_i()
2048 GEN z = gel(matb,j); in hnfspec_i()
2214 matb = rowslice(extramat, nlze+1, lig); in hnfadd_i()
[all …]
/dports/graphics/opencollada/OpenCOLLADA-1.6.68/Externals/MayaDataModel/include/
H A DMayaDMMesh.h931 void setMaterialBlend(unsigned int matb) in setMaterialBlend() argument
933 if(matb == 0) return; in setMaterialBlend()
934 fprintf(mFile,"\tsetAttr \".matb\" %i;\n", matb); in setMaterialBlend()
/dports/cad/electric/electric-7.00/src/db/
H A Ddbmath.c392 void transmult(XARRAY mata, XARRAY matb, XARRAY matc) in transmult() argument
397 mb = matb[2][2]; in transmult()
411 xform(matb[0][2], matb[1][2], &matc[0][2], &matc[1][2], mata); in transmult()
413 xform(mata[2][0], mata[2][1], &matc[2][0], &matc[2][1], matb); in transmult()
427 matb[i][j] = db_matstyle[mb][i][j]; in transmult()
428 matb[2][2] = P1; in transmult()
435 for(k=0; k<3; k++) sum += mult(mata[i][k], matb[k][j]); in transmult()
438 mata[2][2] = ma; matb[2][2] = mb; in transmult()
/dports/science/dalton/dalton-66052b3af5ea7225e31178bf9a8b031913c72190/DALTON/dft/
H A Dcube-fast.c424 real **matb = d->B; in inactive_trace_AB() local
437 coef[vec]*ddot_(&inforb_.nocc[isym], &mata[vec][iorb], &ONEI, &matb[vec][iorb], &ONEI); in inactive_trace_AB()
/dports/cad/xcircuit/xcircuit-3.10.30/
H A Dfunctions.c947 float mata, matb, matc; in UMultCTM() local
958 matb = ctm->b * tmpa + ctm->e * tmpb; in UMultCTM()
966 ctm->b = matb; in UMultCTM()

12