/third_party/boost/boost/geometry/srs/projections/proj/ |
D | lcc.hpp | 89 T rho; in fwd() local 95 rho = 0.; in fwd() 97 rho = this->m_proj_parm.c * (this->m_proj_parm.ellips in fwd() 102 xy_x = par.k0 * (rho * sin( lp_lon) ); in fwd() 103 xy_y = par.k0 * (this->m_proj_parm.rho0 - rho * cos(lp_lon) ); in fwd() 112 T rho; in inv() local 118 rho = boost::math::hypot(xy_x, xy_y); in inv() 119 if(rho != 0.0) { in inv() 121 rho = -rho; in inv() 126 … lp_lat = pj_phi2(math::pow(rho / this->m_proj_parm.c, T(1)/this->m_proj_parm.n), par.e); in inv() [all …]
|
D | eqdc.hpp | 87 T rho = 0.0; in fwd() local 89 … rho = this->m_proj_parm.c - (this->m_proj_parm.ellips ? pj_mlfn(lp_lat, sin(lp_lat), in fwd() 91 xy_x = rho * sin( lp_lon *= this->m_proj_parm.n ); in fwd() 92 xy_y = this->m_proj_parm.rho0 - rho * cos(lp_lon); in fwd() 101 T rho = 0.0; in inv() local 103 … if ((rho = boost::math::hypot(xy_x, xy_y = this->m_proj_parm.rho0 - xy_y)) != 0.0 ) { in inv() 105 rho = -rho; in inv() 109 lp_lat = this->m_proj_parm.c - rho; in inv()
|
D | aea.hpp | 127 T rho = this->m_proj_parm.c - (this->m_proj_parm.ellips in fwd() local 130 if (rho < 0.) in fwd() 132 rho = this->m_proj_parm.dd * sqrt(rho); in fwd() 133 xy_x = rho * sin( lp_lon *= this->m_proj_parm.n ); in fwd() 134 xy_y = this->m_proj_parm.rho0 - rho * cos(lp_lon); in fwd() 143 T rho = 0.0; in inv() local 144 … if( (rho = boost::math::hypot(xy_x, xy_y = this->m_proj_parm.rho0 - xy_y)) != 0.0 ) { in inv() 146 rho = -rho; in inv() 150 lp_lat = rho / this->m_proj_parm.dd; in inv()
|
D | sconics.hpp | 114 T rho; in fwd() local 118 rho = this->m_proj_parm.rho_c + tan(this->m_proj_parm.sig - lp_lat); in fwd() 121 … rho = this->m_proj_parm.c2 * (this->m_proj_parm.c1 - tan(lp_lat - this->m_proj_parm.sig)); in fwd() 124 rho = this->m_proj_parm.rho_c - lp_lat; in fwd() 127 xy_x = rho * sin( lp_lon *= this->m_proj_parm.n ); in fwd() 128 xy_y = this->m_proj_parm.rho_0 - rho * cos(lp_lon); in fwd() 135 T rho; in inv() local 137 rho = boost::math::hypot(xy_x, xy_y = this->m_proj_parm.rho_0 - xy_y); in inv() 139 rho = - rho; in inv() 148 … lp_lat = atan(this->m_proj_parm.c1 - rho / this->m_proj_parm.c2) + this->m_proj_parm.sig; in inv() [all …]
|
D | sterea.hpp | 96 T rho, c, sinc, cosc; in inv() local 100 if((rho = boost::math::hypot(xy_x, xy_y)) != 0.0) { in inv() 101 c = 2. * atan2(rho, this->m_proj_parm.R2); in inv() 104 … lp_lat = asin(cosc * this->m_proj_parm.sinc0 + xy_y * sinc * this->m_proj_parm.cosc0 / rho); in inv() 105 lp_lon = atan2(xy_x * sinc, rho * this->m_proj_parm.cosc0 * cosc - in inv()
|
D | krovak.hpp | 113 T gfi, u, deltav, s, d, eps, rho; in fwd() local 124 …rho = this->m_proj_parm.rho0 * math::pow(tan(S0 / T(2) + S45) , this->m_proj_parm.n) / math::pow(t… in fwd() 126 xy_y = rho * cos(eps); in fwd() 127 xy_x = rho * sin(eps); in fwd() 137 T u, deltav, s, d, eps, rho, fi1, xy0; in inv() local 148 rho = sqrt(xy_x * xy_x + xy_y * xy_y); in inv() 152 …s = T(2) * (atan(math::pow(this->m_proj_parm.rho0 / rho, T(1) / this->m_proj_parm.n) * tan(S0 / T(… in inv()
|
D | laea.hpp | 157 T cCe, sCe, q, rho, ab=0.0; in inv() local 164 rho = boost::math::hypot(xy_x, xy_y); in inv() 165 if (rho < epsilon10) { in inv() 170 sCe = 2. * asin(.5 * rho / this->m_proj_parm.rq); in inv() 175 … ab = cCe * this->m_proj_parm.sinb1 + xy_y * sCe * this->m_proj_parm.cosb1 / rho; in inv() 176 … xy_y = rho * this->m_proj_parm.cosb1 * cCe - xy_y * this->m_proj_parm.sinb1 * sCe; in inv() 178 ab = xy_y * sCe / rho; in inv() 179 xy_y = rho * cCe; in inv()
|
D | stere.hpp | 154 T cosphi, sinphi, tp=0.0, phi_l=0.0, rho, halfe=0.0, halfpi=0.0; in inv() local 157 rho = boost::math::hypot(xy_x, xy_y); in inv() 161 … cosphi = cos( tp = 2. * atan2(rho * this->m_proj_parm.cosX1 , this->m_proj_parm.akm1) ); in inv() 163 if( rho == 0.0 ) in inv() 166 … phi_l = asin(cosphi * this->m_proj_parm.sinX1 + (xy_y * sinphi * this->m_proj_parm.cosX1 / rho)); in inv() 170 … xy_y = rho * this->m_proj_parm.cosX1 * cosphi - xy_y * this->m_proj_parm.sinX1* sinphi; in inv() 178 phi_l = half_pi - 2. * atan(tp = - rho / this->m_proj_parm.akm1); in inv()
|
/third_party/boost/boost/math/tools/ |
D | bivariate_statistics.hpp | 87 Real rho = cov/sqrt(Qu*Qv); in correlation_coefficient() local 88 if (rho > 1) { in correlation_coefficient() 89 rho = 1; in correlation_coefficient() 91 if (rho < -1) { in correlation_coefficient() 92 rho = -1; in correlation_coefficient() 94 return rho; in correlation_coefficient()
|
/third_party/boost/boost/math/statistics/ |
D | bivariate_statistics.hpp | 85 Real rho = cov/sqrt(Qu*Qv); in correlation_coefficient() local 86 if (rho > 1) { in correlation_coefficient() 87 rho = 1; in correlation_coefficient() 89 if (rho < -1) { in correlation_coefficient() 90 rho = -1; in correlation_coefficient() 92 return rho; in correlation_coefficient()
|
/third_party/boost/boost/geometry/formulas/ |
D | gnomonic_spheroid.hpp | 66 CT rho = m / M; in forward() local 67 x = sin(i_res.azimuth) * rho; in forward() 68 y = cos(i_res.azimuth) * rho; in forward() 83 CT const rho = math::sqrt(math::sqr(x) + math::sqr(y)); // use hypot? in inverse() local 84 CT distance = a * atan(rho / a); in inverse() 99 CT const drho = m / M - rho; // rho = m / M in inverse()
|
/third_party/mesa3d/src/gallium/auxiliary/gallivm/ |
D | lp_bld_sample.c | 357 LLVMValueRef rho; in lp_build_rho() local 389 rho = lp_build_pack_aos_scalars(bld->gallivm, coord_bld->type, in lp_build_rho() 393 rho = lp_build_swizzle_scalar_aos(coord_bld, cube_rho, 0, 4); in lp_build_rho() 400 rho = lp_build_mul(rho_bld, cubesize, rho); in lp_build_rho() 436 rho = lp_build_max(coord_bld, rho_xvec, rho_yvec); in lp_build_rho() 440 rho = ddmax[0]; in lp_build_rho() 442 rho = lp_build_max(coord_bld, rho, ddmax[1]); in lp_build_rho() 444 rho = lp_build_max(coord_bld, rho, ddmax[2]); in lp_build_rho() 452 rho = lp_build_pack_aos_scalars(bld->gallivm, coord_bld->type, in lp_build_rho() 453 rho_bld->type, rho, 0); in lp_build_rho() [all …]
|
/third_party/musl/src/complex/ |
D | ctanhf.c | 36 float t, beta, s, rho, denom; in ctanhf() local 63 rho = sqrtf(1 + s * s); in ctanhf() 65 return CMPLXF((beta * rho * s) / denom, t / denom); in ctanhf()
|
D | ctanh.c | 71 double t, beta, s, rho, denom; in ctanh() local 126 rho = sqrt(1 + s * s); /* = cosh(x) */ in ctanh() 128 return CMPLX((beta * rho * s) / denom, t / denom); in ctanh()
|
/third_party/ffmpeg/libavcodec/ |
D | aacps_tablegen.h | 159 float alpha, gamma, mu, rho; in ps_tableinit() local 161 rho = FFMAX(icc_invq[icc], 0.05f); in ps_tableinit() 162 alpha = 0.5f * atan2f(2.0f * c * rho, c*c - 1.0f); in ps_tableinit() 164 mu = sqrtf(1 + (4 * rho * rho - 4)/(mu * mu)); in ps_tableinit()
|
/third_party/boost/libs/compute/include/boost/compute/random/ |
D | normal_distribution.hpp | 105 const RealType rho = sqrt(-two * log(one-x1)); in generate() 107 const RealType z1 = rho * cos(two * M_PI_F * x2); in generate() 108 const RealType z2 = rho * sin(two * M_PI_F * x2); in generate()
|
/third_party/boost/boost/compute/random/ |
D | normal_distribution.hpp | 105 const RealType rho = sqrt(-two * log(one-x1)); in generate() 107 const RealType z1 = rho * cos(two * M_PI_F * x2); in generate() 108 const RealType z2 = rho * sin(two * M_PI_F * x2); in generate()
|
/third_party/mindspore/mindspore/ccsrc/backend/optimizer/ascend/mindir/ |
D | optimizer_unify_output.cc | 116 VarPtr rho = std::make_shared<Var>(); in DefinePattern() local 120 …VectorRef pattern({prim::kPrimApplyCenteredRMSProp, var, mg, ms, mom, grad, lr, rho, momentum, eps… in DefinePattern()
|
/third_party/boost/boost/random/ |
D | binomial_distribution.hpp | 345 RealType rho = in generate() local 348 if(v < t - rho) return k; in generate() 349 if(v > t + rho) continue; in generate()
|
/third_party/boost/libs/math/doc/quaternion/ |
D | output_more.txt | 48 The value of the quaternion represented in spherical form by rho = 2.82843 , theta = 0.785398 , phi… 49 The value of the quaternion represented in semipolar form by rho = 2.82843 , alpha = 0.785398 , phi…
|
/third_party/boost/libs/math/example/ |
D | HSO3SO4.cpp | 48 const float rho = 1.0f; in test_SO3_spherical() local 71 … ::boost::math::quaternion<float> q = ::boost::math::spherical(rho, theta, phi1, phi2); in test_SO3_spherical() 104 const float rho = 1.0f; in test_SO3_semipolar() local 127 … ::boost::math::quaternion<float> q = ::boost::math::semipolar(rho, alpha, theta1, theta2); in test_SO3_semipolar()
|
/third_party/openssl/crypto/bn/ |
D | bn_gf2m.c | 987 BIGNUM *a, *z, *rho, *w, *w2, *tmp; in BN_GF2m_mod_solve_quad_arr() local 1028 rho = BN_CTX_get(ctx); in BN_GF2m_mod_solve_quad_arr() 1034 if (!BN_priv_rand(rho, p[0], BN_RAND_TOP_ONE, BN_RAND_BOTTOM_ANY)) in BN_GF2m_mod_solve_quad_arr() 1036 if (!BN_GF2m_mod_arr(rho, rho, p)) in BN_GF2m_mod_solve_quad_arr() 1039 if (!BN_copy(w, rho)) in BN_GF2m_mod_solve_quad_arr() 1050 if (!BN_GF2m_add(w, w2, rho)) in BN_GF2m_mod_solve_quad_arr()
|
/third_party/ffmpeg/libavutil/ |
D | twofish.c | 274 const uint32_t rho = 0x01010101; in av_twofish_init() local 299 A = tf_h((2 * i) * rho, Me, cs->ksize); in av_twofish_init() 300 B = tf_h((2 * i + 1) * rho, Mo, cs->ksize); in av_twofish_init()
|
/third_party/mindspore/mindspore/ccsrc/transform/graph_ir/op_declare/ |
D | nn_training_ops_declare.cc | 106 {4, INPUT_DESC(lr)}, {5, INPUT_DESC(rho)}, {6, INPUT_DESC(epsilon)}, 208 INPUT_ATTR_MAP(ApplyRMSPropD) = {{6, ATTR_DESC(rho, AnyTraits<float>())}, 218 … {7, INPUT_DESC(rho)}, {8, INPUT_DESC(momentum)}, {9, INPUT_DESC(epsilon)}};
|
/third_party/mesa3d/src/microsoft/compiler/ |
D | dxil_nir_lower_int_samplers.c | 353 nir_ssa_def *rho = nir_channel(b, r, 0); in evalute_active_lod() local 355 rho = nir_fmax(b, rho, nir_channel(b, r, i)); in evalute_active_lod() 356 lod = nir_flog2(b, rho); in evalute_active_lod()
|