Home
last modified time | relevance | path

Searched refs:cospsi (Results 1 – 25 of 31) sorted by relevance

12

/dports/science/tfel/tfel-3.4.0/include/TFEL/Math/General/
H A DRandomRotationMatrix.hxx35 T cospsi=cos(psi); in getRandomRotationMatrix() local
41 drot(0,0) = cosphi*cospsi - sinphi*costhe*sinpsi; in getRandomRotationMatrix()
42 drot(0,1) = cosphi*sinpsi + sinphi*costhe*cospsi; in getRandomRotationMatrix()
44 drot(1,0) = -sinphi*cospsi - cosphi*costhe*sinpsi; in getRandomRotationMatrix()
45 drot(1,1) = -sinphi*sinpsi + cosphi*costhe*cospsi; in getRandomRotationMatrix()
48 drot(2,1) = -sinthe*cospsi; in getRandomRotationMatrix()
/dports/science/tfel-edf/tfel-3.2.1/include/TFEL/Math/General/
H A DRandomRotationMatrix.hxx35 T cospsi=cos(psi); in getRandomRotationMatrix() local
41 drot(0,0) = cosphi*cospsi - sinphi*costhe*sinpsi; in getRandomRotationMatrix()
42 drot(0,1) = cosphi*sinpsi + sinphi*costhe*cospsi; in getRandomRotationMatrix()
44 drot(1,0) = -sinphi*cospsi - cosphi*costhe*sinpsi; in getRandomRotationMatrix()
45 drot(1,1) = -sinphi*sinpsi + cosphi*costhe*cospsi; in getRandomRotationMatrix()
48 drot(2,1) = -sinthe*cospsi; in getRandomRotationMatrix()
/dports/science/tfel-edf/tfel-3.2.1/tests/Math/st2tost2/
H A DST2toST2ChangeBasis.cxx49 const double cospsi = std::cos(psi); in execute() local
56 r(0,0) = cosphi*cospsi - sinphi*costhe*sinpsi; in execute()
57 r(0,1) = cosphi*sinpsi + sinphi*costhe*cospsi; in execute()
59 r(1,0) = -sinphi*cospsi - cosphi*costhe*sinpsi; in execute()
60 r(1,1) = -sinphi*sinpsi + cosphi*costhe*cospsi; in execute()
63 r(2,1) = -sinthe*cospsi; in execute()
/dports/science/tfel/tfel-3.4.0/tests/Math/st2tost2/
H A DST2toST2ChangeBasis.cxx49 const double cospsi = std::cos(psi); in execute() local
56 r(0,0) = cosphi*cospsi - sinphi*costhe*sinpsi; in execute()
57 r(0,1) = cosphi*sinpsi + sinphi*costhe*cospsi; in execute()
59 r(1,0) = -sinphi*cospsi - cosphi*costhe*sinpsi; in execute()
60 r(1,1) = -sinphi*sinpsi + cosphi*costhe*cospsi; in execute()
63 r(2,1) = -sinthe*cospsi; in execute()
/dports/science/tfel-edf/tfel-3.2.1/tests/Math/stensor/
H A Dstensor_changeBasis2.cxx50 const real cospsi = cos(psi); in execute() local
57 r(0,0) = cosphi*cospsi - sinphi*costhe*sinpsi; in execute()
58 r(1,0) = cosphi*sinpsi + sinphi*costhe*cospsi; in execute()
60 r(0,1) = -sinphi*cospsi - cosphi*costhe*sinpsi; in execute()
61 r(1,1) = -sinphi*sinpsi + cosphi*costhe*cospsi; in execute()
64 r(1,2) = -sinthe*cospsi; in execute()
/dports/science/tfel/tfel-3.4.0/tests/Math/stensor/
H A Dstensor_changeBasis2.cxx50 const real cospsi = cos(psi); in execute() local
57 r(0,0) = cosphi*cospsi - sinphi*costhe*sinpsi; in execute()
58 r(1,0) = cosphi*sinpsi + sinphi*costhe*cospsi; in execute()
60 r(0,1) = -sinphi*cospsi - cosphi*costhe*sinpsi; in execute()
61 r(1,1) = -sinphi*sinpsi + cosphi*costhe*cospsi; in execute()
64 r(1,2) = -sinthe*cospsi; in execute()
/dports/science/tfel/tfel-3.4.0/include/TFEL/Material/
H A DPolyCrystalsSlidingSystems.ixx69 const real cospsi = std::cos(psi);
75 drot(0, 0) = cosphi * cospsi - sinphi * costhe * sinpsi;
76 drot(0, 1) = cosphi * sinpsi + sinphi * costhe * cospsi;
78 drot(1, 0) = -sinphi * cospsi - cosphi * costhe * sinpsi;
79 drot(1, 1) = -sinphi * sinpsi + cosphi * costhe * cospsi;
82 drot(2, 1) = -sinthe * cospsi;
/dports/science/tfel-edf/tfel-3.2.1/include/TFEL/Material/
H A DPolyCrystalsSlidingSystems.ixx74 const real cospsi = std::cos(psi);
80 drot(0,0) = cosphi*cospsi - sinphi*costhe*sinpsi;
81 drot(0,1) = cosphi*sinpsi + sinphi*costhe*cospsi;
83 drot(1,0) = -sinphi*cospsi - cosphi*costhe*sinpsi;
84 drot(1,1) = -sinphi*sinpsi + cosphi*costhe*cospsi;
87 drot(2,1) = -sinthe*cospsi;
/dports/graphics/blender/blender-2.91.0/source/blender/gpu/shaders/material/
H A Dgpu_shader_material_tex_sky.glsl3 float cospsi = sin(thetav) * sin(theta) * cos(phi - phiv) + cos(thetav) * cos(theta);
5 if (cospsi > 1.0) {
8 if (cospsi < -1.0) {
12 return acos(cospsi);
/dports/graphics/yafaray/libYafaRay-3.5.1/src/backgrounds/
H A Dsunsky.cc137 double cospsi = fSin(thetav) * fSin(thetaS) * fCos(phiS-phiv) + fCos(thetav) * fCos(thetaS); in AngleBetween() local
138 if (cospsi > 1) return 0; in AngleBetween()
139 if (cospsi < -1) return M_PI; in AngleBetween()
140 return fAcos(cospsi); in AngleBetween()
/dports/lang/slib/slib-3b6/
H A Ddaylight.scm256 (define cospsi (+ (* (sin theta) (sin theta_s) (cos (- phi phi_s)))
258 (cond ((> cospsi 1) 0)
259 ((< cospsi -1) pi)
260 (else (acos cospsi))))
/dports/science/py-gpaw/gpaw-21.6.0/gpaw/pes/
H A Dds_beta.py150 cospsi = cos(self.angle['psi'])
152 sinphi * cospsi) +
155 cosphi * cospsi) +
/dports/devel/simgear/simgear-2020.3.11/simgear/magvar/
H A Dcoremag.cxx216 double sinpsi, cospsi, inv_s; in calc_magvar() local
342 cospsi = cos(psi); in calc_magvar()
343 X = -B_theta * cospsi - B_r * sinpsi; in calc_magvar()
345 Z = B_theta * sinpsi - B_r * cospsi; in calc_magvar()
/dports/graphics/blender/blender-2.91.0/intern/cycles/kernel/shaders/
H A Dnode_sky_texture.osl22 float cospsi = sin(thetav) * sin(theta) * cos(phi - phiv) + cos(thetav) * cos(theta);
24 if (cospsi > 1.0)
26 if (cospsi < -1.0)
29 return acos(cospsi);
/dports/games/flightgear/flightgear-2020.3.11/src/FDM/JSBSim/models/atmosphere/
H A DFGWinds.cpp357 double cospsi = cos(psiw), sinpsi = sin(psiw); in Turbulence() local
358 vTurbulenceNED(eNorth) = cospsi*xi_u + sinpsi*xi_v; in Turbulence()
359 vTurbulenceNED(eEast) = -sinpsi*xi_u + cospsi*xi_v; in Turbulence()
362 vTurbPQR(eP) = cospsi*xi_p + sinpsi*xi_q; in Turbulence()
363 vTurbPQR(eQ) = -sinpsi*xi_p + cospsi*xi_q; in Turbulence()
/dports/graphics/gmt/gmt-6.3.0/src/potential/
H A Dgrdredpol.c267 double *cosphi, double *sinphi, double *cospsi, double *sinpsi) { in grdgravmag3d_tfpoeq() argument
324 cospsi[i] = cos(arg1); in grdgravmag3d_tfpoeq()
348 co2 = cospsi[ksn - 1]; in grdgravmag3d_tfpoeq()
1224 double *cosphi = NULL, *sinphi = NULL, *cospsi = NULL, *sinpsi = NULL; in GMT_grdredpol() local
1317 cospsi = gmt_M_memory (GMT, NULL, n_coef, double); in GMT_grdredpol()
1446 …grdgravmag3d_tfpoeq(fxr, Ctrl->F.ncoef_row, Ctrl->F.ncoef_col,gxr,gxi, cosphi,sinphi,cospsi,sinp… in GMT_grdredpol()
1447 …grdgravmag3d_tfpoeq(fxar,Ctrl->F.ncoef_row, Ctrl->F.ncoef_col,gxar,gxai, cosphi,sinphi,cospsi,sinp… in GMT_grdredpol()
1448 …grdgravmag3d_tfpoeq(fxbr,Ctrl->F.ncoef_row, Ctrl->F.ncoef_col,gxbr,gxbi, cosphi,sinphi,cospsi,sinp… in GMT_grdredpol()
1449 …grdgravmag3d_tfpoeq(fxgr,Ctrl->F.ncoef_row, Ctrl->F.ncoef_col,gxgr,gxgi, cosphi,sinphi,cospsi,sinp… in GMT_grdredpol()
1455 …grdgravmag3d_tfpoeq(fxtr,Ctrl->F.ncoef_row, Ctrl->F.ncoef_col,gxtr,gxti, cosphi,sinphi,cospsi,sinp… in GMT_grdredpol()
[all …]
/dports/science/tfel-edf/tfel-3.2.1/mtest/src/
H A DMTestParser.cxx459 const real cospsi = std::cos(psi); in handleRotationMatrix() local
465 r(0, 0) = cosphi * cospsi - sinphi * costhe * sinpsi; in handleRotationMatrix()
466 r(0, 1) = cosphi * sinpsi + sinphi * costhe * cospsi; in handleRotationMatrix()
468 r(1, 0) = -sinphi * cospsi - cosphi * costhe * sinpsi; in handleRotationMatrix()
469 r(1, 1) = -sinphi * sinpsi + cosphi * costhe * cospsi; in handleRotationMatrix()
472 r(2, 1) = -sinthe * cospsi; in handleRotationMatrix()
/dports/science/tfel/tfel-3.4.0/mtest/src/
H A DMTestParser.cxx462 const real cospsi = std::cos(psi); in handleRotationMatrix() local
468 r(0, 0) = cosphi * cospsi - sinphi * costhe * sinpsi; in handleRotationMatrix()
469 r(0, 1) = cosphi * sinpsi + sinphi * costhe * cospsi; in handleRotationMatrix()
471 r(1, 0) = -sinphi * cospsi - cosphi * costhe * sinpsi; in handleRotationMatrix()
472 r(1, 1) = -sinphi * sinpsi + cosphi * costhe * cospsi; in handleRotationMatrix()
475 r(2, 1) = -sinthe * cospsi; in handleRotationMatrix()
/dports/astro/p5-Astro-satpass/Astro-satpass-0.122/lib/Astro/Coord/ECI/
H A DSun.pm347 my $cospsi = sqrt ($costheta * $costheta -
352 $psiterm *= $cospsi;
/dports/graphics/blender/blender-2.91.0/intern/cycles/kernel/svm/
H A Dsvm_sky.h23 float cospsi = sinf(thetav) * sinf(theta) * cosf(phi - phiv) + cosf(thetav) * cosf(theta); in sky_angle_between() local
24 return safe_acosf(cospsi); in sky_angle_between()
/dports/math/ggobi/ggobi-2.1.11/src/
H A Dtour2d3.c837 gfloat phi, cosphi, sinphi, ca, sa, cosm, cospsi, sinpsi; in tour2d3_manip() local
951 cospsi = x1*x2+y1*y2; in tour2d3_manip()
956 cospsi = 1.; in tour2d3_manip()
962 cospsi = 1.; in tour2d3_manip()
965 dsp->t2d3_Rmat2.vals[0][0] = cospsi; in tour2d3_manip()
969 dsp->t2d3_Rmat2.vals[1][1] = cospsi; in tour2d3_manip()
H A Dtour2d.c1102 gfloat phi, cosphi, sinphi, ca, sa, cosm, cospsi, sinpsi; in tour2d_manip() local
1217 cospsi = x1*x2+y1*y2; in tour2d_manip()
1222 cospsi = 1.; in tour2d_manip()
1228 cospsi = 1.; in tour2d_manip()
1231 dsp->t2d_Rmat2.vals[0][0] = cospsi; in tour2d_manip()
1235 dsp->t2d_Rmat2.vals[1][1] = cospsi; in tour2d_manip()
/dports/audio/praat/praat-6.2.03/dwsys/
H A DNUM2.cpp1855 void NUMgetEllipseBoundingBox (double a, double b, double cospsi, double *out_width, double *out_he… in NUMgetEllipseBoundingBox() argument
1856 Melder_require (cospsi >= -1.0 && cospsi <= 1.0, in NUMgetEllipseBoundingBox()
1857 U"NUMgetEllipseBoundingBox: abs (cospi) should not exceed 1.", cospsi); in NUMgetEllipseBoundingBox()
1859 if (cospsi == 1.0) { // a-axis along x-axis in NUMgetEllipseBoundingBox()
1862 } else if (cospsi == 0.0) { // a-axis along y-axis in NUMgetEllipseBoundingBox()
1866 const double psi = acos (cospsi), sinpsi = sin (psi); in NUMgetEllipseBoundingBox()
1867 double phi = atan2 (-b * sinpsi, a * cospsi); in NUMgetEllipseBoundingBox()
1868 width = fabs (a * cospsi * cos (phi) - b * sinpsi * sin (phi)); in NUMgetEllipseBoundingBox()
1869 phi = atan2 (b * cospsi, a * sinpsi); in NUMgetEllipseBoundingBox()
1870 height = fabs (a * sinpsi * cos (phi) + b * cospsi * sin (phi)); in NUMgetEllipseBoundingBox()
/dports/science/gromacs/gromacs-2021.4/src/gromacs/mdlib/
H A Dsettle_gpu.cu221 float cospsi = tmp2 * rsqrt(tmp2); in __launch_bounds__() local
224 float b2d_x = -pars.rc * cospsi; in __launch_bounds__()
H A Dsettle.cpp552 T cospsi = tmp2 * gmx::invsqrt(tmp2); in settleTemplate() local
556 T b2d_x = -rc * cospsi; in settleTemplate()

12