GEOSX
geos::PetscMatrix Member List

This is the complete list of members for geos::PetscMatrix, including all inherited members.

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