Package petsc4py :: Module PETSc :: Class Mat
[hide private]
[frames] | no frames]

Class Mat


Nested Classes [hide private]
  AssemblyType
  DuplicateOption
  FactorShiftType
  InfoType
  Option
  OrderingType
  SORType
  SolverType
  Stencil
  Structure
  Type
Instance Methods [hide private]
 
H2OpusCompress(self, tol)
 
H2OpusLowRankUpdate(self, Mat U, Mat V=None, s=1.0)
 
H2OpusOrthogonalize(self)
 
PtAP(self, Mat P, Mat result=None, fill=None)
 
SOR(self, Vec b, Vec x, omega=1.0, sortype=None, shift=0.0, its=1, lits=1)
 
__add__(y)
x+y
 
__call__(...) <==> x(...)
 
__delitem__(y)
del x[y]
 
__div__(y)
x/y
 
__dlpack__(self, stream=-1)
 
__dlpack_device__(self)
 
__getitem__(y)
x[y]
 
__iadd__(y)
x+=y
 
__idiv__(y)
x/=y
 
__imul__(y)
x*=y
 
__isub__(y)
x-=y
 
__itruediv__(y)
x/=y
 
__mul__(y)
x*y
 
__neg__()
-x
a new object with type S, a subtype of T
__new__(S, ...)
 
__pos__()
+x
 
__radd__(y)
y+x
 
__rdiv__(y)
y/x
 
__rmul__(y)
y*x
 
__rsub__(y)
y-x
 
__rtruediv__(y)
y/x
 
__setitem__(i, y)
x[i]=y
 
__sub__(y)
x-y
 
__truediv__(y)
x/y
 
appendOptionsPrefix(self, prefix)
 
assemble(self, assembly=None)
 
assemblyBegin(self, assembly=None)
 
assemblyEnd(self, assembly=None)
 
axpy(self, alpha, Mat X, structure=None)
 
aypx(self, alpha, Mat X, structure=None)
 
bindToCPU(self, flg)
 
boundToCPU(self)
 
chop(self, tol)
 
conjugate(self, Mat out=None)
 
convert(self, mat_type=None, Mat out=None)
 
copy(self, Mat result=None, structure=None)
 
create(self, comm=None)
 
createAIJ(self, size, bsize=None, nnz=None, csr=None, comm=None)
 
createAIJCRL(self, size, bsize=None, nnz=None, csr=None, comm=None)
 
createAIJWithArrays(self, size, csr, bsize=None, comm=None)
 
createBAIJ(self, size, bsize, nnz=None, csr=None, comm=None)
 
createDense(self, size, bsize=None, array=None, comm=None)
 
createDenseCUDA(self, size, bsize=None, array=None, cudahandle=None, comm=None)
Returns an instance of :class:`Mat`, a MATDENSECUDA with user provided memory spaces for CPU and GPU arrays.
 
createH2OpusFromMat(self, Mat A, coordinates=None, dist=None, eta=None, leafsize=None, maxrank=None, bs=None, rtol=None)
 
createHermitianTranspose(self, Mat mat)
 
createIS(self, size, LGMap lgmapr=None, LGMap lgmapc=None, comm=None)
 
createLRC(self, Mat A, Mat U, Vec c, Mat V)
 
createNest(self, mats, isrows=None, iscols=None, comm=None)
 
createNormal(self, Mat mat)
 
createNormalHermitian(self, Mat mat)
 
createPython(self, size, context=None, comm=None)
 
createSBAIJ(self, size, bsize, nnz=None, csr=None, comm=None)
 
createScatter(self, Scatter scatter, comm=None)
 
createSubMatrices(self, isrows, iscols=None, submats=None)
 
createSubMatrix(self, IS isrow, IS iscol=None, Mat submat=None)
 
createSubMatrixVirtual(self, Mat A, IS isrow, IS iscol=None)
 
createTranspose(self, Mat mat)
 
createVecLeft(self)
 
createVecRight(self)
 
createVecs(self, side=None)
 
destroy(self)
 
diagonalScale(self, Vec L=None, Vec R=None)
 
duplicate(self, copy=False)
 
equal(self, Mat mat)
 
factorCholesky(self, IS isperm, options=None)
 
factorICC(self, IS isperm, options=None)
 
factorILU(self, IS isrow, IS iscol, options=None)
 
factorLU(self, IS isrow, IS iscol, options=None)
 
factorNumericCholesky(self, Mat mat, options=None)
 
factorNumericLU(self, Mat mat, options=None)
 
factorSymbolicCholesky(self, IS isperm, options=None)
 
factorSymbolicICC(self, IS isperm, options=None)
 
factorSymbolicILU(self, IS isrow, IS iscol, options=None)
 
factorSymbolicLU(self, Mat mat, IS isrow, IS iscol, options=None)
 
findZeroRows(self)
 
fixISLocalEmpty(self, fix)
 
getBlockSize(self)
 
getBlockSizes(self)
 
getColumnIJ(self, symmetric=False, compressed=False)
 
getColumnVector(self, column, Vec result=None)
 
getDM(self)
 
getDenseArray(self, readonly=False)
 
getDenseColumnVec(self, i, mode='rw')
 
getDenseLDA(self)
 
getDenseLocalMatrix(self)
 
getDiagonal(self, Vec result=None)
 
getDiagonalBlock(self)
 
getISLocalMat(self)
 
getInertia(self)
 
getInfo(self, info=None)
 
getLGMap(self)
 
getLRCMats(self)
 
getLocalSize(self)
 
getLocalSubMatrix(self, IS isrow, IS iscol, Mat submat=None)
 
getMumpsCntl(self, icntl)
 
getMumpsIcntl(self, icntl)
 
getMumpsInfo(self, icntl)
 
getMumpsInfog(self, icntl)
 
getMumpsRinfo(self, icntl)
 
getMumpsRinfog(self, icntl)
 
getNearNullSpace(self)
 
getNestISs(self)
 
getNestLocalISs(self)
 
getNestSize(self)
 
getNestSubMatrix(self, i, j)
 
getNullSpace(self)
 
getOption(self, option)
 
getOptionsPrefix(self)
 
getOrdering(self, ord_type)
 
getOwnershipIS(self)
 
getOwnershipRange(self)
 
getOwnershipRangeColumn(self)
 
getOwnershipRanges(self)
 
getOwnershipRangesColumn(self)
 
getPythonContext(self)
 
getPythonType(self)
 
getRedundantMatrix(self, nsubcomm, subcomm=None, Mat out=None)
 
getRow(self, row)
 
getRowIJ(self, symmetric=False, compressed=False)
 
getRowSum(self, Vec result=None)
 
getSize(self)
 
getSizes(self)
 
getTransposeNullSpace(self)
 
getType(self)
 
getValue(self, row, col)
 
getValues(self, rows, cols, values=None)
 
getValuesCSR(self)
 
getVecLeft(self)
 
getVecRight(self)
 
getVecType(self)
 
getVecs(self, side=None)
 
hermitianTranspose(self, Mat out=None)
 
imagPart(self, Mat out=None)
 
increaseOverlap(self, IS iset, overlap=1)
 
invertBlockDiagonal(self)
 
isAssembled(self)
 
isHermitian(self, tol=0)
 
isHermitianKnown(self)
 
isStructurallySymmetric(self)
 
isSymmetric(self, tol=0)
 
isSymmetricKnown(self)
 
isTranspose(self, Mat mat=None, tol=0)
 
kron(self, Mat mat, Mat result=None)
 
load(self, Viewer viewer)
 
matMatMult(self, Mat B, Mat C, Mat result=None, fill=None)
 
matMult(self, Mat mat, Mat result=None, fill=None)
 
matSolve(self, Mat B, Mat X)
 
matTransposeMult(self, Mat mat, Mat result=None, fill=None)
 
mult(self, Vec x, Vec y)
 
multAdd(self, Vec x, Vec v, Vec y)
 
multHermitian(self, Vec x, Vec y)
 
multHermitianAdd(self, Vec x, Vec v, Vec y)
 
multTranspose(self, Vec x, Vec y)
 
multTransposeAdd(self, Vec x, Vec v, Vec y)
 
norm(self, norm_type=None)
 
permute(self, IS row, IS col)
 
ptap(self, Mat P, Mat result=None, fill=None)
 
rart(self, Mat R, Mat result=None, fill=None)
 
realPart(self, Mat out=None)
 
reorderForNonzeroDiagonal(self, IS isrow, IS iscol, atol=0)
 
restoreDenseColumnVec(self, i, mode='rw')
 
restoreISLocalMat(self, Mat local)
 
restoreLocalSubMatrix(self, IS isrow, IS iscol, Mat submat)
 
retrieveValues(self)
 
scale(self, alpha)
 
setBlockSize(self, bsize)
 
setBlockSizes(self, row_bsize, col_bsize)
 
setDM(self, DM dm)
 
setDenseLDA(self, lda)
 
setDiagonal(self, Vec diag, addv=None)
 
setFromOptions(self)
 
setISLocalMat(self, Mat local)
 
setISPreallocation(self, nnz, onnz)
 
setLGMap(self, LGMap rmap, LGMap cmap=None)
 
setMumpsCntl(self, icntl, val)
 
setMumpsIcntl(self, icntl, ival)
 
setNearNullSpace(self, NullSpace nsp)
 
setNullSpace(self, NullSpace nsp)
 
setOption(self, option, flag)
 
setOptionsPrefix(self, prefix)
 
setPreallocationCSR(self, csr)
 
setPreallocationDense(self, array)
 
setPreallocationNNZ(self, nnz)
 
setPythonContext(self, context)
 
setPythonType(self, py_type)
 
setRandom(self, Random random=None)
 
setSizes(self, size, bsize=None)
 
setStencil(self, dims, starts=None, dof=1)
 
setTransposeNullSpace(self, NullSpace nsp)
 
setTransposePrecursor(self, Mat out)
 
setType(self, mat_type)
 
setUnfactored(self)
 
setUp(self)
 
setValue(self, row, col, value, addv=None)
 
setValueBlockedStagStencil(self, row, col, value, addv=None)
 
setValueBlockedStencil(self, row, col, value, addv=None)
 
setValueLocal(self, row, col, value, addv=None)
 
setValueStagStencil(self, row, col, value, addv=None)
 
setValueStencil(self, row, col, value, addv=None)
 
setValues(self, rows, cols, values, addv=None)
 
setValuesBlocked(self, rows, cols, values, addv=None)
 
setValuesBlockedCSR(self, I, J, V, addv=None)
 
setValuesBlockedIJV(self, I, J, V, addv=None, rowmap=None)
 
setValuesBlockedLocal(self, rows, cols, values, addv=None)
 
setValuesBlockedLocalCSR(self, I, J, V, addv=None)
 
setValuesBlockedLocalIJV(self, I, J, V, addv=None, rowmap=None)
 
setValuesBlockedLocalRCV(self, R, C, V, addv=None)
 
setValuesBlockedRCV(self, R, C, V, addv=None)
 
setValuesCSR(self, I, J, V, addv=None)
 
setValuesIJV(self, I, J, V, addv=None, rowmap=None)
 
setValuesLocal(self, rows, cols, values, addv=None)
 
setValuesLocalCSR(self, I, J, V, addv=None)
 
setValuesLocalIJV(self, I, J, V, addv=None, rowmap=None)
 
setValuesLocalRCV(self, R, C, V, addv=None)
 
setValuesRCV(self, R, C, V, addv=None)
 
setVecType(self, vec_type)
 
shift(self, alpha)
 
solve(self, Vec b, Vec x)
 
solveAdd(self, Vec b, Vec y, Vec x)
 
solveBackward(self, Vec b, Vec x)
 
solveForward(self, Vec b, Vec x)
 
solveTranspose(self, Vec b, Vec x)
 
solveTransposeAdd(self, Vec b, Vec y, Vec x)
 
storeValues(self)
 
toDLPack(self, mode='rw')
 
transpose(self, Mat out=None)
 
transposeMatMult(self, Mat mat, Mat result=None, fill=None)
 
view(self, Viewer viewer=None)
 
zeroEntries(self)
 
zeroRows(self, rows, diag=1, Vec x=None, Vec b=None)
 
zeroRowsColumns(self, rows, diag=1, Vec x=None, Vec b=None)
 
zeroRowsColumnsLocal(self, rows, diag=1, Vec x=None, Vec b=None)
 
zeroRowsColumnsStencil(self, rows, diag=1, Vec x=None, Vec b=None)
 
zeroRowsLocal(self, rows, diag=1, Vec x=None, Vec b=None)

Inherited from Object: __copy__, __deepcopy__, __eq__, __ge__, __gt__, __le__, __lt__, __ne__, __nonzero__, compose, decRef, getAttr, getClassId, getClassName, getComm, getDict, getName, getRefCount, getTabLevel, incRef, incrementTabLevel, query, setAttr, setName, setTabLevel, stateGet, stateIncrease, stateSet, viewFromOptions

Inherited from object: __delattr__, __format__, __getattribute__, __hash__, __init__, __reduce__, __reduce_ex__, __repr__, __setattr__, __sizeof__, __str__, __subclasshook__

Properties [hide private]
  assembled
  block_size
  block_sizes
  hermitian
  local_size
  owner_range
  owner_ranges
  size
  sizes
  structsymm
  symmetric

Inherited from Object: classid, comm, fortran, handle, klass, name, prefix, refcount, type

Inherited from object: __class__

Method Details [hide private]

__new__(S, ...)

 
Returns: a new object with type S, a subtype of T
Overrides: object.__new__

appendOptionsPrefix(self, prefix)

 
Overrides: Object.appendOptionsPrefix

createDenseCUDA(self, size, bsize=None, array=None, cudahandle=None, comm=None)

 
Returns an instance of :class:`Mat`, a MATDENSECUDA with user provided
memory spaces for CPU and GPU arrays.

:arg size: A list denoting the size of the Mat.
:arg bsize: A :class:`int` denoting the block size.
:arg array: A :class:`numpy.ndarray`. Will be lazily allocated if
    *None*.
:arg cudahandle: Address of the array on the GPU. Will be lazily
    allocated if *None*. If cudahandle is provided, array will be
    ignored.
:arg comm: MPI communicator

destroy(self)

 
Overrides: Object.destroy

getOptionsPrefix(self)

 
Overrides: Object.getOptionsPrefix

getType(self)

 
Overrides: Object.getType

setFromOptions(self)

 
Overrides: Object.setFromOptions

setOptionsPrefix(self, prefix)

 
Overrides: Object.setOptionsPrefix

view(self, Viewer viewer=None)

 
Overrides: Object.view