/external/eigen/Eigen/src/LU/ |
D | Inverse.h | 43 result.coeffRef(0,0) = Scalar(1) / matrix.coeff(0,0); 60 if(invertible) result.coeffRef(0,0) = typename ResultType::Scalar(1) / determinant; 73 result.coeffRef(0,0) = matrix.coeff(1,1) * invdet; 74 result.coeffRef(1,0) = -matrix.coeff(1,0) * invdet; 75 result.coeffRef(0,1) = -matrix.coeff(0,1) * invdet; 76 result.coeffRef(1,1) = matrix.coeff(0,0) * invdet; 135 result.coeffRef(1,0) = cofactor_3x3<MatrixType,0,1>(matrix) * invdet; 136 result.coeffRef(1,1) = cofactor_3x3<MatrixType,1,1>(matrix) * invdet; 137 result.coeffRef(1,2) = cofactor_3x3<MatrixType,2,1>(matrix) * invdet; 138 result.coeffRef(2,0) = cofactor_3x3<MatrixType,0,2>(matrix) * invdet; [all …]
|
/external/eigen/Eigen/src/Core/ |
D | ArrayWrapper.h | 66 inline Scalar& coeffRef(Index row, Index col) 68 return m_expression.const_cast_derived().coeffRef(row, col); 71 inline const Scalar& coeffRef(Index row, Index col) const 73 return m_expression.const_cast_derived().coeffRef(row, col); 81 inline Scalar& coeffRef(Index index) 83 return m_expression.const_cast_derived().coeffRef(index); 86 inline const Scalar& coeffRef(Index index) const 88 return m_expression.const_cast_derived().coeffRef(index); 179 inline Scalar& coeffRef(Index row, Index col) 181 return m_expression.const_cast_derived().coeffRef(row, col); [all …]
|
D | Swap.h | 52 inline Scalar& coeffRef(Index row, Index col) 54 return m_expression.const_cast_derived().coeffRef(row, col); 57 inline Scalar& coeffRef(Index index) 59 return m_expression.const_cast_derived().coeffRef(index); 62 inline Scalar& coeffRef(Index row, Index col) const 64 return m_expression.coeffRef(row, col); 67 inline Scalar& coeffRef(Index index) const 69 return m_expression.coeffRef(index); 79 m_expression.coeffRef(row, col) = _other.coeff(row, col); 80 _other.coeffRef(row, col) = tmp; [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 | 97 …inline ScalarWithConstIfNotLvalue* data() { return &(m_matrix.const_cast_derived().coeffRef(rowOff… 98 …inline const Scalar* data() const { return &(m_matrix.const_cast_derived().coeffRef(rowOffset(), c… 100 inline Scalar& coeffRef(Index row, Index) 103 return m_matrix.const_cast_derived().coeffRef(row+rowOffset(), row+colOffset()); 106 inline const Scalar& coeffRef(Index row, Index) const 108 return m_matrix.const_cast_derived().coeffRef(row+rowOffset(), row+colOffset()); 116 inline Scalar& coeffRef(Index index) 119 return m_matrix.const_cast_derived().coeffRef(index+rowOffset(), index+colOffset()); 122 inline const Scalar& coeffRef(Index index) const 124 return m_matrix.const_cast_derived().coeffRef(index+rowOffset(), index+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) = real(src.coeff(row, col)); 219 dst.coeffRef(col, row) = conj(dst.coeffRef(row, col) = src.coeff(row, col)); 242 dst.coeffRef(row, col) = real(src.coeff(row, col)); 244 dst.coeffRef(col, row) = conj(dst.coeffRef(row, col) = src.coeff(row, col)); 265 dst.coeffRef(j,i) = conj(dst.coeff(i,j)); 283 dst.coeffRef(j,i) = conj(dst.coeff(i,j));
|
D | Block.h | 155 inline Scalar& coeffRef(Index row, Index col) 159 .coeffRef(row + m_startRow.value(), col + m_startCol.value()); 162 inline const Scalar& coeffRef(Index row, Index col) const 165 .coeffRef(row + m_startRow.value(), col + m_startCol.value()); 173 inline Scalar& coeffRef(Index index) 177 .coeffRef(m_startRow.value() + (RowsAtCompileTime == 1 ? 0 : index), 181 inline const Scalar& coeffRef(Index index) const 184 .coeffRef(m_startRow.value() + (RowsAtCompileTime == 1 ? 0 : index), 271 : Base(internal::const_cast_ptr(&xpr.coeffRef( 287 : Base(internal::const_cast_ptr(&xpr.coeffRef(startRow,startCol))), m_xpr(xpr) [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 | 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 | 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 | Transpose.h | 120 inline ScalarWithConstIfNotLvalue& coeffRef(Index row, Index col) 123 return derived().nestedExpression().const_cast_derived().coeffRef(col, row); 126 inline ScalarWithConstIfNotLvalue& coeffRef(Index index) 129 return derived().nestedExpression().const_cast_derived().coeffRef(index); 132 inline const Scalar& coeffRef(Index row, Index col) const 134 return derived().nestedExpression().coeffRef(col, row); 137 inline const Scalar& coeffRef(Index index) const 139 return derived().nestedExpression().coeffRef(index);
|
/external/eigen/Eigen/src/Eigenvalues/ |
D | RealSchur.h | 216 Scalar* workspace = &m_workspaceVector.coeffRef(0); in compute() 236 m_matT.coeffRef(iu,iu) = m_matT.coeff(iu,iu) + exshift; in compute() 238 m_matT.coeffRef(iu, iu-1) = Scalar(0); in compute() 312 m_matT.coeffRef(iu,iu) += exshift; in splitOffTwoRows() 313 m_matT.coeffRef(iu-1,iu-1) += exshift; in splitOffTwoRows() 326 m_matT.coeffRef(iu, iu-1) = Scalar(0); in splitOffTwoRows() 332 m_matT.coeffRef(iu-1, iu-2) = Scalar(0); in splitOffTwoRows() 339 shiftInfo.coeffRef(0) = m_matT.coeff(iu,iu); in computeShift() 340 shiftInfo.coeffRef(1) = m_matT.coeff(iu-1,iu-1); in computeShift() 341 shiftInfo.coeffRef(2) = m_matT.coeff(iu,iu-1) * m_matT.coeff(iu-1,iu); in computeShift() [all …]
|
D | EigenSolver.h | 308 matD.coeffRef(i,i) = internal::real(m_eivalues.coeff(i)); in pseudoEigenvalueMatrix() 339 matV.coeffRef(i,j) = ComplexScalar(m_eivec.coeff(i,j), m_eivec.coeff(i,j+1)); in eigenvectors() 340 matV.coeffRef(i,j+1) = ComplexScalar(m_eivec.coeff(i,j), -m_eivec.coeff(i,j+1)); in eigenvectors() 370 m_eivalues.coeffRef(i) = m_matT.coeff(i, i); in compute() 377 m_eivalues.coeffRef(i) = ComplexScalar(m_matT.coeff(i+1, i+1) + p, z); in compute() 378 m_eivalues.coeffRef(i+1) = ComplexScalar(m_matT.coeff(i+1, i+1) + p, -z); in compute() 444 m_matT.coeffRef(n,n) = 1.0; in doComputeEigenvectors() 461 m_matT.coeffRef(i,n) = -r / w; in doComputeEigenvectors() 463 m_matT.coeffRef(i,n) = -r / (eps * norm); in doComputeEigenvectors() 471 m_matT.coeffRef(i,n) = t; in doComputeEigenvectors() [all …]
|
/external/eigen/unsupported/Eigen/src/MatrixFunctions/ |
D | MatrixSquareRoot.h | 106 sqrtT.coeffRef(i,i) = internal::sqrt(T.coeff(i,i)); in computeDiagonalPartOfSqrt() 165 sqrtT.coeffRef(i,j) = (T.coeff(i,j) - tmp) / (sqrtT.coeff(i,i) + sqrtT.coeff(j,j)); in compute1x1offDiagonalBlock() 223 coeffMatrix.coeffRef(0,0) = A.coeff(0,0) + B.coeff(0,0); in solveAuxiliaryEquation() 224 coeffMatrix.coeffRef(1,1) = A.coeff(0,0) + B.coeff(1,1); in solveAuxiliaryEquation() 225 coeffMatrix.coeffRef(2,2) = A.coeff(1,1) + B.coeff(0,0); in solveAuxiliaryEquation() 226 coeffMatrix.coeffRef(3,3) = A.coeff(1,1) + B.coeff(1,1); in solveAuxiliaryEquation() 227 coeffMatrix.coeffRef(0,1) = B.coeff(1,0); in solveAuxiliaryEquation() 228 coeffMatrix.coeffRef(0,2) = A.coeff(0,1); in solveAuxiliaryEquation() 229 coeffMatrix.coeffRef(1,0) = B.coeff(0,1); in solveAuxiliaryEquation() 230 coeffMatrix.coeffRef(1,3) = A.coeff(0,1); in solveAuxiliaryEquation() [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/Geometry/ |
D | OrthoMethods.h | 144 perp.coeffRef(maxi) = -conj(src.coeff(sndi)) * invnm; in run() 145 perp.coeffRef(sndi) = conj(src.coeff(maxi)) * invnm; in run() 171 perp.coeffRef(0) = -conj(src.y())*invnm; 172 perp.coeffRef(1) = conj(src.x())*invnm; 173 perp.coeffRef(2) = 0; 182 perp.coeffRef(0) = 0; 183 perp.coeffRef(1) = -conj(src.z())*invnm; 184 perp.coeffRef(2) = conj(src.y())*invnm;
|
D | AngleAxis.h | 212 res.coeffRef(0,1) = tmp - sin_axis.z(); 213 res.coeffRef(1,0) = tmp + sin_axis.z(); 216 res.coeffRef(0,2) = tmp + sin_axis.y(); 217 res.coeffRef(2,0) = tmp - sin_axis.y(); 220 res.coeffRef(1,2) = tmp - sin_axis.x(); 221 res.coeffRef(2,1) = tmp + sin_axis.x();
|
D | Quaternion.h | 69 inline Scalar& x() { return this->derived().coeffs().coeffRef(0); } in x() 71 inline Scalar& y() { return this->derived().coeffs().coeffRef(1); } in y() 73 inline Scalar& z() { return this->derived().coeffs().coeffRef(2); } in z() 75 inline Scalar& w() { return this->derived().coeffs().coeffRef(3); } in w() 556 res.coeffRef(0,0) = Scalar(1)-(tyy+tzz); 557 res.coeffRef(0,1) = txy-twz; 558 res.coeffRef(0,2) = txz+twy; 559 res.coeffRef(1,0) = txy+twz; 560 res.coeffRef(1,1) = Scalar(1)-(txx+tzz); 561 res.coeffRef(1,2) = tyz-twx; [all …]
|
/external/eigen/Eigen/src/Cholesky/ |
D | LDLT.h | 288 for(Index i = k; i < size; i++) transpositions.coeffRef(i) = i; 292 transpositions.coeffRef(k) = index_of_biggest_in_corner; 300 … std::swap(mat.coeffRef(k,k),mat.coeffRef(index_of_biggest_in_corner,index_of_biggest_in_corner)); 303 Scalar tmp = mat.coeffRef(i,k); 304 mat.coeffRef(i,k) = conj(mat.coeffRef(index_of_biggest_in_corner,i)); 305 mat.coeffRef(index_of_biggest_in_corner,i) = conj(tmp); 308 … mat.coeffRef(index_of_biggest_in_corner,k) = conj(mat.coeff(index_of_biggest_in_corner,k)); 323 mat.coeffRef(k,k) -= (A10 * temp.head(k)).value(); 327 if((rs>0) && (abs(mat.coeffRef(k,k)) > cutoff)) 328 A21 /= mat.coeffRef(k,k); [all …]
|
/external/eigen/Eigen/src/Core/products/ |
D | TriangularMatrixVector.h | 59 res.coeffRef(i) += alpha * cjRhs.coeff(i); 67 &lhs.coeffRef(s,pi), lhsStride, 68 &rhs.coeffRef(pi), rhsIncr, 69 &res.coeffRef(s), resIncr, alpha); 76 &lhs.coeffRef(0,size), lhsStride, 77 &rhs.coeffRef(size), rhsIncr, 120 …res.coeffRef(i) += alpha * (cjLhs.row(i).segment(s,r).cwiseProduct(cjRhs.segment(s,r).transpose())… 122 res.coeffRef(i) += alpha * cjRhs.coeff(i); 130 &lhs.coeffRef(pi,s), lhsStride, 131 &rhs.coeffRef(s), rhsIncr, [all …]
|
/external/eigen/Eigen/src/QR/ |
D | ColPivHouseholderQR.h | 375 m_colSqNorms.coeffRef(k) = m_qr.col(k).squaredNorm(); in compute() 396 m_colSqNorms.coeffRef(biggest_col_index) = biggest_col_sq_norm; in compute() 414 m_colsTranspositions.coeffRef(k) = biggest_col_index; in compute() 417 std::swap(m_colSqNorms.coeffRef(k), m_colSqNorms.coeffRef(biggest_col_index)); in compute() 423 m_qr.col(k).tail(rows-k).makeHouseholderInPlace(m_hCoeffs.coeffRef(k), beta); in compute() 426 m_qr.coeffRef(k,k) = beta; in compute() 433 …pplyHouseholderOnTheLeft(m_qr.col(k).tail(rows-k-1), m_hCoeffs.coeffRef(k), &m_temp.coeffRef(k+1)); in compute()
|
/external/eigen/unsupported/Eigen/src/IterativeSolvers/ |
D | GMRES.h | 87 r0.makeHouseholder(e, tau.coeffRef(0), beta); in gmres() 99 …v.tail(m - i).applyHouseholderOnTheLeft(H.col(i).tail(m - i - 1), tau.coeffRef(i), workspace.data(… in gmres() 108 …v.tail(m - i).applyHouseholderOnTheLeft(H.col(i).tail(m - i - 1), tau.coeffRef(i), workspace.data(… in gmres() 118 v.tail(m - k).makeHouseholder(e, tau.coeffRef(k), beta); in gmres() 122 …v.tail(m - k).applyHouseholderOnTheLeft(H.col(k).tail(m - k - 1), tau.coeffRef(k), workspace.data(… in gmres() 159 …tail(m - k + 1).applyHouseholderOnTheLeft(H.col(k - 1).tail(m - k), tau.coeffRef(k - 1), workspace… in gmres() 164 …new.tail(m - i).applyHouseholderOnTheLeft(H.col(i).tail(m - i - 1), tau.coeffRef(i), workspace.dat… in gmres() 185 r0.makeHouseholder(e, tau.coeffRef(0), beta); in gmres()
|