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

123

/external/qemu/distrib/sdl-1.2.15/Xcode/TemplatesForXcodeLeopard/SDL OpenGL Application/atlantis/
H A Dswim.c48 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
[all...]
H A Datlantis.h47 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/
H A Dswim.c48 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
[all...]
H A Datlantis.h47 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/
H A Dswim.c48 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
[all...]
H A Datlantis.h47 float x, y, z, phi, theta, psi, v; member in struct:_fishRec
/external/valgrind/main/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/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/chromium_org/third_party/freetype/src/base/
H A Dfttrigon.c146 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
[all...]
/external/freetype/src/base/
H A Dfttrigon.c146 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
[all...]
/external/pdfium/core/src/fxge/fx_freetype/fxft2.5.01/src/base/
H A Dfttrigon.c146 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
[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:__anon28691
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/libvpx/libvpx/vp9/common/
H A Dvp9_tapify.py38 theta = angle / 57.2957795;
39 affine = [[math.cos(theta),-math.sin(theta)],
40 [math.sin(theta),math.cos(theta)]]
/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/chromium_org/third_party/mesa/src/src/gallium/state_trackers/vega/
H A Darc.h44 VGfloat theta; member in struct:arc
/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);
H A Dcvhough.cpp78 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, argument
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 >
191 icvHoughLinesSDiv( const CvMat* img, float rho, float theta, int threshold, int srn, int stn, CvSeq* lines, int linesMax ) argument
483 icvHoughLinesProbabalistic( CvMat* image, float rho, float theta, int threshold, int lineLength, int lineGap, CvSeq *lines, int linesMax ) argument
740 cvHoughLines2( CvArr* src_image, void* lineStorage, int method, double rho, double theta, int threshold, double param1, double param2 ) argument
[all...]
/external/srec/srec/clib/
H A Djacobi.c128 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;
/external/chromium_org/third_party/webrtc/modules/video_coding/main/test/
H A DplotJitterEstimate.m35 title('theta(1)*x+theta(2), (dT-dTS)/dL');
/external/valgrind/main/perf/
H A Dffbench.c176 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 302 milliseconds

123