Home
last modified time | relevance | path

Searched refs:phi_l (Results 1 – 21 of 21) sorted by relevance

/dports/math/vtk6/VTK-6.2.0/ThirdParty/libproj4/vtklibproj4/
H A Dproj_stere.c120 double cosphi, sinphi, tp=0., phi_l=0., rho, halfe=0., halfpi=0.;
132 phi_l = P->X;
136 phi_l = proj_asin(cosphi * P->sinX1 + (xy.y * sinphi * P->cosX1 / rho));
138 tp = tan(.5 * (HALFPI + phi_l));
145 phi_l = HALFPI - 2. * atan(tp = - rho / P->akm1);
150 for (i = NITER; i--; phi_l = lp.phi) {
151 sinphi = P->e * sin(phi_l);
154 if (fabs(phi_l - lp.phi) < CONV) {
/dports/math/vtk9/VTK-9.1.0/ThirdParty/libproj/vtklibproj/src/
H A DPJ_stere.c114 double cosphi, sinphi, tp=0.0, phi_l=0.0, rho, halfe=0.0, halfpi=0.0; in e_inverse() local
125 phi_l = asin (cosphi * Q->sinX1); in e_inverse()
127 phi_l = asin (cosphi * Q->sinX1 + (xy.y * sinphi * Q->cosX1 / rho)); in e_inverse()
129 tp = tan (.5 * (M_HALFPI + phi_l)); in e_inverse()
138 phi_l = M_HALFPI - 2. * atan (tp = - rho / Q->akm1); in e_inverse()
144 for (i = NITER; i--; phi_l = lp.phi) { in e_inverse()
145 sinphi = P->e * sin(phi_l); in e_inverse()
147 if (fabs (phi_l - lp.phi) < CONV) { in e_inverse()
/dports/graphics/proj/proj-7.2.1/src/projections/
H A Dstere.cpp146 double cosphi, sinphi, tp=0.0, phi_l=0.0, rho, halfe=0.0, halfpi=0.0; in stere_e_inverse() local
157 phi_l = asin (cosphi * Q->sinX1); in stere_e_inverse()
159 phi_l = asin (cosphi * Q->sinX1 + (xy.y * sinphi * Q->cosX1 / rho)); in stere_e_inverse()
161 tp = tan (.5 * (M_HALFPI + phi_l)); in stere_e_inverse()
172 phi_l = M_HALFPI - 2. * atan (tp); in stere_e_inverse()
179 sinphi = P->e * sin(phi_l); in stere_e_inverse()
181 if (fabs (phi_l - lp.phi) < CONV) { in stere_e_inverse()
187 phi_l = lp.phi; in stere_e_inverse()
/dports/math/vtk8/VTK-8.2.0/ThirdParty/libproj/vtklibproj/src/
H A DPJ_stere.c114 double cosphi, sinphi, tp=0.0, phi_l=0.0, rho, halfe=0.0, halfpi=0.0; in e_inverse() local
125 phi_l = asin (cosphi * Q->sinX1); in e_inverse()
127 phi_l = asin (cosphi * Q->sinX1 + (xy.y * sinphi * Q->cosX1 / rho)); in e_inverse()
129 tp = tan (.5 * (M_HALFPI + phi_l)); in e_inverse()
138 phi_l = M_HALFPI - 2. * atan (tp = - rho / Q->akm1); in e_inverse()
144 for (i = NITER; i--; phi_l = lp.phi) { in e_inverse()
145 sinphi = P->e * sin(phi_l); in e_inverse()
147 if (fabs (phi_l - lp.phi) < CONV) { in e_inverse()
/dports/devel/boost-docs/boost_1_72_0/boost/geometry/srs/projections/proj/
H A Dstere.hpp154 T cosphi, sinphi, tp=0.0, phi_l=0.0, rho, halfe=0.0, halfpi=0.0; in inv() local
164 phi_l = asin(cosphi * this->m_proj_parm.sinX1); in inv()
166phi_l = asin(cosphi * this->m_proj_parm.sinX1 + (xy_y * sinphi * this->m_proj_parm.cosX1 / rho)); in inv()
168 tp = tan(.5 * (half_pi + phi_l)); in inv()
178 phi_l = half_pi - 2. * atan(tp = - rho / this->m_proj_parm.akm1); in inv()
183 for (i = n_iter; i--; phi_l = lp_lat) { in inv()
184 sinphi = par.e * sin(phi_l); in inv()
186 if (fabs(phi_l - lp_lat) < conv_tolerance) { in inv()
/dports/devel/hyperscan/boost_1_75_0/boost/geometry/srs/projections/proj/
H A Dstere.hpp154 T cosphi, sinphi, tp=0.0, phi_l=0.0, rho, halfe=0.0, halfpi=0.0; in inv() local
164 phi_l = asin(cosphi * this->m_proj_parm.sinX1); in inv()
166phi_l = asin(cosphi * this->m_proj_parm.sinX1 + (xy_y * sinphi * this->m_proj_parm.cosX1 / rho)); in inv()
168 tp = tan(.5 * (half_pi + phi_l)); in inv()
178 phi_l = half_pi - 2. * atan(tp = - rho / this->m_proj_parm.akm1); in inv()
183 for (i = n_iter; i--; phi_l = lp_lat) { in inv()
184 sinphi = par.e * sin(phi_l); in inv()
186 if (fabs(phi_l - lp_lat) < conv_tolerance) { in inv()
/dports/devel/boost-python-libs/boost_1_72_0/boost/geometry/srs/projections/proj/
H A Dstere.hpp154 T cosphi, sinphi, tp=0.0, phi_l=0.0, rho, halfe=0.0, halfpi=0.0; in inv() local
164 phi_l = asin(cosphi * this->m_proj_parm.sinX1); in inv()
166phi_l = asin(cosphi * this->m_proj_parm.sinX1 + (xy_y * sinphi * this->m_proj_parm.cosX1 / rho)); in inv()
168 tp = tan(.5 * (half_pi + phi_l)); in inv()
178 phi_l = half_pi - 2. * atan(tp = - rho / this->m_proj_parm.akm1); in inv()
183 for (i = n_iter; i--; phi_l = lp_lat) { in inv()
184 sinphi = par.e * sin(phi_l); in inv()
186 if (fabs(phi_l - lp_lat) < conv_tolerance) { in inv()
/dports/devel/R-cran-BH/BH/inst/include/boost/geometry/srs/projections/proj/
H A Dstere.hpp154 T cosphi, sinphi, tp=0.0, phi_l=0.0, rho, halfe=0.0, halfpi=0.0; in inv() local
164 phi_l = asin(cosphi * this->m_proj_parm.sinX1); in inv()
166phi_l = asin(cosphi * this->m_proj_parm.sinX1 + (xy_y * sinphi * this->m_proj_parm.cosX1 / rho)); in inv()
168 tp = tan(.5 * (half_pi + phi_l)); in inv()
178 phi_l = half_pi - 2. * atan(tp = - rho / this->m_proj_parm.akm1); in inv()
183 for (i = n_iter; i--; phi_l = lp_lat) { in inv()
184 sinphi = par.e * sin(phi_l); in inv()
186 if (fabs(phi_l - lp_lat) < conv_tolerance) { in inv()
/dports/math/stanmath/math-4.2.0/lib/boost_1.75.0/boost/geometry/srs/projections/proj/
H A Dstere.hpp154 T cosphi, sinphi, tp=0.0, phi_l=0.0, rho, halfe=0.0, halfpi=0.0; in inv() local
164 phi_l = asin(cosphi * this->m_proj_parm.sinX1); in inv()
166phi_l = asin(cosphi * this->m_proj_parm.sinX1 + (xy_y * sinphi * this->m_proj_parm.cosX1 / rho)); in inv()
168 tp = tan(.5 * (half_pi + phi_l)); in inv()
178 phi_l = half_pi - 2. * atan(tp = - rho / this->m_proj_parm.akm1); in inv()
183 for (i = n_iter; i--; phi_l = lp_lat) { in inv()
184 sinphi = par.e * sin(phi_l); in inv()
186 if (fabs(phi_l - lp_lat) < conv_tolerance) { in inv()
/dports/science/py-scipy/scipy-1.7.1/scipy/_lib/boost/boost/geometry/srs/projections/proj/
H A Dstere.hpp154 T cosphi, sinphi, tp=0.0, phi_l=0.0, rho, halfe=0.0, halfpi=0.0; in inv() local
164 phi_l = asin(cosphi * this->m_proj_parm.sinX1); in inv()
166phi_l = asin(cosphi * this->m_proj_parm.sinX1 + (xy_y * sinphi * this->m_proj_parm.cosX1 / rho)); in inv()
168 tp = tan(.5 * (half_pi + phi_l)); in inv()
178 phi_l = half_pi - 2. * atan(tp = - rho / this->m_proj_parm.akm1); in inv()
183 for (i = n_iter; i--; phi_l = lp_lat) { in inv()
184 sinphi = par.e * sin(phi_l); in inv()
186 if (fabs(phi_l - lp_lat) < conv_tolerance) { in inv()
/dports/devel/boost-libs/boost_1_72_0/boost/geometry/srs/projections/proj/
H A Dstere.hpp154 T cosphi, sinphi, tp=0.0, phi_l=0.0, rho, halfe=0.0, halfpi=0.0; in inv() local
164 phi_l = asin(cosphi * this->m_proj_parm.sinX1); in inv()
166phi_l = asin(cosphi * this->m_proj_parm.sinX1 + (xy_y * sinphi * this->m_proj_parm.cosX1 / rho)); in inv()
168 tp = tan(.5 * (half_pi + phi_l)); in inv()
178 phi_l = half_pi - 2. * atan(tp = - rho / this->m_proj_parm.akm1); in inv()
183 for (i = n_iter; i--; phi_l = lp_lat) { in inv()
184 sinphi = par.e * sin(phi_l); in inv()
186 if (fabs(phi_l - lp_lat) < conv_tolerance) { in inv()
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/bundled/boost-1.70.0/include/boost/geometry/srs/projections/proj/
H A Dstere.hpp160 T cosphi, sinphi, tp=0.0, phi_l=0.0, rho, halfe=0.0, halfpi=0.0; in inv() local
170 phi_l = asin(cosphi * this->m_proj_parm.sinX1); in inv()
172phi_l = asin(cosphi * this->m_proj_parm.sinX1 + (xy_y * sinphi * this->m_proj_parm.cosX1 / rho)); in inv()
174 tp = tan(.5 * (half_pi + phi_l)); in inv()
184 phi_l = half_pi - 2. * atan(tp = - rho / this->m_proj_parm.akm1); in inv()
189 for (i = n_iter; i--; phi_l = lp_lat) { in inv()
190 sinphi = this->m_par.e * sin(phi_l); in inv()
192 if (fabs(phi_l - lp_lat) < conv_tolerance) { in inv()
/dports/math/py-pystan/pystan-2.19.0.0/pystan/stan/lib/stan_math/lib/boost_1.69.0/boost/geometry/srs/projections/proj/
H A Dstere.hpp159 T cosphi, sinphi, tp=0.0, phi_l=0.0, rho, halfe=0.0, halfpi=0.0; in inv() local
169 phi_l = asin(cosphi * this->m_proj_parm.sinX1); in inv()
171phi_l = asin(cosphi * this->m_proj_parm.sinX1 + (xy_y * sinphi * this->m_proj_parm.cosX1 / rho)); in inv()
173 tp = tan(.5 * (half_pi + phi_l)); in inv()
183 phi_l = half_pi - 2. * atan(tp = - rho / this->m_proj_parm.akm1); in inv()
188 for (i = n_iter; i--; phi_l = lp_lat) { in inv()
189 sinphi = this->m_par.e * sin(phi_l); in inv()
191 if (fabs(phi_l - lp_lat) < conv_tolerance) { in inv()
/dports/science/cantera/cantera-2.5.1-611-gc4d6ecc15/samples/matlab/
H A Dlithium_ion_battery.m103 function anCurr = anode_curr(phi_s,phi_l,X_Li_an,anode,elde,elyt,anode_interface,S_an)
109 setElectricPotential(elyt,phi_l);
120 function caCurr = cathode_curr(phi_s,phi_l,X_Li_ca,cathode,elde,elyt,cathode_interface,S_ca)
126 setElectricPotential(elyt,phi_l);
/dports/math/SCIP/scip-7.0.3/src/scip/
H A Dtreemodel.c696 SCIP_Real phi_l = branchratio.upratio; in computeSampleTreesize() local
701 SCIP_Real phi_lr = phi_l * phi_r; in computeSampleTreesize()
706 leftsize = (integerpow(phi_l, kl + 1) - 1.0) / (phi_l - 1.0); in computeSampleTreesize()
710 midsize = (1.0 + phi_l) * (phi_klr * phi_lr - 1.0) / (phi_lr - 1.0) - phi_klr * phi_l; in computeSampleTreesize()
712 midsize = (1.0 + phi_l) * (phi_klr - 1.0) / (phi_lr - 1.0); in computeSampleTreesize()
/dports/astro/gpsman/gpsman-6.4.4.2/gmsrc/
H A Dprojs_main.tcl1477 set phi_l [Aasin [expr $cosphi*$sinX1]]
1479 set phi_l [Aasin [expr $cosphi*$sinX1+($y*$sinphi*$cosX1/$rho)]]
1490 set phi_l [expr 1.5707963267948966-2*atan($tp)]
1497 set phi_l [expr 1.5707963267948966-2*atan($tp)]
1502 for { set i 8 } { [incr i -1] } { set phi_l $phi } {
1503 set sinphi [expr $e*sin($phi_l)]
/dports/devel/libfirm/libfirm-1.21.0/ir/lower/
H A Dlower_dw.c2149 ir_node *phi_l; in lower_Phi() local
2182 phi_l = new_rd_Phi(dbg, block, arity, in_l, mode_l); in lower_Phi()
2185 ir_set_dw_lowered(phi, phi_l, phi_h); in lower_Phi()
2194 ir_node *phi_l = entry->low_word; in fixup_phi() local
2204 set_Phi_pred(phi_l, i, pred_entry->low_word); in fixup_phi()
/dports/science/py-OpenFermion/OpenFermion-1.3.0/docs/fqe/tutorials/
H A Ddiagonal_coulomb_evolution.ipynb110 …" tei_mat[(i, j), (k, l)] = int dr1 int dr2 phi_i(dr1) phi_j(dr1) O(r12) phi_k(dr1) phi_l(dr1)\…
/dports/math/highs/HiGHS-cfe064e/src/mip/
H A DHighsSeparation.cpp233 auto phi_l = [&](double a) { in separateMixedIntegerKnapsackCover() local
341 vals[i] = -phi_l(-vals[i]); in separateMixedIntegerKnapsackCover()
/dports/science/py-scipy/scipy-1.7.1/doc/source/tutorial/
H A Dfft.rst315 \sum_{n=0}^{N-1} \phi_k[n] \phi_l[n] = \delta_{lk}.
/dports/cad/opencascade/opencascade-7.6.0/dox/specification/
H A Dpbr_math.md696 \f$\overline{\cos}\theta_l\f$ is independent from \f$\phi_l\f$ and in case of such radial symmetric…