/external/eigen/Eigen/src/LU/ |
D | Inverse.h | 43 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(2,0) = cofactor_3x3<MatrixType,0,2>(matrix) * invdet; [all …]
|
/external/eigen/Eigen/src/Core/ |
D | Swap.h | 52 inline Scalar& coeffRef(Index rowId, Index colId) 54 return m_expression.const_cast_derived().coeffRef(rowId, colId); 57 inline Scalar& coeffRef(Index index) 59 return m_expression.const_cast_derived().coeffRef(index); 62 inline Scalar& coeffRef(Index rowId, Index colId) const 64 return m_expression.coeffRef(rowId, colId); 67 inline Scalar& coeffRef(Index index) const 69 return m_expression.coeffRef(index); 79 m_expression.coeffRef(rowId, colId) = _other.coeff(rowId, colId); 80 _other.coeffRef(rowId, colId) = tmp; [all …]
|
D | ArrayWrapper.h | 71 inline Scalar& coeffRef(Index rowId, Index colId) 73 return m_expression.const_cast_derived().coeffRef(rowId, colId); 76 inline const Scalar& coeffRef(Index rowId, Index colId) const 78 return m_expression.const_cast_derived().coeffRef(rowId, colId); 86 inline Scalar& coeffRef(Index index) 88 return m_expression.const_cast_derived().coeffRef(index); 91 inline const Scalar& coeffRef(Index index) const 93 return m_expression.const_cast_derived().coeffRef(index); 196 inline Scalar& coeffRef(Index rowId, Index colId) 198 return m_expression.const_cast_derived().coeffRef(rowId, colId); [all …]
|
D | Flagged.h | 68 inline const Scalar& coeffRef(Index row, Index col) const 70 return m_matrix.const_cast_derived().coeffRef(row, col); 73 inline const Scalar& coeffRef(Index index) const 75 return m_matrix.const_cast_derived().coeffRef(index); 78 inline Scalar& coeffRef(Index row, Index col) 80 return m_matrix.const_cast_derived().coeffRef(row, col); 83 inline Scalar& coeffRef(Index index) 85 return m_matrix.const_cast_derived().coeffRef(index);
|
D | Diagonal.h | 98 …inline ScalarWithConstIfNotLvalue* data() { return &(m_matrix.const_cast_derived().coeffRef(rowOff… 99 …inline const Scalar* data() const { return &(m_matrix.const_cast_derived().coeffRef(rowOffset(), c… 101 inline Scalar& coeffRef(Index row, Index) 104 return m_matrix.const_cast_derived().coeffRef(row+rowOffset(), row+colOffset()); 107 inline const Scalar& coeffRef(Index row, Index) const 109 return m_matrix.const_cast_derived().coeffRef(row+rowOffset(), row+colOffset()); 117 inline Scalar& coeffRef(Index idx) 120 return m_matrix.const_cast_derived().coeffRef(idx+rowOffset(), idx+colOffset()); 123 inline const Scalar& coeffRef(Index idx) const 125 return m_matrix.const_cast_derived().coeffRef(idx+rowOffset(), idx+colOffset());
|
D | SelfCwiseBinaryOp.h | 65 inline Scalar& coeffRef(Index row, Index col) 68 return m_matrix.const_cast_derived().coeffRef(row, col); 70 inline const Scalar& coeffRef(Index row, Index col) const 72 return m_matrix.coeffRef(row, col); 77 inline Scalar& coeffRef(Index index) 80 return m_matrix.const_cast_derived().coeffRef(index); 82 inline const Scalar& coeffRef(Index index) const 84 return m_matrix.const_cast_derived().coeffRef(index); 93 Scalar& tmp = m_matrix.coeffRef(row,col); 102 Scalar& tmp = m_matrix.coeffRef(index);
|
D | SelfAdjointView.h | 92 inline Scalar& coeffRef(Index row, Index col) 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(j,i) = numext::conj(dst.coeff(i,j)); 283 dst.coeffRef(j,i) = numext::conj(dst.coeff(i,j));
|
D | DenseCoeffsBase.h | 247 void coeffRef(); 314 EIGEN_STRONG_INLINE Scalar& coeffRef(Index row, Index col) in coeffRef() function 318 return derived().coeffRef(row, col); in coeffRef() 324 return coeffRef(rowIndexByOuterInner(outer, inner), in coeffRefByOuterInner() 338 return derived().coeffRef(row, col); in operator() 358 coeffRef(Index index) in coeffRef() function 361 return derived().coeffRef(index); in coeffRef() 379 return derived().coeffRef(index); 395 return derived().coeffRef(index); in operator() 480 derived().coeffRef(row, col) = other.derived().coeff(row, col); in copyCoeff() [all …]
|
D | NestByValue.h | 55 inline Scalar& coeffRef(Index row, Index col) 57 return m_expression.const_cast_derived().coeffRef(row, col); 65 inline Scalar& coeffRef(Index index) 67 return m_expression.const_cast_derived().coeffRef(index);
|
D | Block.h | 211 inline Scalar& coeffRef(Index rowId, Index colId) 215 .coeffRef(rowId + m_startRow.value(), colId + m_startCol.value()); 218 inline const Scalar& coeffRef(Index rowId, Index colId) const 221 .coeffRef(rowId + m_startRow.value(), colId + m_startCol.value()); 229 inline Scalar& coeffRef(Index index) 233 .coeffRef(m_startRow.value() + (RowsAtCompileTime == 1 ? 0 : index), 237 inline const Scalar& coeffRef(Index index) const 240 .coeffRef(m_startRow.value() + (RowsAtCompileTime == 1 ? 0 : index), 327 : Base(internal::const_cast_ptr(&xpr.coeffRef( 340 : Base(internal::const_cast_ptr(&xpr.coeffRef(startRow,startCol))), m_xpr(xpr) [all …]
|
D | PermutationMatrix.h | 122 other.coeffRef(indices().coeff(i),i) = typename DenseDerived::Scalar(1); in evalTo() 151 indices().coeffRef(i) = i; in setIdentity() 176 if(indices().coeff(k) == i) indices().coeffRef(k) = j; in applyTranspositionOnTheLeft() 177 else if(indices().coeff(k) == j) indices().coeffRef(k) = i; in applyTranspositionOnTheLeft() 193 std::swap(indices().coeffRef(i), indices().coeffRef(j)); in applyTranspositionOnTheRight() 218 for (int i=0; i<rows();++i) indices().coeffRef(other.indices().coeff(i)) = i; in assignTranspose() 224 … for (int i=0; i<rows();++i) indices().coeffRef(i) = lhs.indices().coeff(rhs.indices().coeff(i)); in assignProduct() 273 mask.coeffRef(k0) = true; in determinant() 276 mask.coeffRef(k) = true; in determinant() 399 …for (int i=0; i<m_indices.size();++i) m_indices.coeffRef(other.nestedPermutation().indices().coeff… [all …]
|
D | Reverse.h | 113 return coeffRef(row, col); 116 inline Scalar& coeffRef(Index row, Index col) 118 return m_matrix.const_cast_derived().coeffRef(ReverseRow ? m_matrix.rows() - row - 1 : row, 133 inline Scalar& coeffRef(Index index) 135 return m_matrix.const_cast_derived().coeffRef(m_matrix.size() - index - 1); 141 return coeffRef(index);
|
D | CwiseUnaryView.h | 103 inline Scalar* data() { return &coeffRef(0); } 126 EIGEN_STRONG_INLINE Scalar& coeffRef(Index row, Index col) 128 return derived().functor()(const_cast_derived().nestedExpression().coeffRef(row, col)); 131 EIGEN_STRONG_INLINE Scalar& coeffRef(Index index) 133 return derived().functor()(const_cast_derived().nestedExpression().coeffRef(index));
|
/external/eigen/Eigen/src/Eigenvalues/ |
D | EigenSolver.h | 328 matD.coeffRef(i,i) = numext::real(m_eivalues.coeff(i)); in pseudoEigenvalueMatrix() 359 matV.coeffRef(i,j) = ComplexScalar(m_eivec.coeff(i,j), m_eivec.coeff(i,j+1)); in eigenvectors() 360 matV.coeffRef(i,j+1) = ComplexScalar(m_eivec.coeff(i,j), -m_eivec.coeff(i,j+1)); in eigenvectors() 396 m_eivalues.coeffRef(i) = m_matT.coeff(i, i); in compute() 403 m_eivalues.coeffRef(i) = ComplexScalar(m_matT.coeff(i+1, i+1) + p, z); in compute() 404 m_eivalues.coeffRef(i+1) = ComplexScalar(m_matT.coeff(i+1, i+1) + p, -z); in compute() 472 m_matT.coeffRef(n,n) = 1.0; in doComputeEigenvectors() 489 m_matT.coeffRef(i,n) = -r / w; in doComputeEigenvectors() 491 m_matT.coeffRef(i,n) = -r / (eps * norm); in doComputeEigenvectors() 499 m_matT.coeffRef(i,n) = t; in doComputeEigenvectors() [all …]
|
D | RealSchur.h | 273 Scalar* workspace = &m_workspaceVector.coeffRef(0); in computeFromHessenberg() 294 m_matT.coeffRef(iu,iu) = m_matT.coeff(iu,iu) + exshift; in computeFromHessenberg() 296 m_matT.coeffRef(iu, iu-1) = Scalar(0); in computeFromHessenberg() 372 m_matT.coeffRef(iu,iu) += exshift; in splitOffTwoRows() 373 m_matT.coeffRef(iu-1,iu-1) += exshift; in splitOffTwoRows() 386 m_matT.coeffRef(iu, iu-1) = Scalar(0); in splitOffTwoRows() 392 m_matT.coeffRef(iu-1, iu-2) = Scalar(0); in splitOffTwoRows() 401 shiftInfo.coeffRef(0) = m_matT.coeff(iu,iu); in computeShift() 402 shiftInfo.coeffRef(1) = m_matT.coeff(iu-1,iu-1); in computeShift() 403 shiftInfo.coeffRef(2) = m_matT.coeff(iu,iu-1) * m_matT.coeff(iu-1,iu); in computeShift() [all …]
|
D | GeneralizedEigenSolver.h | 324 m_alphas.coeffRef(i) = m_matS.coeff(i, i); in compute() 325 m_betas.coeffRef(i) = m_realQZ.matrixT().coeff(i,i); in compute() 332 m_alphas.coeffRef(i) = ComplexScalar(m_matS.coeff(i+1, i+1) + p, z); in compute() 333 m_alphas.coeffRef(i+1) = ComplexScalar(m_matS.coeff(i+1, i+1) + p, -z); in compute() 335 m_betas.coeffRef(i) = m_realQZ.matrixT().coeff(i,i); in compute() 336 m_betas.coeffRef(i+1) = m_realQZ.matrixT().coeff(i,i); in compute()
|
D | RealQZ.h | 239 G.makeGivens(m_S.coeff(i-1,j), m_S.coeff(i,j), &m_S.coeffRef(i-1, j)); in hessenbergTriangular() 240 m_S.coeffRef(i,j) = Scalar(0.0); in hessenbergTriangular() 250 G.makeGivens(m_T.coeff(i,i), m_T.coeff(i,i-1), &m_T.coeffRef(i,i)); in hessenbergTriangular() 251 m_T.coeffRef(i,i-1) = Scalar(0.0); in hessenbergTriangular() 349 m_S.coeffRef(i+1,i) = Scalar(0.0); in splitOffTwoRows() 350 m_T.coeffRef(i+1,i) = Scalar(0.0); in splitOffTwoRows() 372 m_T.coeffRef(zz+1,zz+1) = Scalar(0.0); in pushDownZero() 382 m_S.coeffRef(zz+1,zz-1) = Scalar(0.0); in pushDownZero() 392 m_S.coeffRef(l,l-1)=Scalar(0.0); in pushDownZero() 491 m_S.coeffRef(k+2,k-1) = m_S.coeffRef(k+1,k-1) = Scalar(0.0); in step() [all …]
|
/external/eigen/unsupported/Eigen/src/MatrixFunctions/ |
D | MatrixSquareRoot.h | 98 sqrtT.coeffRef(i,i) = sqrt(T.coeff(i,i)); in computeDiagonalPartOfSqrt() 157 sqrtT.coeffRef(i,j) = (T.coeff(i,j) - tmp) / (sqrtT.coeff(i,i) + sqrtT.coeff(j,j)); in compute1x1offDiagonalBlock() 215 coeffMatrix.coeffRef(0,0) = A.coeff(0,0) + B.coeff(0,0); in solveAuxiliaryEquation() 216 coeffMatrix.coeffRef(1,1) = A.coeff(0,0) + B.coeff(1,1); in solveAuxiliaryEquation() 217 coeffMatrix.coeffRef(2,2) = A.coeff(1,1) + B.coeff(0,0); in solveAuxiliaryEquation() 218 coeffMatrix.coeffRef(3,3) = A.coeff(1,1) + B.coeff(1,1); in solveAuxiliaryEquation() 219 coeffMatrix.coeffRef(0,1) = B.coeff(1,0); in solveAuxiliaryEquation() 220 coeffMatrix.coeffRef(0,2) = A.coeff(0,1); in solveAuxiliaryEquation() 221 coeffMatrix.coeffRef(1,0) = B.coeff(0,1); in solveAuxiliaryEquation() 222 coeffMatrix.coeffRef(1,3) = A.coeff(0,1); in solveAuxiliaryEquation() [all …]
|
/external/eigen/unsupported/test/ |
D | kronecker_product.cpp | 92 SM_a.insert(0,0) = DM_a.coeffRef(0,0) = -0.4461540300782201; in test_kronecker_product() 93 SM_a.insert(0,1) = DM_a.coeffRef(0,1) = -0.8057364375283049; in test_kronecker_product() 94 SM_a.insert(0,2) = DM_a.coeffRef(0,2) = 0.3896572459516341; in test_kronecker_product() 95 SM_a.insert(1,0) = DM_a.coeffRef(1,0) = -0.9076572187376921; in test_kronecker_product() 96 SM_a.insert(1,1) = DM_a.coeffRef(1,1) = 0.6469156566545853; in test_kronecker_product() 97 SM_a.insert(1,2) = DM_a.coeffRef(1,2) = -0.3658010398782789; in test_kronecker_product() 101 SM_b.insert(0,0) = DM_b.coeffRef(0,0) = 0.9004440976767099; in test_kronecker_product() 102 SM_b.insert(0,1) = DM_b.coeffRef(0,1) = -0.2368830858139832; in test_kronecker_product() 103 SM_b.insert(1,0) = DM_b.coeffRef(1,0) = -0.9311078389941825; in test_kronecker_product() 104 SM_b.insert(1,1) = DM_b.coeffRef(1,1) = 0.5310335762980047; in test_kronecker_product() [all …]
|
/external/eigen/Eigen/src/SparseCore/ |
D | TriangularSolver.h | 49 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(rhsIt.index()) = rhsIt.value(); [all …]
|
/external/eigen/Eigen/src/Eigen2Support/Geometry/ |
D | Quaternion.h | 78 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(1,2) = tyz-twx; [all …]
|
D | AngleAxis.h | 198 res.coeffRef(0,1) = tmp - sin_axis.z(); 199 res.coeffRef(1,0) = tmp + sin_axis.z(); 202 res.coeffRef(0,2) = tmp + sin_axis.y(); 203 res.coeffRef(2,0) = tmp - sin_axis.y(); 206 res.coeffRef(1,2) = tmp - sin_axis.x(); 207 res.coeffRef(2,1) = tmp + sin_axis.x();
|
/external/eigen/Eigen/src/Core/products/ |
D | TriangularMatrixVector.h | 65 res.coeffRef(i) += alpha * cjRhs.coeff(i); 73 &lhs.coeffRef(s,pi), lhsStride, 74 &rhs.coeffRef(pi), rhsIncr, 75 &res.coeffRef(s), resIncr, alpha); 82 &lhs.coeffRef(0,size), lhsStride, 83 &rhs.coeffRef(size), rhsIncr, 131 …res.coeffRef(i) += alpha * (cjLhs.row(i).segment(s,r).cwiseProduct(cjRhs.segment(s,r).transpose())… 133 res.coeffRef(i) += alpha * cjRhs.coeff(i); 141 &lhs.coeffRef(pi,s), lhsStride, 142 &rhs.coeffRef(s), rhsIncr, [all …]
|
/external/eigen/Eigen/src/Geometry/ |
D | OrthoMethods.h | 144 perp.coeffRef(maxi) = -numext::conj(src.coeff(sndi)) * invnm; in run() 145 perp.coeffRef(sndi) = numext::conj(src.coeff(maxi)) * invnm; in run() 171 perp.coeffRef(0) = -numext::conj(src.y())*invnm; 172 perp.coeffRef(1) = numext::conj(src.x())*invnm; 173 perp.coeffRef(2) = 0; 182 perp.coeffRef(0) = 0; 183 perp.coeffRef(1) = -numext::conj(src.z())*invnm; 184 perp.coeffRef(2) = numext::conj(src.y())*invnm;
|
D | AngleAxis.h | 215 res.coeffRef(0,1) = tmp - sin_axis.z(); 216 res.coeffRef(1,0) = tmp + sin_axis.z(); 219 res.coeffRef(0,2) = tmp + sin_axis.y(); 220 res.coeffRef(2,0) = tmp - sin_axis.y(); 223 res.coeffRef(1,2) = tmp - sin_axis.x(); 224 res.coeffRef(2,1) = tmp + sin_axis.x();
|