Home
last modified time | relevance | path

Searched +defs:Vi +defs:u (Results 1 – 25 of 107) sorted by relevance

12345

/dports/graphics/wings/libigl-2.1.0/tests/include/igl/copyleft/cgal/
H A Dhausdorff.cpp38 Eigen::MatrixXd Vi(3,3); variable
45 for(int u = 0;u<4;u++) variable
/dports/math/R-cran-spdep/spdep/R/
H A Dmoran.exact.alt.R5 resfun=weighted.residuals, Omega=NULL, save.Vi = FALSE, save.M=FALSE,
25 u <- resfun(model) functionVar
68 Vi <- listw2star(B, select[i], style=style, n, D, a, functionVar
94 exactLocalMoranAlt <- function(Ii, Vi, M1, M2, n, alternative, argument
H A Dlocalmoran.exact.R5 resfun=weighted.residuals, save.Vi = FALSE, useTP=FALSE, truncErr=1e-6,
15 u <- resfun(model) functionVar
54 Vi <- listw2star(B, select[i], style=style, n, D, a, functionVar
H A Dmtlocalmoran.R8 save.Vi = FALSE, tol = .Machine$double.eps^0.5,
21 u <- resfun(model) functionVar
69 Vi <- listw2star(B, select[i], style=style, n, D, a, functionVar
128 Vi = if(save.Vi) Vi else NULL) globalVar
139 sadLocalMoranAlt <- function(Ii, Vi, M1, M2, n, tol.bounds=0.0001, argument
/dports/math/spooles-mpich/spooles.2.2/GPart/src/
H A Dutil.c21 int ierr, ii, last, ncomp, now, nvtx, u, usize, v, w ; in GPart_setCweights() local
148 int domid, ii, nvtx, u, Vi, vsize ; in GPart_vtxIsAdjToOneDomain() local
/dports/math/spooles-mpich/spooles.2.2_SHARED/GPart/src/
H A Dutil.c21 int ierr, ii, last, ncomp, now, nvtx, u, usize, v, w ; in GPart_setCweights() local
148 int domid, ii, nvtx, u, Vi, vsize ; in GPart_vtxIsAdjToOneDomain() local
/dports/math/spooles/spooles.2.2_SHARED/GPart/src/
H A Dutil.c21 int ierr, ii, last, ncomp, now, nvtx, u, usize, v, w ; in GPart_setCweights() local
148 int domid, ii, nvtx, u, Vi, vsize ; in GPart_vtxIsAdjToOneDomain() local
/dports/math/spooles/spooles.2.2/GPart/src/
H A Dutil.c21 int ierr, ii, last, ncomp, now, nvtx, u, usize, v, w ; in GPart_setCweights() local
148 int domid, ii, nvtx, u, Vi, vsize ; in GPart_vtxIsAdjToOneDomain() local
/dports/math/cgal/CGAL-5.3/demo/Polyhedron/
H A DScene_textured_surface_mesh_item.cpp13 typedef Viewer_interface Vi; typedef
108 const float u = get(umap, *he); in compute_normals_and_vertices() local
133 float u = get(umap, halfedge(*he, *sm)); in compute_normals_and_vertices() local
H A DScene_implicit_function_item.cpp14 typedef Viewer_interface Vi; typedef
174 for(int u = 0; u < 11; u++) in compute_vertices_and_texmap() local
/dports/biology/gcta/gcta_1.26.0_src/
H A Dest_hsq.cpp646 eigenMatrix u; in reml() local
1078 bool gcta::calcu_Vi(eigenMatrix &Vi, eigenVector &prev_varcmp, double &logdet, int &iter) in calcu_Vi()
1136 void gcta::bend_V(eigenMatrix &Vi) in bend_V()
1184 bool gcta::comput_inverse_logdet_LDLT(eigenMatrix &Vi, double &logdet) { in comput_inverse_logdet_LDLT()
1199 bool gcta::comput_inverse_logdet_PLU(eigenMatrix &Vi, double &logdet) in comput_inverse_logdet_PLU()
1205 eigenVector u = lu.matrixLU().diagonal(); in comput_inverse_logdet_PLU() local
1212 bool gcta::comput_inverse_logdet_LU(eigenMatrix &Vi, double &logdet) in comput_inverse_logdet_LU()
1218 eigenVector u = lu.matrixLU().diagonal(); in comput_inverse_logdet_LU() local
1245 double gcta::calcu_P(eigenMatrix &Vi, eigenMatrix &Vi_X, eigenMatrix &Xt_Vi_X_i, eigenMatrix &P) in calcu_P()
/dports/math/xlife++/xlifepp-sources-v2.0.1-2018-05-09/tests/unit/
H A Dunit_operator.cpp158 Value Vi(i_); out << "complex Value Vi(i) :" << Vi; in unit_operator() local
179 Unknown u(V,"u"); in unit_operator() local
/dports/cad/opencascade/opencascade-7.6.0/src/IntTools/
H A DIntTools_TopolTool.cxx343 Standard_Real u = myU0 + iu * myDU; in SamplePoint() local
361 gp_Vec Vi,Vip1; in Analyse() local
/dports/math/polymake/polymake-4.5/lib/core/src/
H A Dnumerical_linalg.cc72 const Matrix<double> Vi = householder_trafo(v); in bidiag() local
133 Vector<double> u(2); in singular_value_decomposition() local
230 Vector<double> u = v + negate_if(sqrt(v*v) * unit_vector<double>(dimv,0), v[0]); in householder_trafo() local
/dports/cad/opencascade/opencascade-7.6.0/src/BRepTopAdaptor/
H A DBRepTopAdaptor_TopolTool.cxx262 gp_Vec Vi,Vip1; in Analyse() local
471 Standard_Real u=myU0+iu*myDU; in SamplePoint() local
/dports/print/texlive-base/texlive-20150521-source/utils/asymptote/
H A Drunpath3d.cc363 triple u=unit(p.point(t+1)-z0); in gen_runpath3d23() local
379 triple u=unit(z1-z0); in gen_runpath3d24() local
456 array *Vi=new array(2); in gen_runpath3d29() local
464 array *Vi=new array(2); in gen_runpath3d29() local
/dports/graphics/graphviz/graphviz-2.44.1/lib/sparse/
H A Dmq.c80 real mq_in = 0, mq_out = 0, *a = NULL, Vi, Vj; in get_mq() local
544 real *u; in hierachical_mq_clustering() local
/dports/science/PETSc/petsc-3.14.1/src/ts/tutorials/power_grid/stability_9bus/
H A Dex9busoptfd.c123 PetscScalar Vr,Vi,IGr,IGi,Vm,Vm2; in SetInitialGuess() local
208 PetscScalar Vr,Vi,Vm,Vm2; in ResidualFunction() local
437 PetscScalar Vr,Vi,Vm,Vm2; in ResidualJacobian() local
717 const PetscScalar *u; in CostIntegrand() local
H A Dex9busopt.c161 PetscScalar Vr,Vi,IGr,IGi,Vm,Vm2; in SetInitialGuess() local
245 PetscScalar Vr,Vi,IGr,IGi,Vm,Vm2; in InitialGuess() local
351 PetscScalar Vr,Vi,Vm,Vm2; in ResidualFunction() local
578 PetscScalar Vr,Vi,Vm,Vm2; in ResidualJacobian() local
884 const PetscScalar *u; in CostIntegrand() local
/dports/math/openturns/openturns-1.18/lib/src/Uncertainty/Algorithm/Sensitivity/
H A DSobolIndicesAlgorithmImplementation.cxx182 const Sample Vi(sai_.computeIndices(randomCollection, VTi)); in operator ()() local
243 Scalar SobolIndicesAlgorithmImplementation::computeVariance(const Sample & u, const Function & psi)… in computeVariance() argument
699 Point SobolIndicesAlgorithmImplementation::computeAggregatedIndices(const Sample & Vi, in computeAggregatedIndices()
/dports/math/eclib/eclib-20210318/libsrc/
H A Dsmat.cc282 scalar *V = new scalar [ d + d2 ]; scalar* Vi=V; in operator +=() local
335 scalar *V = new scalar [ d + d2 ]; scalar* Vi=V; in operator -=() local
375 scalar* Vi=V; in operator +=() local
910 long nr,nc,u,v; in liftmats_chinese() local
/dports/cad/opencascade/opencascade-7.6.0/src/Adaptor3d/
H A DAdaptor3d_TopolTool.cxx599 gp_Vec Vi,Vip1; in Analyse() local
788 Standard_Real u, v; in SamplePoint() local
/dports/graphics/opencv/opencv-4.5.3/modules/core/src/
H A Dlapack.cpp487 _Tp *Vi = Vt + i*vstep, *Vj = Vt + j*vstep; in JacobiSVDImpl_() local
664 const T* u, int ldu, bool uT, in SVBkSbImpl_()
728 const float* u, size_t ustep, bool uT, in SVBkSb()
743 const double* u, size_t ustep, bool uT, in SVBkSb()
862 Mat u(m, nm, type, buf); in invert() local
881 Mat u(n, n, type, buf); in invert() local
1337 Mat v(n, n, type, ptr, vstep), w(n, 1, type, ptr + vstep*n), u; in solve() local
1530 void SVD::compute( InputArray a, OutputArray w, OutputArray u, OutputArray vt, int flags ) in compute()
1547 Mat w = _w.getMat(), u = _u.getMat(), vt = _vt.getMat(), rhs = _rhs.getMat(); in backSubst() local
1701 cv::Mat a = cv::cvarrToMat(aarr), w = cv::cvarrToMat(warr), u, v; in cvSVD() local
[all …]
/dports/textproc/opensearch-dashboards/opensearch-dashboards-1.2.0-linux-x64/plugins/anomalyDetectionDashboards/node_modules/prettier/esm/
H A Dparser-meriyah.mjs1 var e=function(e,u){const t=new SyntaxError(e+" ("+u.start.line+":"+u.start.column+")");return t.lo… argument
22ult:2,description:"Number of spaces per indentation level.",range:{start:0,end:Number.POSITIVE_INF… property in mi
/dports/math/pari/pari-2.13.3/src/basemath/
H A DFpX_factor.c645 GEN Vi = gel(V,i); in ddf_to_ddf2_i() local
672 GEN Vi = gel(V,i); in vddf_to_simplefact() local
728 int u; in FpX_is_totally_split() local
844 GEN u = FpX_gcd(Tr, gel(h,j), p); in FpX_ddf_Shoup() local
1030 GEN u = Flx_factor_squarefree(ZX_to_Flx(T,pp), pp); in FpX_factor_squarefree() local
1502 F2x_Berlekamp_ker(GEN u) in F2x_Berlekamp_ker()
1521 GEN u = *t, a, b, vker; in F2x_split_Berlekamp() local
1631 GEN u = const_vec(n+1, pol1_F2x(f[1])); in F2x_factor_squarefree() local
1676 GEN u = F2x_gcd(Tr, F2x_add(z, X)); in F2x_ddf_simple() local
1884 GEN u = const_vec(n+1, pol1_Flx(f[1])); in Flx_factor_squarefree() local
[all …]

12345