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

12 3 4 5

  /external/eigen/Eigen/src/Eigenvalues/
RealSchur.h 216 Scalar* workspace = &m_workspaceVector.coeffRef(0);
236 m_matT.coeffRef(iu,iu) = m_matT.coeff(iu,iu) + exshift;
238 m_matT.coeffRef(iu, iu-1) = Scalar(0);
312 m_matT.coeffRef(iu,iu) += exshift;
313 m_matT.coeffRef(iu-1,iu-1) += exshift;
326 m_matT.coeffRef(iu, iu-1) = Scalar(0);
332 m_matT.coeffRef(iu-1, iu-2) = Scalar(0);
339 shiftInfo.coeffRef(0) = m_matT.coeff(iu,iu);
340 shiftInfo.coeffRef(1) = m_matT.coeff(iu-1,iu-1);
341 shiftInfo.coeffRef(2) = m_matT.coeff(iu,iu-1) * m_matT.coeff(iu-1,iu)
    [all...]
  /external/eigen/Eigen/src/Core/products/
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())).sum();
122 res.coeffRef(i) += alpha * cjRhs.coeff(i);
130 &lhs.coeffRef(pi,s), lhsStride,
131 &rhs.coeffRef(s), rhsIncr
    [all...]
  /external/eigen/blas/
BandTriangularSolver.h 47 other.coeffRef(i,col) -= cjLhs.row(i).segment(actual_start,actual_k).transpose()
51 other.coeffRef(i,col) /= cjLhs(i,IsLower ? k : 0);
83 other.coeffRef(i,col) /= cjLhs(IsLower ? 0 : k, i);
  /external/eigen/Eigen/src/Core/
MapBase.h 65 using Base::coeffRef;
101 inline const Scalar& coeffRef(Index row, Index col) const
106 inline const Scalar& coeffRef(Index index) const
185 using Base::coeffRef;
201 inline ScalarWithConstIfNotLvalue& coeffRef(Index row, Index col)
206 inline ScalarWithConstIfNotLvalue& coeffRef(Index index)
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);
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...]
DenseCoeffsBase.h 44 // - The LvalueBit means exactly that we can offer a coeffRef() method, which means exactly that we can get references
92 * \sa operator()(Index,Index) const, coeffRef(Index,Index), coeff(Index) const
130 * \sa operator[](Index) const, coeffRef(Index), coeff(Index,Index) const
247 void coeffRef();
312 * \sa operator()(Index,Index), coeff(Index, Index) const, coeffRef(Index)
314 EIGEN_STRONG_INLINE Scalar& coeffRef(Index row, Index col)
318 return derived().coeffRef(row, col);
324 return coeffRef(rowIndexByOuterInner(outer, inner),
338 return derived().coeffRef(row, col);
354 * \sa operator[](Index), coeff(Index) const, coeffRef(Index,Index
    [all...]
TriangularMatrix.h 55 inline Scalar& coeffRef(Index row, Index col) { return derived().coeffRef(row,col); }
62 derived().coeffRef(row, col) = other.coeff(row, col);
73 return coeffRef(row,col);
228 /** \sa MatrixBase::coeffRef()
231 inline Scalar& coeffRef(Index row, Index col)
234 return m_matrix.const_cast_derived().coeffRef(row, col);
459 dst.coeffRef(row, col) = Scalar(1);
461 dst.coeffRef(row, col) = Scalar(0);
487 dst.coeffRef(i, j) = Scalar(0)
    [all...]
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);
Assign_MKL.h 95 const Scalar *src_ptr = src.IsRowMajor ? &(src.nestedExpression().coeffRef(outer,0)) :
96 &(src.nestedExpression().coeffRef(0, outer));
97 Scalar *dst_ptr = dst.IsRowMajor ? &(dst.coeffRef(outer,0)) : &(dst.coeffRef(0, outer));
  /external/eigen/Eigen/src/Eigen2Support/Geometry/
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();
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...]
  /external/eigen/Eigen/src/Geometry/
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();
OrthoMethods.h 144 perp.coeffRef(maxi) = -conj(src.coeff(sndi)) * invnm;
145 perp.coeffRef(sndi) = conj(src.coeff(maxi)) * invnm;
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;
  /external/eigen/Eigen/src/Householder/
BlockHouseholder.h 33 vectors.const_cast_derived().coeffRef(i,i) = Scalar(1);
36 vectors.const_cast_derived().coeffRef(i, i) = Vii;
  /external/eigen/bench/
sparse_setter.cpp 79 // if(stencil.coeffRef(ij.x(), ij.y())==0)
81 // stencil.coeffRef(ij.x(), ij.y()) = 1;
215 mat.coeffRef(coords[i].x(), coords[i].y()) += vals[i];
219 return &mat.coeffRef(coords[0].x(), coords[0].y());
238 return &mat.coeffRef(coords[0].x(), coords[0].y());
248 setter.coeffRef(coords[i].x(), coords[i].y()) += vals[i];
252 return &mat.coeffRef(coords[0].x(), coords[0].y());
267 return &mat.coeffRef(coords[0].x(), coords[0].y());
281 return &mat.coeffRef(coords[0].x(), coords[0].y());
294 return &mat.coeffRef(coords[0].x(), coords[0].y())
    [all...]
  /external/eigen/Eigen/src/SVD/
UpperBidiagonalization.h 107 .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));
JacobiSVD_MKL.h 75 /* for(int i=0;i<m_diagSize;i++) if (m_singularValues.coeffRef(i) < precision) { m_nonzeroSingularValues--; m_singularValues.coeffRef(i)=RealScalar(0);}*/ \
  /external/eigen/Eigen/src/SparseCore/
MappedSparseMatrix.h 85 inline Scalar& coeffRef(Index row, Index col)
92 eigen_assert(end>=start && "you probably called coeffRef on a non finalized matrix");
93 eigen_assert(end>start && "coeffRef cannot be called on a zero coefficient");
96 eigen_assert((*r==inner) && (id<end) && "coeffRef cannot be called on a zero coefficient");
  /external/eigen/unsupported/Eigen/
AlignedVector3 64 inline Scalar& coeffRef(Index row, Index col)
65 { return m_coeffs.coeffRef(row, col); }
70 inline Scalar& coeffRef(Index index)
71 { return m_coeffs.coeffRef(index);}
  /external/eigen/test/eigen2/
eigen2_sparse_basic.cpp 39 sm.coeffRef(remaining[i].x(),remaining[i].y()) = ref.coeff(remaining[i].x(),remaining[i].y());
70 // test coeff and coeffRef
75 VERIFY_RAISES_ASSERT( m.coeffRef(zeroCoords[0].x(),zeroCoords[0].y()) = 5 );
79 m.coeffRef(nonzeroCoords[0].x(), nonzeroCoords[0].y()) = Scalar(5);
80 refMat.coeffRef(nonzeroCoords[0].x(), nonzeroCoords[0].y()) = Scalar(5);
133 // w->coeffRef(nonzeroCoords[i].x(),nonzeroCoords[i].y()) = refMat.coeff(nonzeroCoords[i].x(),nonzeroCoords[i].y());
147 // w->coeffRef(remaining[i].x(),remaining[i].y()) = refMat.coeff(remaining[i].x(),remaining[i].y());
eigen2_basicstuff.cpp 38 m1.coeffRef(r,c) = x;
42 v1.coeffRef(r) = x;
  /external/eigen/Eigen/src/Cholesky/
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()
    [all...]
  /external/eigen/Eigen/src/Eigen2Support/
Minor.h 74 inline Scalar& coeffRef(Index row, Index col)
76 return m_matrix.const_cast_derived().coeffRef(row + (row >= m_row), col + (col >= m_col));
  /external/eigen/unsupported/Eigen/src/IterativeSolvers/
GMRES.h 87 r0.makeHouseholder(e, tau.coeffRef(0), beta);
99 v.tail(m - i).applyHouseholderOnTheLeft(H.col(i).tail(m - i - 1), tau.coeffRef(i), workspace.data());
108 v.tail(m - i).applyHouseholderOnTheLeft(H.col(i).tail(m - i - 1), tau.coeffRef(i), workspace.data());
118 v.tail(m - k).makeHouseholder(e, tau.coeffRef(k), beta);
122 v.tail(m - k).applyHouseholderOnTheLeft(H.col(k).tail(m - k - 1), tau.coeffRef(k), workspace.data());
159 x_new.tail(m - k + 1).applyHouseholderOnTheLeft(H.col(k - 1).tail(m - k), tau.coeffRef(k - 1), workspace.data());
164 x_new.tail(m - i).applyHouseholderOnTheLeft(H.col(i).tail(m - i - 1), tau.coeffRef(i), workspace.data());
185 r0.makeHouseholder(e, tau.coeffRef(0), beta);

Completed in 1159 milliseconds

12 3 4 5