HomeSort by relevance Sort by last modified time
    Searched refs:theta (Results 1 - 25 of 132) sorted by null

1 2 3 4 5 6

  /external/qemu/distrib/sdl-1.2.15/Xcode/TemplatesForXcodeLeopard/SDL OpenGL Application/atlantis/
swim.c 48 glRotatef(fish->theta, 1.0, 0.0, 0.0);
57 fish->theta = 0.0;
60 fish->x += WHALESPEED * fish->v * cos(fish->psi / RAD) * cos(fish->theta / RAD);
61 fish->y += WHALESPEED * fish->v * sin(fish->psi / RAD) * cos(fish->theta / RAD);
62 fish->z += WHALESPEED * fish->v * sin(fish->theta / RAD);
79 thetal = fish->theta;
83 if (ttheta > fish->theta + 0.25) {
84 fish->theta += 0.5;
85 } else if (ttheta < fish->theta - 0.25) {
86 fish->theta -= 0.5
    [all...]
atlantis.h 47 float x, y, z, phi, theta, psi, v; member in struct:_fishRec
  /external/qemu/distrib/sdl-1.2.15/Xcode/TemplatesForXcodeSnowLeopard/SDL OpenGL Application/atlantis/
swim.c 48 glRotatef(fish->theta, 1.0, 0.0, 0.0);
57 fish->theta = 0.0;
60 fish->x += WHALESPEED * fish->v * cos(fish->psi / RAD) * cos(fish->theta / RAD);
61 fish->y += WHALESPEED * fish->v * sin(fish->psi / RAD) * cos(fish->theta / RAD);
62 fish->z += WHALESPEED * fish->v * sin(fish->theta / RAD);
79 thetal = fish->theta;
83 if (ttheta > fish->theta + 0.25) {
84 fish->theta += 0.5;
85 } else if (ttheta < fish->theta - 0.25) {
86 fish->theta -= 0.5
    [all...]
atlantis.h 47 float x, y, z, phi, theta, psi, v; member in struct:_fishRec
  /external/qemu/distrib/sdl-1.2.15/Xcode/TemplatesForXcodeTiger/SDL OpenGL Application/atlantis/
swim.c 48 glRotatef(fish->theta, 1.0, 0.0, 0.0);
57 fish->theta = 0.0;
60 fish->x += WHALESPEED * fish->v * cos(fish->psi / RAD) * cos(fish->theta / RAD);
61 fish->y += WHALESPEED * fish->v * sin(fish->psi / RAD) * cos(fish->theta / RAD);
62 fish->z += WHALESPEED * fish->v * sin(fish->theta / RAD);
79 thetal = fish->theta;
83 if (ttheta > fish->theta + 0.25) {
84 fish->theta += 0.5;
85 } else if (ttheta < fish->theta - 0.25) {
86 fish->theta -= 0.5
    [all...]
atlantis.h 47 float x, y, z, phi, theta, psi, v; member in struct:_fishRec
  /external/valgrind/main/none/tests/amd64/
bug132918.c 44 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);
  /ndk/sources/cxx-stl/llvm-libc++/libcxx/test/numerics/complex.number/complex.value.ops/
polar.pass.cpp 14 // polar(const T& rho, const T& theta = 0);
30 test(const T& rho, const T& theta, std::complex<T> x)
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) != NaN && classify(theta) != inf
    [all...]
  /external/eigen/bench/
quat_slerp.cpp 32 // 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) ) / sinTheta
90 Scalar theta; local
114 Scalar theta; local
    [all...]
  /external/freetype/src/base/
fttrigon.c 146 FT_Angle theta )
157 while ( theta < -FT_ANGLE_PI4 )
162 theta += FT_ANGLE_PI2;
165 while ( theta > FT_ANGLE_PI4 )
170 theta -= FT_ANGLE_PI2;
178 if ( theta < 0 )
183 theta += *arctanptr++;
190 theta -= *arctanptr++;
202 FT_Angle theta; local
216 theta = FT_ANGLE_PI2
    [all...]
  /external/chromium_org/third_party/freetype/src/base/
fttrigon.c 187 FT_Angle theta )
198 while ( theta <= -FT_ANGLE_PI2 )
202 theta += FT_ANGLE_PI;
205 while ( theta > FT_ANGLE_PI2 )
209 theta -= FT_ANGLE_PI;
215 if ( theta < 0 )
220 theta += *arctanptr++;
227 theta -= *arctanptr++;
234 if ( theta < 0 )
239 theta += *arctanptr++
258 FT_Fixed theta; local
    [all...]
  /external/ceres-solver/internal/ceres/
rotation_test.cc 210 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/2), sin(theta/2.0), 0, 0 }
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
695 double theta = pow(10.0, i); local
715 double theta = pow(10.0, i); local
751 double theta = pow(10.0, i); local
771 double theta = pow(10.0, i); local
894 double theta = (2.0 * i * 0.0011 - 1.0) * kPi; local
943 double theta = (2.0 * i * 0.0001 - 1.0) * 1e-16; local
    [all...]
  /external/libvpx/libvpx/vp9/common/
vp9_tapify.py 38 theta = angle / 57.2957795;
39 affine = [[math.cos(theta),-math.sin(theta)],
40 [math.sin(theta),math.cos(theta)]]
  /external/jmonkeyengine/engine/src/core/com/jme3/scene/shape/
PQTorus.java 150 float r, x, y, z, theta = 0.0f, beta = 0.0f; local
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 + 0.01f)) * radius)
    [all...]
  /external/ceres-solver/include/ceres/
rotation.h 231 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 - pi)
333 const T theta = atan2(sintheta, costheta); local
402 const T theta = sqrt(theta2); local
599 const T theta = sqrt(theta2); local
    [all...]
  /external/jmonkeyengine/engine/src/core/com/jme3/math/
Ring.java 190 + FastMath.nextRandomFloat() * (outer2 - inner2)), theta = FastMath local
199 result.set(b1).multLocal(r * FastMath.cos(theta)).addLocal(center);
200 result.scaleAdd(r * FastMath.sin(theta), b2, result);
  /external/chromium_org/third_party/mesa/src/src/gallium/state_trackers/vega/
arc.h 44 VGfloat theta; member in struct:arc
  /external/mesa3d/src/gallium/state_trackers/vega/
arc.h 44 VGfloat theta; member in struct:arc
  /packages/apps/Camera2/jni/
tinyplanet.cc 111 float theta = angle+atan2(yf, xf); local
112 if (theta>PI_F) theta-=2*PI_F;
116 // (theta stays the same)
119 float px = (theta / (2 * PI_F)) * input_width;
  /packages/apps/Gallery2/jni/filters/
tinyplanet.cc 110 float theta = angle+atan2(yf, xf); local
111 if (theta>PI_F) theta-=2*PI_F;
115 // (theta stays the same)
118 float px = (theta / (2 * PI_F)) * input_width;
  /external/opencv/cv/src/
cvcamshift.cpp 175 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);
cvhough.cpp 78 rho and theta are discretization steps (in pixels and radians correspondingly).
81 array of (rho, theta) pairs. linesMax is the buffer size (number of pairs).
85 icvHoughLinesStandard( const CvMat* img, float rho, float theta,
114 numangle = cvRound(CV_PI / theta);
123 for( ang = 0, n = 0; n < numangle; ang += theta, n++ )
166 line.angle = n * theta;
192 float rho, float theta, int threshold,
211 int rn, tn; /* number of rho and theta discrete values */
215 float r, t; /* Current rho and theta */
238 CV_ASSERT( linesMax > 0 && rho > 0 && theta > 0 )
    [all...]
  /external/srec/srec/clib/
jacobi.c 128 double theta = 0.5 * h / a[i][j]; local
129 t = 1.0 / (fabs(theta) + sqrt(1.0 + theta * theta));
130 if (theta < 0.0) t = -t;
  /ndk/tests/device/issue42891-boost-1_52/jni/boost/boost/math/special_functions/
math_fwd.hpp 246 spherical_harmonic(unsigned n, int m, T1 theta, T2 phi);
250 spherical_harmonic(unsigned n, int m, T1 theta, T2 phi, const Policy& pol);
254 spherical_harmonic_r(unsigned n, int m, T1 theta, T2 phi);
258 spherical_harmonic_r(unsigned n, int m, T1 theta, T2 phi, const Policy& pol);
262 spherical_harmonic_i(unsigned n, int m, T1 theta, T2 phi);
266 spherical_harmonic_i(unsigned n, int m, T1 theta, T2 phi, const Policy& pol);
741 typename tools::promote_args<T>::type jacobi_elliptic(T k, T theta, T* pcn, T* pdn, const Policy&);
744 typename tools::promote_args<T>::type jacobi_elliptic(T k, T theta, T* pcn = 0, T* pdn = 0);
747 typename tools::promote_args<T, U>::type jacobi_sn(U k, T theta, const Policy& pol);
750 typename tools::promote_args<T, U>::type jacobi_sn(U k, T theta);
    [all...]
  /external/valgrind/main/perf/
ffbench.c 176 double theta, wi, wpi, wpr, wr, wtemp; local
209 theta = isign * 6.28318530717959 / (ifp2 / ip1);
210 wtemp = sin(0.5 * theta);
212 wpi = sin(theta);

Completed in 513 milliseconds

1 2 3 4 5 6