Home
last modified time | relevance | path

Searched refs:sinphi (Results 1 – 25 of 417) sorted by relevance

12345678910>>...17

/dports/math/vtk6/VTK-6.2.0/ThirdParty/libproj4/vtklibproj4/
H A Dproj_stere.c51 sinphi *= eccen; in ssfn_()
53 pow((1. - sinphi) / (1. + sinphi), .5 * eccen)); in ssfn_()
60 sinphi = sin(lp.phi);
80 sinphi = -sinphi;
90 double sinphi, cosphi, coslam, sinlam;
92 sinphi = sin(lp.phi);
131 sinphi = 0.;
135 sinphi = sin(tp);
139 xy.x *= sinphi;
151 sinphi = P->e * sin(phi_l);
[all …]
H A Dproj_ocea.c31 double sinphi; \
47 xy.x = atan((tan(lp.phi) * P->cosphi + P->sinphi * xy.y) / t);
51 xy.y = P->rok * (P->sinphi * sin(lp.phi) - P->cosphi * cos(lp.phi) * xy.y);
60 lp.phi = asin(xy.y * P->sinphi + t * P->cosphi * (s = sin(xy.x)));
61 lp.lam = atan2(t * P->sinphi * s - xy.y * P->cosphi,
75 P->sinphi = asin(cos(phi_0) * sin(alpha));
85 P->sinphi = atan(-cos(P->singam - lam_1) / tan(phi_1));
88 P->cosphi = cos(P->sinphi);
89 P->sinphi = sin(P->sinphi);
H A Dproj_eqdc.c67 double sinphi, cosphi;
69 sinphi = sin(lp.phi);
73 fac->k = P->n * (P->c - (P->ellips ? proj_mdist(lp.phi, sinphi,
74 cosphi, P->en) : lp.phi)) / proj_msfn(sinphi, cosphi, P->es);
78 double cosphi, sinphi;
84 P->n = sinphi = sin(P->phi1);
90 m1 = proj_msfn(sinphi, cosphi, P->es);
92 ml1 = proj_mdist(P->phi1, sinphi, cosphi, P->en);
94 sinphi = sin(P->phi2);
96 P->n = (m1 - proj_msfn(sinphi, cosphi, P->es)) /
[all …]
H A Dproj_tob_g1.c37 double cosphi, sinphi, aphi; variable
44 sinphi = sin(aphi);
46 xy.y = sqrt(aphi * sinphi);
47 xy.x = 2.0 * lp.lam * cosphi * xy.y/(sinphi + aphi * cosphi);
49 xy.y = pow(aphi, P->n) * pow(fabs(sinphi),P->np);
51 pow(fabs(aphi), P->np) * pow(fabs(sinphi),P->n) /
52 (P->n * sinphi + P->np * aphi * cosphi);
/dports/graphics/proj/proj-7.2.1/src/conversions/
H A Dcart.cpp110 static double normal_radius_of_curvature (double a, double es, double sinphi) { in normal_radius_of_curvature() argument
115 return a / sqrt (1 - es*sinphi*sinphi); in normal_radius_of_curvature()
119 static double geocentric_radius (double a, double b, double cosphi, double sinphi) { in geocentric_radius() argument
127 return hypot (a*a*cosphi, b*b*sinphi) / hypot (a*cosphi, b*sinphi); in geocentric_radius()
137 const double sinphi = sin(geod.phi); in cartesian() local
138 const double N = normal_radius_of_curvature(P->a, P->es, sinphi); in cartesian()
143 xyz.z = (N * (1 - P->es) + geod.z) * sinphi; in cartesian()
176 double sinphi = norm_phi == 0 ? 0 : y_phi / norm_phi; in geodetic() local
184 sinphi = cart.z >= 0 ? 1 : -1; in geodetic()
195 const double r = geocentric_radius (P->a, P->b, cosphi, sinphi); in geodetic()
[all …]
/dports/math/vtk9/VTK-9.1.0/ThirdParty/libproj/vtklibproj/src/
H A DPJ_stere.c28 sinphi *= eccen; in ssfn_()
30 pow ((1. - sinphi) / (1. + sinphi), .5 * eccen)); in ssfn_()
41 sinphi = sin (lp.phi); in e_forward()
64 sinphi = -sinphi; in e_forward()
79 double sinphi, cosphi, coslam, sinlam; in s_forward() local
81 sinphi = sin(lp.phi); in s_forward()
95 xy.y *= (Q->mode == EQUIT) ? sinphi : in s_forward()
123 sinphi = sin (tp); in e_inverse()
130 xy.x *= sinphi; in e_inverse()
145 sinphi = P->e * sin(phi_l); in e_inverse()
[all …]
H A Dpj_qsfn.c7 pj_qsfn(double sinphi, double e, double one_es) { in pj_qsfn() argument
11 con = e * sinphi; in pj_qsfn()
12 return (one_es * (sinphi / (1. - con * con) - in pj_qsfn()
15 return (sinphi + sinphi); in pj_qsfn()
H A DPJ_ocea.c10 double sinphi; member
24 xy.x = atan((tan(lp.phi) * Q->cosphi + Q->sinphi * xy.y) / t); in s_forward()
28 xy.y = Q->rok * (Q->sinphi * sin(lp.phi) - Q->cosphi * cos(lp.phi) * xy.y); in s_forward()
41 lp.phi = asin(xy.y * Q->sinphi + t * Q->cosphi * (s = sin(xy.x))); in s_inverse()
42 lp.lam = atan2(t * Q->sinphi * s - xy.y * Q->cosphi, in s_inverse()
82 Q->sinphi = asin(cos(phi_0) * sin(alpha)); in PROJECTION()
96 Q->sinphi = atan(-cos(Q->singam - lam_1) / tan(phi_1)); in PROJECTION()
99 Q->cosphi = cos(Q->sinphi); in PROJECTION()
100 Q->sinphi = sin(Q->sinphi); in PROJECTION()
/dports/graphics/proj/proj-7.2.1/src/projections/
H A Dstere.cpp38 sinphi *= eccen; in ssfn_()
40 pow ((1. - sinphi) / (1. + sinphi), .5 * eccen)); in ssfn_()
51 sinphi = sin (lp.phi); in stere_e_forward()
86 sinphi = -sinphi; in stere_e_forward()
102 double sinphi, cosphi, coslam, sinlam; in stere_s_forward() local
104 sinphi = sin(lp.phi); in stere_s_forward()
122 xy.y *= (Q->mode == EQUIT) ? sinphi : in stere_s_forward()
155 sinphi = sin (tp); in stere_e_inverse()
162 xy.x *= sinphi; in stere_e_inverse()
179 sinphi = P->e * sin(phi_l); in stere_e_inverse()
[all …]
/dports/math/vtk8/VTK-8.2.0/ThirdParty/libproj/vtklibproj/src/
H A DPJ_stere.c28 sinphi *= eccen; in ssfn_()
30 pow ((1. - sinphi) / (1. + sinphi), .5 * eccen)); in ssfn_()
41 sinphi = sin (lp.phi); in e_forward()
64 sinphi = -sinphi; in e_forward()
79 double sinphi, cosphi, coslam, sinlam; in s_forward() local
81 sinphi = sin(lp.phi); in s_forward()
95 xy.y *= (Q->mode == EQUIT) ? sinphi : in s_forward()
123 sinphi = sin (tp); in e_inverse()
130 xy.x *= sinphi; in e_inverse()
145 sinphi = P->e * sin(phi_l); in e_inverse()
[all …]
H A Dpj_qsfn.c7 pj_qsfn(double sinphi, double e, double one_es) { in pj_qsfn() argument
11 con = e * sinphi; in pj_qsfn()
12 return (one_es * (sinphi / (1. - con * con) - in pj_qsfn()
15 return (sinphi + sinphi); in pj_qsfn()
/dports/devel/boost-docs/boost_1_72_0/boost/geometry/srs/projections/proj/
H A Dstere.hpp85 inline T ssfn_(T const& phit, T sinphi, T const& eccen) in ssfn_() argument
89 sinphi *= eccen; in ssfn_()
91 math::pow((T(1) - sinphi) / (T(1) + sinphi), T(0.5) * eccen)); in ssfn_()
109 sinphi = sin(lp_lat); in fwd()
137 sinphi = -sinphi; in fwd()
162 sinphi = sin(tp); in inv()
169 xy_x *= sinphi; in inv()
184 sinphi = par.e * sin(phi_l); in inv()
185 … lp_lat = T(2) * atan(tp * math::pow((T(1)+sinphi)/(T(1)-sinphi), halfe)) - halfpi; in inv()
215 T sinphi, cosphi, coslam, sinlam; in fwd() local
[all …]
H A Docea.hpp64 T sinphi; member
85 … xy_x = atan((tan(lp_lat) * this->m_proj_parm.cosphi + this->m_proj_parm.sinphi * xy_y) / t); in fwd()
89 …xy_y = this->m_proj_parm.rok * (this->m_proj_parm.sinphi * sin(lp_lat) - this->m_proj_parm.cosphi … in fwd()
101 … lp_lat = asin(xy_y * this->m_proj_parm.sinphi + t * this->m_proj_parm.cosphi * (s = sin(xy_x))); in inv()
102 … lp_lon = atan2(t * this->m_proj_parm.sinphi * s - xy_y * this->m_proj_parm.cosphi, in inv()
131 proj_parm.sinphi = asin(cos(phi_0) * sin(alpha)); in setup_ocea()
150 proj_parm.sinphi = atan(-cos(proj_parm.singam - lam_1) / tan(phi_1)); in setup_ocea()
153 proj_parm.cosphi = cos(proj_parm.sinphi); in setup_ocea()
154 proj_parm.sinphi = sin(proj_parm.sinphi); in setup_ocea()
/dports/devel/hyperscan/boost_1_75_0/boost/geometry/srs/projections/proj/
H A Dstere.hpp85 inline T ssfn_(T const& phit, T sinphi, T const& eccen) in ssfn_() argument
89 sinphi *= eccen; in ssfn_()
91 math::pow((T(1) - sinphi) / (T(1) + sinphi), T(0.5) * eccen)); in ssfn_()
109 sinphi = sin(lp_lat); in fwd()
137 sinphi = -sinphi; in fwd()
162 sinphi = sin(tp); in inv()
169 xy_x *= sinphi; in inv()
184 sinphi = par.e * sin(phi_l); in inv()
185 … lp_lat = T(2) * atan(tp * math::pow((T(1)+sinphi)/(T(1)-sinphi), halfe)) - halfpi; in inv()
215 T sinphi, cosphi, coslam, sinlam; in fwd() local
[all …]
/dports/devel/boost-python-libs/boost_1_72_0/boost/geometry/srs/projections/proj/
H A Dstere.hpp85 inline T ssfn_(T const& phit, T sinphi, T const& eccen) in ssfn_() argument
89 sinphi *= eccen; in ssfn_()
91 math::pow((T(1) - sinphi) / (T(1) + sinphi), T(0.5) * eccen)); in ssfn_()
109 sinphi = sin(lp_lat); in fwd()
137 sinphi = -sinphi; in fwd()
162 sinphi = sin(tp); in inv()
169 xy_x *= sinphi; in inv()
184 sinphi = par.e * sin(phi_l); in inv()
185 … lp_lat = T(2) * atan(tp * math::pow((T(1)+sinphi)/(T(1)-sinphi), halfe)) - halfpi; in inv()
215 T sinphi, cosphi, coslam, sinlam; in fwd() local
[all …]
/dports/devel/R-cran-BH/BH/inst/include/boost/geometry/srs/projections/proj/
H A Dstere.hpp85 inline T ssfn_(T const& phit, T sinphi, T const& eccen) in ssfn_() argument
89 sinphi *= eccen; in ssfn_()
91 math::pow((T(1) - sinphi) / (T(1) + sinphi), T(0.5) * eccen)); in ssfn_()
109 sinphi = sin(lp_lat); in fwd()
137 sinphi = -sinphi; in fwd()
162 sinphi = sin(tp); in inv()
169 xy_x *= sinphi; in inv()
184 sinphi = par.e * sin(phi_l); in inv()
185 … lp_lat = T(2) * atan(tp * math::pow((T(1)+sinphi)/(T(1)-sinphi), halfe)) - halfpi; in inv()
215 T sinphi, cosphi, coslam, sinlam; in fwd() local
[all …]
/dports/math/stanmath/math-4.2.0/lib/boost_1.75.0/boost/geometry/srs/projections/proj/
H A Dstere.hpp85 inline T ssfn_(T const& phit, T sinphi, T const& eccen) in ssfn_() argument
89 sinphi *= eccen; in ssfn_()
91 math::pow((T(1) - sinphi) / (T(1) + sinphi), T(0.5) * eccen)); in ssfn_()
109 sinphi = sin(lp_lat); in fwd()
137 sinphi = -sinphi; in fwd()
162 sinphi = sin(tp); in inv()
169 xy_x *= sinphi; in inv()
184 sinphi = par.e * sin(phi_l); in inv()
185 … lp_lat = T(2) * atan(tp * math::pow((T(1)+sinphi)/(T(1)-sinphi), halfe)) - halfpi; in inv()
215 T sinphi, cosphi, coslam, sinlam; in fwd() local
[all …]
/dports/science/py-scipy/scipy-1.7.1/scipy/_lib/boost/boost/geometry/srs/projections/proj/
H A Dstere.hpp85 inline T ssfn_(T const& phit, T sinphi, T const& eccen) in ssfn_() argument
89 sinphi *= eccen; in ssfn_()
91 math::pow((T(1) - sinphi) / (T(1) + sinphi), T(0.5) * eccen)); in ssfn_()
109 sinphi = sin(lp_lat); in fwd()
137 sinphi = -sinphi; in fwd()
162 sinphi = sin(tp); in inv()
169 xy_x *= sinphi; in inv()
184 sinphi = par.e * sin(phi_l); in inv()
185 … lp_lat = T(2) * atan(tp * math::pow((T(1)+sinphi)/(T(1)-sinphi), halfe)) - halfpi; in inv()
215 T sinphi, cosphi, coslam, sinlam; in fwd() local
[all …]
/dports/devel/boost-libs/boost_1_72_0/boost/geometry/srs/projections/proj/
H A Dstere.hpp85 inline T ssfn_(T const& phit, T sinphi, T const& eccen) in ssfn_() argument
89 sinphi *= eccen; in ssfn_()
91 math::pow((T(1) - sinphi) / (T(1) + sinphi), T(0.5) * eccen)); in ssfn_()
109 sinphi = sin(lp_lat); in fwd()
137 sinphi = -sinphi; in fwd()
162 sinphi = sin(tp); in inv()
169 xy_x *= sinphi; in inv()
184 sinphi = par.e * sin(phi_l); in inv()
185 … lp_lat = T(2) * atan(tp * math::pow((T(1)+sinphi)/(T(1)-sinphi), halfe)) - halfpi; in inv()
215 T sinphi, cosphi, coslam, sinlam; in fwd() local
[all …]
/dports/cad/feappv/feappv-4.1i/elements/
H A Dshell2d.f105 subroutine trsh2d(cosphi,sinphi,rr,ss, r,s, ndf,nst) argument
109 real*8 cosphi,sinphi local
120 r(1,i) = cosphi*rr(1,i) - sinphi*rr(2,i)
121 r(2,i) = sinphi*rr(1,i) + cosphi*rr(2,i)
193 sinphi = (xl(2,2) - xl(2,1))/hh
283 bb(5,2,i) = -sn*sinphi/r2*shp(2,i)
335 & + shp(2,i)*N_22/r2*sinphi*sinphi*shp(2,j)
417 & + shp(2,i)*N_22/r2*sinphi*sinphi*shp(2,j)
584 sinphi = (xl(2,2) - xl(2,1))/hh
714 & + shp(2,i)*N_22/r2*sinphi*sinphi*shp(2,j)
[all …]
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/bundled/boost-1.70.0/include/boost/geometry/srs/projections/proj/
H A Dstere.hpp85 inline T ssfn_(T const& phit, T sinphi, T const& eccen) in ssfn_() argument
89 sinphi *= eccen; in ssfn_()
91 math::pow((T(1) - sinphi) / (T(1) + sinphi), T(0.5) * eccen)); in ssfn_()
115 sinphi = sin(lp_lat); in fwd()
143 sinphi = -sinphi; in fwd()
168 sinphi = sin(tp); in inv()
175 xy_x *= sinphi; in inv()
190 sinphi = this->m_par.e * sin(phi_l); in inv()
191 … lp_lat = T(2) * atan(tp * math::pow((T(1)+sinphi)/(T(1)-sinphi), halfe)) - halfpi; in inv()
227 T sinphi, cosphi, coslam, sinlam; in fwd() local
[all …]
/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.hpp84 inline T ssfn_(T const& phit, T sinphi, T const& eccen) in ssfn_() argument
88 sinphi *= eccen; in ssfn_()
90 math::pow((T(1) - sinphi) / (T(1) + sinphi), T(0.5) * eccen)); in ssfn_()
114 sinphi = sin(lp_lat); in fwd()
142 sinphi = -sinphi; in fwd()
167 sinphi = sin(tp); in inv()
174 xy_x *= sinphi; in inv()
189 sinphi = this->m_par.e * sin(phi_l); in inv()
190 … lp_lat = T(2) * atan(tp * math::pow((T(1)+sinphi)/(T(1)-sinphi), halfe)) - halfpi; in inv()
226 T sinphi, cosphi, coslam, sinlam; in fwd() local
[all …]
/dports/science/nwchem/nwchem-7b21660b82ebd85ef659f6fba7e1e73433b0bd0a/src/qhop/
H A Dqhop_newpc.F51 real*8 costh,sinth,cosphi,sinphi,theta,phi
88 sinphi=sin(phi)
106 xhydr2(1)=cosphi*costh*(xhydr(1)-xr(1))-costh*sinphi*(xhydr(2)
108 xhydr2(2)=sinphi*(xhydr(1)-xr(1))+cosphi*(xhydr(2)-xr(2))
109 xhydr2(3)=sinth*cosphi*(xhydr(1)-xr(1))-sinth*sinphi*(xhydr(2)
126 xnew(1)=costh*cosphi*xnew2(1)+sinphi*xnew2(2)+sinth*cosphi
128 xnew(2)=-costh*sinphi*xnew2(1)+cosphi*xnew2(2)-sinth*sinphi
/dports/science/nwchem-data/nwchem-7.0.2-release/src/qhop/
H A Dqhop_newpc.F51 real*8 costh,sinth,cosphi,sinphi,theta,phi
88 sinphi=sin(phi)
106 xhydr2(1)=cosphi*costh*(xhydr(1)-xr(1))-costh*sinphi*(xhydr(2)
108 xhydr2(2)=sinphi*(xhydr(1)-xr(1))+cosphi*(xhydr(2)-xr(2))
109 xhydr2(3)=sinth*cosphi*(xhydr(1)-xr(1))-sinth*sinphi*(xhydr(2)
126 xnew(1)=costh*cosphi*xnew2(1)+sinphi*xnew2(2)+sinth*cosphi
128 xnew(2)=-costh*sinphi*xnew2(1)+cosphi*xnew2(2)-sinth*sinphi
/dports/graphics/proj/proj-7.2.1/src/
H A Dqsfn.cpp8 double pj_qsfn(double sinphi, double e, double one_es) { in pj_qsfn() argument
12 con = e * sinphi; in pj_qsfn()
20 return (one_es * (sinphi / div1 - (.5 / e) * log ((1. - con) / div2 ))); in pj_qsfn()
22 return (sinphi + sinphi); in pj_qsfn()

12345678910>>...17