Searched refs:theta (Results 26 - 50 of 59) sorted by relevance

123

/external/opencv/cv/src/
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...]
H A Dcvcalibration.cpp531 double rx, ry, rz, theta; local
552 theta = sqrt(rx*rx + ry*ry + rz*rz);
554 if( theta < DBL_EPSILON )
569 double c = cos(theta);
570 double s = sin(theta);
572 double itheta = theta ? 1./theta : 0.;
581 // R = cos(theta)*I + (1 - cos(theta))*r*rT + sin(theta)*[r_
615 double theta, s, c; local
[all...]
/external/apache-commons-math/src/main/java/org/apache/commons/math/ode/sampling/
H A DDummyStepInterpolator.java95 * @param theta normalized interpolation abscissa within the step
96 * (theta is zero at the previous time step and one at the current time step)
101 protected void computeInterpolatedStateAndDerivatives(final double theta, final double oneMinusThetaH) { argument
H A DNordsieckStepInterpolator.java187 protected void computeInterpolatedStateAndDerivatives(final double theta, final double oneMinusThetaH) { argument
/external/valgrind/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);
/external/freetype/src/base/
H A Dftstroke.c103 FT_Angle theta; local
142 theta = ft_pos_abs( FT_Angle_Diff( *angle_in, *angle_out ) );
144 return FT_BOOL( theta < FT_SMALL_CONIC_THRESHOLD );
531 FT_Angle total, angle, step, rotate, next, theta; local
556 theta = step;
557 if ( theta < 0 )
558 theta = -theta;
560 theta >>= 1;
568 length = FT_MulDiv( radius, FT_Sin( theta ) *
989 FT_Angle phi, theta, rotate; local
1064 FT_Angle theta = 0, phi = 0; local
1448 FT_Angle theta, phi, rotate, alpha0 = 0; local
[all...]
/external/eigen/bench/
H A Deig33.cpp77 Scalar theta = std::atan2(internal::sqrt(-q),half_b)*s_inv3; local
78 Scalar cos_theta = internal::cos(theta);
79 Scalar sin_theta = internal::sin(theta);
/external/jmonkeyengine/engine/src/core/com/jme3/scene/shape/
H A DTorus.java138 float theta = FastMath.TWO_PI * circleFraction;
139 float cosTheta = FastMath.cos(theta);
140 float sinTheta = FastMath.sin(theta);
/external/pdfium/third_party/freetype/src/base/
H A Dftstroke.c103 FT_Angle theta; local
142 theta = ft_pos_abs( FT_Angle_Diff( *angle_in, *angle_out ) );
144 return FT_BOOL( theta < FT_SMALL_CONIC_THRESHOLD );
531 FT_Angle total, angle, step, rotate, next, theta; local
556 theta = step;
557 if ( theta < 0 )
558 theta = -theta;
560 theta >>= 1;
568 length = FT_MulDiv( radius, FT_Sin( theta ) *
989 FT_Angle phi, theta, rotate; local
1062 FT_Angle theta = 0, phi = 0; local
1449 FT_Angle theta, phi, rotate, alpha0 = 0; local
[all...]
/external/ceres-solver/internal/ceres/
H A Dtrust_region_minimizer_test.cc380 double theta = i * 2. * pi/ static_cast< double >(N); local
382 y[i][0] = cos(theta);
383 y[i][1] = sin(theta);
/external/fonttools/Lib/fontTools/misc/
H A DbezierTools.py308 theta = acos(R/sqrt(Q*Q*Q))
310 x0 = rQ2*cos(theta/3.0) - a1/3.0
311 x1 = rQ2*cos((theta+2.0*pi)/3.0) - a1/3.0
312 x2 = rQ2*cos((theta+4.0*pi)/3.0) - a1/3.0
/external/fonttools/Tools/fontTools/misc/
H A DbezierTools.py308 theta = acos(R/sqrt(Q*Q*Q))
310 x0 = rQ2*cos(theta/3.0) - a1/3.0
311 x1 = rQ2*cos((theta+2.0*pi)/3.0) - a1/3.0
312 x2 = rQ2*cos((theta+4.0*pi)/3.0) - a1/3.0
/external/libopus/celt/
H A Dvq.c70 opus_val16 gain, theta; local
79 theta = HALF16(MULT16_16_Q15(gain,gain));
81 c = celt_cos_norm(EXTEND32(theta));
82 s = celt_cos_norm(EXTEND32(SUB16(Q15ONE,theta))); /* sin(theta) */
/external/eigen/demos/opengl/
H A Dcamera.cpp217 float theta = mFovY*0.5; local
219 float invtan = 1./tan(theta);
/external/jmonkeyengine/engine/src/core/com/jme3/math/
H A DQuaternion.java656 float theta = FastMath.acos(result);
657 float invSinTheta = 1f / FastMath.sin(theta);
661 scale0 = FastMath.sin((1 - t) * theta) * invSinTheta;
662 scale1 = FastMath.sin((t * theta)) * invSinTheta;
713 float theta = FastMath.acos(result);
714 float invSinTheta = 1f / FastMath.sin(theta);
718 scale0 = FastMath.sin((1 - changeAmnt) * theta) * invSinTheta;
719 scale1 = FastMath.sin((changeAmnt * theta)) * invSinTheta;
/external/mesa3d/src/gallium/state_trackers/vega/
H A Darc.c171 rot = DEGREES_TO_RADIANS(arc->theta);
239 matrix_rotate(&matrix, -arc->theta);
364 arc->theta = rot;
365 arc->cos_theta = cos(arc->theta);
366 arc->sin_theta = sin(arc->theta);
405 arc->theta = DEGREES_TO_RADIANS(rot);
406 arc->cos_theta = cos(arc->theta);
407 arc->sin_theta = sin(arc->theta);
/external/clang/test/CodeGenCXX/
H A Dmangle-ms.cpp171 void theta(theta_arg^ block) {}
172 // CHECK-DAG: @"\01?theta@@YAXP_EAHHH@Z@Z"
/external/eigen/Eigen/src/Eigen2Support/Geometry/
H A DQuaternion.h432 // theta is the angle between the 2 quaternions
433 Scalar theta = std::acos(absD); local
434 Scalar sinTheta = ei_sin(theta);
436 scale0 = ei_sin( ( Scalar(1) - t ) * theta) / sinTheta;
437 scale1 = ei_sin( ( t * theta) ) / sinTheta;
/external/proguard/src/proguard/gui/splash/
H A DOverrideGraphics2D.java524 public void rotate(double theta) argument
526 graphics.rotate(theta);
529 public void rotate(double theta, double x, double y) argument
531 graphics.rotate(theta, x, y);
/external/ceres-solver/examples/
H A Dmore_garbow_hillstrom.cc180 const T theta = T(0.5 / M_PI) * atan(x2 / x1) + (x1 > 0.0 ? T(0.0) : T(0.5)); member in namespace:ceres::examples
182 residual[0] = T(10.0) * (x3 - T(10.0) * theta);
/external/speex/libspeex/
H A Dpreprocess.c837 spx_word32_t theta; local
851 theta = MULT16_32_P15(prior_ratio, QCONST32(1.f,EXPIN_SHIFT)+SHL32(EXTEND32(st->post[i]),EXPIN_SHIFT-SNR_SHIFT));
853 MM = hypergeom_gain(theta);
862 theta = MIN32(theta, EXTEND32(32767));
863 /*Q8*/tmp = MULT16_16_Q15((SHL32(1,SNR_SHIFT)+st->prior[i]),EXTRACT16(MIN32(Q15ONE,SHR32(spx_exp(-EXTRACT16(theta)),1))));
868 st->gain2[i]=1/(1.f + (q/(1.f-q))*(1+st->prior[i])*exp(-theta));
884 spx_word32_t theta; local
892 theta = MULT16_32_P15(prior_ratio, QCONST32(1.f,EXPIN_SHIFT)+SHL32(EXTEND32(st->post[i]),EXPIN_SHIFT-SNR_SHIFT));
895 MM = hypergeom_gain(theta);
[all...]
/external/eigen/Eigen/src/Eigenvalues/
H A DSelfAdjointEigenSolver.h525 Scalar theta = atan2(sqrt(-q),half_b)*s_inv3; local
526 Scalar cos_theta = cos(theta);
527 Scalar sin_theta = sin(theta);
/external/opencv/cv/include/
H A Dcvcompat.h504 double theta, int threshold,
509 rho, theta, threshold, 0, 0 );
516 double theta, int threshold,
522 rho, theta, threshold, lineLength, lineGap );
529 double theta, int stn, int threshold,
534 rho, theta, threshold, srn, stn );
503 cvHoughLines( CvArr* image, double rho, double theta, int threshold, float* lines, int linesNumber ) argument
515 cvHoughLinesP( CvArr* image, double rho, double theta, int threshold, int lineLength, int lineGap, int* lines, int linesNumber ) argument
528 cvHoughLinesSDiv( CvArr* image, double rho, int srn, double theta, int stn, int threshold, float* lines, int linesNumber ) argument
/external/eigen/test/
H A Dgeo_quaternion.cpp38 Scalar theta = AA(q*q0.inverse()).angle(); local
41 else VERIFY(abs(theta - t * theta_tot) < largeEps);
/external/eigen/Eigen/src/Geometry/
H A DQuaternion.h708 // theta is the angle between the 2 quaternions
709 Scalar theta = acos(absD); local
710 Scalar sinTheta = sin(theta);
712 scale0 = sin( ( Scalar(1) - t ) * theta) / sinTheta;
713 scale1 = sin( ( t * theta) ) / sinTheta;

Completed in 5144 milliseconds

123