Home
last modified time | relevance | path

Searched +defs:Ad +defs:n +defs:z (Results 1 – 25 of 62) sorted by relevance

123

/dports/science/R-cran-bayesm/bayesm/R/
H A DrivGibbs_rcpp.R51 z=Data$z functionVar
63 n=length(y) functionVar
75 { md=c(rep(0,dimd));Ad=BayesmConstant.A*diag(dimd); functionVar
H A DrivDP_rcpp.R65 z=Data$z functionVar
73 n=length(y) functionVar
95 Ad=diag(BayesmConstant.A,dimd) functionVar
107 Prioralpha=list(n=n,alphamin=alphamin,alphamax=alphamax,power=power) nameattr
129 Prioralpha=list(n=n,alphamin=alphamin,alphamax=alphamax,power=power)} globalVar
157 {lmxz = lm(x~z,data.frame(x=x,z=z)) nameattr
H A DRcppExports.R4 bayesBLP_rcpp_loop <- function(IV, X, Z, share, J, T, v, R, sigmasqR, A, theta_hat, deltabar, Ad, n… argument
56 rhierLinearMixture_rcpp_loop <- function(regdata, Z, deltabar, Ad, mubar, Amu, nu, V, nu_e, ssq, R,… argument
64 rhierMnlDP_rcpp_loop <- function(R, keep, nprint, lgtdata, Z, deltabar, Ad, PrioralphaList, lambda_… argument
72 rhierMnlRwMixture_rcpp_loop <- function(lgtdata, Z, deltabar, Ad, mubar, Amu, nu, V, s, R, keep, np… argument
80 rivDP_rcpp_loop <- function(R, keep, nprint, dimd, mbg, Abg, md, Ad, y, isgamma, z, x, w, delta, Pr… argument
84 rivGibbs_rcpp_loop <- function(y, x, z, w, mbg, Abg, md, Ad, V, nu, R, keep, nprint) { argument
88 rmixGibbs <- function(y, Bbar, A, nu, V, a, p, z) { argument
92 rmixture <- function(n, pvec, comps) { argument
120 rnmixGibbs_rcpp_loop <- function(y, Mubar, A, nu, V, a, p, z, R, keep, nprint) { argument
124 rordprobitGibbs_rcpp_loop <- function(y, X, k, A, betabar, Ad, s, inc_root, dstarbar, betahat, R, k… argument
[all …]
H A DrhierMnlRwMixture_rcpp.R162 if(is.null(Prior$Ad) & drawdelta) {Ad=BayesmConstant.A*diag(nvar*nz)} else {Ad=Prior$Ad} functionVar
234 z=as.vector(rootH%*%(beta-betapooled)) functionVar
244 n = length(y) functionVar
/dports/science/R-cran-bayesm/bayesm/src/
H A Drivgibbs_rcpp_loop.cpp4 List rivGibbs_rcpp_loop(vec const& y, vec const& x, mat const& z, mat const& w, vec const& mbg, mat… in rivGibbs_rcpp_loop()
5 … vec const& md, mat const& Ad, mat const& V, double nu, int R, int keep, int nprint){ in rivGibbs_rcpp_loop()
48 int n = y.size(); in rivGibbs_rcpp_loop() local
H A DrhierMnlDP_rcpp_loop.cpp4 …Delta(mat const& x,mat const& y,ivec const& z,std::vector<murooti> const& comps_vector,vec const& … in drawDelta()
93 int n = y.n_rows; in rDPGibbs1() local
170 … vec const& deltabar, mat const& Ad, List const& PrioralphaList, List const& lambda_hyper, in rhierMnlDP_rcpp_loop()
H A DbayesBLP_rcpp_loop.cpp139 List rivDraw(vec const& mu, vec const& Xend, mat const& z, mat const& Xexo, vec const& theta_hat, m… in rivDraw()
140 …vec const& deltabar, mat const& Ad, mat const& V, double nu, vec const& delta_old, mat const& Omeg… in rivDraw()
179 int n = mu.size(); in rivDraw() local
257 vec const& deltabar, mat const& Ad, in bayesBLP_rcpp_loop()
316 vec r_new, mu_new, theta_tilde, z, mu, err, mu0, mu1, eta_new, eta_old, tau_sq_all, zeta; in bayesBLP_rcpp_loop() local
H A DrivDP_rcpp_loop.cpp10 ytxtxtd get_ytxt(vec const& y, mat const& z, mat const& delta, mat const& x, mat const& w, in get_ytxt()
76 ytxtxtd get_ytxtd(vec const& y, mat const& z, double beta, vec const& gamma, mat const& x, mat cons… in get_ytxtd()
208 int n = y.n_rows; in rthetaDP() local
287 int dimd, vec const& mbg, mat const& Abg, vec const& md, mat const& Ad, in rivDP_rcpp_loop()
288 … vec const& y, bool isgamma, mat const& z, vec const& x, mat const& w, vec delta, in rivDP_rcpp_loop()
294 int n = y.size(); in rivDP_rcpp_loop() local
H A DRcppExports.cpp28 Rcpp::traits::input_parameter< mat const& >::type Ad(AdSEXP); in _bayesm_bayesBLP_rcpp_loop() local
232 Rcpp::traits::input_parameter< mat const& >::type Ad(AdSEXP); in _bayesm_rhierLinearMixture_rcpp_loop() local
288 Rcpp::traits::input_parameter< mat const& >::type Ad(AdSEXP); in _bayesm_rhierMnlDP_rcpp_loop() local
327 Rcpp::traits::input_parameter< mat const& >::type Ad(AdSEXP); in _bayesm_rhierMnlRwMixture_rcpp_loop() local
389 Rcpp::traits::input_parameter< mat const& >::type Ad(AdSEXP); in _bayesm_rivDP_rcpp_loop() local
392 Rcpp::traits::input_parameter< mat const& >::type z(zSEXP); in _bayesm_rivDP_rcpp_loop() local
417 Rcpp::traits::input_parameter< mat const& >::type z(zSEXP); in _bayesm_rivGibbs_rcpp_loop() local
445 Rcpp::traits::input_parameter< vec const& >::type z(zSEXP); in _bayesm_rmixGibbs() local
456 Rcpp::traits::input_parameter< int >::type n(nSEXP); in _bayesm_rmixture() local
596 Rcpp::traits::input_parameter< vec >::type z(zSEXP); in _bayesm_rnmixGibbs_rcpp_loop() local
[all …]
H A DutilityFunctions.cpp53 mat drawDelta(mat const& x,mat const& y,vec const& z,List const& comps,vec const& deltabar,mat cons… in drawDelta()
126 int n = y.size(); in runiregG() local
198 vec z = rootA*(beta-betabar); in lpostbeta() local
258 int n = mu.size(); in rtrunVec() local
351 int n = y.n_rows; in yden() local
439 int n = indic.size(); in thetaStarDraw() local
781 int n = c1.size(); in callroot() local
/dports/science/py-scipy/scipy-1.7.1/scipy/special/cephes/
H A Dellie.c189 double x, y, z, x1, y1, z1, ret, Q; in ellie_neg_m() local
191 double A0d, Ad, seriesn, seriesd, Xd, Yd, Zd, E2d, E3d, E4d, E5d, scaled; in ellie_neg_m() local
192 int n = 0; in ellie_neg_m() local
/dports/math/fflas-ffpack/fflas-ffpack-2.4.3/fflas-ffpack/field/
H A Drns-integer-mod.h233 Element& add(Element& x, const Element& y, const Element& z) const { in add()
241 Element& sub(Element& x, const Element& y, const Element& z) const { in sub()
256 Element& mul(Element& x, const Element& y, const Element& z) const { in mul()
265 Element& axpyin(Element& x, const Element& y, const Element& z) const { in axpyin()
305 void reduce_modp(size_t n, Element_ptr B) const{ in reduce_modp()
356 int n, int m, int lda) const in write_matrix()
369 int n, int m, int lda) const in write_matrix_long()
389 BasisElement *Gamma, *alpha, *z, *A; in reduce_modp() local
507 void reduce_modp_rnsmajor_scal_quad(size_t n, Element_ptr B) const { in reduce_modp_rnsmajor_scal_quad()
632 double* Ad; in reduce_modp_rnsmajor_scal_quad() local
[all …]
/dports/math/pari/pari-2.13.3/src/basemath/
H A DZV.c34 long n = lg(A); in RgM_check_ZM() local
75 long n = lg(x); in ZM_max_lg() local
162 GEN z; in zv_ZM_mul() local
694 GEN d, n, Ad, B, u; in ZC_Q_mul() local
741 GEN z; in ZV_ZM_mul() local
752 GEN z; in ZC_ZV_mul() local
768 GEN z; in ZV_dotsquare() local
867 GEN z; in ZM_add() local
877 GEN z; in ZM_sub() local
1464 GEN n; in ZV_prod() local
[all …]
H A Dbase1.c448 ZX_Q_mul(GEN A, GEN z) in ZX_Q_mul()
452 GEN d, n, Ad, B, u; in ZX_Q_mul() local
491 ZXX_Q_mul(GEN A, GEN z) in ZXX_Q_mul()
563 zk_galoisapplymod(GEN nf, GEN z, GEN S, GEN p) in zk_galoisapplymod()
747 long k, n; in nfgaloismatrix() local
827 long f, n, s; in idealfrobenius_aut() local
863 long f, n, s; in idealramfrobenius_aut() local
1201 GEN rnf = rnfequation2(a, t), z; in partmap_reverse() local
1348 GEN z; in get_roots() local
2067 GEN z; in nfnewprec() local
[all …]
/dports/math/giacxcas/giac-1.6.0/src/
H A DGraph3d.cc114 double n=std::sqrt(qx*qx+qy*qy+qz*qz+qw*qw); in rotation_2_quaternion_double() local
241 double Ai,Aj,Ad; in legende_draw() local
469 int n=surface.size(); in glsurface() local
966 vecteur P,n; in indraw() local
1080 double z=window_zmin+j*dz; in indraw() local
1101 double z=window_zmin+j*dz; in indraw() local
1216 int n=nphi*10; in indraw() local
1705 double n=std::sqrt(a*a+b*b+c*c); in normalize() local
1814 double x,y,z,theta; in display() local
2199 double x,y,z; in display() local
[all …]
H A Dopengl.cc792 int n=int(std::floor(std::log10(x)+.5)); // round to nearest in setup_round() local
1209 int n=v.size(); in selection2vecteur() local
1443 double n=std::sqrt(qx*qx+qy*qy+qz*qz+qw*qw); in rotation_2_quaternion_double() local
1542 double Ai,Aj,Ad; in legende_draw() local
1775 int n=surface.size(); in glsurface() local
2273 vecteur P,n; in indraw() local
2337 double z=a*x+b*y+c; in indraw() local
2502 int n=nphi*10; in indraw() local
3090 double n=std::sqrt(a*a+b*b+c*c); in normalize() local
3210 double x,y,z,theta; in display() local
[all …]
/dports/devel/ode/ode-0.13/ode/src/
H A Dquickstep.cpp373 const dReal *cfm, dReal *z, dReal *in, dReal *out) in multiply_J_invM_JT()
391 static inline dReal dot (unsigned int n, const dReal *x, const dReal *y) in dot()
401 static inline void add (unsigned int n, dReal *x, const dReal *y, const dReal *z, dReal alpha) in add()
420 dReal *z = memarena->AllocateArray<dReal>(m); in CG_LCP() local
425 dReal *Ad = memarena->AllocateArray<dReal>(m); in CG_LCP() local
555 dReal *Ad = memarena->AllocateArray<dReal>(m); in SOR_LCP() local
/dports/www/fusionpbx/fusionpbx-4.4.1/app/adminer/
H A Dadminer.php206 delete($Q,$Mf,$z=0){$H="FROM ".table($Q);return
208 update($Q,$O,$Mf,$z=0,$ug="\n"){$Th=array();foreach($O
286 limit($H,$Z,$z,$D=0,$ug=" "){return" $H$Z".($z!==null?$ug."LIMIT $z".($D?" OFFSET $D":""):"");}func…
445 limit($H,$Z,$z,$D=0,$ug=" "){return" $H$Z".($z!==null?$ug."LIMIT $z".($D?" OFFSET $D":""):"");}func…
757 limit($H,$Z,$z,$D=0,$ug=" "){return($z!==null?" TOP (".($z+$D).")":"")." $H$Z";}function
881 limit($H,$Z,$z,$D=0,$ug=" "){$J='';$J.=($z!==null?$ug."FIRST $z".($D?" SKIP $D":""):"");$J.=" $H$Z"…
979 delete($Q,$Mf,$z=0){return$this->_chunkRequest($this->_extractIds($Q,$Mf,$z),'BatchDeleteAttributes…
1024 limit($H,$Z,$z,$D=0,$ug=" "){return" $H$Z".($z!==null?$ug."LIMIT $z":"");}function
1071 select($Q,$M,$Z,$Xc,$We=array(),$z=1,$E=0,$Df=false){$M=($M==array("*")?array():array_fill_keys($M,…
1248 limit($H,$Z,$z,$D=0,$ug=" "){return" $H$Z".($z!==null?$ug."LIMIT $z".($D?" OFFSET $D":""):"");}func…
[all …]
/dports/graphics/argyllcms/Argyll_V1.9.2/rspl/
H A Dscat.c292 double **Ad; /* A matrix of data vertex weights */ member
308 double *z, *xx, *q, *r; member
309 double *n; member
728 int i, n, e, f; in add_rspl_imp() local
1371 int e, g, n, i; in new_mgtmp() local
1753 int e, n,i,k; in setup_solve() local
2330 int n; variable
2369 int e, n; in mgtmp_interp() local
2425 int e, n; in init_soln() local
/dports/textproc/opensearch-dashboards/opensearch-dashboards-1.2.0-linux-x64/plugins/anomalyDetectionDashboards/node_modules/prettier/esm/
H A Dparser-typescript.mjs1n]of e.entries())try{return{result:n()}}catch(e){0===r&&(t=e)}return{error:t}},n=void 0!==n?n:"und… function
22nt",category:"Global",default:2,description:"Number of spaces per indentation level.",range:{start… field in Tu
/dports/science/mcstas-comps/mcstas-comps-2.5-src/libs/cif2hkl/
H A Dcif2hkl.F901309 real(kind=cp) :: ax, xx, z local
1370 real(kind=cp) :: ax,xx,z local
5797 Subroutine Tqli2(d,e,n,z) argument
5801 real(kind=cp), dimension(:,:), intent(in out) :: z ! z(np,np) local
10120 real(kind=cp) :: z,z0,area,factor local
10268 real(kind=cp), dimension(3), intent(in) :: z local
32349 Subroutine Niggli_Cell_ABC(Ad,Niggli_Point,Celln,Trans) !Scalar algorithm argument
48995 Subroutine Read_Cif_Z(filevar,nline_ini,nline_end,z) argument
49000 integer, intent(out) :: z local
49723 integer, optional, intent(out) :: z local
[all …]
/dports/science/mbdyn/mbdyn-1.7.3/libraries/libmbmath/
H A Dmatvectest.cc1297 void doVecAdd(const Vector<T, iRowCount>& x, const Vector<T, iRowCount>& y, Vector<T, iRowCount>& z) in doVecAdd()
1303 void doVecMul(const Vector<T, iRowCount>& x, const Vector<T, iRowCount>& y, Vector<T, iRowCount>& z) in doVecMul()
1313 Vector<Gradient<iMaxDeriv>, iRowCount> x, y, z; in testVecOp() local
1396 Matrix<doublereal, 3, 4> Ad; in testMatVecProductGradient() local
1540 …Gradient<0> z = Norm(A * x) / Norm(Ad * x) + (Norm(A * x) / Norm(Ad * x) - Norm(A * x) / Norm(Ad *… in testMatVecProductGradient() local
1579 Vector<doublereal, 3> n = Cross(h + h, h) + h; in testMatVecProductGradient() local
2635 for (int n = 0; n < NLoops; ++n) { in testMatVec3() local
/dports/devel/godot-tools/godot-3.2.3-stable/thirdparty/xatlas/
H A Dxatlas.cpp707 Vector3(float x, float y, float z) : x(x), y(y), z(z) {} in Vector3()
708 Vector3(const Vector2 &v, float z) : x(v.x), y(v.y), z(z) {} in Vector3()
763 float x, y, z; member in xatlas::internal::Vector3
2121 uint32_t x, y, z, c; member in xatlas::internal::KISSRng
4445 uint32_t n; member
4471 uint32_t n; member
4487 uint32_t n; member
4516 uint32_t n; member
4886 double *Ad = h; in nlSolveSystem_PRE_CG() local
4959 uint32_t n; member
[all …]
/dports/devel/godot/godot-3.2.3-stable/thirdparty/xatlas/
H A Dxatlas.cpp707 Vector3(float x, float y, float z) : x(x), y(y), z(z) {} in Vector3()
708 Vector3(const Vector2 &v, float z) : x(v.x), y(v.y), z(z) {} in Vector3()
763 float x, y, z; member in xatlas::internal::Vector3
2121 uint32_t x, y, z, c; member in xatlas::internal::KISSRng
4445 uint32_t n; member
4471 uint32_t n; member
4487 uint32_t n; member
4516 uint32_t n; member
4886 double *Ad = h; in nlSolveSystem_PRE_CG() local
4959 uint32_t n; member
[all …]
/dports/mail/rspamd/rspamd-3.1/contrib/languages-data/
H A Did.json1W":10090,"V":6089,"Q":1321,"P":55685,"S":65231,"R":21435,"Y":7072,"X":1468,"Z":2501,"f":36925,"g":… number

123