HomeSort by relevance Sort by last modified time
    Searched full:diagonal (Results 26 - 50 of 657) sorted by null

12 3 4 5 6 7 8 91011>>

  /external/libopus/silk/float/
solve_LS_FLP.c 36 * LDL Factorisation. Finds the upper triangular matrix L and the diagonal
37 * Matrix D (only the diagonal elements returned in a vector)such that
44 silk_float *Dinv /* I/O Pointer to vector holding the inverse diagonal elements of D */
49 * triangular matrix, with ones on the diagonal.
60 * triangular, with ones on the diagonal. (ie then A^T is upper triangular)
83 silk_float Dinv[ MAX_MATRIX_SIZE ]; /* inverse diagonal elements of D*/
89 where L is lower triangular with ones on diagonal
101 diagonal just multiply with 1/d_i
160 silk_float *Dinv /* I/O Pointer to vector holding the inverse diagonal elements of D */
  /cts/tests/tests/graphics/src/android/graphics/drawable/shapes/cts/
PathShapeTest.java 78 // scale down to half size; diagonal is now 50px
84 int diagonal = 0; local
93 diagonal += 1;
98 assertEquals(25, diagonal, TOLERANCE);
  /device/google/contexthub/firmware/os/algos/calibration/common/
calibration_data.h 20 * bias, and a lower-diagonal scaling and skew matrix, scale_skew_mat.
40 // diagonal scale_skew_mat:
sphere_fit_calibration.h 27 * M is a 3x3 lower diagonal scaling matrix
34 * M and b. M is assumed to be a lower diagonal, consisting of 6 parameters.
53 // sphere fit calibration computes a lower-diagonal scaling matrix (M) and
  /external/eigen/Eigen/src/SparseCore/
SparseAssign.h 192 Index size = src.diagonal().size();
197 Map<ArrayXS>(dst.valuePtr(), size) = src.diagonal();
203 dst.diagonal() = src.diagonal();
207 { dst.diagonal() += src.diagonal(); }
210 { dst.diagonal() -= src.diagonal(); }
  /external/eigen/test/
eigensolver_selfadjoint.cpp 149 VERIFY_IS_APPROX(tridiag.diagonal(), tridiag.matrixT().diagonal());
150 VERIFY_IS_APPROX(tridiag.subDiagonal(), tridiag.matrixT().template diagonal<-1>());
156 VERIFY_IS_APPROX(tridiag.diagonal(), T.diagonal());
157 VERIFY_IS_APPROX(tridiag.subDiagonal(), T.template diagonal<1>());
165 eiSymmTridiag.computeFromTridiagonal(tridiag.matrixT().diagonal(), tridiag.matrixT().diagonal(-1), ComputeEigenvectors);
selfadjoint.cpp 28 m1.diagonal() = m1.diagonal().real().template cast<Scalar>();
triangular.cpp 102 // check solve with unit diagonal
130 VERIFY_IS_APPROX(m1.template selfadjointView<Upper>().diagonal(), m1.diagonal());
194 VERIFY(m2.diagonal().isMuchSmallerThan(RealScalar(1)));
197 m2.diagonal().array() -= Scalar(1);
198 VERIFY(m2.diagonal().isMuchSmallerThan(RealScalar(1)));
204 VERIFY(m2.diagonal().isMuchSmallerThan(RealScalar(1)));
207 m2.diagonal().array() -= Scalar(1);
208 VERIFY(m2.diagonal().isMuchSmallerThan(RealScalar(1)));
cuda_basic.cu 115 struct diagonal {
122 res += x1.diagonal();
167 CALL_SUBTEST( run_and_compare_to_cuda(diagonal<Matrix3f,Vector3f>(), nthreads, in, out) );
168 CALL_SUBTEST( run_and_compare_to_cuda(diagonal<Matrix4f,Vector4f>(), nthreads, in, out) );
nesting_ops.cpp 42 VERIFY_IS_APPROX( (m.transpose() * m).diagonal().sum(), (m.transpose() * m).diagonal().sum() );
43 VERIFY_IS_APPROX( (m.transpose() * m).diagonal().array().abs().sum(), (m.transpose() * m).diagonal().array().abs().sum() );
  /external/libopus/silk/fixed/
solve_LS_FIX.c 50 inv_D_t *inv_D /* I/O Pointer to vector holding inverted diagonal elements of D */
53 /* Solve Lx = b, when L is lower triangular and has ones on the diagonal */
61 /* Solve L^t*x = b, where L is lower triangular with ones on the diagonal */
93 where L is lower triangular with ones on diagonal
105 diagonal just multiply with 1/d_i
120 inv_D_t *inv_D /* I/O Pointer to vector holding inverted diagonal elements of D */
207 /* Solve Lx = b, when L is lower triangular and has ones on the diagonal */
229 /* Solve L^t*x = b, where L is lower triangular with ones on the diagonal */
  /packages/apps/LegacyCamera/jni/feature_stab/db_vlvm/
db_bundle.h 35 using only upper half of JtJ, destroying lower half below diagonal in the process
52 using only upper half of JtJ, destroying lower half below diagonal in the process
  /external/apache-commons-math/src/main/java/org/apache/commons/math/linear/
SingularValueDecomposition.java 29 * p &times; p diagonal matrix with positive or null elements, V is a p &times;
72 * Returns the diagonal matrix &Sigma; of the decomposition.
73 * <p>&Sigma; is a diagonal matrix. The singular values are provided in
80 * Returns the diagonal elements of the matrix &Sigma; of the decomposition.
83 * @return the diagonal elements of the &Sigma; matrix
106 * where J is the diagonal matrix of the inverse of the squares of
TriDiagonalTransformer.java 31 * diagonal is not accessed at all.</p>
45 /** Main diagonal. */
48 /** Secondary diagonal. */
174 * @return the main diagonal elements of the B matrix
181 * Get the main diagonal elements of the matrix T of the transform.
184 * @return the main diagonal elements of the T matrix
191 * Get the secondary diagonal elements of the matrix T of the transform.
194 * @return the secondary diagonal elements of the T matrix
  /external/eigen/Eigen/src/SVD/
UpperBidiagonalization.h 40 const typename internal::remove_all<typename Diagonal<const MatrixType,0>::ConjugateReturnType>::type
44 Diagonal<const MatrixType,1>,
73 return HouseholderUSequenceType(m_householder, m_householder.diagonal().conjugate());
79 return HouseholderVSequenceType(m_householder.conjugate(), m_householder.const_derived().template diagonal<1>())
94 typename MatrixType::RealScalar *diagonal,
118 .makeHouseholderInPlace(mat.coeffRef(k,k), diagonal[k]);
153 typename MatrixType::RealScalar *diagonal,
190 v_k.makeHouseholderInPlace(tau_v, diagonal[k]);
324 // where A11 is a bs x bs diagonal block,
339 &(bidiagonal.template diagonal<0>().coeffRef(k))
    [all...]
  /device/google/contexthub/firmware/os/algos/common/math/
mat.h 63 // Updates A with the value x on the main diagonal and 0 on the off diagonals,
136 // where L is a lower-diagonal matrix, U is an upper-diagonal matrix, and P is a
140 // -) the superdiagonal elements make up "U" (with a diagonal of 1.0s),
141 // -) the subdiagonal and diagonal elements make up "L".
179 // Returns the maximum diagonal element of the given matrix.
183 // Adds a constant value to the diagonal of the given square n x n matrix and
208 // Solves the linear system L L^T x = b for x, where L is a lower diagonal,
210 // L is a lower-diagonal matrix of dimension n x n.
218 // A = L L^T, where L, the Cholesky factor, is a lower diagonal matrix
    [all...]
  /external/eigen/Eigen/src/Core/
MatrixBase.h 98 /** \returns the size of the main diagonal, which is min(rows(),cols()).
194 operator*(const DiagonalBase<DiagonalDerived> &diagonal) const;
214 typedef Diagonal<Derived> DiagonalReturnType;
216 DiagonalReturnType diagonal();
218 typedef typename internal::add_const<Diagonal<const Derived> >::type ConstDiagonalReturnType;
220 ConstDiagonalReturnType diagonal() const;
222 template<int Index> struct DiagonalIndexReturnType { typedef Diagonal<Derived,Index> Type; };
223 template<int Index> struct ConstDiagonalIndexReturnType { typedef const Diagonal<const Derived,Index> Type; };
227 typename DiagonalIndexReturnType<Index>::Type diagonal();
231 typename ConstDiagonalIndexReturnType<Index>::Type diagonal() const
    [all...]
  /external/apache-commons-math/src/main/java/org/apache/commons/math/random/
CorrelatedRandomVectorGenerator.java 86 * @param small diagonal elements threshold under which column are
119 * @param small diagonal elements threshold under which column are
176 * <li>columns with the too small diagonal element are discarded</li>
183 * @param small diagonal elements threshold under which column are
204 // find maximal diagonal element
222 // check diagonal element
230 // check remaining diagonal elements
233 // there is at least one sufficiently negative diagonal element,
239 // all remaining diagonal elements are close to zero,
  /external/eigen/Eigen/src/SparseLU/
SparseLU_pivotL.h 51 * \param diagpivotthresh diagonal pivoting threshold
53 * \param[in] iperm_c column permutation - used to finf diagonal of Pc*A*Pc'
73 Index diagind = iperm_c(jcol); // diagonal index
102 // Test if the diagonal element can be used as a pivot (given the threshold value)
105 // Diagonal element exists
  /cts/tests/tests/dpi/src/android/dpi/cts/
ConfigurationTest.java 48 // Watches have a different minimum diagonal.
51 assertTrue("Screen diagonal must be at least " + minSize + " inches: " + diagonalInches,
  /device/linaro/bootloader/edk2/AppPkg/Applications/Python/Python-2.7.2/Demo/scripts/
queens.py 24 self.up = [0] * (2*n-1) # Is upward diagonal[x-y] safe?
25 self.down = [0] * (2*n-1) # Is downward diagonal[x+y] safe?
  /external/apache-commons-math/src/main/java/org/apache/commons/math/optimization/general/
Preconditioner.java 35 * is to compute only the diagonal elements of the hessian and to divide
39 * rationale for this simplified choice is that a negative diagonal element
  /external/python/cpython2/Demo/scripts/
queens.py 24 self.up = [0] * (2*n-1) # Is upward diagonal[x-y] safe?
25 self.down = [0] * (2*n-1) # Is downward diagonal[x+y] safe?
  /external/jdiff/src/jdiff/
DiffMyers.java 73 private int[] fdiag; /* Vector, indexed by diagonal, containing
75 along the given diagonal in the forward
77 private int[] bdiag; /* Vector, indexed by diagonal, containing
79 along the given diagonal in the backward
93 The value returned is the number of the diagonal on which the midpoint lies.
94 The diagonal number equals the number of inserted lines minus the number
104 Note that if we return the "wrong" diagonal value, or if
105 the value of bdiag at that diagonal is "wrong",
115 final int dmin = xoff - ylim; // Minimum valid diagonal.
116 final int dmax = xlim - yoff; // Maximum valid diagonal
    [all...]
  /device/google/atv/sdk/
devices.xml 13 <d:diagonal-length>55.0</d:diagonal-length>
84 <d:diagonal-length>55.0</d:diagonal-length>

Completed in 684 milliseconds

12 3 4 5 6 7 8 91011>>