Home
last modified time | relevance | path

Searched refs:cosphi (Results 1 – 25 of 462) sorted by relevance

12345678910>>...19

/dports/math/vtk6/VTK-6.2.0/ThirdParty/libproj4/vtklibproj4/
H A Dproj_tmerc.c49 double al, als, n, cosphi, sinphi, t; variable
52 t = fabs(cosphi) > 1e-10 ? sinphi/cosphi : 0.;
54 al = cosphi * lp.lam;
57 n = P->esp * cosphi * cosphi;
74 double b, cosphi;
76 b = (cosphi = cos(lp.phi)) * sin(lp.lam);
89 double n, con, cosphi, d, ds, sinphi, t;
97 cosphi = cos(lp.phi);
98 t = fabs(cosphi) > 1e-10 ? sinphi/cosphi : 0.;
99 n = P->esp * cosphi * cosphi;
[all …]
H A Dproj_eqdc.c67 double sinphi, cosphi;
70 cosphi = cos(lp.phi);
74 cosphi, P->en) : lp.phi)) / proj_msfn(sinphi, cosphi, P->es);
78 double cosphi, sinphi;
85 cosphi = cos(P->phi1);
90 m1 = proj_msfn(sinphi, cosphi, P->es);
92 ml1 = proj_mdist(P->phi1, sinphi, cosphi, P->en);
95 cosphi = cos(P->phi2);
96 P->n = (m1 - proj_msfn(sinphi, cosphi, P->es)) /
97 (proj_mdist(P->phi2, sinphi, cosphi, P->en) - ml1);
[all …]
/dports/math/vtk8/VTK-8.2.0/ThirdParty/libproj/vtklibproj/src/
H A DPJ_tmerc.c44 cosphi = cos (lp.phi); in e_forward()
45 t = fabs (cosphi) > 1e-10 ? sinphi/cosphi : 0.; in e_forward()
47 al = cosphi * lp.lam; in e_forward()
50 n = Q->esp * cosphi * cosphi; in e_forward()
68 double b, cosphi; in s_forward() local
84 cosphi = cos(lp.phi); in s_forward()
85 b = cosphi * sin (lp.lam); in s_forward()
118 cosphi = cos(lp.phi); in e_inverse()
119 t = fabs (cosphi) > 1e-10 ? sinphi/cosphi : 0.; in e_inverse()
120 n = Q->esp * cosphi * cosphi; in e_inverse()
[all …]
H A DPJ_ob_tran.c22 double coslam, sinphi, cosphi; in o_forward() local
26 cosphi = cos(lp.phi); in o_forward()
27 lp.lam = adjlon(aatan2(cosphi * sin(lp.lam), Q->sphip * cosphi * coslam + in o_forward()
37 double cosphi, coslam; in t_forward() local
39 cosphi = cos(lp.phi); in t_forward()
42 lp.phi = aasin(P->ctx, - cosphi * coslam); in t_forward()
51 double coslam, sinphi, cosphi; in o_inverse() local
57 cosphi = cos(lp.phi); in o_inverse()
59 lp.lam = aatan2(cosphi * sin(lp.lam), Q->sphip * cosphi * coslam - in o_inverse()
69 double cosphi, t; in t_inverse() local
[all …]
H A DPJ_eqdc.c57 double sinphi, cosphi; in special() local
60 cosphi = cos(lp.phi); in special()
64 cosphi, Q->en) : lp.phi)) / pj_msfn(sinphi, cosphi, P->es); in special()
89 double cosphi, sinphi; in PROJECTION() local
103 cosphi = cos(Q->phi1); in PROJECTION()
108 m1 = pj_msfn(sinphi, cosphi, P->es); in PROJECTION()
109 ml1 = pj_mlfn(Q->phi1, sinphi, cosphi, Q->en); in PROJECTION()
112 cosphi = cos(Q->phi2); in PROJECTION()
113 Q->n = (m1 - pj_msfn(sinphi, cosphi, P->es)) / in PROJECTION()
114 (pj_mlfn(Q->phi2, sinphi, cosphi, Q->en) - ml1); in PROJECTION()
[all …]
/dports/math/vtk9/VTK-9.1.0/ThirdParty/libproj/vtklibproj/src/
H A DPJ_tmerc.c44 cosphi = cos (lp.phi); in e_forward()
45 t = fabs (cosphi) > 1e-10 ? sinphi/cosphi : 0.; in e_forward()
47 al = cosphi * lp.lam; in e_forward()
50 n = Q->esp * cosphi * cosphi; in e_forward()
68 double b, cosphi; in s_forward() local
84 cosphi = cos(lp.phi); in s_forward()
85 b = cosphi * sin (lp.lam); in s_forward()
118 cosphi = cos(lp.phi); in e_inverse()
119 t = fabs (cosphi) > 1e-10 ? sinphi/cosphi : 0.; in e_inverse()
120 n = Q->esp * cosphi * cosphi; in e_inverse()
[all …]
H A DPJ_ob_tran.c22 double coslam, sinphi, cosphi; in o_forward() local
26 cosphi = cos(lp.phi); in o_forward()
27 lp.lam = adjlon(aatan2(cosphi * sin(lp.lam), Q->sphip * cosphi * coslam + in o_forward()
37 double cosphi, coslam; in t_forward() local
39 cosphi = cos(lp.phi); in t_forward()
42 lp.phi = aasin(P->ctx, - cosphi * coslam); in t_forward()
51 double coslam, sinphi, cosphi; in o_inverse() local
57 cosphi = cos(lp.phi); in o_inverse()
59 lp.lam = aatan2(cosphi * sin(lp.lam), Q->sphip * cosphi * coslam - in o_inverse()
69 double cosphi, t; in t_inverse() local
[all …]
/dports/devel/boost-docs/boost_1_72_0/boost/geometry/srs/projections/proj/
H A Dtmerc.hpp126 cosphi = cos(lp_lat); in fwd()
127 t = fabs(cosphi) > 1e-10 ? sinphi/cosphi : 0.; in fwd()
129 al = cosphi * lp_lon; in fwd()
132 n = this->m_proj_parm.esp * cosphi * cosphi; in fwd()
168 cosphi = cos(lp_lat); in inv()
169 t = fabs(cosphi) > 1e-10 ? sinphi/cosphi : 0.; in inv()
170 n = this->m_proj_parm.esp * cosphi * cosphi; in inv()
185 ))) / cosphi; in inv()
207 T b, cosphi; in fwd() local
224 cosphi = cos(lp_lat); in fwd()
[all …]
/dports/devel/boost-python-libs/boost_1_72_0/boost/geometry/srs/projections/proj/
H A Dtmerc.hpp126 cosphi = cos(lp_lat); in fwd()
127 t = fabs(cosphi) > 1e-10 ? sinphi/cosphi : 0.; in fwd()
129 al = cosphi * lp_lon; in fwd()
132 n = this->m_proj_parm.esp * cosphi * cosphi; in fwd()
168 cosphi = cos(lp_lat); in inv()
169 t = fabs(cosphi) > 1e-10 ? sinphi/cosphi : 0.; in inv()
170 n = this->m_proj_parm.esp * cosphi * cosphi; in inv()
185 ))) / cosphi; in inv()
207 T b, cosphi; in fwd() local
224 cosphi = cos(lp_lat); in fwd()
[all …]
/dports/devel/R-cran-BH/BH/inst/include/boost/geometry/srs/projections/proj/
H A Dtmerc.hpp126 cosphi = cos(lp_lat); in fwd()
127 t = fabs(cosphi) > 1e-10 ? sinphi/cosphi : 0.; in fwd()
129 al = cosphi * lp_lon; in fwd()
132 n = this->m_proj_parm.esp * cosphi * cosphi; in fwd()
168 cosphi = cos(lp_lat); in inv()
169 t = fabs(cosphi) > 1e-10 ? sinphi/cosphi : 0.; in inv()
170 n = this->m_proj_parm.esp * cosphi * cosphi; in inv()
185 ))) / cosphi; in inv()
207 T b, cosphi; in fwd() local
224 cosphi = cos(lp_lat); in fwd()
[all …]
/dports/math/stanmath/math-4.2.0/lib/boost_1.75.0/boost/geometry/srs/projections/proj/
H A Dtmerc.hpp126 cosphi = cos(lp_lat); in fwd()
127 t = fabs(cosphi) > 1e-10 ? sinphi/cosphi : 0.; in fwd()
129 al = cosphi * lp_lon; in fwd()
132 n = this->m_proj_parm.esp * cosphi * cosphi; in fwd()
168 cosphi = cos(lp_lat); in inv()
169 t = fabs(cosphi) > 1e-10 ? sinphi/cosphi : 0.; in inv()
170 n = this->m_proj_parm.esp * cosphi * cosphi; in inv()
185 ))) / cosphi; in inv()
207 T b, cosphi; in fwd() local
224 cosphi = cos(lp_lat); in fwd()
[all …]
/dports/science/py-scipy/scipy-1.7.1/scipy/_lib/boost/boost/geometry/srs/projections/proj/
H A Dtmerc.hpp126 cosphi = cos(lp_lat);
127 t = fabs(cosphi) > 1e-10 ? sinphi/cosphi : 0.;
129 al = cosphi * lp_lon;
132 n = this->m_proj_parm.esp * cosphi * cosphi;
168 cosphi = cos(lp_lat);
169 t = fabs(cosphi) > 1e-10 ? sinphi/cosphi : 0.;
170 n = this->m_proj_parm.esp * cosphi * cosphi;
185 ))) / cosphi;
207 T b, cosphi;
224 cosphi = cos(lp_lat);
[all …]
/dports/devel/boost-libs/boost_1_72_0/boost/geometry/srs/projections/proj/
H A Dtmerc.hpp126 cosphi = cos(lp_lat); in fwd()
127 t = fabs(cosphi) > 1e-10 ? sinphi/cosphi : 0.; in fwd()
129 al = cosphi * lp_lon; in fwd()
132 n = this->m_proj_parm.esp * cosphi * cosphi; in fwd()
168 cosphi = cos(lp_lat); in inv()
169 t = fabs(cosphi) > 1e-10 ? sinphi/cosphi : 0.; in inv()
170 n = this->m_proj_parm.esp * cosphi * cosphi; in inv()
185 ))) / cosphi; in inv()
207 T b, cosphi; in fwd() local
224 cosphi = cos(lp_lat); in fwd()
[all …]
/dports/devel/hyperscan/boost_1_75_0/boost/geometry/srs/projections/proj/
H A Dtmerc.hpp126 cosphi = cos(lp_lat); in fwd()
127 t = fabs(cosphi) > 1e-10 ? sinphi/cosphi : 0.; in fwd()
129 al = cosphi * lp_lon; in fwd()
132 n = this->m_proj_parm.esp * cosphi * cosphi; in fwd()
168 cosphi = cos(lp_lat); in inv()
169 t = fabs(cosphi) > 1e-10 ? sinphi/cosphi : 0.; in inv()
170 n = this->m_proj_parm.esp * cosphi * cosphi; in inv()
185 ))) / cosphi; in inv()
207 T b, cosphi; in fwd() local
224 cosphi = cos(lp_lat); in fwd()
[all …]
/dports/graphics/proj/proj-7.2.1/src/projections/
H A Dtobmerc.cpp23 double cosphi; in tobmerc_s_forward() local
30 cosphi = cos(lp.phi); in tobmerc_s_forward()
31 xy.x = P->k0 * lp.lam * cosphi * cosphi; in tobmerc_s_forward()
38 double cosphi; in tobmerc_s_inverse() local
41 cosphi = cos(lp.phi); in tobmerc_s_inverse()
42 lp.lam = xy.x / P->k0 / (cosphi * cosphi); in tobmerc_s_inverse()
H A Dob_tran.cpp29 double coslam, sinphi, cosphi; in o_forward() local
33 cosphi = cos(lp.phi); in o_forward()
35 lp.lam = adjlon(aatan2(cosphi * sin(lp.lam), Q->sphip * cosphi * coslam + in o_forward()
46 double cosphi, coslam; in t_forward() local
48 cosphi = cos(lp.phi); in t_forward()
51 lp.phi = aasin(P->ctx, - cosphi * coslam); in t_forward()
60 double coslam, sinphi, cosphi; in o_inverse() local
67 cosphi = cos(lp.phi); in o_inverse()
71 lp.lam = aatan2(cosphi * sin(lp.lam), Q->sphip * cosphi * coslam - in o_inverse()
81 double cosphi, t; in t_inverse() local
[all …]
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/bundled/boost-1.70.0/include/boost/geometry/srs/projections/proj/
H A Dtmerc.hpp132 cosphi = cos(lp_lat); in fwd()
133 t = fabs(cosphi) > 1e-10 ? sinphi/cosphi : 0.; in fwd()
135 al = cosphi * lp_lon; in fwd()
138 n = this->m_proj_parm.esp * cosphi * cosphi; in fwd()
174 cosphi = cos(lp_lat); in inv()
175 t = fabs(cosphi) > 1e-10 ? sinphi/cosphi : 0.; in inv()
176 n = this->m_proj_parm.esp * cosphi * cosphi; in inv()
191 ))) / cosphi; in inv()
219 T b, cosphi; in fwd() local
236 cosphi = cos(lp_lat); in fwd()
[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 Dtmerc.hpp132 cosphi = cos(lp_lat); in fwd()
133 t = fabs(cosphi) > 1e-10 ? sinphi/cosphi : 0.; in fwd()
135 al = cosphi * lp_lon; in fwd()
138 n = this->m_proj_parm.esp * cosphi * cosphi; in fwd()
174 cosphi = cos(lp_lat); in inv()
175 t = fabs(cosphi) > 1e-10 ? sinphi/cosphi : 0.; in inv()
176 n = this->m_proj_parm.esp * cosphi * cosphi; in inv()
191 ))) / cosphi; in inv()
219 T b, cosphi; in fwd() local
236 cosphi = cos(lp_lat); in fwd()
[all …]
/dports/graphics/proj/proj-7.2.1/src/conversions/
H A Dcart.cpp119 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()
136 const double cosphi = cos(geod.phi); in cartesian() local
141 xyz.x = (N + geod.z) * cosphi * cos(geod.lam); in cartesian()
142 xyz.y = (N + geod.z) * cosphi * sin(geod.lam); in cartesian()
175 double cosphi = norm_phi == 0 ? 1 : x_phi / norm_phi; in geodetic() local
183 cosphi = 0; in geodetic()
190 if (cosphi < 1e-6) { in geodetic()
195 const double r = geocentric_radius (P->a, P->b, cosphi, sinphi); in geodetic()
201 lpz.z = p / cosphi - N; in geodetic()
/dports/math/vtk6/VTK-6.2.0/Filters/Sources/
H A DvtkPointSource.cxx61 double theta, rho, cosphi, sinphi, radius; in RequestData() local
88 cosphi = 1 - 2*vtkMath::Random(); in RequestData()
89 sinphi = sqrt(1 - cosphi*cosphi); in RequestData()
94 x[2] = this->Center[2] + this->Radius*cosphi; in RequestData()
102 cosphi = 1 - 2*vtkMath::Random(); in RequestData()
103 sinphi = sqrt(1 - cosphi*cosphi); in RequestData()
109 x[2] = this->Center[2] + rho*cosphi; in RequestData()
/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)
192 cosphi = (xl(1,2) - xl(1,1))/hh
282 bb(5,1,i) = sn*cosphi/r2*shp(2,i)
326 & + shp(2,i)*N_22/r2*cosphi*cosphi*shp(2,j)
407 & + shp(2,i)*N_22/r2*cosphi*cosphi*shp(2,j)
583 cosphi = (xl(1,2) - xl(1,1))/hh
708 & + shp(2,i)*N_22/r2*cosphi*cosphi*shp(2,j)
[all …]
/dports/math/vtk9/VTK-9.1.0/Filters/Sources/
H A DvtkPointSource.cxx71 double theta, rho, cosphi, sinphi, radius; in RequestData() local
98 cosphi = 1 - 2 * this->Random(); in RequestData()
99 sinphi = sqrt(1 - cosphi * cosphi); in RequestData()
104 x[2] = this->Center[2] + this->Radius * cosphi; in RequestData()
112 cosphi = 1 - 2 * this->Random(); in RequestData()
113 sinphi = sqrt(1 - cosphi * cosphi); in RequestData()
119 x[2] = this->Center[2] + rho * cosphi; in RequestData()
/dports/math/vtk8/VTK-8.2.0/Filters/Sources/
H A DvtkPointSource.cxx74 double theta, rho, cosphi, sinphi, radius; in RequestData() local
101 cosphi = 1 - 2 * this->Random(); in RequestData()
102 sinphi = sqrt(1 - cosphi*cosphi); in RequestData()
107 x[2] = this->Center[2] + this->Radius*cosphi; in RequestData()
115 cosphi = 1 - 2*this->Random(); in RequestData()
116 sinphi = sqrt(1 - cosphi*cosphi); in RequestData()
122 x[2] = this->Center[2] + rho*cosphi; in RequestData()
/dports/science/nwchem/nwchem-7b21660b82ebd85ef659f6fba7e1e73433b0bd0a/src/qhop/
H A Dqhop_newpc.F51 real*8 costh,sinth,cosphi,sinphi,theta,phi
89 cosphi=cos(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
89 cosphi=cos(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

12345678910>>...19