Searched refs:theta (Results 1 - 25 of 59) sorted by relevance

123

/external/apache-commons-math/src/main/java/org/apache/commons/math/ode/nonstiff/
H A DHighamHall54StepInterpolator.java72 protected void computeInterpolatedStateAndDerivatives(final double theta, argument
76 final double theta2 = theta * theta;
78 final double b0 = h * (-1.0/12.0 + theta * (1.0 + theta * (-15.0/4.0 + theta * (16.0/3.0 + theta * -5.0/2.0))));
79 final double b2 = h * (-27.0/32.0 + theta2 * (459.0/32.0 + theta * (-243.0/8.0 + theta * 135.0/8.0)));
80 final double b3 = h * (4.0/3.0 + theta2 * (-22.0 + theta * (152.
[all...]
H A DThreeEighthesStepInterpolator.java32 * y(t_n + theta h) = y (t_n + h)
33 * - (1 - theta) (h/8) [ (1 - 7 theta + 8 theta^2) y'_1
34 * + 3 (1 + theta - 4 theta^2) y'_2
35 * + 3 (1 + theta) y'_3
36 * + (1 + theta + 4 theta^2) y'_4
40 * where theta belong
87 computeInterpolatedStateAndDerivatives(final double theta, final double oneMinusThetaH) argument
[all...]
H A DClassicalRungeKuttaStepInterpolator.java32 * y(t_n + theta h) = y (t_n + h)
33 * + (1 - theta) (h/6) [ (-4 theta^2 + 5 theta - 1) y'_1
34 * +(4 theta^2 - 2 theta - 2) (y'_2 + y'_3)
35 * -(4 theta^2 + theta + 1) y'_4
39 * where theta belongs to [0 ; 1] and where y'_1 to y'_4 are the four
84 protected void computeInterpolatedStateAndDerivatives(final double theta, argument
[all...]
H A DMidpointStepInterpolator.java32 * y(t_n + theta h) = y (t_n + h) + (1-theta) h [theta y'_1 - (1+theta) y'_2]
35 * where theta belongs to [0 ; 1] and where y'_1 and y'_2 are the two
82 protected void computeInterpolatedStateAndDerivatives(final double theta, argument
86 final double coeff1 = oneMinusThetaH * theta;
87 final double coeff2 = oneMinusThetaH * (1.0 + theta);
88 final double coeffDot2 = 2 * theta;
H A DGillStepInterpolator.java33 * y(t_n + theta h) = y (t_n + h)
34 * - (1 - theta) (h/6) [ (1 - theta) (1 - 4 theta) y'_1
35 * + (1 - theta) (1 + 2 theta) ((2-q) y'_2 + (2+q) y'_3)
36 * + (1 + theta + 4 theta^2) y'_4
39 * where theta belongs to [0 ; 1], q = sqrt(2) and where y'_1 to y'_4
92 protected void computeInterpolatedStateAndDerivatives(final double theta, argument
[all...]
H A DDormandPrince853StepInterpolator.java313 protected void computeInterpolatedStateAndDerivatives(final double theta, argument
360 final double eta = 1 - theta;
361 final double twoTheta = 2 * theta;
362 final double theta2 = theta * theta;
364 final double dot2 = theta * (2 - 3 * theta);
365 final double dot3 = twoTheta * (1 + theta * (twoTheta -3));
366 final double dot4 = theta2 * (3 + theta * (5 * theta
[all...]
H A DDormandPrince54StepInterpolator.java167 protected void computeInterpolatedStateAndDerivatives(final double theta, argument
201 final double eta = 1 - theta;
202 final double twoTheta = 2 * theta;
204 final double dot3 = theta * (2 - 3 * theta);
205 final double dot4 = twoTheta * (1 + theta * (twoTheta - 3));
208 currentState[i] - oneMinusThetaH * (v1[i] - theta * (v2[i] + theta * (v3[i] + eta * v4[i])));
H A DGraggBulirschStoerStepInterpolator.java311 protected void computeInterpolatedStateAndDerivatives(final double theta, argument
316 final double oneMinusTheta = 1.0 - theta;
317 final double theta05 = theta - 0.5;
318 final double tOmT = theta * oneMinusTheta;
320 final double t4Dot = 2 * tOmT * (1 - 2 * theta);
322 final double dot2 = theta * (2 - 3 * theta) / h;
323 final double dot3 = ((3 * theta - 4) * theta + 1) / h;
331 interpolatedState[i] = p0 + theta * (p
[all...]
H A DEulerStepInterpolator.java31 * y(t_n + theta h) = y (t_n + h) - (1-theta) h y'
34 * where theta belongs to [0 ; 1] and where y' is the evaluation of
80 protected void computeInterpolatedStateAndDerivatives(final double theta, argument
/external/apache-commons-math/src/main/java/org/apache/commons/math/complex/
H A DComplexUtils.java42 * The value returned is <code>r&middot;e<sup>i&middot;theta</sup></code>,
43 * computed as <code>r&middot;cos(theta) + r&middot;sin(theta)i</code></p>
45 * If either <code>r</code> or <code>theta</code> is NaN, or
46 * <code>theta</code> is infinite, {@link Complex#NaN} is returned.</p>
48 * If <code>r</code> is infinite and <code>theta</code> is finite,
59 * @param theta the argument of the complex number to create
60 * @return <code>r&middot;e<sup>i&middot;theta</sup></code>
64 public static Complex polar2Complex(double r, double theta) { argument
69 return new Complex(r * FastMath.cos(theta),
[all...]
/external/valgrind/none/tests/amd64/
H A Dbug132918.c44 double theta; local
50 theta = (2.0 * 3.14159) / 10.0 * (double)i;
51 do_fprem(&r, 12.3*sin(theta), cos(theta)); show("xx", &r);
/external/fio/lib/
H A Dzipf.h9 double theta; member in struct:zipf_state
17 void zipf_init(struct zipf_state *zs, unsigned long nranges, double theta, unsigned int seed);
H A Dzipf.c29 zs->zetan += pow(1.0 / (double) (i + 1), zs->theta);
42 void zipf_init(struct zipf_state *zs, unsigned long nranges, double theta, argument
47 zs->theta = theta;
48 zs->zeta2 = pow(1.0, zs->theta) + pow(0.5, zs->theta);
59 alpha = 1.0 / (1.0 - zs->theta);
60 eta = (1.0 - pow(2.0 / n, 1.0 - zs->theta)) / (1.0 - zs->zeta2 / zs->zetan);
67 else if (rand_z < (1.0 + pow(0.5, zs->theta)))
/external/libcxx/test/std/numerics/complex.number/complex.value.ops/
H A Dpolar.pass.cpp14 // polar(const T& rho, const T& theta = 0);
30 test(const T& rho, const T& theta, std::complex<T> x) argument
32 assert(std::polar(rho, theta) == x);
53 double theta = imag(x[i]); local
54 std::complex<double> z = std::polar(r, theta);
58 if (std::signbit(r) || classify(theta) == inf || classify(theta) == NaN)
69 if (std::signbit(r) || classify(theta) == inf || classify(theta) == NaN)
88 if (classify(theta) !
[all...]
/external/eigen/bench/
H A Dquat_slerp.cpp32 // theta is the angle between the 2 quaternions
33 Scalar theta = std::acos(absD);
34 Scalar sinTheta = internal::sin(theta);
36 Scalar scale0 = internal::sin( ( Scalar(1) - t ) * theta) / sinTheta;
37 Scalar scale1 = internal::sin( ( t * theta) ) / sinTheta;
62 // theta is the angle between the 2 quaternions
63 Scalar theta = std::acos(absD); local
64 Scalar sinTheta = internal::sin(theta);
66 scale0 = internal::sin( ( Scalar(1) - t ) * theta) / sinTheta;
67 scale1 = internal::sin( ( t * theta) ) / sinThet
90 Scalar theta; local
114 Scalar theta; local
[all...]
/external/freetype/src/base/
H A Dfttrigon.c164 FT_Angle theta )
175 while ( theta < -FT_ANGLE_PI4 )
180 theta += FT_ANGLE_PI2;
183 while ( theta > FT_ANGLE_PI4 )
188 theta -= FT_ANGLE_PI2;
196 if ( theta < 0 )
201 theta += *arctanptr++;
208 theta -= *arctanptr++;
220 FT_Angle theta; local
234 theta
[all...]
/external/pdfium/third_party/freetype/src/base/
H A Dfttrigon.c164 FT_Angle theta )
175 while ( theta < -FT_ANGLE_PI4 )
180 theta += FT_ANGLE_PI2;
183 while ( theta > FT_ANGLE_PI4 )
188 theta -= FT_ANGLE_PI2;
196 if ( theta < 0 )
201 theta += *arctanptr++;
208 theta -= *arctanptr++;
220 FT_Angle theta; local
234 theta
[all...]
/external/pdfium/core/src/fxcodec/lcms2/lcms2-2.6/src/
H A Dcmssm.c37 // theta = L*
39 #define SECTORS 16 // number of divisions in alpha and theta
46 cmsFloat64Number theta; member in struct:__anon13254
61 cmsSpherical p; // Keep also alpha & theta of maximum
131 sp ->alpha = sp ->theta = 0;
136 sp ->theta = _cmsAtan2(sqrt(a*a + b*b), L);
152 sin_theta = sin((M_PI * sp ->theta) / 180.0);
153 cos_theta = cos((M_PI * sp ->theta) / 180.0);
168 void QuantizeToSector(const cmsSpherical* sp, int* alpha, int* theta) argument
171 *theta
325 int alpha, theta; local
439 FindNearSectors(cmsGDB* gbd, int alpha, int theta, cmsGDBPoint* Close[]) argument
473 InterpolateMissingSector(cmsGDB* gbd, int alpha, int theta) argument
551 int alpha, theta; local
[all...]
/external/ceres-solver/internal/ceres/
H A Drotation_test.cc210 double theta = 1.0e-2; local
211 double axis_angle[3] = { theta, 0, 0 };
213 double expected[4] = { cos(theta/2), sin(theta/2.0), 0, 0 };
222 double theta = pow(numeric_limits<double>::min(), 0.75); local
223 double axis_angle[3] = { theta, 0, 0 };
225 double expected[4] = { cos(theta/2), sin(theta/2.0), 0, 0 };
272 double theta = 1.0e-2; local
273 double quaternion[4] = { cos(theta/
283 double theta = pow(numeric_limits<double>::min(), 0.75); local
326 double theta = kPi * 2 * RandDouble() - kPi; local
436 double theta = kPi - kMaxSmallAngle * RandDouble(); local
534 double theta = kPi * 2 * RandDouble() - kPi; local
567 double theta = 1e-16 * (kPi * 2 * RandDouble() - kPi); local
730 double theta = pow(10.0, i); local
750 double theta = pow(10.0, i); local
786 double theta = pow(10.0, i); local
806 double theta = pow(10.0, i); local
929 double theta = (2.0 * i * 0.0011 - 1.0) * kPi; local
978 double theta = (2.0 * i * 0.0001 - 1.0) * 1e-16; local
[all...]
/external/jmonkeyengine/engine/src/core/com/jme3/scene/shape/
H A DPQTorus.java150 float r, x, y, z, theta = 0.0f, beta = 0.0f;
155 theta += thetaStep;
159 r = (0.5f * (2.0f + FastMath.sin(q * theta)) * radius);
160 x = (r * FastMath.cos(p * theta) * radius);
161 y = (r * FastMath.sin(p * theta) * radius);
162 z = (r * FastMath.cos(q * theta) * radius);
166 r = (0.5f * (2.0f + FastMath.sin(q * (theta + 0.01f))) * radius);
167 x = (r * FastMath.cos(p * (theta + 0.01f)) * radius);
168 y = (r * FastMath.sin(p * (theta + 0.01f)) * radius);
169 z = (r * FastMath.cos(q * (theta
[all...]
/external/jmonkeyengine/engine/src/core/com/jme3/math/
H A DRing.java190 + FastMath.nextRandomFloat() * (outer2 - inner2)), theta = FastMath
199 result.set(b1).multLocal(r * FastMath.cos(theta)).addLocal(center);
200 result.scaleAdd(r * FastMath.sin(theta), b2, result);
/external/ceres-solver/include/ceres/
H A Drotation.h231 const T theta = sqrt(theta_squared); local
232 const T half_theta = theta * T(0.5);
233 const T k = sin(half_theta) / theta;
264 // If cos_theta is negative, theta is greater than pi/2, which
265 // means that angle for the angle_axis vector which is 2 * theta
271 // In that case we observe that 2 * theta ~ 2 * theta - 2 * pi,
274 // theta - pi = atan(sin(theta - pi), cos(theta
333 const T theta = atan2(sintheta, costheta); local
402 const T theta = sqrt(theta2); local
595 const T theta = sqrt(theta2); local
[all...]
/external/mesa3d/src/gallium/state_trackers/vega/
H A Darc.h44 VGfloat theta; member in struct:arc
/external/opencv/cv/src/
H A Dcvcamshift.cpp175 double theta = 0, square; local
235 theta = atan2( 2 * b, a - c + square );
238 cs = cos( theta );
239 sn = sin( theta );
253 theta = CV_PI*0.5 - theta;
292 box->angle = (float)(theta*180./CV_PI);
/external/apache-commons-math/src/main/java/org/apache/commons/math/ode/sampling/
H A DAbstractStepInterpolator.java327 * @param theta normalized interpolation abscissa within the step
328 * (theta is zero at the previous time step and one at the current time step)
334 protected abstract void computeInterpolatedStateAndDerivatives(double theta, argument
344 final double theta = (h == 0) ? 0 : (h - oneMinusThetaH) / h;
345 computeInterpolatedStateAndDerivatives(theta, oneMinusThetaH);
359 final double theta = (h == 0) ? 0 : (h - oneMinusThetaH) / h;
360 computeInterpolatedStateAndDerivatives(theta, oneMinusThetaH);

Completed in 542 milliseconds

123