HomeSort by relevance Sort by last modified time
    Searched full:norm (Results 276 - 300 of 1009) sorted by null

<<11121314151617181920>>

  /external/eigen/test/eigen2/
eigen2_geometry_with_eigen2_prefix.cpp 68 VERIFY_IS_APPROX(u0.unitOrthogonal().norm(), Scalar(1));
69 VERIFY_IS_APPROX(v0.unitOrthogonal().norm(), Scalar(1));
87 if((q1.coeffs()-q2.coeffs()).norm() > 10*largeEps)
156 VERIFY_IS_APPROX( (t0 * Vector3(1,0,0)).norm(), v0.x());
157 //VERIFY(!ei_isApprox((t1 * Vector3(1,0,0)).norm(), v0.x()));
  /external/mesa3d/src/gallium/state_trackers/vega/
matrix.h 400 static INLINE void line_normal(float *l, float *norm)
402 norm[0] = l[0];
403 norm[1] = l[1];
405 norm[2] = l[0] + (l[3] - l[1]);
406 norm[3] = l[1] - (l[2] - l[0]);
  /external/mesa3d/src/mesa/tnl/
t_rasterpos.c 378 GLfloat *norm, eyenorm[3]; local
438 norm = eyenorm;
441 norm = objnorm;
447 shade_rastpos( ctx, vObj, norm,
466 compute_texgen(ctx, vObj, eye, norm, u, tc);
  /external/vulkan-validation-layers/libs/glm/gtc/
noise.inl 77 detail::tvec4<T, P> norm = taylorInvSqrt(detail::tvec4<T, P>(dot(g00, g00), dot(g01, g01), dot(g10, g10), dot(g11, g11)));
78 g00 *= norm.x;
79 g01 *= norm.y;
80 g10 *= norm.z;
81 g11 *= norm.w;
399 detail::tvec4<T, P> norm = detail::taylorInvSqrt(detail::tvec4<T, P>(dot(g00, g00), dot(g01, g01), dot(g10, g10), dot(g11, g11)));
400 g00 *= norm.x;
401 g01 *= norm.y;
402 g10 *= norm.z;
403 g11 *= norm.w
    [all...]
  /external/libxml2/
xmlschemastypes.c 2139 xmlChar *norm = NULL; local
5955 xmlSchemaValPtr norm; local
5984 xmlSchemaValPtr norm; local
6012 xmlSchemaValPtr norm; local
    [all...]
  /external/apache-commons-math/src/main/java/org/apache/commons/math/linear/
AbstractRealVector.java 223 double norm = 0; local
227 norm += FastMath.abs(e.getValue());
229 return norm;
234 double norm = 0; local
238 norm = FastMath.max(norm, FastMath.abs(e.getValue()));
240 return norm;
ArrayRealVector.java 786 * L<sub>2</sub> norm, i.e. the square root of the sum of
834 * L<sub>1</sub> norm, i.e. the sum of the absolute values of
882 * L<sub>&infin;</sub> norm, i.e. the max of the absolute values of
900 final double norm = getNorm(); local
901 if (norm == 0) {
904 return mapDivide(norm);
910 final double norm = getNorm(); local
911 if (norm == 0) {
914 mapDivideToSelf(norm);
    [all...]
SingularValueDecompositionImpl.java 319 * @return a vector X that minimizes the two norm of A &times; X - B
335 * @return a vector X that minimizes the two norm of A &times; X - B
352 * @return a matrix X that minimizes the two norm of A &times; X - B
  /external/ceres-solver/internal/ceres/
trust_region_minimizer.cc 194 double x_norm = x.norm();
223 iteration_summary.gradient_norm = (x - projected_gradient_step).norm();
227 "Gradient max norm: %e <= %e",
455 iteration_summary.step_norm = (x - x_plus_delta).norm();
571 x_norm = x.norm();
599 iteration_summary.gradient_norm = (x - projected_gradient_step).norm();
603 "Gradient max norm: %e <= %e",
corrector.h 51 // The constructor takes the squared norm, the value, the first and
iterative_schur_complement_solver_test.cc 101 double diff = (isc_sol - reference_solution).norm();
  /external/eigen/Eigen/src/Eigenvalues/
RealSchur.h 283 Scalar norm = computeNormOfT(); local
285 if(norm!=0)
330 /** \internal Computes and returns vector L1 norm of T */
336 // Scalar norm = m_matT.upper().cwiseAbs().sum()
338 Scalar norm(0);
340 norm += m_matT.col(j).segment(0, (std::min)(size,j+2)).cwiseAbs().sum();
341 return norm;
  /external/eigen/unsupported/Eigen/src/IterativeSolvers/
DGMRES.h 266 //Initial residual vector and intial norm
269 RealScalar beta = r0.norm();
270 RealScalar normRhs = rhs.norm();
294 * \param beta The norm of the residual computed so far
295 * \param normRhs The norm of the right hand side vector
336 coef = tv1.norm();
356 std::cerr << nbIts << " Relative Residual Norm " << m_error << std::endl;
  /external/opencv3/modules/calib3d/src/
p3p.cpp 101 double norm; local
105 norm = sqrt(mu0 * mu0 + mv0 * mv0 + 1);
106 mk0 = 1. / norm; mu0 *= mk0; mv0 *= mk0;
110 norm = sqrt(mu1 * mu1 + mv1 * mv1 + 1);
111 mk1 = 1. / norm; mu1 *= mk1; mv1 *= mk1;
115 norm = sqrt(mu2 * mu2 + mv2 * mv2 + 1);
116 mk2 = 1. / norm; mu2 *= mk2; mv2 *= mk2;
  /external/apache-commons-math/src/main/java/org/apache/commons/math/optimization/general/
LevenbergMarquardtOptimizer.java 35 * to their jacobian column norm. Only the rank of the matrix and some loop bounds
185 * norm of diag*x if nonzero, or else to initialStepBoundFactor itself. In most
230 * If the squared norm of a column vector is smaller or equal to this threshold
266 // evaluate the function at the starting point and calculate its norm
360 // compute the new point and the norm of the evolution direction
375 // evaluate the function at x + p and calculate its norm
424 // successful iteration, update the norm
498 * @param delta upper bound on the euclidean norm of diagR * lmDir
    [all...]
  /external/eigen/Eigen/src/Geometry/
Quaternion.h 111 /** \returns the squared norm of the quaternion's coefficients
112 * \sa QuaternionBase::norm(), MatrixBase::squaredNorm()
116 /** \returns the norm of the quaternion's coefficients
117 * \sa QuaternionBase::squaredNorm(), MatrixBase::norm()
119 inline Scalar norm() const { return coeffs().norm(); } function in class:Eigen::QuaternionBase
567 * do not need to have the same norm.
617 * do not need to have the same norm.
673 return Scalar(2) * atan2( d.vec().norm(), abs(d.w()) );
OrthoMethods.h 143 RealScalar invnm = RealScalar(1)/(Vector2() << src.coeff(sndi),src.coeff(maxi)).finished().norm();
170 RealScalar invnm = RealScalar(1)/src.template head<2>().norm();
181 RealScalar invnm = RealScalar(1)/src.template tail<2>().norm();
  /external/chromium-trace/catapult/tracing/third_party/gl-matrix/src/gl-matrix/
mat2.js 276 * Returns Frobenius norm of a mat2
278 * @param {mat2} a the matrix to calculate Frobenius norm of
279 * @returns {Number} Frobenius norm
mat2d.js 308 * Returns Frobenius norm of a mat2d
310 * @param {mat2d} a the matrix to calculate Frobenius norm of
311 * @returns {Number} Frobenius norm
  /external/eigen/Eigen/src/SPQRSupport/
SuiteSparseQRSupport.h 108 for (int j = 0; j < mat.cols(); j++) max2Norm = (max)(max2Norm, mat.col(j).norm());
218 /// Set the tolerance tol to treat columns with 2-norm < =tol as zero
247 RealScalar m_tolerance; // treat columns with 2-norm below this tolerance as zero
  /external/opencv3/modules/shape/include/opencv2/shape/
shape_distance.hpp 200 /** @brief Set the norm used to compute the Hausdorff value between two shapes. It can be L1 or L2 norm.
202 @param distanceFlag Flag indicating which norm is used to compute the Hausdorff distance
  /frameworks/av/media/libstagefright/codecs/amrwbenc/src/
pitch_f4.c 173 Word32 corr, exp_corr, norm, exp, scale; local
235 norm = extract_h(L_tmp);
239 L_tmp = L_mult(corr, norm);
  /packages/experimental/DreamTheater/src/com/android/dreamtheater/
BouncyDroid.java 72 public Vec norm() { method in class:BouncyDroid.BouncyView.World.Vec
261 springForce = springForce.norm().mul(mag);
290 mBody.v = mBody.v.norm().mul(MAX_SPEED);
  /external/opencv/cvaux/src/
cvlevmarprojbandle.cpp 1350 double norm = cvNorm(vectorX_points4D); local
1355 double norm = cvNorm(vectorX_projMatrs[i]); local
1384 double norm = cvNorm(matrsUk[i]); local
1390 double norm = cvNorm(matrsVi[i]); local
1427 double norm = cvNorm(matrsUk[i]); local
1433 double norm = cvNorm(matrsVi[i]); local
    [all...]
  /external/antlr/antlr-3.4/runtime/CSharp3/Sources/Antlr3.Runtime.Test/
TestFastLexer.cs 61 Console.WriteLine( "Elapsed time (norm): {0} seconds.", time.TotalSeconds );

Completed in 847 milliseconds

<<11121314151617181920>>