Searched refs:coeff (Results 101 - 125 of 195) sorted by relevance

12345678

/external/eigen/Eigen/src/Householder/
H A DHouseholder.h74 Scalar c0 = coeff(0);
/external/eigen/Eigen/src/QR/
H A DColPivHouseholderQR.h188 result += (internal::abs(m_qr.coeff(i,i)) > premultiplied_threshold);
441 m_colsPermutation.applyTranspositionOnTheRight(k, m_colsTranspositions.coeff(k));
491 for(Index i = 0; i < nonzero_pivots; ++i) dst.row(dec().colsPermutation().indices().coeff(i)) = c.row(i);
492 for(Index i = nonzero_pivots; i < cols; ++i) dst.row(dec().colsPermutation().indices().coeff(i)).setZero();
H A DColPivHouseholderQR_MKL.h77 m_nonzero_pivots += (internal::abs(m_qr.coeff(i,i)) > premultiplied_threshold);\
/external/eigen/Eigen/src/SparseCore/
H A DSparseDot.h33 res += internal::conj(i.value()) * other.coeff(i.index());
H A DSparseVector.h88 inline Scalar coeff(Index row, Index col) const function in class:Eigen::SparseVector
91 return coeff(IsColVector ? row : col);
93 inline Scalar coeff(Index i) const { return m_data.at(i); } function in class:Eigen::SparseVector
98 return coeff(IsColVector ? row : col);
H A DSparseDiagonalProduct.h112 : Base(expr.rhs()*(expr.lhs().diagonal().coeff(outer)), outer)
146 : Base(expr.lhs()*expr.rhs().diagonal().coeff(outer), outer)
H A DSparseDenseProduct.h116 : Base(prod.lhs(), 0), m_outer(outer), m_factor(prod.rhs().coeff(outer))
162 tmp += it.value() * rhs.coeff(it.index(),c);
183 typename Res::Scalar rhs_j = alpha * rhs.coeff(j,c);
/external/libvpx/libvpx/vp9/encoder/
H A Dvp9_block.h66 DECLARE_ALIGNED(16, int16_t, coeff[64*64]);
/external/flac/libFLAC/
H A Dlpc.c92 unsigned sample, coeff; local
98 for(coeff = 0; coeff < lag; coeff++)
99 autoc[coeff] = 0.0;
102 for(coeff = 0; coeff < lag; coeff++)
103 autoc[coeff] += d * data[sample+coeff];
[all...]
/external/eigen/Eigen/src/Core/
H A DReplicate.h92 inline Scalar coeff(Index row, Index col) const function in class:Eigen::Replicate
102 return m_matrix.coeff(actual_row, actual_col);
H A DSelfCwiseBinaryOp.h94 tmp = m_functor(tmp, _other.coeff(row,col));
103 tmp = m_functor(tmp, _other.coeff(index));
H A DTranspositions.h84 inline const Index& coeff(Index i) const { return indices().coeff(i); } function in class:Eigen::TranspositionsBase
383 if((j=m_transpositions.coeff(k))!=k)
/external/eigen/bench/
H A DbenchEigenSolver.cpp61 acc += ei.eigenvectors().coeff(r,c);
75 acc += ei.eigenvectors().coeff(r,c);
/external/eigen/bench/btl/libs/eigen2/
H A Deigen2_interface.hh81 B_stl[i] = B.coeff(i);
91 A_stl[j][i] = A.coeff(i,j);
/external/eigen/unsupported/Eigen/src/IterativeSolvers/
H A DConstrainedConjGrad.h138 Scalar al = C.row(i).dot(x) - f.coeff(i);
177 lambda = (std::min)(lambda, (f.coeff(i)-C.row(i).dot(x)) / bb);
/external/libvpx/libvpx/vp8/encoder/
H A Dvp8_asm_enc_offsets.c23 DEFINE(vp8_block_coeff, offsetof(BLOCK, coeff));
H A Dencodeintra.c67 x->short_fdct4x4(be->src_diff, be->coeff, 32);
/external/chromium_org/third_party/skia/src/pathops/
H A DSkPathOpsCubic.cpp248 static void formulate_F1DotF2(const double src[], double coeff[4]) { argument
252 coeff[0] = c * c;
253 coeff[1] = 3 * b * c;
254 coeff[2] = 2 * b * b + c * a;
255 coeff[3] = a * b;
/external/eigen/Eigen/src/Cholesky/
H A DLDLT.h261 *sign = real(mat.coeff(0,0))>0 ? 1:-1;
282 *sign = real(mat.diagonal().coeff(index_of_biggest_in_corner)) > 0 ? 1 : -1;
308 mat.coeffRef(index_of_biggest_in_corner,k) = conj(mat.coeff(index_of_biggest_in_corner,k));
362 RealScalar dj = real(mat.coeff(j,j));
363 Scalar wj = w.coeff(j);
/external/eigen/demos/opengl/
H A Dquaternion_demo.cpp168 m_angles.coeffRef(1) = std::asin(m.coeff(0,2));
169 m_angles.coeffRef(0) = std::atan2(-m.coeff(1,2),m.coeff(2,2));
170 m_angles.coeffRef(2) = std::atan2(-m.coeff(0,1),m.coeff(0,0));
/external/eigen/test/
H A Dblock.cpp165 VERIFY(m.coeff(i,j) == data[i*rowStride + j*colStride]);
171 VERIFY(m.coeff(i,j) == data[(MatrixType::Flags&RowMajorBit)
178 VERIFY(innerStride == int((&m.coeff(1))-(&m.coeff(0))));
180 VERIFY(m.coeff(i) == data[i*innerStride]);
H A Dsparse_basic.cpp39 // test coeff and coeffRef
42 VERIFY_IS_MUCH_SMALLER_THAN( m.coeff(zeroCoords[i].x(),zeroCoords[i].y()), eps );
67 // VERIFY_IS_APPROX(m.block(i,j,h,w).col(c).coeff(r), refMat.block(i,j,h,w).col(c).coeff(r));
75 // VERIFY_IS_APPROX(m.block(i,j,h,w).row(r).coeff(c), refMat.block(i,j,h,w).row(r).coeff(c));
105 if (m1.coeff(i,j)==Scalar(0))
124 if ((m1.coeff(i,j)==Scalar(0)) && (internal::random<int>()%2))
148 if (m1.coeff(i,j)==Scalar(0))
/external/skia/src/pathops/
H A DSkPathOpsCubic.cpp248 static void formulate_F1DotF2(const double src[], double coeff[4]) { argument
252 coeff[0] = c * c;
253 coeff[1] = 3 * b * c;
254 coeff[2] = 2 * b * b + c * a;
255 coeff[3] = a * b;
/external/eigen/Eigen/src/Geometry/
H A DHomogeneous.h78 inline Scalar coeff(Index row, Index col) const function in class:Eigen::Homogeneous
83 return m_matrix.coeff(row, col);
163 ColsAtCompileTime==1?1:size()-1) / coeff(size()-1);
/external/eigen/blas/
H A DBandTriangularSolver.h87 -= other.coeff(i,col) * cjLhs.col(i).segment(actual_start,actual_k);

Completed in 405 milliseconds

12345678