Searched refs:coeffRef (Results 1 - 25 of 124) sorted by relevance

12345

/external/eigen/failtest/
H A Dblock_on_const_type_actually_const_0.cpp13 Block<CV_QUALIFIER Matrix3f>(m, 0, 0, 3, 3).coeffRef(0, 0) = 1.0f;
H A Dblock_on_const_type_actually_const_1.cpp13 Block<CV_QUALIFIER MatrixXf, 3, 3>(m, 0, 0).coeffRef(0, 0) = 1.0f;
H A Ddiagonal_on_const_type_actually_const.cpp13 Diagonal<CV_QUALIFIER MatrixXf>(m).coeffRef(0) = 1.0f;
H A Dmap_on_const_type_actually_const_0.cpp12 Map<CV_QUALIFIER MatrixXf>(ptr, 1, 1).coeffRef(0,0) = 1.0f;
H A Dmap_on_const_type_actually_const_1.cpp12 Map<CV_QUALIFIER Vector3f>(ptr).coeffRef(0) = 1.0f;
H A Dtranspose_on_const_type_actually_const.cpp13 Transpose<CV_QUALIFIER MatrixXf>(m).coeffRef(0, 0) = 1.0f;
/external/eigen/Eigen/src/LU/
H A DInverse.h43 result.coeffRef(0,0) = Scalar(1) / matrix.coeff(0,0);
61 if(invertible) result.coeffRef(0,0) = typename ResultType::Scalar(1) / determinant;
74 result.coeffRef(0,0) = matrix.coeff(1,1) * invdet;
75 result.coeffRef(1,0) = -matrix.coeff(1,0) * invdet;
76 result.coeffRef(0,1) = -matrix.coeff(0,1) * invdet;
77 result.coeffRef(1,1) = matrix.coeff(0,0) * invdet;
137 result.coeffRef(1,0) = cofactor_3x3<MatrixType,0,1>(matrix) * invdet;
138 result.coeffRef(1,1) = cofactor_3x3<MatrixType,1,1>(matrix) * invdet;
139 result.coeffRef(1,2) = cofactor_3x3<MatrixType,2,1>(matrix) * invdet;
140 result.coeffRef(
[all...]
/external/eigen/Eigen/src/Core/
H A DSwap.h52 inline Scalar& coeffRef(Index rowId, Index colId) function in class:Eigen::SwapWrapper
54 return m_expression.const_cast_derived().coeffRef(rowId, colId);
57 inline Scalar& coeffRef(Index index) function in class:Eigen::SwapWrapper
59 return m_expression.const_cast_derived().coeffRef(index);
62 inline Scalar& coeffRef(Index rowId, Index colId) const function in class:Eigen::SwapWrapper
64 return m_expression.coeffRef(rowId, colId);
67 inline Scalar& coeffRef(Index index) const function in class:Eigen::SwapWrapper
69 return m_expression.coeffRef(index);
79 m_expression.coeffRef(rowId, colId) = _other.coeff(rowId, colId);
80 _other.coeffRef(rowI
[all...]
H A DFlagged.h68 inline const Scalar& coeffRef(Index row, Index col) const function in class:Eigen::Flagged
70 return m_matrix.const_cast_derived().coeffRef(row, col);
73 inline const Scalar& coeffRef(Index index) const function in class:Eigen::Flagged
75 return m_matrix.const_cast_derived().coeffRef(index);
78 inline Scalar& coeffRef(Index row, Index col) function in class:Eigen::Flagged
80 return m_matrix.const_cast_derived().coeffRef(row, col);
83 inline Scalar& coeffRef(Index index) function in class:Eigen::Flagged
85 return m_matrix.const_cast_derived().coeffRef(index);
H A DArrayWrapper.h66 inline Scalar& coeffRef(Index rowId, Index colId) function in class:Eigen::ArrayWrapper
68 return m_expression.const_cast_derived().coeffRef(rowId, colId);
71 inline const Scalar& coeffRef(Index rowId, Index colId) const function in class:Eigen::ArrayWrapper
73 return m_expression.const_cast_derived().coeffRef(rowId, colId);
81 inline Scalar& coeffRef(Index index) function in class:Eigen::ArrayWrapper
83 return m_expression.const_cast_derived().coeffRef(index);
86 inline const Scalar& coeffRef(Index index) const function in class:Eigen::ArrayWrapper
88 return m_expression.const_cast_derived().coeffRef(index);
186 inline Scalar& coeffRef(Index rowId, Index colId) function in class:Eigen::MatrixWrapper
188 return m_expression.const_cast_derived().coeffRef(rowI
191 inline const Scalar& coeffRef(Index rowId, Index colId) const function in class:Eigen::MatrixWrapper
201 inline Scalar& coeffRef(Index index) function in class:Eigen::MatrixWrapper
206 inline const Scalar& coeffRef(Index index) const function in class:Eigen::MatrixWrapper
[all...]
H A DNestByValue.h55 inline Scalar& coeffRef(Index row, Index col) function in class:Eigen::NestByValue
57 return m_expression.const_cast_derived().coeffRef(row, col);
65 inline Scalar& coeffRef(Index index) function in class:Eigen::NestByValue
67 return m_expression.const_cast_derived().coeffRef(index);
H A DDiagonal.h98 inline ScalarWithConstIfNotLvalue* data() { return &(m_matrix.const_cast_derived().coeffRef(rowOffset(), colOffset())); }
99 inline const Scalar* data() const { return &(m_matrix.const_cast_derived().coeffRef(rowOffset(), colOffset())); }
101 inline Scalar& coeffRef(Index row, Index) function in class:Eigen::Diagonal
104 return m_matrix.const_cast_derived().coeffRef(row+rowOffset(), row+colOffset());
107 inline const Scalar& coeffRef(Index row, Index) const function in class:Eigen::Diagonal
109 return m_matrix.const_cast_derived().coeffRef(row+rowOffset(), row+colOffset());
117 inline Scalar& coeffRef(Index idx) function in class:Eigen::Diagonal
120 return m_matrix.const_cast_derived().coeffRef(idx+rowOffset(), idx+colOffset());
123 inline const Scalar& coeffRef(Index idx) const function in class:Eigen::Diagonal
125 return m_matrix.const_cast_derived().coeffRef(id
[all...]
H A DSelfCwiseBinaryOp.h65 inline Scalar& coeffRef(Index row, Index col) function in class:Eigen::SelfCwiseBinaryOp
68 return m_matrix.const_cast_derived().coeffRef(row, col);
70 inline const Scalar& coeffRef(Index row, Index col) const function in class:Eigen::SelfCwiseBinaryOp
72 return m_matrix.coeffRef(row, col);
77 inline Scalar& coeffRef(Index index) function in class:Eigen::SelfCwiseBinaryOp
80 return m_matrix.const_cast_derived().coeffRef(index);
82 inline const Scalar& coeffRef(Index index) const function in class:Eigen::SelfCwiseBinaryOp
84 return m_matrix.const_cast_derived().coeffRef(index);
93 Scalar& tmp = m_matrix.coeffRef(row,col);
102 Scalar& tmp = m_matrix.coeffRef(inde
[all...]
H A DForceAlignedAccess.h54 inline Scalar& coeffRef(Index row, Index col) function in class:Eigen::ForceAlignedAccess
56 return m_expression.const_cast_derived().coeffRef(row, col);
64 inline Scalar& coeffRef(Index index) function in class:Eigen::ForceAlignedAccess
66 return m_expression.const_cast_derived().coeffRef(index);
H A DCwiseUnaryView.h103 inline Scalar* data() { return &coeffRef(0); }
126 EIGEN_STRONG_INLINE Scalar& coeffRef(Index row, Index col) function in class:Eigen::CwiseUnaryViewImpl
128 return derived().functor()(const_cast_derived().nestedExpression().coeffRef(row, col));
131 EIGEN_STRONG_INLINE Scalar& coeffRef(Index index) function in class:Eigen::CwiseUnaryViewImpl
133 return derived().functor()(const_cast_derived().nestedExpression().coeffRef(index));
H A DSelfAdjointView.h89 /** \sa MatrixBase::coeffRef()
92 inline Scalar& coeffRef(Index row, Index col) function in class:Eigen::SelfAdjointView
95 return m_matrix.const_cast_derived().coeffRef(row, col);
217 dst.coeffRef(row, col) = numext::real(src.coeff(row, col));
219 dst.coeffRef(col, row) = numext::conj(dst.coeffRef(row, col) = src.coeff(row, col));
242 dst.coeffRef(row, col) = numext::real(src.coeff(row, col));
244 dst.coeffRef(col, row) = numext::conj(dst.coeffRef(row, col) = src.coeff(row, col));
265 dst.coeffRef(
[all...]
/external/eigen/bench/
H A Dbench_sum.cpp15 v.coeffRef(0) += v.sum() * SCALAR(1e-20);
/external/eigen/unsupported/test/
H A Dkronecker_product.cpp92 SM_a.insert(0,0) = DM_a.coeffRef(0,0) = -0.4461540300782201;
93 SM_a.insert(0,1) = DM_a.coeffRef(0,1) = -0.8057364375283049;
94 SM_a.insert(0,2) = DM_a.coeffRef(0,2) = 0.3896572459516341;
95 SM_a.insert(1,0) = DM_a.coeffRef(1,0) = -0.9076572187376921;
96 SM_a.insert(1,1) = DM_a.coeffRef(1,1) = 0.6469156566545853;
97 SM_a.insert(1,2) = DM_a.coeffRef(1,2) = -0.3658010398782789;
101 SM_b.insert(0,0) = DM_b.coeffRef(0,0) = 0.9004440976767099;
102 SM_b.insert(0,1) = DM_b.coeffRef(0,1) = -0.2368830858139832;
103 SM_b.insert(1,0) = DM_b.coeffRef(1,0) = -0.9311078389941825;
104 SM_b.insert(1,1) = DM_b.coeffRef(
[all...]
/external/eigen/Eigen/src/Eigenvalues/
H A DEigenSolver.h321 matD.coeffRef(i,i) = numext::real(m_eivalues.coeff(i));
352 matV.coeffRef(i,j) = ComplexScalar(m_eivec.coeff(i,j), m_eivec.coeff(i,j+1));
353 matV.coeffRef(i,j+1) = ComplexScalar(m_eivec.coeff(i,j), -m_eivec.coeff(i,j+1));
387 m_eivalues.coeffRef(i) = m_matT.coeff(i, i);
394 m_eivalues.coeffRef(i) = ComplexScalar(m_matT.coeff(i+1, i+1) + p, z);
395 m_eivalues.coeffRef(i+1) = ComplexScalar(m_matT.coeff(i+1, i+1) + p, -z);
463 m_matT.coeffRef(n,n) = 1.0;
480 m_matT.coeffRef(i,n) = -r / w;
482 m_matT.coeffRef(i,n) = -r / (eps * norm);
490 m_matT.coeffRef(
[all...]
H A DRealSchur.h273 Scalar* workspace = &m_workspaceVector.coeffRef(0);
294 m_matT.coeffRef(iu,iu) = m_matT.coeff(iu,iu) + exshift;
296 m_matT.coeffRef(iu, iu-1) = Scalar(0);
374 m_matT.coeffRef(iu,iu) += exshift;
375 m_matT.coeffRef(iu-1,iu-1) += exshift;
388 m_matT.coeffRef(iu, iu-1) = Scalar(0);
394 m_matT.coeffRef(iu-1, iu-2) = Scalar(0);
403 shiftInfo.coeffRef(0) = m_matT.coeff(iu,iu);
404 shiftInfo.coeffRef(1) = m_matT.coeff(iu-1,iu-1);
405 shiftInfo.coeffRef(
[all...]
H A DHessenbergDecomposition.h304 matA.col(i).coeffRef(i+1) = beta;
305 hCoeffs.coeffRef(i) = h;
312 .applyHouseholderOnTheLeft(matA.col(i).tail(remainingSize-1), h, &temp.coeffRef(0));
316 .applyHouseholderOnTheRight(matA.col(i).tail(remainingSize-1).conjugate(), numext::conj(h), &temp.coeffRef(0));
/external/eigen/unsupported/Eigen/src/MatrixFunctions/
H A DMatrixSquareRoot.h98 sqrtT.coeffRef(i,i) = sqrt(T.coeff(i,i));
157 sqrtT.coeffRef(i,j) = (T.coeff(i,j) - tmp) / (sqrtT.coeff(i,i) + sqrtT.coeff(j,j));
215 coeffMatrix.coeffRef(0,0) = A.coeff(0,0) + B.coeff(0,0);
216 coeffMatrix.coeffRef(1,1) = A.coeff(0,0) + B.coeff(1,1);
217 coeffMatrix.coeffRef(2,2) = A.coeff(1,1) + B.coeff(0,0);
218 coeffMatrix.coeffRef(3,3) = A.coeff(1,1) + B.coeff(1,1);
219 coeffMatrix.coeffRef(0,1) = B.coeff(1,0);
220 coeffMatrix.coeffRef(0,2) = A.coeff(0,1);
221 coeffMatrix.coeffRef(1,0) = B.coeff(0,1);
222 coeffMatrix.coeffRef(
[all...]
/external/eigen/Eigen/src/SparseCore/
H A DTriangularSolver.h49 other.coeffRef(i,col) = tmp;
53 other.coeffRef(i,col) = tmp/lastVal;
90 other.coeffRef(i,col) = tmp;
92 other.coeffRef(i,col) = tmp/l_ii;
109 Scalar& tmp = other.coeffRef(i,col);
123 other.coeffRef(it.index(), col) -= tmp * it.value();
141 Scalar& tmp = other.coeffRef(i,col);
151 other.coeffRef(i,col) /= it.value();
155 other.coeffRef(it.index(), col) -= tmp * it.value();
230 tempVector.coeffRef(rhsI
[all...]
/external/eigen/Eigen/src/Eigen2Support/Geometry/
H A DQuaternion.h78 inline Scalar& x() { return m_coeffs.coeffRef(0); }
80 inline Scalar& y() { return m_coeffs.coeffRef(1); }
82 inline Scalar& z() { return m_coeffs.coeffRef(2); }
84 inline Scalar& w() { return m_coeffs.coeffRef(3); }
317 res.coeffRef(0,0) = Scalar(1)-(tyy+tzz);
318 res.coeffRef(0,1) = txy-twz;
319 res.coeffRef(0,2) = txz+twy;
320 res.coeffRef(1,0) = txy+twz;
321 res.coeffRef(1,1) = Scalar(1)-(txx+tzz);
322 res.coeffRef(
[all...]
/external/eigen/Eigen/src/SVD/
H A DUpperBidiagonalization.h107 .makeHouseholderInPlace(m_householder.coeffRef(k,k),
108 m_bidiagonal.template diagonal<0>().coeffRef(k));
119 .makeHouseholderInPlace(m_householder.coeffRef(k,k+1),
120 m_bidiagonal.template diagonal<1>().coeffRef(k));

Completed in 251 milliseconds

12345