GEOS
|
This is the complete list of members for geos::PetscMatrix, including all inherited members.
add(globalIndex const rowIndex, globalIndex const colIndex, real64 const value) override | geos::PetscMatrix | virtual |
add(globalIndex const rowIndex, globalIndex const *colIndices, real64 const *values, localIndex const size) override | geos::PetscMatrix | virtual |
add(globalIndex const rowIndex, arraySlice1d< globalIndex const > const &colIndices, arraySlice1d< real64 const > const &values) override | geos::PetscMatrix | virtual |
add(arraySlice1d< globalIndex const > const &rowIndices, arraySlice1d< globalIndex const > const &colIndices, arraySlice2d< real64 const > const &values) override | geos::PetscMatrix | virtual |
add(globalIndex const *rowIndices, globalIndex const *colIndices, real64 const *values, localIndex const numRows, localIndex const numCols) override | geos::PetscMatrix | virtual |
addDiagonal(PetscVector const &src, real64 const scale) override | geos::PetscMatrix | virtual |
addEntries(PetscMatrix const &src, MatrixPatternOp const op, real64 const scale=1.0) override | geos::PetscMatrix | virtual |
apply(PetscVector const &src, PetscVector &dst) const override | geos::PetscMatrix | virtual |
applyTranspose(Vector const &src, Vector &dst) const override | geos::PetscMatrix | virtual |
assembled() const | geos::PetscMatrix | inline |
MatrixBase< PetscMatrix, PetscVector >::assembled() const | geos::MatrixBase< PetscMatrix, PetscVector > | inlineprivate |
clampEntries(real64 const lo, real64 const hi, bool const excludeDiag) override | geos::PetscMatrix | virtual |
clearRow(globalIndex const row, bool const keepDiag=false, real64 const diagValue=0.0) override | geos::PetscMatrix | virtual |
close() override | geos::PetscMatrix | virtual |
closed() const | geos::PetscMatrix | inline |
MatrixBase< PetscMatrix, PetscVector >::closed() const | geos::MatrixBase< PetscMatrix, PetscVector > | inlineprivate |
comm() const override | geos::PetscMatrix | virtual |
create(CRSMatrixView< real64 const, globalIndex const > const &localMatrix, localIndex const numLocalColumns, MPI_Comm const &comm) | geos::PetscMatrix | inline |
MatrixBase< PetscMatrix, PetscVector >::create(CRSMatrixView< real64 const, globalIndex const > const &localMatrix, localIndex const numLocalColumns, MPI_Comm const &comm) | geos::MatrixBase< PetscMatrix, PetscVector > | inlineprivatevirtual |
created() const override | geos::PetscMatrix | virtual |
createWithGlobalSize(globalIndex const globalRows, globalIndex const globalCols, localIndex const maxEntriesPerRow, MPI_Comm const &comm) override | geos::PetscMatrix | virtual |
createWithGlobalSize(globalIndex const globalSize, localIndex const maxEntriesPerRow, MPI_Comm const &comm) | geos::PetscMatrix | inline |
createWithGlobalSize(globalIndex const globalRows, globalIndex const globalCols, localIndex const maxEntriesPerRow, MPI_Comm const &comm)=0 | geos::PetscMatrix | |
MatrixBase< PetscMatrix, PetscVector >::createWithGlobalSize(globalIndex const globalSize, localIndex const maxEntriesPerRow, MPI_Comm const &comm) | geos::MatrixBase< PetscMatrix, PetscVector > | inlineprivatevirtual |
createWithLocalSize(localIndex const localRows, localIndex const localCols, localIndex const maxEntriesPerRow, MPI_Comm const &comm) override | geos::PetscMatrix | virtual |
createWithLocalSize(localIndex const localSize, localIndex const maxEntriesPerRow, MPI_Comm const &comm) | geos::PetscMatrix | inline |
createWithLocalSize(localIndex const localRows, localIndex const localCols, localIndex const maxEntriesPerRow, MPI_Comm const &comm)=0 | geos::PetscMatrix | |
MatrixBase< PetscMatrix, PetscVector >::createWithLocalSize(localIndex const localSize, localIndex const maxEntriesPerRow, MPI_Comm const &comm) | geos::MatrixBase< PetscMatrix, PetscVector > | inlineprivatevirtual |
dofManager() const | geos::PetscMatrix | inline |
MatrixBase< PetscMatrix, PetscVector >::dofManager() const | geos::MatrixBase< PetscMatrix, PetscVector > | inlineprivate |
Export typedef | geos::PetscMatrix | |
extractDiagonal(PetscVector &dst) const override | geos::PetscMatrix | virtual |
gemv(real64 const alpha, PetscVector const &x, real64 const beta, PetscVector &y, bool useTranspose=false) const override | geos::PetscMatrix | virtual |
getGlobalRowID(localIndex const index) const override | geos::PetscMatrix | virtual |
getLocalRowID(globalIndex const index) const override | geos::PetscMatrix | virtual |
getRowCopy(globalIndex globalRow, arraySlice1d< globalIndex > const &colIndices, arraySlice1d< real64 > const &values) const override | geos::PetscMatrix | virtual |
getRowLengths(arrayView1d< localIndex > const &lengths) const override | geos::PetscMatrix | virtual |
getRowSums(PetscVector &dst, RowSumType const rowSumType) const override | geos::PetscMatrix | virtual |
ilower() const override | geos::PetscMatrix | virtual |
insert(globalIndex const rowIndex, globalIndex const colIndex, real64 const value) override | geos::PetscMatrix | virtual |
insert(globalIndex const rowIndex, globalIndex const *colIndices, real64 const *values, localIndex const size) override | geos::PetscMatrix | virtual |
insert(globalIndex const rowIndex, arraySlice1d< globalIndex const > const &colIndices, arraySlice1d< real64 const > const &values) override | geos::PetscMatrix | virtual |
insert(arraySlice1d< globalIndex const > const &rowIndices, arraySlice1d< globalIndex const > const &colIndices, arraySlice2d< real64 const > const &values) override | geos::PetscMatrix | virtual |
insert(globalIndex const *rowIndices, globalIndex const *colIndices, real64 const *values, localIndex const numRows, localIndex const numCols) override | geos::PetscMatrix | virtual |
insert(arrayView1d< globalIndex const > const &rowIndices, arrayView1d< globalIndex const > const &colIndices, arrayView1d< real64 const > const &values) override | geos::PetscMatrix | virtual |
insertable() const | geos::PetscMatrix | inline |
MatrixBase< PetscMatrix, PetscVector >::insertable() const | geos::MatrixBase< PetscMatrix, PetscVector > | inlineprivate |
iupper() const override | geos::PetscMatrix | virtual |
jlower() const override | geos::PetscMatrix | virtual |
jupper() const override | geos::PetscMatrix | virtual |
leftMultiplyTranspose(PetscMatrix const &src, PetscMatrix &dst) const override | geos::PetscMatrix | virtual |
leftRightScale(PetscVector const &vecLeft, PetscVector const &vecRight) override | geos::PetscMatrix | virtual |
leftScale(PetscVector const &vec) override | geos::PetscMatrix | virtual |
LinearOperator()=default | geos::LinearOperator< PetscVector > | |
Mat typedef | geos::PetscMatrix | |
maxRowLength() const override | geos::PetscMatrix | virtual |
modifiable() const | geos::PetscMatrix | inline |
MatrixBase< PetscMatrix, PetscVector >::modifiable() const | geos::MatrixBase< PetscMatrix, PetscVector > | inlineprivate |
multiply(PetscMatrix const &src, PetscMatrix &dst) const override | geos::PetscMatrix | virtual |
multiplyPtAP(PetscMatrix const &P, PetscMatrix &dst) const override | geos::PetscMatrix | virtual |
multiplyRAP(PetscMatrix const &R, PetscMatrix const &P, PetscMatrix &dst) const override | geos::PetscMatrix | virtual |
norm1() const override | geos::PetscMatrix | virtual |
normFrobenius() const override | geos::PetscMatrix | virtual |
normInf() const override | geos::PetscMatrix | virtual |
normMax() const override | geos::PetscMatrix | virtual |
normMax(arrayView1d< globalIndex const > const &m) const override | geos::PetscMatrix | virtual |
numGlobalCols() const override | geos::PetscMatrix | virtual |
MatrixBase< PetscMatrix, PetscVector >::numGlobalCols() const =0 | geos::MatrixBase< PetscMatrix, PetscVector > | private |
numGlobalNonzeros() const override | geos::PetscMatrix | virtual |
numGlobalRows() const override | geos::PetscMatrix | virtual |
MatrixBase< PetscMatrix, PetscVector >::numGlobalRows() const =0 | geos::MatrixBase< PetscMatrix, PetscVector > | private |
numLocalCols() const override | geos::PetscMatrix | virtual |
MatrixBase< PetscMatrix, PetscVector >::numLocalCols() const =0 | geos::MatrixBase< PetscMatrix, PetscVector > | private |
numLocalNonzeros() const override | geos::PetscMatrix | virtual |
numLocalRows() const override | geos::PetscMatrix | virtual |
MatrixBase< PetscMatrix, PetscVector >::numLocalRows() const =0 | geos::MatrixBase< PetscMatrix, PetscVector > | private |
open() override | geos::PetscMatrix | virtual |
operator=(PetscMatrix const &src) | geos::PetscMatrix | |
operator=(PetscMatrix &&src) noexcept | geos::PetscMatrix | |
PetscMatrix() | geos::PetscMatrix | |
PetscMatrix(PetscMatrix const &src) | geos::PetscMatrix | |
PetscMatrix(PetscMatrix &&src) noexcept | geos::PetscMatrix | |
print(std::ostream &os=std::cout) const override | geos::PetscMatrix | virtual |
ready() const | geos::PetscMatrix | inline |
MatrixBase< PetscMatrix, PetscVector >::ready() const | geos::MatrixBase< PetscMatrix, PetscVector > | inlineprivate |
rescaleRows(arrayView1d< globalIndex const > const &rowIndices, RowSumType const rowSumType) override | geos::PetscMatrix | virtual |
reset() override | geos::PetscMatrix | virtual |
residual(Vector const &x, Vector const &b, Vector &r) const override | geos::PetscMatrix | inline |
LinearOperator< PetscVector >::residual(Vector const &x, Vector const &b, Vector &r) const | geos::LinearOperator< PetscVector > | inlinevirtual |
MatrixBase< PetscMatrix, PetscVector >::residual(Vector const &x, Vector const &b, Vector &r) const override | geos::MatrixBase< PetscMatrix, PetscVector > | inlineprivatevirtual |
rightMultiplyTranspose(PetscMatrix const &src, PetscMatrix &dst) const override | geos::PetscMatrix | virtual |
rightScale(PetscVector const &vec) override | geos::PetscMatrix | virtual |
rowLength(globalIndex const globalRowIndex) const override | geos::PetscMatrix | virtual |
scale(real64 const scalingFactor) override | geos::PetscMatrix | virtual |
separateComponentFilter(PetscMatrix &dst, integer const dofsPerNode) const override | geos::PetscMatrix | virtual |
set(real64 const value) override | geos::PetscMatrix | virtual |
set(globalIndex const rowIndex, globalIndex const colIndex, real64 const value) override | geos::PetscMatrix | virtual |
set(globalIndex const rowIndex, globalIndex const *colIndices, real64 const *values, localIndex const size) override | geos::PetscMatrix | virtual |
set(globalIndex const rowIndex, arraySlice1d< globalIndex const > const &colIndices, arraySlice1d< real64 const > const &values) override | geos::PetscMatrix | virtual |
set(arraySlice1d< globalIndex const > const &rowIndices, arraySlice1d< globalIndex const > const &colIndices, arraySlice2d< real64 const > const &values) override | geos::PetscMatrix | virtual |
set(globalIndex const *rowIndices, globalIndex const *colIndices, real64 const *values, localIndex const numRows, localIndex const numCols) override | geos::PetscMatrix | virtual |
setDofManager(DofManager const *const dofManager) | geos::PetscMatrix | inline |
MatrixBase< PetscMatrix, PetscVector >::setDofManager(DofManager const *const dofManager) | geos::MatrixBase< PetscMatrix, PetscVector > | inlineprivate |
transpose(PetscMatrix &dst) const override | geos::PetscMatrix | virtual |
unwrapped() const | geos::PetscMatrix | |
unwrapped() | geos::PetscMatrix | |
Vector typedef | geos::PetscMatrix | |
write(string const &filename, LAIOutputFormat const format=LAIOutputFormat::MATRIX_MARKET) const override | geos::PetscMatrix | virtual |
zero() override | geos::PetscMatrix | virtual |
~LinearOperator()=default | geos::LinearOperator< PetscVector > | virtual |
~PetscMatrix() override | geos::PetscMatrix |