Scroll to navigation

PETSC4PY(3) Project name not set PETSC4PY(3)

NAME

petsc4py - PETSc for Python

Lisandro Dalcin
<dalcinl@gmail.com>
<https://gitlab.com/petsc/petsc>
Nov 22, 2025

Abstract

This document describes petsc4py <#module-petsc4py>, a Python <https://www.python.org> wrapper to the PETSc <https://petsc.org> libraries.

PETSc <https://petsc.org> (the Portable, Extensible Toolkit for Scientific Computation) is a suite of data structures and routines for the scalable (parallel) solution of scientific applications modeled by partial differential equations. It employs the MPI <https://www.mpi-forum.org> standard for all message-passing communication.

This package provides an important subset of PETSc functionalities and uses NumPy <https://numpy.org> to efficiently manage input and output of array data.

A good friend of petsc4py is:

mpi4py <https://github.com/mpi4py/mpi4py>: Python bindings for MPI <https://www.mpi-forum.org>, the Message Passing Interface.



Other projects depend on petsc4py:

slepc4py <https://gitlab.com/slepc/slepc>: Python bindings for SLEPc <https://slepc.upv.es>, the Scalable Library for Eigenvalue Problem Computations.



PETSC OVERVIEW

PETSc <https://petsc.org> is a suite of data structures and routines for the scalable (parallel) solution of scientific applications modeled by partial differential equations. It employs the MPI <https://www.mpi-forum.org> standard for all message-passing communication.

PETSc is intended for use in large-scale application projects [petsc-efficient] <#petsc-efficient>, and several ongoing computational science projects are built around the PETSc libraries. With strict attention to component interoperability, PETSc facilitates the integration of independently developed application modules, which often most naturally employ different coding styles and data structures.

PETSc is easy to use for beginners [petsc-user-ref] <#petsc-user-ref>. Moreover, its careful design allows advanced users to have detailed control over the solution process. PETSc includes an expanding suite of parallel linear and nonlinear equation solvers that are easily used in application codes written in C, C++, and Fortran. PETSc provides many of the mechanisms needed within parallel application codes, such as simple parallel matrix and vector assembly routines that allow the overlap of communication and computation.

[petsc-user-ref]
S. Balay, S. Abhyankar, M. Adams, S. Benson, J. Brown, P. Brune, K. Buschelman, E. Constantinescu, L. Dalcin, A. Dener, V. Eijkhout, J. Faibussowitsch, W. Gropp, V. Hapla, T. Isaac, P. Jolivet, D. Karpeyev, D. Kaushik, M. Knepley, F. Kong, S. Kruger, D. May, L. Curfman McInnes, R. Mills, L. Mitchell, T. Munson, J. Roman, K. Rupp, P. Sanan, J Sarich, B. Smith, H. Suh, S. Zampini, H. Zhang, and H. Zhang, J. Zhang, PETSc/TAO Users Manual, ANL-21/39 - Revision 3.24, 2025. <https://doi.org/10.2172/2998643>, <https://petsc.org/release/docs/manual/manual.pdf>
[petsc-efficient]
Satish Balay, Victor Eijkhout, William D. Gropp, Lois Curfman McInnes and Barry F. Smith. Efficient Management of Parallelism in Object Oriented Numerical Software Libraries. Modern Software Tools in Scientific Computing. E. Arge, A. M. Bruaset and H. P. Langtangen, editors. 163--202. Birkhauser Press. 1997.

Components

PETSc is designed with an object-oriented style. Almost all user-visible types are abstract interfaces with implementations that may be chosen at runtime. Those objects are managed through handles to opaque data structures which are created, accessed and destroyed by calling appropriate library routines.

PETSc consists of a variety of components. Each component manipulates a particular family of objects and the operations one would like to perform on these objects. These components provide the functionality required for many parallel solutions of PDEs.

Provides the vector operations required for setting up and solving large-scale linear and nonlinear problems. Includes easy-to-use parallel scatter and gather operations, as well as special-purpose code for handling ghost points for regular data structures.
A large suite of data structures and code for the manipulation of parallel sparse matrices. Includes several different parallel matrix data structures, each appropriate for a different class of problems.
A collection of sequential and parallel preconditioners, including (sequential) ILU(k), LU, and (both sequential and parallel) block Jacobi, overlapping additive Schwarz methods.
Parallel implementations of many popular Krylov subspace iterative methods, including GMRES, CG, CGS, Bi-CG-Stab, two variants of TFQMR, CR, and LSQR. All are coded so that they are immediately usable with any preconditioners and any matrix data structures, including matrix-free methods.
Data-structure-neutral implementations of Newton-like methods for nonlinear systems. Includes both line search and trust region techniques with a single interface. Employs by default the above data structures and linear solvers. Users can set custom monitoring routines, convergence criteria, etc.
Code for the time evolution of solutions of PDEs. In addition, provides pseudo-transient continuation techniques for computing steady-state solutions.

INSTALLATION

Install from PyPI using pip

You can use pip to install petsc4py <#module-petsc4py> and its dependencies:

$ python -m pip install petsc petsc4py


Install from the PETSc source tree

First build PETSc <https://petsc.org/release/install/index.html#doc-install>. Next cd to the top of the PETSc source tree and set the PETSC_DIR <https://petsc.org/release/install/multibuild.html#doc-multi> and PETSC_ARCH <https://petsc.org/release/install/multibuild.html#doc-multi> environment variables. Run:

$ python -m pip install src/binding/petsc4py


The installation of petsc4py <#module-petsc4py> supports multiple PETSC_ARCH <https://petsc.org/release/install/multibuild.html#doc-multi> in the form of colon separated list:

$ PETSC_ARCH='arch-0:...:arch-N' python -m pip install src/binding/petsc4py


If you are cross-compiling, and the numpy <https://numpy.org/doc/stable/reference/index.html#module-numpy> module cannot be loaded on your build host, then before invoking pip, set the NUMPY_INCLUDE environment variable to the path that would be returned by import numpy; numpy.get_include():

$ export NUMPY_INCLUDE=/usr/lib/pythonX/site-packages/numpy/core/include


Running the testing suite

When installing from source, the petsc4py complete testsuite can be run as:

$ cd src/binding/petsc4py
$ python test/runtests.py


or via the makefile rule test:

$ make test -C src/binding/petsc4py


Specific tests can be run using the command-line option -k, e.g.:

$ python test/runtests.py -k test_optdb


to run all the tests provided in tests/test_optdb.py.

For other command-line options, run:

$ python test/runtests.py --help


If not otherwise specified, all tests will be run in sequential mode. To run all the tests with the same number of MPI processes, for example 4, run:

$ mpiexec -n 4 python test/runtests.py


or:

$ make test-4 -C src/binding/petsc4py


Building the documentation

Install the documentation dependencies:

$ python -m pip install -r src/binding/petsc4py/conf/requirements-docs.txt


Then:

$ cd src/binding/petsc4py/docs/source
$ make html


The resulting HTML files will be in _build/html.

Note:

Building the documentation requires Python 3.11 or later.


CONTRIBUTING

Contributions from the user community are welcome. See the PETSc developers <https://petsc.org/release/developers/index.html#ind-developers> documentation for general information on contributions.

New contributions to petsc4py must adhere with the coding standards. We use cython-lint <https://github.com/MarcoGorelli/cython-lint> for Cython and ruff <https://docs.astral.sh/ruff> for Python source codes. These can be installed using:

$ python -m pip install -r src/binding/petsc4py/conf/requirements-lint.txt


If you are contributing Cython code, you can check compliance with:

$ make cython-lint -C src/binding/petsc4py


For Python code, run:

$ make ruff-lint -C src/binding/petsc4py


Python code can be auto-formatted using:

$ make ruff-lint RUFF_OPTS='format' -C src/binding/petsc4py


New contributions to petsc4py must be tested. Tests are located in the src/binding/petsc4py/test folder. To add a new test, either add a new test_xxx.py or modify a pre-existing file according to the unittest <https://docs.python.org/3/library/unittest.html> specifications.

If you add a new test_xxx.py, you can run the tests using:

$ cd src/binding/petsc4py
$ python test/runtests.py -k test_xxx


If instead you are modifying an existing test_xxx.py, you can test your additions by using the fully qualified name of the Python class or method you are modifying, e.g.:

$ python test/runtests.py -k test_xxx.class_name.method_name


All new code must include documentation in accordance with the documentation standard <>. To check for compliance, run:

$ make html SPHINXOPTS='-W' -C src/binding/petsc4py/docs/source


Warning:

The docstrings must not cause Sphinx warnings.


CITATIONS

If PETSc for Python has been significant to a project that leads to an academic publication, please acknowledge that fact by citing the project.

  • L. Dalcin, P. Kler, R. Paz, and A. Cosimo, Parallel Distributed Computing using Python, Advances in Water Resources, 34(9):1124-1139, 2011. <https://doi.org/10.1016/j.advwatres.2011.04.013>
  • S. Balay, S. Abhyankar, M. Adams, S. Benson, J. Brown, P. Brune, K. Buschelman, E. Constantinescu, L. Dalcin, A. Dener, V. Eijkhout, J. Faibussowitsch, W. Gropp, V. Hapla, T. Isaac, P. Jolivet, D. Karpeyev, D. Kaushik, M. Knepley, F. Kong, S. Kruger, D. May, L. Curfman McInnes, R. Mills, L. Mitchell, T. Munson, J. Roman, K. Rupp, P. Sanan, J Sarich, B. Smith, H. Suh, S. Zampini, H. Zhang, and H. Zhang, J. Zhang, PETSc/TAO Users Manual, ANL-21/39 - Revision 3.24, 2025. <https://doi.org/10.2172/2998643>, <https://petsc.org/release/docs/manual/manual.pdf>

REFERENCE

petsc4py <#module-petsc4py> The PETSc for Python package.
petsc4py.typing <#module-petsc4py.typing> Typing support.
petsc4py.PETSc <#module-petsc4py.PETSc> Portable, Extensible Toolkit for Scientific Computation.

petsc4py

The PETSc for Python package.

This package is an interface to PETSc libraries.

PETSc <https://petsc.org> (the Portable, Extensible Toolkit for Scientific Computation) is a suite of data structures and routines for the scalable (parallel) solution of scientific applications modeled by partial differential equations. It employs the MPI <https://www.mpi-forum.org> standard for all message-passing communications.

Functions

get_config <#petsc4py.get_config>() Return a dictionary with information about PETSc.
get_include <#petsc4py.get_include>() Return the directory in the package that contains header files.
init <#petsc4py.init>([args, arch, comm]) Initialize PETSc.

petsc4py.get_config


petsc4py.get_include

Return the directory in the package that contains header files.

Extension modules that need to compile against petsc4py should use this function to locate the appropriate include directory.

Example

Using Python distutils or NumPy distutils:

import petsc4py
Extension('extension_name', ...

include_dirs=[..., petsc4py.get_include()])




petsc4py.init


petsc4py.typing

Typing support.

Attributes

Scalar <#petsc4py.typing.Scalar> Scalar type.
ArrayBool <#petsc4py.typing.ArrayBool> Array of bool <https://docs.python.org/3/library/functions.html#bool>.
ArrayInt <#petsc4py.typing.ArrayInt> Array of int <https://docs.python.org/3/library/functions.html#int>.
ArrayReal <#petsc4py.typing.ArrayReal> Array of float <https://docs.python.org/3/library/functions.html#float>.
ArrayComplex <#petsc4py.typing.ArrayComplex> Array of complex <https://docs.python.org/3/library/functions.html#complex>.
ArrayScalar <#petsc4py.typing.ArrayScalar> Array of Scalar <#petsc4py.typing.Scalar> numbers.
DimsSpec <#petsc4py.typing.DimsSpec> Dimensions specification.
AccessModeSpec <#petsc4py.typing.AccessModeSpec> Access mode specification.
InsertModeSpec <#petsc4py.typing.InsertModeSpec> Insertion mode specification.
ScatterModeSpec <#petsc4py.typing.ScatterModeSpec> Scatter mode specification.
LayoutSizeSpec <#petsc4py.typing.LayoutSizeSpec> int <https://docs.python.org/3/library/functions.html#int> or 2-tuple <https://docs.python.org/3/library/stdtypes.html#tuple> of int <https://docs.python.org/3/library/functions.html#int> describing the layout sizes.
NormTypeSpec <#petsc4py.typing.NormTypeSpec> Norm type specification.
PetscOptionsHandlerFunction <#petsc4py.typing.PetscOptionsHandlerFunction> Callback for processing extra options.
MatAssemblySpec <#petsc4py.typing.MatAssemblySpec> Matrix assembly specification.
MatSizeSpec <#petsc4py.typing.MatSizeSpec> int <https://docs.python.org/3/library/functions.html#int> or (nested) tuple <https://docs.python.org/3/library/stdtypes.html#tuple> of int <https://docs.python.org/3/library/functions.html#int> describing the matrix sizes.
MatBlockSizeSpec <#petsc4py.typing.MatBlockSizeSpec> The row and column block sizes.
CSRIndicesSpec <#petsc4py.typing.CSRIndicesSpec> CSR indices format specification.
CSRSpec <#petsc4py.typing.CSRSpec> CSR format specification.
NNZSpec <#petsc4py.typing.NNZSpec> Nonzero pattern specification.
MatNullFunction <#petsc4py.typing.MatNullFunction> PETSc.NullSpace <#petsc4py.PETSc.NullSpace> callback.
DMCoarsenHookFunction <#petsc4py.typing.DMCoarsenHookFunction> PETSc.DM <#petsc4py.PETSc.DM> coarsening hook callback.
DMRestrictHookFunction <#petsc4py.typing.DMRestrictHookFunction> PETSc.DM <#petsc4py.PETSc.DM> restriction hook callback.
KSPRHSFunction <#petsc4py.typing.KSPRHSFunction> PETSc.KSP <#petsc4py.PETSc.KSP> right-hand side function callback.
KSPOperatorsFunction <#petsc4py.typing.KSPOperatorsFunction> PETSc.KSP <#petsc4py.PETSc.KSP> operators function callback.
KSPConvergenceTestFunction <#petsc4py.typing.KSPConvergenceTestFunction> PETSc.KSP <#petsc4py.PETSc.KSP> convergence test callback.
KSPMonitorFunction <#petsc4py.typing.KSPMonitorFunction> PETSc.KSP <#petsc4py.PETSc.KSP> monitor callback.
KSPPreSolveFunction <#petsc4py.typing.KSPPreSolveFunction> PETSc.KSP <#petsc4py.PETSc.KSP> pre solve callback.
KSPPostSolveFunction <#petsc4py.typing.KSPPostSolveFunction> PETSc.KSP <#petsc4py.PETSc.KSP> post solve callback.
SNESMonitorFunction <#petsc4py.typing.SNESMonitorFunction> SNES <#petsc4py.PETSc.SNES> monitor callback.
SNESObjFunction <#petsc4py.typing.SNESObjFunction> SNES <#petsc4py.PETSc.SNES> objective function callback.
SNESFunction <#petsc4py.typing.SNESFunction> SNES <#petsc4py.PETSc.SNES> residual function callback.
SNESJacobianFunction <#petsc4py.typing.SNESJacobianFunction> SNES <#petsc4py.PETSc.SNES> Jacobian callback.
SNESGuessFunction <#petsc4py.typing.SNESGuessFunction> SNES <#petsc4py.PETSc.SNES> initial guess callback.
SNESUpdateFunction <#petsc4py.typing.SNESUpdateFunction> SNES <#petsc4py.PETSc.SNES> step update callback.
SNESLSPreFunction <#petsc4py.typing.SNESLSPreFunction> SNES <#petsc4py.PETSc.SNES> linesearch pre-check update callback.
SNESNGSFunction <#petsc4py.typing.SNESNGSFunction> SNES <#petsc4py.PETSc.SNES> nonlinear Gauss-Seidel callback.
SNESConvergedFunction <#petsc4py.typing.SNESConvergedFunction> SNES <#petsc4py.PETSc.SNES> convergence test callback.
TSRHSFunction <#petsc4py.typing.TSRHSFunction> TS <#petsc4py.PETSc.TS> right-hand side function callback.
TSRHSJacobian <#petsc4py.typing.TSRHSJacobian> TS <#petsc4py.PETSc.TS> right-hand side Jacobian callback.
TSRHSJacobianP <#petsc4py.typing.TSRHSJacobianP> TS <#petsc4py.PETSc.TS> right-hand side parameter Jacobian callback.
TSIFunction <#petsc4py.typing.TSIFunction> TS <#petsc4py.PETSc.TS> implicit function callback.
TSIJacobian <#petsc4py.typing.TSIJacobian> TS <#petsc4py.PETSc.TS> implicit Jacobian callback.
TSIJacobianP <#petsc4py.typing.TSIJacobianP> TS <#petsc4py.PETSc.TS> implicit parameter Jacobian callback.
TSI2Function <#petsc4py.typing.TSI2Function> TS <#petsc4py.PETSc.TS> implicit 2nd order function callback.
TSI2Jacobian <#petsc4py.typing.TSI2Jacobian> TS <#petsc4py.PETSc.TS> implicit 2nd order Jacobian callback.
TSI2JacobianP <#petsc4py.typing.TSI2JacobianP> TS <#petsc4py.PETSc.TS> implicit 2nd order parameter Jacobian callback.
TSMonitorFunction <#petsc4py.typing.TSMonitorFunction> TS <#petsc4py.PETSc.TS> monitor callback.
TSPreStepFunction <#petsc4py.typing.TSPreStepFunction> TS <#petsc4py.PETSc.TS> pre-step callback.
TSPostStepFunction <#petsc4py.typing.TSPostStepFunction> TS <#petsc4py.PETSc.TS> post-step callback.
TSIndicatorFunction <#petsc4py.typing.TSIndicatorFunction> TS <#petsc4py.PETSc.TS> event indicator callback.
TSPostEventFunction <#petsc4py.typing.TSPostEventFunction> TS <#petsc4py.PETSc.TS> post-event callback.
TAOObjectiveFunction <#petsc4py.typing.TAOObjectiveFunction> TAO <#petsc4py.PETSc.TAO> objective function callback.
TAOGradientFunction <#petsc4py.typing.TAOGradientFunction> TAO <#petsc4py.PETSc.TAO> objective gradient callback.
TAOObjectiveGradientFunction <#petsc4py.typing.TAOObjectiveGradientFunction> TAO <#petsc4py.PETSc.TAO> objective function and gradient callback.
TAOHessianFunction <#petsc4py.typing.TAOHessianFunction> TAO <#petsc4py.PETSc.TAO> objective Hessian callback.
TAOUpdateFunction <#petsc4py.typing.TAOUpdateFunction> TAO <#petsc4py.PETSc.TAO> update callback.
TAOMonitorFunction <#petsc4py.typing.TAOMonitorFunction> TAO <#petsc4py.PETSc.TAO> monitor callback.
TAOConvergedFunction <#petsc4py.typing.TAOConvergedFunction> TAO <#petsc4py.PETSc.TAO> convergence test callback.
TAOJacobianFunction <#petsc4py.typing.TAOJacobianFunction> TAO <#petsc4py.PETSc.TAO> Jacobian callback.
TAOResidualFunction <#petsc4py.typing.TAOResidualFunction> TAO <#petsc4py.PETSc.TAO> residual callback.
TAOJacobianResidualFunction <#petsc4py.typing.TAOJacobianResidualFunction> TAO <#petsc4py.PETSc.TAO> Jacobian residual callback.
TAOVariableBoundsFunction <#petsc4py.typing.TAOVariableBoundsFunction> TAO <#petsc4py.PETSc.TAO> variable bounds callback.
TAOConstraintsFunction <#petsc4py.typing.TAOConstraintsFunction> TAO <#petsc4py.PETSc.TAO> constraints callback.
TAOConstraintsJacobianFunction <#petsc4py.typing.TAOConstraintsJacobianFunction> TAO <#petsc4py.PETSc.TAO> constraints Jacobian callback.
TAOLSObjectiveFunction <#petsc4py.typing.TAOLSObjectiveFunction> TAOLineSearch <#petsc4py.PETSc.TAOLineSearch> objective function callback.
TAOLSGradientFunction <#petsc4py.typing.TAOLSGradientFunction> TAOLineSearch <#petsc4py.PETSc.TAOLineSearch> objective gradient callback.
TAOLSObjectiveGradientFunction <#petsc4py.typing.TAOLSObjectiveGradientFunction> TAOLineSearch <#petsc4py.PETSc.TAOLineSearch> objective function and gradient callback.

petsc4py.typing.Scalar

petsc4py.typing.Scalar = float | complex
Scalar type.

Scalars can be either float <https://docs.python.org/3/library/functions.html#float> or complex <https://docs.python.org/3/library/functions.html#complex> (but not both) depending on how PETSc was configured (./configure --with-scalar-type=real|complex).


petsc4py.typing.ArrayBool


petsc4py.typing.ArrayInt


petsc4py.typing.ArrayReal


petsc4py.typing.ArrayComplex


petsc4py.typing.ArrayScalar


petsc4py.typing.DimsSpec

Dimensions specification.

N-tuples indicates N-dimensional grid sizes.

alias of tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, ...]


petsc4py.typing.AccessModeSpec

Access mode specification.


alias of Literal <https://docs.python.org/3/library/typing.html#typing.Literal>['rw', 'r', 'w'] | None <https://docs.python.org/3/library/constants.html#None>


petsc4py.typing.InsertModeSpec

petsc4py.typing.InsertModeSpec = petsc4py.PETSc.InsertMode | bool | None
Insertion mode specification.


See also:

InsertMode <#petsc4py.PETSc.InsertMode>



petsc4py.typing.ScatterModeSpec

petsc4py.typing.ScatterModeSpec = petsc4py.PETSc.ScatterMode | bool | str | None
Scatter mode specification.


See also:

ScatterMode <#petsc4py.PETSc.ScatterMode>



petsc4py.typing.LayoutSizeSpec

petsc4py.typing.LayoutSizeSpec = int | tuple[int, int]
int <https://docs.python.org/3/library/functions.html#int> or 2-tuple <https://docs.python.org/3/library/stdtypes.html#tuple> of int <https://docs.python.org/3/library/functions.html#int> describing the layout sizes.

A single int <https://docs.python.org/3/library/functions.html#int> indicates global size. A tuple <https://docs.python.org/3/library/stdtypes.html#tuple> of int <https://docs.python.org/3/library/functions.html#int> indicates (local_size, global_size).

See also:

Sys.splitOwnership <#petsc4py.PETSc.Sys.splitOwnership>



petsc4py.typing.NormTypeSpec

petsc4py.typing.NormTypeSpec = petsc4py.PETSc.NormType | None
Norm type specification.

Possible values include:

  • NormType.NORM_1 <#petsc4py.PETSc.NormType.NORM_1> The 1-norm: Σₙ abs(xₙ) for vectors, maxₙ (Σᵢ abs(xₙᵢ)) for matrices.
  • NormType.NORM_2 <#petsc4py.PETSc.NormType.NORM_2> The 2-norm: √(Σₙ xₙ²) for vectors, largest singular values for matrices.
  • NormType.NORM_INFINITY <#petsc4py.PETSc.NormType.NORM_INFINITY> The ∞-norm: maxₙ abs(xₙ) for vectors, maxᵢ (Σₙ abs(xₙᵢ)) for matrices.
  • NormType.NORM_FROBENIUS <#petsc4py.PETSc.NormType.NORM_FROBENIUS> The Frobenius norm: same as 2-norm for vectors, √(Σₙᵢ xₙᵢ²) for matrices.
  • NormType.NORM_1_AND_2 <#petsc4py.PETSc.NormType.NORM_1_AND_2> Compute both NormType.NORM_1 <#petsc4py.PETSc.NormType.NORM_1> and NormType.NORM_2 <#petsc4py.PETSc.NormType.NORM_2>.
  • None <https://docs.python.org/3/library/constants.html#None> as NormType.NORM_2 <#petsc4py.PETSc.NormType.NORM_2> for vectors, NormType.NORM_FROBENIUS <#petsc4py.PETSc.NormType.NORM_FROBENIUS> for matrices.

See also:

PETSc.NormType <#petsc4py.PETSc.NormType>, NormType <https://petsc.org/release/manualpages/Vec/NormType.html>



petsc4py.typing.PetscOptionsHandlerFunction

Callback for processing extra options.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[Object <#petsc4py.PETSc.Object>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.MatAssemblySpec

petsc4py.typing.MatAssemblySpec = petsc4py.PETSc.Mat.AssemblyType | bool | None
Matrix assembly specification.


See also:



petsc4py.typing.MatSizeSpec

petsc4py.typing.MatSizeSpec = int | tuple[int, int] | tuple[tuple[int, int], tuple[int, int]]
int <https://docs.python.org/3/library/functions.html#int> or (nested) tuple <https://docs.python.org/3/library/stdtypes.html#tuple> of int <https://docs.python.org/3/library/functions.html#int> describing the matrix sizes.

If int <https://docs.python.org/3/library/functions.html#int> then rows = columns. A single tuple <https://docs.python.org/3/library/stdtypes.html#tuple> of int <https://docs.python.org/3/library/functions.html#int> indicates (rows, columns). A nested tuple <https://docs.python.org/3/library/stdtypes.html#tuple> of int <https://docs.python.org/3/library/functions.html#int> indicates ((local_rows, rows), (local_columns, columns)).

See also:

Sys.splitOwnership <#petsc4py.PETSc.Sys.splitOwnership>



petsc4py.typing.MatBlockSizeSpec

petsc4py.typing.MatBlockSizeSpec = int | tuple[int, int]
The row and column block sizes.

If a single int <https://docs.python.org/3/library/functions.html#int> is provided then rows and columns share the same block size.


petsc4py.typing.CSRIndicesSpec


petsc4py.typing.CSRSpec


petsc4py.typing.NNZSpec


petsc4py.typing.MatNullFunction

PETSc.NullSpace <#petsc4py.PETSc.NullSpace> callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[NullSpace <#petsc4py.PETSc.NullSpace>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.DMCoarsenHookFunction

PETSc.DM <#petsc4py.PETSc.DM> coarsening hook callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[DM <#petsc4py.PETSc.DM>, DM <#petsc4py.PETSc.DM>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.DMRestrictHookFunction

PETSc.DM <#petsc4py.PETSc.DM> restriction hook callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[DM <#petsc4py.PETSc.DM>, Mat <#petsc4py.PETSc.Mat>, Vec <#petsc4py.PETSc.Vec>, Mat <#petsc4py.PETSc.Mat>, DM <#petsc4py.PETSc.DM>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.KSPRHSFunction

PETSc.KSP <#petsc4py.PETSc.KSP> right-hand side function callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[KSP <#petsc4py.PETSc.KSP>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.KSPOperatorsFunction

PETSc.KSP <#petsc4py.PETSc.KSP> operators function callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[KSP <#petsc4py.PETSc.KSP>, Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.KSPConvergenceTestFunction

PETSc.KSP <#petsc4py.PETSc.KSP> convergence test callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[KSP <#petsc4py.PETSc.KSP>, int <https://docs.python.org/3/library/functions.html#int>, float <https://docs.python.org/3/library/functions.html#float>], ConvergedReason <#petsc4py.PETSc.KSP.ConvergedReason>]


petsc4py.typing.KSPMonitorFunction


petsc4py.typing.KSPPreSolveFunction

PETSc.KSP <#petsc4py.PETSc.KSP> pre solve callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[KSP <#petsc4py.PETSc.KSP>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.KSPPostSolveFunction

PETSc.KSP <#petsc4py.PETSc.KSP> post solve callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[KSP <#petsc4py.PETSc.KSP>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.SNESMonitorFunction


petsc4py.typing.SNESObjFunction

SNES <#petsc4py.PETSc.SNES> objective function callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[SNES <#petsc4py.PETSc.SNES>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.SNESFunction

SNES <#petsc4py.PETSc.SNES> residual function callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[SNES <#petsc4py.PETSc.SNES>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.SNESJacobianFunction

SNES <#petsc4py.PETSc.SNES> Jacobian callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[SNES <#petsc4py.PETSc.SNES>, Vec <#petsc4py.PETSc.Vec>, Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.SNESGuessFunction

SNES <#petsc4py.PETSc.SNES> initial guess callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[SNES <#petsc4py.PETSc.SNES>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.SNESUpdateFunction


petsc4py.typing.SNESLSPreFunction

SNES <#petsc4py.PETSc.SNES> linesearch pre-check update callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.SNESNGSFunction

SNES <#petsc4py.PETSc.SNES> nonlinear Gauss-Seidel callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[SNES <#petsc4py.PETSc.SNES>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.SNESConvergedFunction


petsc4py.typing.TSRHSFunction

TS <#petsc4py.PETSc.TS> right-hand side function callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TS <#petsc4py.PETSc.TS>, float <https://docs.python.org/3/library/functions.html#float>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TSRHSJacobian

TS <#petsc4py.PETSc.TS> right-hand side Jacobian callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TS <#petsc4py.PETSc.TS>, float <https://docs.python.org/3/library/functions.html#float>, Vec <#petsc4py.PETSc.Vec>, Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TSRHSJacobianP

TS <#petsc4py.PETSc.TS> right-hand side parameter Jacobian callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TS <#petsc4py.PETSc.TS>, float <https://docs.python.org/3/library/functions.html#float>, Vec <#petsc4py.PETSc.Vec>, Mat <#petsc4py.PETSc.Mat>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TSIFunction

TS <#petsc4py.PETSc.TS> implicit function callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TS <#petsc4py.PETSc.TS>, float <https://docs.python.org/3/library/functions.html#float>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TSIJacobian

TS <#petsc4py.PETSc.TS> implicit Jacobian callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TS <#petsc4py.PETSc.TS>, float <https://docs.python.org/3/library/functions.html#float>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>, float <https://docs.python.org/3/library/functions.html#float>, Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TSIJacobianP

TS <#petsc4py.PETSc.TS> implicit parameter Jacobian callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TS <#petsc4py.PETSc.TS>, float <https://docs.python.org/3/library/functions.html#float>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>, float <https://docs.python.org/3/library/functions.html#float>, Mat <#petsc4py.PETSc.Mat>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TSI2Function

TS <#petsc4py.PETSc.TS> implicit 2nd order function callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TS <#petsc4py.PETSc.TS>, float <https://docs.python.org/3/library/functions.html#float>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TSI2Jacobian

TS <#petsc4py.PETSc.TS> implicit 2nd order Jacobian callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TS <#petsc4py.PETSc.TS>, float <https://docs.python.org/3/library/functions.html#float>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>, float <https://docs.python.org/3/library/functions.html#float>, float <https://docs.python.org/3/library/functions.html#float>, Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TSI2JacobianP

TS <#petsc4py.PETSc.TS> implicit 2nd order parameter Jacobian callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TS <#petsc4py.PETSc.TS>, float <https://docs.python.org/3/library/functions.html#float>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>, float <https://docs.python.org/3/library/functions.html#float>, float <https://docs.python.org/3/library/functions.html#float>, Mat <#petsc4py.PETSc.Mat>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TSMonitorFunction


petsc4py.typing.TSPreStepFunction

TS <#petsc4py.PETSc.TS> pre-step callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TS <#petsc4py.PETSc.TS>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TSPostStepFunction

TS <#petsc4py.PETSc.TS> post-step callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TS <#petsc4py.PETSc.TS>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TSIndicatorFunction


petsc4py.typing.TSPostEventFunction


petsc4py.typing.TAOObjectiveFunction

TAO <#petsc4py.PETSc.TAO> objective function callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TAO <#petsc4py.PETSc.TAO>, Vec <#petsc4py.PETSc.Vec>], float <https://docs.python.org/3/library/functions.html#float>]


petsc4py.typing.TAOGradientFunction

TAO <#petsc4py.PETSc.TAO> objective gradient callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TAO <#petsc4py.PETSc.TAO>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TAOObjectiveGradientFunction

TAO <#petsc4py.PETSc.TAO> objective function and gradient callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TAO <#petsc4py.PETSc.TAO>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>], float <https://docs.python.org/3/library/functions.html#float>]


petsc4py.typing.TAOHessianFunction

TAO <#petsc4py.PETSc.TAO> objective Hessian callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TAO <#petsc4py.PETSc.TAO>, Vec <#petsc4py.PETSc.Vec>, Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TAOUpdateFunction


petsc4py.typing.TAOMonitorFunction

TAO <#petsc4py.PETSc.TAO> monitor callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TAO <#petsc4py.PETSc.TAO>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TAOConvergedFunction

TAO <#petsc4py.PETSc.TAO> convergence test callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TAO <#petsc4py.PETSc.TAO>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TAOJacobianFunction

TAO <#petsc4py.PETSc.TAO> Jacobian callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TAO <#petsc4py.PETSc.TAO>, Vec <#petsc4py.PETSc.Vec>, Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TAOResidualFunction

TAO <#petsc4py.PETSc.TAO> residual callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TAO <#petsc4py.PETSc.TAO>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TAOJacobianResidualFunction

TAO <#petsc4py.PETSc.TAO> Jacobian residual callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TAO <#petsc4py.PETSc.TAO>, Vec <#petsc4py.PETSc.Vec>, Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TAOVariableBoundsFunction

TAO <#petsc4py.PETSc.TAO> variable bounds callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TAO <#petsc4py.PETSc.TAO>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TAOConstraintsFunction

TAO <#petsc4py.PETSc.TAO> constraints callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TAO <#petsc4py.PETSc.TAO>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TAOConstraintsJacobianFunction

TAO <#petsc4py.PETSc.TAO> constraints Jacobian callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TAO <#petsc4py.PETSc.TAO>, Vec <#petsc4py.PETSc.Vec>, Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TAOLSObjectiveFunction

TAOLineSearch <#petsc4py.PETSc.TAOLineSearch> objective function callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TAOLineSearch <#petsc4py.PETSc.TAOLineSearch>, Vec <#petsc4py.PETSc.Vec>], float <https://docs.python.org/3/library/functions.html#float>]


petsc4py.typing.TAOLSGradientFunction

TAOLineSearch <#petsc4py.PETSc.TAOLineSearch> objective gradient callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TAOLineSearch <#petsc4py.PETSc.TAOLineSearch>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>]


petsc4py.typing.TAOLSObjectiveGradientFunction

TAOLineSearch <#petsc4py.PETSc.TAOLineSearch> objective function and gradient callback.

alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TAOLineSearch <#petsc4py.PETSc.TAOLineSearch>, Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>], float <https://docs.python.org/3/library/functions.html#float>]


petsc4py.PETSc

Portable, Extensible Toolkit for Scientific Computation.

Basic constants:

Use a default value for an int <https://docs.python.org/3/library/functions.html#int> or float <https://docs.python.org/3/library/functions.html#float> parameter.
Use a default value chosen by PETSc.
Compute a default value for an int <https://docs.python.org/3/library/functions.html#int> or float <https://docs.python.org/3/library/functions.html#float> parameter. For tolerances this uses the default value from when the object's type was set.
Do not change the current value that is set.
For a parameter that is a bound, such as the maximum number of iterations, do not bound the value.

More constants:

Very large real value.
Very large negative real value.
Very large positive real value, same as INFINITY <#petsc4py.PETSc.INFINITY>.

Classes

AO <#petsc4py.PETSc.AO> Application ordering object.
CellDM <#petsc4py.PETSc.CellDM> CellDM object.
Comm <#petsc4py.PETSc.Comm> Communicator object.
DM <#petsc4py.PETSc.DM> An object describing a computational grid or mesh.
DMComposite <#petsc4py.PETSc.DMComposite> A DM object that is used to manage data for a collection of DMs.
DMDA <#petsc4py.PETSc.DMDA> A DM object that is used to manage data for a structured grid.
DMInterpolation <#petsc4py.PETSc.DMInterpolation> Interpolation on a mesh.
DMLabel <#petsc4py.PETSc.DMLabel> An object representing a subset of mesh entities from a DM <#petsc4py.PETSc.DM>.
DMPlex <#petsc4py.PETSc.DMPlex> Encapsulate an unstructured mesh.
DMPlexTransform <#petsc4py.PETSc.DMPlexTransform> Mesh transformations.
DMPlexTransformType <#petsc4py.PETSc.DMPlexTransformType> Transformation types.
DMShell <#petsc4py.PETSc.DMShell> A shell DM object, used to manage user-defined problem data.
DMStag <#petsc4py.PETSc.DMStag> A DM object representing a "staggered grid" or a structured cell complex.
DMSwarm <#petsc4py.PETSc.DMSwarm> A DM <#petsc4py.PETSc.DM> object used to represent arrays of data (fields) of arbitrary type.
DS <#petsc4py.PETSc.DS> Discrete System object.
Device <#petsc4py.PETSc.Device> The device object.
DeviceContext <#petsc4py.PETSc.DeviceContext> DeviceContext object.
DualSpace <#petsc4py.PETSc.DualSpace> Dual space to a linear space.
FE <#petsc4py.PETSc.FE> A PETSc object that manages a finite element space.
IS <#petsc4py.PETSc.IS> A collection of indices.
InsertMode <#petsc4py.PETSc.InsertMode> Insertion mode.
KSP <#petsc4py.PETSc.KSP> Abstract PETSc object that manages all Krylov methods.
LGMap <#petsc4py.PETSc.LGMap> Mapping from a local to a global ordering.
Log <#petsc4py.PETSc.Log> Logging support.
LogClass <#petsc4py.PETSc.LogClass> Logging support.
LogEvent <#petsc4py.PETSc.LogEvent> Logging support.
LogStage <#petsc4py.PETSc.LogStage> Logging support for different stages.
Mat <#petsc4py.PETSc.Mat> Matrix object.
MatPartitioning <#petsc4py.PETSc.MatPartitioning> Object for managing the partitioning of a matrix or graph.
NormType <#petsc4py.PETSc.NormType> Norm type.
NullSpace <#petsc4py.PETSc.NullSpace> Nullspace object.
Object <#petsc4py.PETSc.Object> Base class wrapping a PETSc object.
Options <#petsc4py.PETSc.Options> The options database object.
PC <#petsc4py.PETSc.PC> Preconditioners.
Partitioner <#petsc4py.PETSc.Partitioner> A graph partitioner.
Quad <#petsc4py.PETSc.Quad> Quadrature rule for integration.
Random <#petsc4py.PETSc.Random> The random number generator object.
Regressor <#petsc4py.PETSc.Regressor> Regression solver.
RegressorLinearType <#petsc4py.PETSc.RegressorLinearType> Linear regressor type.
SF <#petsc4py.PETSc.SF> Star Forest object for communication.
SNES <#petsc4py.PETSc.SNES> Nonlinear equations solver.
SNESLineSearch <#petsc4py.PETSc.SNESLineSearch> Linesearch object used by SNES solvers.
Scatter <#petsc4py.PETSc.Scatter> Scatter object.
ScatterMode <#petsc4py.PETSc.ScatterMode> Scatter mode.
Section <#petsc4py.PETSc.Section> Mapping from integers in a range to unstructured set of integers.
Space <#petsc4py.PETSc.Space> Function space object.
Sys <#petsc4py.PETSc.Sys> System utilities.
TAO <#petsc4py.PETSc.TAO> Optimization solver.
TAOLineSearch <#petsc4py.PETSc.TAOLineSearch> TAO Line Search.
TS <#petsc4py.PETSc.TS> ODE integrator.
Vec <#petsc4py.PETSc.Vec> A vector object.
Viewer <#petsc4py.PETSc.Viewer> Viewer object.
ViewerHDF5 <#petsc4py.PETSc.ViewerHDF5> Viewer object for HDF5 file formats.

petsc4py.PETSc.AO

Bases: Object <#petsc4py.PETSc.Object>

Application ordering object.

Enumerations

Type <#petsc4py.PETSc.AO.Type> The application ordering types.

petsc4py.PETSc.AO.Type


Methods Summary

app2petsc(indices) Map an application-defined ordering to the PETSc ordering.
createBasic(app[, petsc, comm]) Return a basic application ordering using two orderings.
createMapping(app[, petsc, comm]) Return an application mapping using two orderings.
createMemoryScalable(app[, petsc, comm]) Return a memory scalable application ordering using two orderings.
destroy() Destroy the application ordering.
getType() Return the application ordering type.
petsc2app(indices) Map a PETSc ordering to the application-defined ordering.
view([viewer]) Display the application ordering.

Methods Documentation

Map an application-defined ordering to the PETSc ordering.

Collective.

Any integers in indices that are negative are left unchanged. This allows one to convert, for example, neighbor lists that use negative entries to indicate nonexistent neighbors due to boundary conditions, etc.

Integers that are out of range are mapped to -1.

If IS is used, it cannot be of type stride or block.


See also:


Source code at petsc4py/PETSc/AO.pyx:214 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/AO.pyx#L214>


Return a basic application ordering using two orderings.

Collective.

The arrays/indices app and petsc must contain all the integers 0 to len(app)-1 with no duplicates; that is there cannot be any "holes" in the indices. Use createMapping if you wish to have "holes" in the indices.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/AO.pyx:53 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/AO.pyx#L53>


Return an application mapping using two orderings.

Collective.

The arrays app and petsc need NOT contain all the integers 0 to len(app)-1, that is there CAN be "holes" in the indices. Use createBasic if they do not have holes for better performance.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/AO.pyx:154 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/AO.pyx#L154>


Return a memory scalable application ordering using two orderings.

Collective.

The arrays/indices app and petsc must contain all the integers 0 to len(app)-1 with no duplicates; that is there cannot be any "holes" in the indices. Use createMapping if you wish to have "holes" in the indices.

Comparing with createBasic, this routine trades memory with message communication.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/AO.pyx:102 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/AO.pyx#L102>




Map a PETSc ordering to the application-defined ordering.

Collective.

Any integers in indices that are negative are left unchanged. This allows one to convert, for example, neighbor lists that use negative entries to indicate nonexistent neighbors due to boundary conditions, etc.

Integers that are out of range are mapped to -1.

If IS is used, it cannot be of type stride or block.


See also:


Source code at petsc4py/PETSc/AO.pyx:248 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/AO.pyx#L248>


Display the application ordering.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the ordering.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/AO.pyx:21 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/AO.pyx#L21>




petsc4py.PETSc.CellDM

Bases: Object <#petsc4py.PETSc.Object>

CellDM object.

See also:


Methods Summary

create(dm, fields, coords) Create the cell DM.
destroy() Destroy the cell DM.
getBlockSize(sw) Return the block size for this cell DM.
getCellID() Return the cellid field for this cell DM.
getCoordinateFields() Return the swarm fields used as coordinates on this cell DM.
getDM() Return the underlying DM.
getFields() Return the swarm fields defined on this cell DM.
view([viewer]) View the cell DM.

Methods Documentation

Create the cell DM.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:1121 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L1121>



Return the block size for this cell DM.

Not collective.

sw (DM <#petsc4py.PETSc.DM>) -- The DMSwarm <#petsc4py.PETSc.DMSwarm> object
int <https://docs.python.org/3/library/functions.html#int>

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:1195 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L1195>




Return the underlying DM.

Not collective.

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:1164 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L1164>

DM <#petsc4py.PETSc.DM>



View the cell DM.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> instance or None <https://docs.python.org/3/library/constants.html#None> for the default viewer.
None <https://docs.python.org/3/library/constants.html#None>

See also:

Viewer <#petsc4py.PETSc.Viewer>, DMSwarmCellDMView <https://petsc.org/release/manualpages/DMSwarm/DMSwarmCellDMView.html>


Source code at petsc4py/PETSc/DMSwarm.pyx:1089 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L1089>



petsc4py.PETSc.Comm

Bases: object <https://docs.python.org/3/library/functions.html#object>

Communicator object.

Predefined instances:

The null (or invalid) communicator.
The self communicator.
The world communicator.

See also:

Sys.setDefaultComm <#petsc4py.PETSc.Sys.setDefaultComm>, Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>


Methods Summary

barrier() Barrier synchronization.
destroy() Destroy the communicator.
duplicate() Duplicate the communicator.
getRank() Return the rank of the calling processes in the communicator.
getSize() Return the number of processes in the communicator.
tompi4py() Convert communicator to mpi4py <https://mpi4py.readthedocs.io/en/stable/mpi4py.html#module-mpi4py>.

Attributes Summary

fortran Fortran handle.
rank Communicator rank.
size Communicator size.

Methods Documentation




Return the rank of the calling processes in the communicator.

Not collective.

Source code at petsc4py/PETSc/Comm.pyx:111 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Comm.pyx#L111>



Return the number of processes in the communicator.

Not collective.

Source code at petsc4py/PETSc/Comm.pyx:99 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Comm.pyx#L99>




Attributes Documentation





petsc4py.PETSc.DM

Bases: Object <#petsc4py.PETSc.Object>

An object describing a computational grid or mesh.

Enumerations

BoundaryType <#petsc4py.PETSc.DM.BoundaryType> DM Boundary types.
PolytopeType <#petsc4py.PETSc.DM.PolytopeType> The DM cell types.
ReorderDefaultFlag <#petsc4py.PETSc.DM.ReorderDefaultFlag> The DM reordering default flags.
Type <#petsc4py.PETSc.DM.Type> DM types.

petsc4py.PETSc.DM.BoundaryType


petsc4py.PETSc.DM.PolytopeType

Bases: object <https://docs.python.org/3/library/functions.html#object>

The DM <#petsc4py.PETSc.DM> cell types.

Attributes Summary

FV_GHOST Constant FV_GHOST of type int <https://docs.python.org/3/library/functions.html#int>
HEXAHEDRON Constant HEXAHEDRON of type int <https://docs.python.org/3/library/functions.html#int>
INTERIOR_GHOST Constant INTERIOR_GHOST of type int <https://docs.python.org/3/library/functions.html#int>
POINT Constant POINT of type int <https://docs.python.org/3/library/functions.html#int>
POINT_PRISM_TENSOR Constant POINT_PRISM_TENSOR of type int <https://docs.python.org/3/library/functions.html#int>
PYRAMID Constant PYRAMID of type int <https://docs.python.org/3/library/functions.html#int>
QUADRILATERAL Constant QUADRILATERAL of type int <https://docs.python.org/3/library/functions.html#int>
QUAD_PRISM_TENSOR Constant QUAD_PRISM_TENSOR of type int <https://docs.python.org/3/library/functions.html#int>
SEGMENT Constant SEGMENT of type int <https://docs.python.org/3/library/functions.html#int>
SEG_PRISM_TENSOR Constant SEG_PRISM_TENSOR of type int <https://docs.python.org/3/library/functions.html#int>
TETRAHEDRON Constant TETRAHEDRON of type int <https://docs.python.org/3/library/functions.html#int>
TRIANGLE Constant TRIANGLE of type int <https://docs.python.org/3/library/functions.html#int>
TRI_PRISM Constant TRI_PRISM of type int <https://docs.python.org/3/library/functions.html#int>
TRI_PRISM_TENSOR Constant TRI_PRISM_TENSOR of type int <https://docs.python.org/3/library/functions.html#int>
UNKNOWN Constant UNKNOWN of type int <https://docs.python.org/3/library/functions.html#int>
UNKNOWN_CELL Constant UNKNOWN_CELL of type int <https://docs.python.org/3/library/functions.html#int>
UNKNOWN_FACE Constant UNKNOWN_FACE of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation



















petsc4py.PETSc.DM.ReorderDefaultFlag


petsc4py.PETSc.DM.Type

Bases: object <https://docs.python.org/3/library/functions.html#object>

DM <#petsc4py.PETSc.DM> types.

Attributes Summary

COMPOSITE Object COMPOSITE of type str <https://docs.python.org/3/library/stdtypes.html#str>
DA Object DA of type str <https://docs.python.org/3/library/stdtypes.html#str>
FOREST Object FOREST of type str <https://docs.python.org/3/library/stdtypes.html#str>
MOAB Object MOAB of type str <https://docs.python.org/3/library/stdtypes.html#str>
NETWORK Object NETWORK of type str <https://docs.python.org/3/library/stdtypes.html#str>
P4EST Object P4EST of type str <https://docs.python.org/3/library/stdtypes.html#str>
P8EST Object P8EST of type str <https://docs.python.org/3/library/stdtypes.html#str>
PATCH Object PATCH of type str <https://docs.python.org/3/library/stdtypes.html#str>
PLEX Object PLEX of type str <https://docs.python.org/3/library/stdtypes.html#str>
PRODUCT Object PRODUCT of type str <https://docs.python.org/3/library/stdtypes.html#str>
REDUNDANT Object REDUNDANT of type str <https://docs.python.org/3/library/stdtypes.html#str>
SHELL Object SHELL of type str <https://docs.python.org/3/library/stdtypes.html#str>
SLICED Object SLICED of type str <https://docs.python.org/3/library/stdtypes.html#str>
STAG Object STAG of type str <https://docs.python.org/3/library/stdtypes.html#str>
SWARM Object SWARM of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation

















Methods Summary

adaptLabel(label) Adapt a DM based on a DMLabel <#petsc4py.PETSc.DMLabel>.
adaptMetric(metric[, bdLabel, rgLabel]) Return a mesh adapted to the specified metric field.
addCoarsenHook(coarsenhook, restricthook[, ...]) Add a callback to be executed when restricting to a coarser grid.
addField(field[, label]) Add a field to a DM object.
appendOptionsPrefix(prefix) Append to the prefix used for searching for options in the database.
clearDS() Remove all discrete systems from the DM.
clearFields() Remove all fields from the DM.
clearLabelStratum(name, value) Remove all points from a stratum.
clearLabelValue(name, point, value) Remove a point from a DMLabel <#petsc4py.PETSc.DMLabel> with given value.
clone() Return the cloned DM .
coarsen([comm]) Return a coarsened DM object.
coarsenHierarchy(nlevels) Coarsen this DM and return the coarsened DM hierarchy.
convert(dm_type) Return a DM converted to another DM.
copyDS(dm[, minDegree, maxDegree]) Copy the discrete systems for this DM into another DM.
copyDisc(dm) Copy fields and discrete systems of a DM into another DM.
copyFields(dm[, minDegree, maxDegree]) Copy the discretizations of this DM into another DM.
create([comm]) Return an empty DM.
createDS() Create discrete systems.
createFieldDecomposition() Return field splitting information.
createGlobalVec() Return a global vector.
createInjection(dm) Return the injection matrix into a finer DM.
createInterpolation(dm) Return the interpolation matrix to a finer DM.
createLabel(name) Create a label of the given name if it does not already exist.
createLocalVec() Return a local vector.
createMassMatrix(dmf) Return the mass matrix between this DM and the given DM.
createMat() Return an empty matrix.
createRestriction(dm) Return the restriction matrix between this DM and the given DM.
createSectionSF(localsec, globalsec) Create the SF <#petsc4py.PETSc.SF> encoding the parallel DOF overlap for the DM.
createSubDM(fields) Return IS <#petsc4py.PETSc.IS> and DM encapsulating a subproblem.
destroy() Destroy the object.
getAppCtx() Return the application context.
getAuxiliaryVec([label, value, part]) Return an auxiliary vector for region.
getBasicAdjacency() Return the flags for determining variable influence.
getBlockSize() Return the inherent block size associated with a DM.
getBoundingBox() Return the dimension of embedding space for coordinates values.
getCellCoordinateDM() Return the cell coordinate DM.
getCellCoordinateSection() Return the cell coordinate layout over the DM.
getCellCoordinates() Return a global vector with the cellwise coordinates.
getCellCoordinatesLocal() Return a local vector with the cellwise coordinates.
getCoarseDM() Return the coarse DM.
getCoarsenLevel() Return the number of coarsenings.
getCoordinateDM() Return the coordinate DM.
getCoordinateDim() Return the dimension of embedding space for coordinates values.
getCoordinateSection() Return coordinate values layout over the mesh.
getCoordinates() Return a global vector with the coordinates associated.
getCoordinatesLocal() Return a local vector with the coordinates associated.
getCoordinatesLocalized() Check if the coordinates have been localized for cells.
getDS() Return default DS <#petsc4py.PETSc.DS>.
getDimension() Return the topological dimension of the DM.
getField(index) Return the discretization object for a given DM field.
getFieldAdjacency(field) Return the flags for determining variable influence.
getGlobalSection() Return the Section <#petsc4py.PETSc.Section> encoding the global data layout for the DM.
getGlobalVec([name]) Return a global vector.
getLGMap() Return local mapping to global mapping.
getLabel(name) Return the label of a given name.
getLabelIdIS(name) Return an IS <#petsc4py.PETSc.IS> of all values that the DMLabel <#petsc4py.PETSc.DMLabel> takes.
getLabelName(index) Return the name of nth label.
getLabelOutput(name) Return the output flag for a given label.
getLabelSize(name) Return the number of values that the DMLabel <#petsc4py.PETSc.DMLabel> takes.
getLabelValue(name, point) Return the value in DMLabel <#petsc4py.PETSc.DMLabel> for the given point.
getLocalBoundingBox() Return the bounding box for the piece of the DM.
getLocalSection() Return the Section <#petsc4py.PETSc.Section> encoding the local data layout for the DM.
getLocalVec([name]) Return a local vector.
getNumFields() Return the number of fields in the DM.
getNumLabels() Return the number of labels defined by on the DM.
getOptionsPrefix() Return the prefix used for searching for options in the database.
getPeriodicity() Set the description of mesh periodicity.
getPointSF() Return the SF <#petsc4py.PETSc.SF> encoding the parallel DOF overlap for the DM.
getRefineLevel() Return the refinement level.
getSectionSF() Return the Section <#petsc4py.PETSc.Section> encoding the parallel DOF overlap.
getStratumIS(name, value) Return the points in a label stratum.
getStratumSize(name, value) Return the number of points in a label stratum.
getType() Return the DM type name.
globalToLocal(vg, vl[, addv]) Update local vectors from global vector.
hasLabel(name) Determine whether the DM has a label.
load(viewer) Return a DM stored in binary.
localToGlobal(vl, vg[, addv]) Update global vectors from local vector.
localToLocal(vl, vlg[, addv]) Map the values from a local vector to another local vector.
localizeCoordinates() Create local coordinates for cells having periodic faces.
refine([comm]) Return a refined DM object.
refineHierarchy(nlevels) Refine this DM and return the refined DM hierarchy.
removeLabel(name) Remove and destroy the label by name.
restoreGlobalVec(vg[, name]) Restore a global vector obtained with getGlobalVec.
restoreLocalVec(vl[, name]) Restore a local vector obtained with getLocalVec.
setAppCtx(appctx) Set the application context.
setAuxiliaryVec(aux, label[, value, part]) Set an auxiliary vector for a specific region.
setBasicAdjacency(useCone, useClosure) Set the flags for determining variable influence.
setCellCoordinateDM(dm) Set the cell coordinate DM.
setCellCoordinateSection(dim, sec) Set the cell coordinate layout over the DM.
setCellCoordinates(c) Set a global vector with the cellwise coordinates.
setCellCoordinatesLocal(c) Set a local vector with the cellwise coordinates.
setCoarseDM(dm) Set the coarse DM.
setCoordinateDim(dim) Set the dimension of embedding space for coordinates values.
setCoordinateDisc(disc, localized, project) Project coordinates to a different space.
setCoordinates(c) Set a global vector that holds the coordinates.
setCoordinatesLocal(c) Set a local vector with the ghost point holding the coordinates.
setDimension(dim) Set the topological dimension of the DM.
setField(index, field[, label]) Set the discretization object for a given DM field.
setFieldAdjacency(field, useCone, useClosure) Set the flags for determining variable influence.
setFromOptions() Configure the object from the options database.
setGlobalSection(sec) Set the Section <#petsc4py.PETSc.Section> encoding the global data layout for the DM.
setKSPComputeOperators(operators[, args, kargs]) Matrix associated with the linear system.
setLabelOutput(name, output) Set if a given label should be saved to a view.
setLabelValue(name, point, value) Set a point to a DMLabel <#petsc4py.PETSc.DMLabel> with a given value.
setLocalSection(sec) Set the Section <#petsc4py.PETSc.Section> encoding the local data layout for the DM.
setMatType(mat_type) Set matrix type to be used by DM.createMat.
setNumFields(numFields) Set the number of fields in the DM.
setOptionsPrefix(prefix) Set the prefix used for searching for options in the database.
setPeriodicity(maxCell, Lstart, L) Set the description of mesh periodicity.
setPointSF(sf) Set the SF <#petsc4py.PETSc.SF> encoding the parallel DOF overlap for the DM.
setRefineLevel(level) Set the number of refinements.
setSNESFunction(function[, args, kargs]) Set SNES <#petsc4py.PETSc.SNES> residual evaluation function.
setSNESJacobian(jacobian[, args, kargs]) Set the SNES <#petsc4py.PETSc.SNES> Jacobian evaluation function.
setSectionSF(sf) Set the Section <#petsc4py.PETSc.Section> encoding the parallel DOF overlap for the DM.
setType(dm_type) Build a DM.
setUp() Return the data structure.
setVecType(vec_type) Set the type of vector.
view([viewer]) View the DM.

Attributes Summary

appctx Application context.
ds Discrete space.

Methods Documentation

Adapt a DM based on a DMLabel <#petsc4py.PETSc.DMLabel>.

Collective.

label (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The name of the DMLabel <#petsc4py.PETSc.DMLabel>.
DM <#petsc4py.PETSc.DM>

See also:


Source code at petsc4py/PETSc/DM.pyx:1713 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1713>


Return a mesh adapted to the specified metric field.

Collective.


DM <#petsc4py.PETSc.DM>

See also:


Source code at petsc4py/PETSc/DM.pyx:1736 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1736>


Add a callback to be executed when restricting to a coarser grid.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:2400 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L2400>


Add a field to a DM object.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:611 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L611>


Append to the prefix used for searching for options in the database.

Logically collective.

See also:

Working with PETSc options <#petsc-options>, setOptionsPrefix, DMAppendOptionsPrefix <https://petsc.org/release/manualpages/DM/DMAppendOptionsPrefix.html>


Source code at petsc4py/PETSc/DM.pyx:298 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L298>






Remove a point from a DMLabel <#petsc4py.PETSc.DMLabel> with given value.

Not collective.


See also:


Source code at petsc4py/PETSc/DM.pyx:2078 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L2078>


Return the cloned DM .

Collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:155 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L155>

DM <#petsc4py.PETSc.DM>


Return a coarsened DM object.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
DM <#petsc4py.PETSc.DM>

See also:


Source code at petsc4py/PETSc/DM.pyx:1587 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1587>


Coarsen this DM and return the coarsened DM hierarchy.

Collective.


See also:


Source code at petsc4py/PETSc/DM.pyx:1638 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1638>


Return a DM converted to another DM.

Collective.

dm_type (Type <#petsc4py.PETSc.DM.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The new DM.Type <#petsc4py.PETSc.DM.Type>, use “same” for the same type.
DM <#petsc4py.PETSc.DM>

See also:

DM.Type <#petsc4py.PETSc.DM.Type>, DMConvert <https://petsc.org/release/manualpages/DM/DMConvert.html>


Source code at petsc4py/PETSc/DM.pyx:1540 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1540>


Copy the discrete systems for this DM into another DM.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:718 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L718>


Copy fields and discrete systems of a DM into another DM.

Collective.

dm (DM <#petsc4py.PETSc.DM>) -- The DM that the fields and discrete systems are copied into.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:751 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L751>


Copy the discretizations of this DM into another DM.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:646 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L646>


Return an empty DM.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/DM.pyx:134 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L134>




Return a global vector.

Collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:798 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L798>

Vec <#petsc4py.PETSc.Vec>


Return the injection matrix into a finer DM.

Collective.

dm (DM <#petsc4py.PETSc.DM>) -- The second, finer DM object.
Mat <#petsc4py.PETSc.Mat>

See also:


Source code at petsc4py/PETSc/DM.pyx:1502 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1502>


Return the interpolation matrix to a finer DM.

Collective.

dm (DM <#petsc4py.PETSc.DM>) -- The second, finer DM.
tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Mat <#petsc4py.PETSc.Mat>, Vec <#petsc4py.PETSc.Vec>]

See also:


Source code at petsc4py/PETSc/DM.pyx:1481 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1481>



Return a local vector.

Not collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:812 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L812>

Vec <#petsc4py.PETSc.Vec>


Return the mass matrix between this DM and the given DM.

Collective.

dmf (DM <#petsc4py.PETSc.DM>) -- The second DM.
Mat <#petsc4py.PETSc.Mat>

See also:


Source code at petsc4py/PETSc/DM.pyx:1462 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1462>


Return an empty matrix.

Collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:1448 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1448>

Mat <#petsc4py.PETSc.Mat>


Return the restriction matrix between this DM and the given DM.

Collective.

dm (DM <#petsc4py.PETSc.DM>) -- The second, finer DM object.
Mat <#petsc4py.PETSc.Mat>

See also:


Source code at petsc4py/PETSc/DM.pyx:1521 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1521>


Create the SF <#petsc4py.PETSc.SF> encoding the parallel DOF overlap for the DM.

Collective.

  • localsec (Section <#petsc4py.PETSc.Section>) -- Describe the local data layout.
  • globalsec (Section <#petsc4py.PETSc.Section>) -- Describe the global data layout.

None <https://docs.python.org/3/library/constants.html#None>

Notes

Encoding based on the Section <#petsc4py.PETSc.Section> describing the data layout.

See also:


Source code at petsc4py/PETSc/DM.pyx:1854 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1854>


Return IS <#petsc4py.PETSc.IS> and DM encapsulating a subproblem.

Not collective.

  • iset (IS <#petsc4py.PETSc.IS>) -- The global indices for all the degrees of freedom.
  • subdm (DM) -- The DM for the subproblem.

fields (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>])
tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[IS <#petsc4py.PETSc.IS>, DM <#petsc4py.PETSc.DM>]

See also:


Source code at petsc4py/PETSc/DM.pyx:446 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L446>




Return an auxiliary vector for region.

Not collective.


See also:


Source code at petsc4py/PETSc/DM.pyx:503 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L503>


Return the flags for determining variable influence.

Not collective.


See also:


Source code at petsc4py/PETSc/DM.pyx:370 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L370>




Return the cell coordinate DM.

Collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:1159 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1159>

DM <#petsc4py.PETSc.DM>


Return the cell coordinate layout over the DM.

Collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:1194 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1194>

Section <#petsc4py.PETSc.Section>


Return a global vector with the cellwise coordinates.

Collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:1226 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1226>

Vec <#petsc4py.PETSc.Vec>


Return a local vector with the cellwise coordinates.

Collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:1258 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1258>

Vec <#petsc4py.PETSc.Vec>


Return the coarse DM.

Collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:1020 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1020>

DM <#petsc4py.PETSc.DM>



Return the coordinate DM.

Collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:1048 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1048>

DM <#petsc4py.PETSc.DM>


Return the dimension of embedding space for coordinates values.

Not collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:238 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L238>



Return coordinate values layout over the mesh.

Collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:1063 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1063>

Section <#petsc4py.PETSc.Section>


Return a global vector with the coordinates associated.

Collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:1095 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1095>

Vec <#petsc4py.PETSc.Vec>


Return a local vector with the coordinates associated.

Collective the first time it is called.

See also:


Source code at petsc4py/PETSc/DM.pyx:1127 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1127>

Vec <#petsc4py.PETSc.Vec>



Return default DS <#petsc4py.PETSc.DS>.

Not collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:703 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L703>

DS <#petsc4py.PETSc.DS>




Return the flags for determining variable influence.

Not collective.


See also:


Source code at petsc4py/PETSc/DM.pyx:416 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L416>


Return the Section <#petsc4py.PETSc.Section> encoding the global data layout for the DM.

Collective the first time it is called.

See also:


Source code at petsc4py/PETSc/DM.pyx:1830 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1830>

Section <#petsc4py.PETSc.Section>


Return a global vector.

Collective.

name (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The optional name to retrieve a persistent vector.
Vec <#petsc4py.PETSc.Vec>

Notes

When done with the vector, it must be restored using restoreGlobalVec.

See also:


Source code at petsc4py/PETSc/DM.pyx:826 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L826>


Return local mapping to global mapping.

Collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:1003 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1003>

LGMap <#petsc4py.PETSc.LGMap>


Return the label of a given name.

Not collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:1772 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1772>

name (str <https://docs.python.org/3/library/stdtypes.html#str>)
DMLabel <#petsc4py.PETSc.DMLabel>


Return an IS <#petsc4py.PETSc.IS> of all values that the DMLabel <#petsc4py.PETSc.DMLabel> takes.

Not collective.

name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The label name.
IS <#petsc4py.PETSc.IS>

See also:


Source code at petsc4py/PETSc/DM.pyx:2123 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L2123>





Return the value in DMLabel <#petsc4py.PETSc.DMLabel> for the given point.

Not collective.


See also:


Source code at petsc4py/PETSc/DM.pyx:2031 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L2031>



Return the Section <#petsc4py.PETSc.Section> encoding the local data layout for the DM.

Not collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:1803 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1803>

Section <#petsc4py.PETSc.Section>


Return a local vector.

Not collective.

name (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The optional name to retrieve a persistent vector.
Vec <#petsc4py.PETSc.Vec>

Notes

When done with the vector, it must be restored using restoreLocalVec.

See also:


Source code at petsc4py/PETSc/DM.pyx:880 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L880>




Return the prefix used for searching for options in the database.

Not collective.

See also:

Working with PETSc options <#petsc-options>, setOptionsPrefix, DMGetOptionsPrefix <https://petsc.org/release/manualpages/DM/DMGetOptionsPrefix.html>


Source code at petsc4py/PETSc/DM.pyx:284 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L284>



Set the description of mesh periodicity.

Not collective.

  • maxCell -- The longest allowable cell dimension in each direction.
  • Lstart -- The start of each coordinate direction, usually [0, 0, 0]
  • L -- The periodic length of each coordinate direction, or -1 for non-periodic

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[ArrayReal <#petsc4py.typing.ArrayReal>, ArrayReal <#petsc4py.typing.ArrayReal>, ArrayReal <#petsc4py.typing.ArrayReal>]

See also:


Source code at petsc4py/PETSc/DM.pyx:1362 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1362>


Return the SF <#petsc4py.PETSc.SF> encoding the parallel DOF overlap for the DM.

Not collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:1908 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1908>

SF <#petsc4py.PETSc.SF>



Return the Section <#petsc4py.PETSc.Section> encoding the parallel DOF overlap.

Collective the first time it is called.

See also:


Source code at petsc4py/PETSc/DM.pyx:1877 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1877>

SF <#petsc4py.PETSc.SF>


Return the points in a label stratum.

Not collective.


IS <#petsc4py.PETSc.IS>

See also:


Source code at petsc4py/PETSc/DM.pyx:2168 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L2168>




Update local vectors from global vector.

Neighborwise collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:934 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L934>



Return a DM stored in binary.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer>) -- Viewer used to store the DM, like Viewer.Type.BINARY <#petsc4py.PETSc.Viewer.Type.BINARY> or Viewer.Type.HDF5 <#petsc4py.PETSc.Viewer.Type.HDF5>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

Notes

When using Viewer.Type.HDF5 <#petsc4py.PETSc.Viewer.Type.HDF5> format, one can save multiple DMPlex <#petsc4py.PETSc.DMPlex> meshes in a single HDF5 files. This in turn requires one to name the DMPlex <#petsc4py.PETSc.DMPlex> object with Object.setName <#petsc4py.PETSc.Object.setName> before saving it with DM.view and before loading it with DM.load for identification of the mesh object.

See also:

DM.view, DM.load, Object.setName <#petsc4py.PETSc.Object.setName>, DMLoad <https://petsc.org/release/manualpages/DM/DMLoad.html>


Source code at petsc4py/PETSc/DM.pyx:95 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L95>


Update global vectors from local vector.

Neighborwise collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:957 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L957>


Map the values from a local vector to another local vector.

Neighborwise collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:980 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L980>


Create local coordinates for cells having periodic faces.

Collective.

Notes

Used if the mesh is periodic.

See also:


Source code at petsc4py/PETSc/DM.pyx:1345 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1345>



Return a refined DM object.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
DM <#petsc4py.PETSc.DM>

See also:


Source code at petsc4py/PETSc/DM.pyx:1563 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1563>


Refine this DM and return the refined DM hierarchy.

Collective.


See also:


Source code at petsc4py/PETSc/DM.pyx:1611 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1611>



Restore a global vector obtained with getGlobalVec.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:855 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L855>


Restore a local vector obtained with getLocalVec.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:909 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L909>



Set an auxiliary vector for a specific region.

Not collective.

  • aux (Vec <#petsc4py.PETSc.Vec>) -- The auxiliary vector.
  • label (DMLabel <#petsc4py.PETSc.DMLabel> | None <https://docs.python.org/3/library/constants.html#None>) -- The name of the DMLabel <#petsc4py.PETSc.DMLabel>.
  • value -- Indicate the region.
  • part -- The equation part, or 0 is unused.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:473 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L473>


Set the flags for determining variable influence.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:349 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L349>


Set the cell coordinate DM.

Collective.

dm (DM <#petsc4py.PETSc.DM>) -- The cell coordinate DM.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:1142 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1142>


Set the cell coordinate layout over the DM.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:1174 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1174>


Set a global vector with the cellwise coordinates.

Collective.

c (Vec <#petsc4py.PETSc.Vec>) -- The global cell coordinate vector.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:1209 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1209>


Set a local vector with the cellwise coordinates.

Not collective.

c (Vec <#petsc4py.PETSc.Vec>) -- The local cell coordinate vector.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:1241 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1241>



Set the dimension of embedding space for coordinates values.

Not collective.


See also:


Source code at petsc4py/PETSc/DM.pyx:252 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L252>


Project coordinates to a different space.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/DM.pyx:1273 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1273>


Set a global vector that holds the coordinates.

Collective.

c (Vec <#petsc4py.PETSc.Vec>) -- Coordinate Vector.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:1078 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1078>


Set a local vector with the ghost point holding the coordinates.

Not collective.

c (Vec <#petsc4py.PETSc.Vec>) -- Coordinate Vector.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:1110 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1110>



Set the discretization object for a given DM field.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:560 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L560>


Set the flags for determining variable influence.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:392 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L392>


Configure the object from the options database.

Collective.

See also:

Working with PETSc options <#petsc-options>, DMSetFromOptions <https://petsc.org/release/manualpages/DM/DMSetFromOptions.html>


Source code at petsc4py/PETSc/DM.pyx:312 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L312>



Set the Section <#petsc4py.PETSc.Section> encoding the global data layout for the DM.

Collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:1818 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1818>

sec (Section <#petsc4py.PETSc.Section>)
None <https://docs.python.org/3/library/constants.html#None>




Set a point to a DMLabel <#petsc4py.PETSc.DMLabel> with a given value.

Not collective.


See also:


Source code at petsc4py/PETSc/DM.pyx:2054 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L2054>


Set the Section <#petsc4py.PETSc.Section> encoding the local data layout for the DM.

Collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:1791 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1791>

sec (Section <#petsc4py.PETSc.Section>)
None <https://docs.python.org/3/library/constants.html#None>


Set matrix type to be used by DM.createMat.

Logically collective.


Notes

The option -dm_mat_type is used to set the matrix type.

See also:

Working with PETSc options <#petsc-options>, DMSetMatType <https://petsc.org/release/manualpages/DM/DMSetMatType.html>


Source code at petsc4py/PETSc/DM.pyx:1425 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1425>



Set the prefix used for searching for options in the database.

Logically collective.

See also:

Working with PETSc options <#petsc-options>, getOptionsPrefix, DMSetOptionsPrefix <https://petsc.org/release/manualpages/DM/DMSetOptionsPrefix.html>


Source code at petsc4py/PETSc/DM.pyx:270 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L270>



Set the description of mesh periodicity.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DM.pyx:1398 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1398>


Set the SF <#petsc4py.PETSc.SF> encoding the parallel DOF overlap for the DM.

Logically collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:1923 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1923>




Set SNES <#petsc4py.PETSc.SNES> residual evaluation function.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

SNES.setFunction <#petsc4py.PETSc.SNES.setFunction>, DMSNESSetFunction <https://petsc.org/release/manualpages/SNES/DMSNESSetFunction.html>


Source code at petsc4py/PETSc/DM.pyx:2337 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L2337>


Set the SNES <#petsc4py.PETSc.SNES> Jacobian evaluation function.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

SNES.setJacobian <#petsc4py.PETSc.SNES.setJacobian>, DMSNESSetJacobian <https://petsc.org/release/manualpages/SNES/DMSNESSetJacobian.html>


Source code at petsc4py/PETSc/DM.pyx:2369 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L2369>


Set the Section <#petsc4py.PETSc.Section> encoding the parallel DOF overlap for the DM.

Logically collective.

See also:


Source code at petsc4py/PETSc/DM.pyx:1892 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1892>



Build a DM.

Collective.


Notes

DM types are available in DM.Type <#petsc4py.PETSc.DM.Type> class.

See also:

DM.Type <#petsc4py.PETSc.DM.Type>, DMSetType <https://petsc.org/release/manualpages/DM/DMSetType.html>


Source code at petsc4py/PETSc/DM.pyx:169 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L169>



Set the type of vector.

Logically collective.

See also:

Vec.Type <#petsc4py.PETSc.Vec.Type>, DMSetVecType <https://petsc.org/release/manualpages/DM/DMSetVecType.html>


Source code at petsc4py/PETSc/DM.pyx:784 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L784>




Attributes Documentation





petsc4py.PETSc.DMComposite

Bases: DM <#petsc4py.PETSc.DM>

A DM object that is used to manage data for a collection of DMs.

Methods Summary

addDM(dm, *args) Add a DM vector to the composite.
create([comm]) Create a composite object.
gather(gvec, imode, lvecs) Gather split local vectors into a coupled global vector.
getAccess(gvec[, locs]) Get access to the individual vectors from the global vector.
getEntries() Return sub-DMs contained in the composite.
getGlobalISs() Return the index sets for each composed object in the composite.
getLGMaps() Return a local-to-global mapping for each DM in the composite.
getLocalISs() Return index sets for each component of a composite local vector.
getNumber() Get number of sub-DMs contained in the composite.
scatter(gvec, lvecs) Scatter coupled global vector into split local vectors.

Methods Documentation

Add a DM vector to the composite.

Collective.

  • dm (DM <#petsc4py.PETSc.DM>) -- The DM object.
  • *args (DM <#petsc4py.PETSc.DM>) -- Additional DM objects.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMComposite.pyx:28 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMComposite.pyx#L28>


Create a composite object.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/DMComposite.pyx:6 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMComposite.pyx#L6>


Gather split local vectors into a coupled global vector.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMComposite.pyx:115 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMComposite.pyx#L115>


Get access to the individual vectors from the global vector.

Not collective.

Use via The with statement <https://docs.python.org/3/reference/compound_stmts.html#with> context manager (PEP 343).


Source code at petsc4py/PETSc/DMComposite.pyx:219 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMComposite.pyx#L219>


Return sub-DMs contained in the composite.

Not collective.

See also:


Source code at petsc4py/PETSc/DMComposite.pyx:66 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMComposite.pyx#L66>



Return the index sets for each composed object in the composite.

Collective.

These could be used to extract a subset of vector entries for a "multi-physics" preconditioner.

Use getLocalISs for index sets in the packed local numbering, and getLGMaps for to map local sub-DM (including ghost) indices to packed global indices.

See also:


Source code at petsc4py/PETSc/DMComposite.pyx:143 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMComposite.pyx#L143>



Return a local-to-global mapping for each DM in the composite.

Collective.

Note that this includes all the ghost points that individual ghosted DMDA may have.

See also:


Source code at petsc4py/PETSc/DMComposite.pyx:196 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMComposite.pyx#L196>



Return index sets for each component of a composite local vector.

Not collective.

To get the composite global indices at all local points (including ghosts), use getLGMaps.

To get index sets for pieces of the composite global vector, use getGlobalISs.

See also:


Source code at petsc4py/PETSc/DMComposite.pyx:170 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMComposite.pyx#L170>




Scatter coupled global vector into split local vectors.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMComposite.pyx:90 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMComposite.pyx#L90>



petsc4py.PETSc.DMDA

Bases: DM <#petsc4py.PETSc.DM>

A DM object that is used to manage data for a structured grid.

Enumerations

ElementType <#petsc4py.PETSc.DMDA.ElementType> Element types.
InterpolationType <#petsc4py.PETSc.DMDA.InterpolationType> Interpolation types.
StencilType <#petsc4py.PETSc.DMDA.StencilType> Stencil types.

petsc4py.PETSc.DMDA.ElementType


petsc4py.PETSc.DMDA.InterpolationType


petsc4py.PETSc.DMDA.StencilType


Methods Summary

create([dim, dof, sizes, proc_sizes, ...]) Create a DMDA object.
createNaturalVec() Create a vector that will hold values in the natural numbering.
duplicate([dof, boundary_type, ...]) Duplicate a DMDA.
getAO() Return the application ordering context for a distributed array.
getBoundaryType() Return the type of ghost nodes at boundary in each dimension.
getCoordinateName(index) Return the name of a coordinate dimension.
getCorners() Return the lower left corner and the sizes of the owned local region.
getDim() Return the topological dimension.
getDof() Return the number of degrees of freedom per node.
getElementType() Return the element type to be returned by getElements.
getElements([elem_type]) Return an array containing the indices of all the local elements.
getFieldName(field) Return the name of an individual field component.
getGhostCorners() Return the lower left corner and the size of the ghosted local region.
getGhostRanges() Return the ranges of the local region in each dimension, including ghost nodes.
getInterpolationType() Return the type of interpolation.
getOwnershipRanges() Return the ranges of indices in each dimension owned by each process.
getProcSizes() Return the number of processes in each dimension.
getRanges() Return the ranges of the owned local region in each dimension.
getRefinementFactor() Return the ratios that the DMDA grid is refined in each dimension.
getScatter() Return the global-to-local, and local-to-local scatter contexts.
getSizes() Return the number of grid points in each dimension.
getStencil() Return the stencil type and width.
getStencilType() Return the stencil type.
getStencilWidth() Return the stencil width.
getVecArray(vec[, readonly]) Get access to the vector as laid out on a N-d grid.
globalToNatural(vg, vn[, addv]) Map values to the "natural" grid ordering.
naturalToGlobal(vn, vg[, addv]) Map values the to grid ordering.
setBoundaryType(boundary_type) Set the type of ghost nodes on domain boundaries.
setCoordinateName(index, name) Set the name of the coordinate dimension.
setDim(dim) Set the topological dimension.
setDof(dof) Set the number of degrees of freedom per vertex.
setElementType(elem_type) Set the element type to be returned by getElements.
setFieldName(field, name) Set the name of individual field components.
setInterpolationType(interp_type) Set the type of interpolation.
setProcSizes(proc_sizes) Set the number of processes in each dimension.
setRefinementFactor([refine_x, refine_y, ...]) Set the ratios for the DMDA grid refinement.
setSizes(sizes) Set the number of grid points in each dimension.
setStencil(stencil_type, stencil_width) Set the stencil type and width.
setStencilType(stencil_type) Set the stencil type.
setStencilWidth(stencil_width) Set the stencil width.
setUniformCoordinates([xmin, xmax, ymin, ...]) Set the DMDA coordinates to be a uniform grid.

Attributes Summary

boundary_type Boundary types in each dimension.
corners The lower left corner and size of local region in each dimension.
dim The grid dimension.
dof The number of DOFs associated with each stratum of the grid.
ghost_corners The lower left corner and size of local region in each dimension.
ghost_ranges Ranges of local region, including ghost nodes.
proc_sizes The number of processes in each dimension in the global decomposition.
ranges Ranges of the local region in each dimension.
sizes The global dimension.
stencil Stencil type and width.
stencil_type Stencil type.
stencil_width Elementwise stencil width.

Methods Documentation

Create a DMDA object.

Collective.

This routine performs the following steps of the C API: - petsc.DMDACreate - petsc.DMSetDimension - petsc.DMDASetDof - petsc.DMDASetSizes - petsc.DMDASetNumProcs - petsc.DMDASetOwnershipRanges - petsc.DMDASetBoundaryType - petsc.DMDASetStencilType - petsc.DMDASetStencilWidth - petsc.DMSetUp (optionally)


Self

See also:


Source code at petsc4py/PETSc/DMDA.pyx:32 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L32>


Create a vector that will hold values in the natural numbering.

Collective.

The number of local entries in the vector on each process is the same as in a vector created with DM.createGlobalVec <#petsc4py.PETSc.DM.createGlobalVec>.

See also:


Source code at petsc4py/PETSc/DMDA.pyx:832 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L832>

Vec <#petsc4py.PETSc.Vec>


Duplicate a DMDA.

Collective.

This routine retrieves the information from the DMDA and recreates it. Parameters dof, boundary_type, stencil_type, stencil_width will be overwritten, if provided.


DMDA <#petsc4py.PETSc.DMDA>

See also:


Source code at petsc4py/PETSc/DMDA.pyx:148 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L148>


Return the application ordering context for a distributed array.

Collective.

The returned AO <#petsc4py.PETSc.AO> maps to the natural grid ordering that would be used for the DMDA if only 1 processor were employed (ordering most rapidly in the x-dimension, then y, then z). Multiple degrees of freedom are numbered for each node (rather than 1 component for the whole grid, then the next component, etc.).

See also:


Source code at petsc4py/PETSc/DMDA.pyx:909 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L909>

AO <#petsc4py.PETSc.AO>


Return the type of ghost nodes at boundary in each dimension.

Not collective.

See also:

setBoundaryType


Source code at petsc4py/PETSc/DMDA.pyx:407 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L407>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[BoundaryType <#petsc4py.PETSc.DM.BoundaryType>, ...]


Return the name of a coordinate dimension.

Not collective.

index (int <https://docs.python.org/3/library/functions.html#int>) -- The coordinate number for the DMDA (0, 1, ..., dim-1).
str <https://docs.python.org/3/library/stdtypes.html#str>

See also:


Source code at petsc4py/PETSc/DMDA.pyx:810 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L810>


Return the lower left corner and the sizes of the owned local region.

Not collective.

Returns the global (x,y,z) indices of the lower left corner (first tuple) and size of the local region (second tuple).

Excluding ghost points.

The corner information is independent of the number of degrees of freedom per node. Thus the returned values can be thought of as coordinates on a logical grid, where each grid point has (potentially) several degrees of freedom.

See also:

getRanges, getGhostRanges, getOwnershipRanges, getGhostCorners, DMDAGetCorners <https://petsc.org/release/manualpages/DMDA/DMDAGetCorners.html>


Source code at petsc4py/PETSc/DMDA.pyx:622 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L622>




Return the number of degrees of freedom per node.

Not collective.

See also:


Source code at petsc4py/PETSc/DMDA.pyx:264 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L264>



Return the element type to be returned by getElements.

Not collective.

See also:


Source code at petsc4py/PETSc/DMDA.pyx:1050 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L1050>

ElementType <#petsc4py.PETSc.DMDA.ElementType>


Return an array containing the indices of all the local elements.

Not collective.

The elements are in local coordinates.

Each process uniquely owns a subset of the elements. That is, no element is owned by two or more processes.

elem_type (ElementType <#petsc4py.PETSc.DMDA.ElementType> | None <https://docs.python.org/3/library/constants.html#None>) -- The element type.
ArrayInt <#petsc4py.typing.ArrayInt>

See also:


Source code at petsc4py/PETSc/DMDA.pyx:1064 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L1064>


Return the name of an individual field component.

Not collective.

field (int <https://docs.python.org/3/library/functions.html#int>) -- The field number for the DMDA (0, 1, ..., dof-1), where dof indicates the number of degrees of freedom per node within the DMDA.
str <https://docs.python.org/3/library/stdtypes.html#str>

See also:


Source code at petsc4py/PETSc/DMDA.pyx:699 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L699>


Return the lower left corner and the size of the ghosted local region.

Not collective.

Returns the global (x,y,z) indices of the lower left corner (first tuple) and size of the local region (second tuple).

See also:

getRanges, getGhostRanges, getOwnershipRanges, getCorners, DMDAGetGhostCorners <https://petsc.org/release/manualpages/DMDA/DMDAGetGhostCorners.html>


Source code at petsc4py/PETSc/DMDA.pyx:651 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L651>



Return the ranges of the local region in each dimension, including ghost nodes.

Not collective.

See also:

getRanges, getOwnershipRanges, getCorners, getGhostCorners, DMDAGetGhostCorners <https://petsc.org/release/manualpages/DMDA/DMDAGetGhostCorners.html>


Source code at petsc4py/PETSc/DMDA.pyx:577 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L577>



Return the type of interpolation.

Not collective.

See also:

setInterpolationType, DMDAGetInterpolationType <https://petsc.org/release/manualpages/DMDA/DMDAGetInterpolationType.html>


Source code at petsc4py/PETSc/DMDA.pyx:1020 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L1020>

InterpolationType <#petsc4py.PETSc.DMDA.InterpolationType>


Return the ranges of indices in each dimension owned by each process.

Not collective.

These numbers are not multiplied by the number of DOFs per node.

See also:

getRanges, getGhostRanges, getCorners, getGhostCorners, DMDAGetOwnershipRanges <https://petsc.org/release/manualpages/DMDA/DMDAGetOwnershipRanges.html>


Source code at petsc4py/PETSc/DMDA.pyx:597 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L597>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[ArrayInt <#petsc4py.typing.ArrayInt>, ...]



Return the ranges of the owned local region in each dimension.

Not collective.

Excluding ghost nodes.

See also:

getGhostRanges, getOwnershipRanges, getCorners, getGhostCorners, DMDAGetCorners <https://petsc.org/release/manualpages/DMDA/DMDAGetCorners.html>


Source code at petsc4py/PETSc/DMDA.pyx:555 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L555>



Return the ratios that the DMDA grid is refined in each dimension.

Not collective.

See also:



Source code at petsc4py/PETSc/DMDA.pyx:981 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L981>



Return the global-to-local, and local-to-local scatter contexts.

Collective.

See also:


Source code at petsc4py/PETSc/DMDA.pyx:930 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L930>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Scatter <#petsc4py.PETSc.Scatter>, Scatter <#petsc4py.PETSc.Scatter>]



Return the stencil type and width.

Not collective.

See also:

getStencilType, getStencilWidth


Source code at petsc4py/PETSc/DMDA.pyx:532 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L532>



Return the stencil type.

Not collective.

See also:


Source code at petsc4py/PETSc/DMDA.pyx:448 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L448>

StencilType <#petsc4py.PETSc.DMDA.StencilType>


Return the stencil width.

Not collective.

See also:

setStencilWidth


Source code at petsc4py/PETSc/DMDA.pyx:486 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L486>



Get access to the vector as laid out on a N-d grid.

Logically collective.


Any <https://docs.python.org/3/library/typing.html#typing.Any>

See also:

Vec.getArray <#petsc4py.PETSc.Vec.getArray>, DMDAVecGetArray <https://petsc.org/release/manualpages/DMDA/DMDAVecGetArray.html>, DMDAVecGetArrayDOF <https://petsc.org/release/manualpages/DMDA/DMDAVecGetArrayDOF.html>


Source code at petsc4py/PETSc/DMDA.pyx:723 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L723>


Map values to the "natural" grid ordering.

Neighborwise collective.

You must call createNaturalVec before using this routine.

  • vg (Vec <#petsc4py.PETSc.Vec>) -- The global vector in a grid ordering.
  • vn (Vec <#petsc4py.PETSc.Vec>) -- The global vector in a "natural" ordering.
  • addv (InsertMode <#petsc4py.PETSc.InsertMode> | None <https://docs.python.org/3/library/constants.html#None>) -- The insertion mode.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMDA.pyx:849 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L849>


Map values the to grid ordering.

Neighborwise collective.

  • vn (Vec <#petsc4py.PETSc.Vec>) -- The global vector in a natural ordering.
  • vg (Vec <#petsc4py.PETSc.Vec>) -- the global vector in a grid ordering.
  • addv (InsertMode <#petsc4py.PETSc.InsertMode> | None <https://docs.python.org/3/library/constants.html#None>) -- The insertion mode.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMDA.pyx:879 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L879>


Set the type of ghost nodes on domain boundaries.

Not collective.


See also:


Source code at petsc4py/PETSc/DMDA.pyx:384 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L384>


Set the name of the coordinate dimension.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMDA.pyx:788 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L788>



Set the number of degrees of freedom per vertex.

Not collective.


See also:


Source code at petsc4py/PETSc/DMDA.pyx:246 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L246>


Set the element type to be returned by getElements.

Not collective.

See also:


Source code at petsc4py/PETSc/DMDA.pyx:1036 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L1036>



Set the name of individual field components.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMDA.pyx:675 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L675>


Set the type of interpolation.

Logically collective.

You should call this on the coarser of the two DMDAs you pass to DM.createInterpolation <#petsc4py.PETSc.DM.createInterpolation>.

interp_type (InterpolationType <#petsc4py.PETSc.DMDA.InterpolationType>) -- The interpolation type.
None <https://docs.python.org/3/library/constants.html#None>

See also:

getInterpolationType, DMDASetInterpolationType <https://petsc.org/release/manualpages/DMDA/DMDASetInterpolationType.html>


Source code at petsc4py/PETSc/DMDA.pyx:999 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L999>


Set the number of processes in each dimension.

Logically collective.

proc_sizes (DimsSpec <#petsc4py.typing.DimsSpec>) -- The number of processes in (x,), (x, y), or (x, y, z) dimensions.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMDA.pyx:334 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L334>


Set the ratios for the DMDA grid refinement.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:



Source code at petsc4py/PETSc/DMDA.pyx:949 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L949>


Set the number of grid points in each dimension.

Logically collective.

sizes (DimsSpec <#petsc4py.typing.DimsSpec>) -- The global (x,), (x, y), or (x, y, z) size.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMDA.pyx:284 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L284>


Set the stencil type and width.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMDA.pyx:506 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L506>


Set the stencil type.

Logically collective.

  • stype -- The stencil type.
  • stencil_type (StencilType <#petsc4py.PETSc.DMDA.StencilType>)

None <https://docs.python.org/3/library/constants.html#None>

See also:

getStencilType, setStencil, DMDASetStencilType <https://petsc.org/release/manualpages/DMDA/DMDASetStencilType.html>


Source code at petsc4py/PETSc/DMDA.pyx:430 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L430>



Set the DMDA coordinates to be a uniform grid.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMDA.pyx:744 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L744>


Attributes Documentation

Boundary types in each dimension.

Source code at petsc4py/PETSc/DMDA.pyx:1123 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L1123>


The lower left corner and size of local region in each dimension.

Source code at petsc4py/PETSc/DMDA.pyx:1153 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L1153>


The grid dimension.

Source code at petsc4py/PETSc/DMDA.pyx:1103 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L1103>


The number of DOFs associated with each stratum of the grid.

Source code at petsc4py/PETSc/DMDA.pyx:1108 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L1108>


The lower left corner and size of local region in each dimension.

Source code at petsc4py/PETSc/DMDA.pyx:1158 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L1158>


Ranges of local region, including ghost nodes.

Source code at petsc4py/PETSc/DMDA.pyx:1148 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L1148>


The number of processes in each dimension in the global decomposition.

Source code at petsc4py/PETSc/DMDA.pyx:1118 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L1118>


Ranges of the local region in each dimension.

Source code at petsc4py/PETSc/DMDA.pyx:1143 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L1143>


The global dimension.

Source code at petsc4py/PETSc/DMDA.pyx:1113 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L1113>


Stencil type and width.

Source code at petsc4py/PETSc/DMDA.pyx:1128 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L1128>



Elementwise stencil width.

Source code at petsc4py/PETSc/DMDA.pyx:1138 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L1138>




petsc4py.PETSc.DMInterpolation

Bases: object <https://docs.python.org/3/library/functions.html#object>

Interpolation on a mesh.

Methods Summary

create([comm]) Create a DMInterpolation context.
destroy() Destroy the DMInterpolation context.
evaluate(dm, x[, v]) Calculate interpolated field values at the interpolation points.
getCoordinates() Return the coordinates of each interpolation point.
getDim() Return the spatial dimension of the interpolation context.
getDof() Return the number of fields interpolated at a point.
getVector() Return a Vec <#petsc4py.PETSc.Vec> which can hold all the interpolated field values.
restoreVector(vec) Restore a Vec which can hold all the interpolated field values.
setDim(dim) Set the spatial dimension for the interpolation context.
setDof(dof) Set the number of fields interpolated at a point.
setUp(dm[, redundantPoints, ignoreOutsideDomain]) Compute spatial indices for point location during interpolation.

Methods Documentation

Create a DMInterpolation context.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to COMM_SELF <#petsc4py.PETSc.COMM_SELF>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/DMUtils.pyx:13 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMUtils.pyx#L13>



Calculate interpolated field values at the interpolation points.

Collective.

  • dm (DM <#petsc4py.PETSc.DM>) -- The DM <#petsc4py.PETSc.DM>.
  • x (Vec <#petsc4py.PETSc.Vec>) -- The local vector containing the field to be interpolated.
  • v (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- A vector capable of holding the interpolated field values.

Vec <#petsc4py.PETSc.Vec>

See also:


Source code at petsc4py/PETSc/DMUtils.pyx:48 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMUtils.pyx#L48>


Return the coordinates of each interpolation point.

Collective.

The local vector entries correspond to interpolation points lying on this process, according to the associated DM.

See also:


Source code at petsc4py/PETSc/DMUtils.pyx:74 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMUtils.pyx#L74>

Vec <#petsc4py.PETSc.Vec>


Return the spatial dimension of the interpolation context.

Not collective.

See also:


Source code at petsc4py/PETSc/DMUtils.pyx:92 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMUtils.pyx#L92>



Return the number of fields interpolated at a point.

Not collective.

See also:


Source code at petsc4py/PETSc/DMUtils.pyx:106 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMUtils.pyx#L106>



Return a Vec <#petsc4py.PETSc.Vec> which can hold all the interpolated field values.

Collective.

This vector should be returned using restoreVector.

See also:


Source code at petsc4py/PETSc/DMUtils.pyx:185 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMUtils.pyx#L185>

Vec <#petsc4py.PETSc.Vec>


Restore a Vec which can hold all the interpolated field values.

Collective.

vec (Vec <#petsc4py.PETSc.Vec>) -- A vector capable of holding the interpolated field values.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMUtils.pyx:201 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMUtils.pyx#L201>


Set the spatial dimension for the interpolation context.

Not collective.


See also:


Source code at petsc4py/PETSc/DMUtils.pyx:120 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMUtils.pyx#L120>


Set the number of fields interpolated at a point.

Not collective.


See also:


Source code at petsc4py/PETSc/DMUtils.pyx:138 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMUtils.pyx#L138>


Compute spatial indices for point location during interpolation.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMUtils.pyx:156 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMUtils.pyx#L156>



petsc4py.PETSc.DMLabel

Bases: Object <#petsc4py.PETSc.Object>

An object representing a subset of mesh entities from a DM <#petsc4py.PETSc.DM>.

Methods Summary

addStrata(strata) Add new stratum values in a DMLabel.
addStrataIS(iset) Add new stratum values in a DMLabel.
addStratum(value) Add a new stratum value in a DMLabel.
clearStratum(stratum) Remove a stratum.
clearValue(point, value) Clear the value a label assigns to a point.
computeIndex() Create an index structure for membership determination.
convertToSection() Return a Section <#petsc4py.PETSc.Section> and IS <#petsc4py.PETSc.IS> that encode the label.
create(name[, comm]) Create a DMLabel object, which is a multimap.
createIndex(pStart, pEnd) Create an index structure for membership determination.
destroy() Destroy the label.
destroyIndex() Destroy the index structure.
distribute(sf) Create a new label pushed forward over the SF <#petsc4py.PETSc.SF>.
duplicate() Duplicate the DMLabel.
filter(start, end) Remove all points outside of [start, end).
gather(sf) Gather all label values from leaves into roots.
getBounds() Return the smallest and largest point in the label.
getDefaultValue() Return the default value returned by getValue.
getNonEmptyStratumValuesIS() Return an IS <#petsc4py.PETSc.IS> of all values that the DMLabel takes.
getNumValues() Return the number of values that the DMLabel takes.
getStratumIS(stratum) Return an IS <#petsc4py.PETSc.IS> with the stratum points.
getStratumSize(stratum) Return the size of a stratum.
getValue(point) Return the value a label assigns to a point.
getValueIS() Return an IS <#petsc4py.PETSc.IS> of all values that the DMLabel takes.
hasPoint(point) Determine whether the label contains a point.
hasStratum(value) Determine whether points exist with the given value.
hasValue(value) Determine whether a label assigns the value to any point.
insertIS(iset, value) Set all points in the IS <#petsc4py.PETSc.IS> to a value.
permute(permutation) Create a new label with permuted points.
reset() Destroy internal data structures in the DMLabel.
setDefaultValue(value) Set the default value returned by getValue.
setStratumIS(stratum, iset) Set the stratum points using an IS <#petsc4py.PETSc.IS>.
setValue(point, value) Set the value a label assigns to a point.
stratumHasPoint(value, point) Return whether the stratum contains a point.
view([viewer]) View the label.

Methods Documentation


Add new stratum values in a DMLabel.

Not collective.

iset (IS <#petsc4py.PETSc.IS>) -- Index set with stratum values.
None <https://docs.python.org/3/library/constants.html#None>

See also:



Source code at petsc4py/PETSc/DMLabel.pyx:258 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L258>





Create an index structure for membership determination.

Not collective.

Automatically determines the bounds.

See also:


Source code at petsc4py/PETSc/DMLabel.pyx:424 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L424>



Return a Section <#petsc4py.PETSc.Section> and IS <#petsc4py.PETSc.IS> that encode the label.

Not collective.

See also:


Source code at petsc4py/PETSc/DMLabel.pyx:607 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L607>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Section <#petsc4py.PETSc.Section>, IS <#petsc4py.PETSc.IS>]


Create a DMLabel object, which is a multimap.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/DMLabel.pyx:40 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L40>


Create an index structure for membership determination.

Not collective.


See also:


Source code at petsc4py/PETSc/DMLabel.pyx:438 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L438>




Create a new label pushed forward over the SF <#petsc4py.PETSc.SF>.

Collective.

sf (SF <#petsc4py.PETSc.SF>) -- The map from old to new distribution.
DMLabel <#petsc4py.PETSc.DMLabel>

See also:


Source code at petsc4py/PETSc/DMLabel.pyx:567 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L567>


Duplicate the DMLabel.

Collective.

See also:


Source code at petsc4py/PETSc/DMLabel.pyx:65 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L65>

DMLabel <#petsc4py.PETSc.DMLabel>



Gather all label values from leaves into roots.

Collective.

This is the inverse operation to distribute.

sf (SF <#petsc4py.PETSc.SF>) -- The SF <#petsc4py.PETSc.SF> communication map.
DMLabel <#petsc4py.PETSc.DMLabel>

See also:


Source code at petsc4py/PETSc/DMLabel.pyx:586 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L586>


Return the smallest and largest point in the label.

Not collective.

The returned values are the smallest point and the largest point + 1.

See also:


Source code at petsc4py/PETSc/DMLabel.pyx:512 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L512>



Return the default value returned by getValue.

Not collective.

The default value is returned if a point has not been explicitly given a value. When a label is created, it is initialized to -1.

See also:


Source code at petsc4py/PETSc/DMLabel.pyx:161 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L161>



Return an IS <#petsc4py.PETSc.IS> of all values that the DMLabel takes.

Not collective.

See also:


Source code at petsc4py/PETSc/DMLabel.pyx:622 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L622>

IS <#petsc4py.PETSc.IS>



Return an IS <#petsc4py.PETSc.IS> with the stratum points.

Not collective.

stratum (int <https://docs.python.org/3/library/functions.html#int>) -- The stratum value.
IS <#petsc4py.PETSc.IS>

See also:


Source code at petsc4py/PETSc/DMLabel.pyx:366 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L366>



Return the value a label assigns to a point.

Not collective.

If no value was assigned, a default value will be returned The default value, initially -1, can be changed with setDefaultValue.


See also:

setValue, setDefaultValue, DMLabelGetValue <https://petsc.org/release/manualpages/DMLabel/DMLabelGetValue.html>


Source code at petsc4py/PETSc/DMLabel.pyx:137 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L137>


Return an IS <#petsc4py.PETSc.IS> of all values that the DMLabel takes.

Not collective.

See also:


Source code at petsc4py/PETSc/DMLabel.pyx:289 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L289>

IS <#petsc4py.PETSc.IS>


Determine whether the label contains a point.

Not collective.

The user must call createIndex before this function.


See also:


Source code at petsc4py/PETSc/DMLabel.pyx:490 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L490>




Set all points in the IS <#petsc4py.PETSc.IS> to a value.

Not collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/DMLabel.pyx:91 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L91>


Create a new label with permuted points.

Not collective.

permutation (IS <#petsc4py.PETSc.IS>) -- The point permutation.
DMLabel <#petsc4py.PETSc.DMLabel>

See also:


Source code at petsc4py/PETSc/DMLabel.pyx:548 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L548>



Set the default value returned by getValue.

Not collective.

The value is used if a point has not been explicitly given a value. When a label is created, the default value is initialized to -1.


See also:


Source code at petsc4py/PETSc/DMLabel.pyx:178 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L178>


Set the stratum points using an IS <#petsc4py.PETSc.IS>.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMLabel.pyx:386 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L386>


Set the value a label assigns to a point.

Not collective.

If the value is the same as the label's default value (which is initially -1, and can be changed with setDefaultValue), this function will do nothing.


See also:

getValue, setDefaultValue, DMLabelSetValue <https://petsc.org/release/manualpages/DMLabel/DMLabelSetValue.html>


Source code at petsc4py/PETSc/DMLabel.pyx:112 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L112>



View the label.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the graph.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMLabel.pyx:21 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L21>



petsc4py.PETSc.DMPlex

Bases: DM <#petsc4py.PETSc.DM>

Encapsulate an unstructured mesh.

DMPlex encapsulates both topology and geometry. It is capable of parallel refinement and coarsening (using Pragmatic or ParMmg) and parallel redistribution for load balancing.

Methods Summary

computeCellGeometryFVM(cell) Compute the volume for a given cell.
computeGradientClementInterpolant(locX, locC) Return the L2 projection of the cellwise gradient of a function onto P1.
constructGhostCells([labelName]) Construct ghost cells which connect to every boundary face.
coordinatesLoad(viewer, sfxc) Load coordinates into this DMPlex object.
coordinatesView(viewer) Save DMPlex coordinates into a file.
create([comm]) Create a DMPlex object, which encapsulates an unstructured mesh.
createBoxMesh(faces[, lower, upper, ...]) Create a mesh on the tensor product of intervals.
createBoxSurfaceMesh(faces[, lower, upper, ...]) Create a mesh on the surface of a box mesh using tensor cells.
createCGNS(cgid[, interpolate, comm]) Create a DMPlex mesh from a CGNS file.
createCGNSFromFile(filename[, interpolate, comm]) "Create a DMPlex mesh from a CGNS file.
createClosureIndex(sec) Calculate an index for sec for the closure operation.
createCoarsePointIS() Create an IS <#petsc4py.PETSc.IS> covering the coarse DMPlex chart with the fine points as data.
createCohesiveSubmesh(hasLagrange, value) Extract the hypersurface defined by one face of the cohesive cells.
createCoordinateSpace(degree, localized, project) Create a finite element space for the coordinates.
createExodus(exoid[, interpolate, comm]) Create a DMPlex mesh from an ExodusII file ID.
createExodusFromFile(filename[, ...]) Create a DMPlex mesh from an ExodusII file.
createFromCellList(dim, cells, coords[, ...]) Create a DMPlex from a list of vertices for each cell on process 0.
createFromFile(filename[, plexname, ...]) Create DMPlex from a file.
createGmsh(viewer[, interpolate, comm]) Create a DMPlex mesh from a Gmsh file viewer.
createPointNumbering() Create a global numbering for all points.
createSection(numComp, numDof[, bcField, ...]) Create a Section <#petsc4py.PETSc.Section> based upon the DOF layout specification provided.
distribute([overlap]) Distribute the mesh and any associated sections.
distributeField(sf, sec, vec[, newsec, newvec]) Distribute field data with a with a given SF <#petsc4py.PETSc.SF>.
distributeGetDefault() Return a flag indicating whether the DM <#petsc4py.PETSc.DM> should be distributed by default.
distributeOverlap([overlap]) Add partition overlap to a distributed non-overlapping DMPlex.
distributeSetDefault(flag) Set flag indicating whether the DMPlex should be distributed by default.
distributionGetName() Retrieve the name of the specific parallel distribution.
distributionSetName(name) Set the name of the specific parallel distribution.
generate(boundary[, name, interpolate]) Generate a mesh.
getAdjacency(p) Return all points adjacent to the given point.
getAdjacencyUseAnchors() Query whether adjacency in the mesh uses the point-to-point constraints.
getCellNumbering() Return a global cell numbering for all cells on this process.
getCellType(p) Return the polytope type of a given cell.
getCellTypeLabel() Return the DMLabel <#petsc4py.PETSc.DMLabel> recording the polytope type of each cell.
getChart() Return the interval for all mesh points [pStart, pEnd).
getCone(p) Return the points on the in-edges for this point in the DAG.
getConeOrientation(p) Return the orientations on the in-edges for this point in the DAG.
getConeSize(p) Return the number of in-edges for this point in the DAG.
getDepth() Return the depth of the DAG representing this mesh.
getDepthStratum(svalue) Return the bounds [start, end) for all points at a certain depth.
getFullJoin(points) Return an array for the join of the set of points.
getHeightStratum(svalue) Return the bounds [start, end) for all points at a certain height.
getJoin(points) Return an array for the join of the set of points.
getMaxSizes() Return the maximum number of in-edges and out-edges of the DAG.
getMeet(points) Return an array for the meet of the set of points.
getMinRadius() Return the minimum distance from any cell centroid to a face.
getOrdering(otype) Calculate a reordering of the mesh.
getPartitioner() Return the mesh partitioner.
getPointDepth(point) Return the depth of a given point.
getPointGlobal(point) Return location of point data in global Vec <#petsc4py.PETSc.Vec>.
getPointGlobalField(point, field) Return location of point field data in global Vec <#petsc4py.PETSc.Vec>.
getPointHeight(point) Return the height of a given point.
getPointLocal(point) Return location of point data in local Vec <#petsc4py.PETSc.Vec>.
getPointLocalField(point, field) Return location of point field data in local Vec <#petsc4py.PETSc.Vec>.
getRefinementLimit() Retrieve the maximum cell volume for refinement.
getRefinementUniform() Retrieve the flag for uniform refinement.
getSubpointIS() Return an IS <#petsc4py.PETSc.IS> covering the entire subdm chart.
getSubpointMap() Return a DMLabel <#petsc4py.PETSc.DMLabel> with point dimension as values.
getSupport(p) Return the points on the out-edges for this point in the DAG.
getSupportSize(p) Return the number of out-edges for this point in the DAG.
getTransitiveClosure(p[, useCone]) Return the points and orientations on the transitive closure of this point.
getVecClosure(sec, vec, point) Return an array of the values on the closure of a point.
getVertexNumbering() Return a global vertex numbering for all vertices on this process.
globalVectorLoad(viewer, sectiondm, sf, vec) Load on-disk vector data into a global vector.
globalVectorView(viewer, sectiondm, vec) Save a global vector.
insertCone(p, conePos, conePoint) DMPlexInsertCone - Insert a point into the in-edges for the point p in the DAG.
insertConeOrientation(p, conePos, ...) Insert a point orientation for the in-edge for the point p in the DAG.
interpolate() Convert to a mesh with all intermediate faces, edges, etc.
isDistributed() Return the flag indicating if the mesh is distributed.
isSimplex() Return the flag indicating if the first cell is a simplex.
labelCohesiveComplete(label, bdlabel, ...) Add all other mesh pieces to complete the surface.
labelComplete(label) Add the transitive closure to the surface.
labelsLoad(viewer, sfxc) Load labels into this DMPlex object.
labelsView(viewer) Save DMPlex labels into a file.
localVectorLoad(viewer, sectiondm, sf, vec) Load on-disk vector data into a local vector.
localVectorView(viewer, sectiondm, vec) Save a local vector.
markBoundaryFaces(label[, value]) Mark all faces on the boundary.
metricAverage2(metric1, metric2, metricAvg) Compute and return the unweighted average of two metrics.
metricAverage3(metric1, metric2, metric3, ...) Compute and return the unweighted average of three metrics.
metricCreate([field]) Create a Riemannian metric field.
metricCreateIsotropic(indicator[, field]) Construct an isotropic metric from an error indicator.
metricCreateUniform(alpha[, field]) Construct a uniform isotropic metric.
metricDeterminantCreate([field]) Create the determinant field for a Riemannian metric.
metricEnforceSPD(metric, ometric, determinant) Enforce symmetric positive-definiteness of a metric.
metricGetGradationFactor() Return the metric gradation factor.
metricGetHausdorffNumber() Return the metric Hausdorff number.
metricGetMaximumAnisotropy() Return the maximum tolerated metric anisotropy.
metricGetMaximumMagnitude() Return the maximum tolerated metric magnitude.
metricGetMinimumMagnitude() Return the minimum tolerated metric magnitude.
metricGetNormalizationOrder() Return the order p for L-p normalization.
metricGetNumIterations() Return the number of parallel adaptation iterations.
metricGetTargetComplexity() Return the target metric complexity.
metricGetVerbosity() Return the verbosity of the mesh adaptation package.
metricIntersection2(metric1, metric2, metricInt) Compute and return the intersection of two metrics.
metricIntersection3(metric1, metric2, ...) Compute the intersection of three metrics.
metricIsIsotropic() Return the flag indicating whether the metric is isotropic or not.
metricIsUniform() Return the flag indicating whether the metric is uniform or not.
metricNoInsertion() Return the flag indicating whether node insertion and deletion are turned off.
metricNoMovement() Return the flag indicating whether node movement is turned off.
metricNoSurf() Return the flag indicating whether surface modification is turned off.
metricNoSwapping() Return the flag indicating whether facet swapping is turned off.
metricNormalize(metric, ometric, determinant) Apply L-p normalization to a metric.
metricRestrictAnisotropyFirst() Return true if anisotropy is restricted before normalization.
metricSetFromOptions() Configure the object from the options database.
metricSetGradationFactor(beta) Set the metric gradation factor.
metricSetHausdorffNumber(hausd) Set the metric Hausdorff number.
metricSetIsotropic(isotropic) Record whether the metric is isotropic or not.
metricSetMaximumAnisotropy(a_max) Set the maximum tolerated metric anisotropy.
metricSetMaximumMagnitude(h_max) Set the maximum tolerated metric magnitude.
metricSetMinimumMagnitude(h_min) Set the minimum tolerated metric magnitude.
metricSetNoInsertion(noInsert) Set the flag indicating whether node insertion should be turned off.
metricSetNoMovement(noMove) Set the flag indicating whether node movement should be turned off.
metricSetNoSurf(noSurf) Set the flag indicating whether surface modification should be turned off.
metricSetNoSwapping(noSwap) Set the flag indicating whether facet swapping should be turned off.
metricSetNormalizationOrder(p) Set the order p for L-p normalization.
metricSetNumIterations(numIter) Set the number of parallel adaptation iterations.
metricSetRestrictAnisotropyFirst(...) Record whether anisotropy is be restricted before normalization or after.
metricSetTargetComplexity(targetComplexity) Set the target metric complexity.
metricSetUniform(uniform) Record whether the metric is uniform or not.
metricSetVerbosity(verbosity) Set the verbosity of the mesh adaptation package.
orient() Give a consistent orientation to the input mesh.
permute(perm) Reorder the mesh according to the input permutation.
rebalanceSharedPoints([entityDepth, ...]) Redistribute shared points in order to achieve better balancing.
reorderGetDefault() Return flag indicating whether the DMPlex should be reordered by default.
reorderSetDefault(flag) Set flag indicating whether the DM should be reordered by default.
sectionLoad(viewer, sectiondm, sfxc) Load section into a DM <#petsc4py.PETSc.DM>.
sectionView(viewer, sectiondm) Save a section associated with a DMPlex.
setAdjacencyUseAnchors([useAnchors]) Define adjacency in the mesh using the point-to-point constraints.
setCellType(p, ctype) Set the polytope type of a given cell.
setChart(pStart, pEnd) Set the interval for all mesh points [pStart, pEnd).
setCone(p, cone[, orientation]) Set the points on the in-edges for this point in the DAG.
setConeOrientation(p, orientation) Set the orientations on the in-edges for this point in the DAG.
setConeSize(p, size) Set the number of in-edges for this point in the DAG.
setMatClosure(sec, gsec, mat, point, values) Set an array of the values on the closure of point.
setPartitioner(part) Set the mesh partitioner.
setRefinementLimit(refinementLimit) Set the maximum cell volume for refinement.
setRefinementUniform([refinementUniform]) Set the flag for uniform refinement.
setSupport(p, supp) Set the points on the out-edges for this point in the DAG.
setSupportSize(p, size) Set the number of out-edges for this point in the DAG.
setTetGenOptions(opts) Set the options used for the Tetgen mesh generator.
setTriangleOptions(opts) Set the options used for the Triangle mesh generator.
setVecClosure(sec, vec, point, values[, addv]) Set an array of the values on the closure of point.
stratify() Calculate the strata of DAG.
symmetrize() Create support (out-edge) information from cone (in-edge) information.
topologyLoad(viewer) Load a topology into this DMPlex object.
topologyView(viewer) Save a DMPlex topology into a file.
uninterpolate() Convert to a mesh with only cells and vertices.
vecGetClosure(sec, vec, p) Return an array of values on the closure of p.

Methods Documentation

Compute the volume for a given cell.

Not collective.

cell (int <https://docs.python.org/3/library/functions.html#int>) -- The cell.

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[float <https://docs.python.org/3/library/functions.html#float>, ArrayReal <#petsc4py.typing.ArrayReal>, ArrayReal <#petsc4py.typing.ArrayReal>]

See also:

DMPlex, DM.getCoordinateSection <#petsc4py.PETSc.DM.getCoordinateSection>, DM.getCoordinates <#petsc4py.PETSc.DM.getCoordinates>, DMPlexComputeCellGeometryFVM <https://petsc.org/release/manualpages/DMPlex/DMPlexComputeCellGeometryFVM.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2241 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2241>


Return the L2 projection of the cellwise gradient of a function onto P1.

Collective.

  • locX (Vec <#petsc4py.PETSc.Vec>) -- The coefficient vector of the function.
  • locC (Vec <#petsc4py.PETSc.Vec>) -- The output Vec <#petsc4py.PETSc.Vec> which holds the Clement interpolant of the gradient.

Vec <#petsc4py.PETSc.Vec>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlexComputeGradientClementInterpolant <https://petsc.org/release/manualpages/DMPlex/DMPlexComputeGradientClementInterpolant.html>


Source code at petsc4py/PETSc/DMPlex.pyx:3175 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3175>


Construct ghost cells which connect to every boundary face.

Collective.

labelName (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The name of the label specifying the boundary faces. Defaults to "Face Sets".
numGhostCells -- The number of ghost cells added to the DMPlex.
int <https://docs.python.org/3/library/functions.html#int>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.create <#petsc4py.PETSc.DM.create>, DMPlexConstructGhostCells <https://petsc.org/release/manualpages/DMPlex/DMPlexConstructGhostCells.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2273 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2273>


Load coordinates into this DMPlex object.

Collective.

  • viewer (Viewer <#petsc4py.PETSc.Viewer>) -- The Viewer <#petsc4py.PETSc.Viewer> for the saved coordinates.
  • sfxc (SF <#petsc4py.PETSc.SF>) -- The SF <#petsc4py.PETSc.SF> returned by topologyLoad.

None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.load <#petsc4py.PETSc.DM.load>, DMPlex.topologyLoad, DMPlex.labelsLoad, DM.view <#petsc4py.PETSc.DM.view>, SF <#petsc4py.PETSc.SF>, Viewer <#petsc4py.PETSc.Viewer>, DMPlexCoordinatesLoad <https://petsc.org/release/manualpages/DMPlex/DMPlexCoordinatesLoad.html>


Source code at petsc4py/PETSc/DMPlex.pyx:3348 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3348>


Save DMPlex coordinates into a file.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer>) -- The Viewer <#petsc4py.PETSc.Viewer> for saving.
None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.view <#petsc4py.PETSc.DM.view>, DMPlex.topologyView, DMPlex.labelsView, DMPlex.coordinatesLoad, Viewer <#petsc4py.PETSc.Viewer>, DMPlexCoordinatesView <https://petsc.org/release/manualpages/DMPlex/DMPlexCoordinatesView.html>


Source code at petsc4py/PETSc/DMPlex.pyx:3215 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3215>


Create a DMPlex object, which encapsulates an unstructured mesh.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.create <#petsc4py.PETSc.DM.create>, DM.setType <#petsc4py.PETSc.DM.setType>, DMPlexCreate <https://petsc.org/release/manualpages/DMPlex/DMPlexCreate.html>


Source code at petsc4py/PETSc/DMPlex.pyx:14 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L14>


Create a mesh on the tensor product of intervals.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.setFromOptions <#petsc4py.PETSc.DM.setFromOptions>, DMPlex.createFromFile, DM.setType <#petsc4py.PETSc.DM.setType>, DM.create <#petsc4py.PETSc.DM.create>, DMPlexCreateBoxMesh <https://petsc.org/release/manualpages/DMPlex/DMPlexCreateBoxMesh.html>


Source code at petsc4py/PETSc/DMPlex.pyx:90 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L90>


Create a mesh on the surface of a box mesh using tensor cells.

Collective.


See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.setFromOptions <#petsc4py.PETSc.DM.setFromOptions>, DMPlex.createBoxMesh, DMPlex.createFromFile, DM.setType <#petsc4py.PETSc.DM.setType>, DM.create <#petsc4py.PETSc.DM.create>, DMPlexCreateBoxSurfaceMesh <https://petsc.org/release/manualpages/DMPlex/DMPlexCreateBoxSurfaceMesh.html>


Source code at petsc4py/PETSc/DMPlex.pyx:149 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L149>


Create a DMPlex mesh from a CGNS file.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, DMPlex.createCGNSFromFile, DMPlex.createExodus, DMPlexCreateCGNS <https://petsc.org/release/manualpages/DMPlex/DMPlexCreateCGNS.html>


Source code at petsc4py/PETSc/DMPlex.pyx:226 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L226>


"Create a DMPlex mesh from a CGNS file.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, DMPlex.createCGNS, DMPlex.createExodus, DMPlexCreateCGNS <https://petsc.org/release/manualpages/DMPlex/DMPlexCreateCGNS.html>


Source code at petsc4py/PETSc/DMPlex.pyx:254 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L254>


Calculate an index for sec for the closure operation.

Not collective.

sec (Section <#petsc4py.PETSc.Section>) -- The Section <#petsc4py.PETSc.Section> describing the layout in the local vector, or None <https://docs.python.org/3/library/constants.html#None> to use the default section.
None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, Section <#petsc4py.PETSc.Section>, DMPlex.vecGetClosure, DMPlexCreateClosureIndex <https://petsc.org/release/manualpages/DMPlex/DMPlexCreateClosureIndex.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2055 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2055>


Create an IS <#petsc4py.PETSc.IS> covering the coarse DMPlex chart with the fine points as data.

Collective.

fpointIS -- The IS <#petsc4py.PETSc.IS> of all the fine points which exist in the original coarse mesh.
IS <#petsc4py.PETSc.IS>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, IS <#petsc4py.PETSc.IS>, DM.refine <#petsc4py.PETSc.DM.refine>, DMPlex.setRefinementUniform, DMPlexCreateCoarsePointIS <https://petsc.org/release/manualpages/DMPlex/DMPlexCreateCoarsePointIS.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1841 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1841>


Extract the hypersurface defined by one face of the cohesive cells.

Collective.


DMPlex <#petsc4py.PETSc.DMPlex>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlexCreateCohesiveSubmesh <https://petsc.org/release/manualpages/DMPlex/DMPlexCreateCohesiveSubmesh.html>


Source code at petsc4py/PETSc/DMPlex.pyx:401 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L401>


Create a finite element space for the coordinates.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlexCreateCoordinateSpace <https://petsc.org/release/manualpages/DMPlex/DMPlexCreateCoordinateSpace.html>


Source code at petsc4py/PETSc/DMPlex.pyx:377 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L377>


Create a DMPlex mesh from an ExodusII file ID.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.create <#petsc4py.PETSc.DM.create>, DMPlexCreateExodus <https://petsc.org/release/manualpages/DMPlex/DMPlexCreateExodus.html>


Source code at petsc4py/PETSc/DMPlex.pyx:312 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L312>


Create a DMPlex mesh from an ExodusII file.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.create <#petsc4py.PETSc.DM.create>, DMPlex.createExodus, DMPlexCreateExodusFromFile <https://petsc.org/release/manualpages/DMPlex/DMPlexCreateExodusFromFile.html>


Source code at petsc4py/PETSc/DMPlex.pyx:283 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L283>


Create a DMPlex from a list of vertices for each cell on process 0.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, DMPlex.interpolate, DMPlexCreateFromCellListPetsc <https://petsc.org/release/manualpages/DMPlex/DMPlexCreateFromCellListPetsc.html>


Source code at petsc4py/PETSc/DMPlex.pyx:35 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L35>


Create DMPlex from a file.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.createFromCellList, DMPlex.create, Object.setName <#petsc4py.PETSc.Object.setName>, DM.view <#petsc4py.PETSc.DM.view>, DM.load <#petsc4py.PETSc.DM.load>, Working with PETSc options <#petsc-options>, DMPlexCreateFromFile <https://petsc.org/release/manualpages/DMPlex/DMPlexCreateFromFile.html>


Source code at petsc4py/PETSc/DMPlex.pyx:192 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L192>


Create a DMPlex mesh from a Gmsh file viewer.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

Notes

-dm_plex_gmsh_hybrid forces triangular prisms to use tensor order.

-dm_plex_gmsh_periodic allows for reading Gmsh periodic section.

-dm_plex_gmsh_highorder allows for generating high-order coordinates.

-dm_plex_gmsh_project projects high-order coordinates to a different space, use the prefix -dm_plex_gmsh_project_ to define the space.

-dm_plex_gmsh_use_regions generates labels with region names.

-dm_plex_gmsh_mark_vertices adds vertices to generated labels.

-dm_plex_gmsh_multiple_tags allows multiple tags for default labels.

-dm_plex_gmsh_spacedim <d> embedding space dimension.

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.create <#petsc4py.PETSc.DM.create>, Working with PETSc options <#petsc-options>, DMPlexCreateGmsh <https://petsc.org/release/manualpages/DMPlex/DMPlexCreateGmsh.html>


Source code at petsc4py/PETSc/DMPlex.pyx:339 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L339>


Create a global numbering for all points.

Collective.

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.getCellNumbering, DMPlexCreatePointNumbering <https://petsc.org/release/manualpages/DMPlex/DMPlexCreatePointNumbering.html>


Source code at petsc4py/PETSc/DMPlex.pyx:939 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L939>

IS <#petsc4py.PETSc.IS>


Create a Section <#petsc4py.PETSc.Section> based upon the DOF layout specification provided.

Not collective.


Section <#petsc4py.PETSc.Section>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, Section.create <#petsc4py.PETSc.Section.create>, Section.setPermutation <#petsc4py.PETSc.Section.setPermutation>, DMPlexCreateSection <https://petsc.org/release/manualpages/DMPlex/DMPlexCreateSection.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1861 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1861>


Distribute the mesh and any associated sections.

Collective.

overlap (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- The overlap of partitions.
sf -- The SF <#petsc4py.PETSc.SF> used for point distribution, or None <https://docs.python.org/3/library/constants.html#None> if not distributed.
SF <#petsc4py.PETSc.SF> or None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, DMPlexDistribute <https://petsc.org/release/manualpages/DMPlex/DMPlexDistribute.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1585 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1585>


Distribute field data with a with a given SF <#petsc4py.PETSc.SF>.

Collective.

  • sf (SF <#petsc4py.PETSc.SF>) -- The SF <#petsc4py.PETSc.SF> describing the communication pattern.
  • sec (Section <#petsc4py.PETSc.Section>) -- The Section <#petsc4py.PETSc.Section> for existing data layout.
  • vec (Vec <#petsc4py.PETSc.Vec>) -- The existing data in a local vector.
  • newsec (Section <#petsc4py.PETSc.Section> | None <https://docs.python.org/3/library/constants.html#None>) -- The SF <#petsc4py.PETSc.SF> describing the new data layout.
  • newvec (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- The new data in a local vector.

  • newSection (Section <#petsc4py.PETSc.Section>) -- The SF <#petsc4py.PETSc.SF> describing the new data layout.
  • newVec (Vec <#petsc4py.PETSc.Vec>) -- The new data in a local vector.

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Section <#petsc4py.PETSc.Section>, Vec <#petsc4py.PETSc.Vec>]

See also:

DMPlex, DMPlex.distribute, DMPlexDistributeField <https://petsc.org/release/manualpages/DMPlex/DMPlexDistributeField.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1782 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1782>


Return a flag indicating whether the DM <#petsc4py.PETSc.DM> should be distributed by default.

Not collective.

dist -- Flag indicating whether the DMPlex should be distributed by default.
bool <https://docs.python.org/3/library/functions.html#bool>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.distributeSetDefault, DMPlex.distribute, DMPlexDistributeGetDefault <https://petsc.org/release/manualpages/DMPlex/DMPlexDistributeGetDefault.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1671 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1671>


Add partition overlap to a distributed non-overlapping DMPlex.

Collective.

overlap (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- The overlap of partitions (the same on all ranks).
sf -- The SF <#petsc4py.PETSc.SF> used for point distribution.
SF <#petsc4py.PETSc.SF>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, SF <#petsc4py.PETSc.SF>, DMPlex.create, DMPlex.distribute, DMPlexDistributeOverlap <https://petsc.org/release/manualpages/DMPlex/DMPlexDistributeOverlap.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1613 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1613>


Set flag indicating whether the DMPlex should be distributed by default.

Logically collective.

flag (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag indicating whether the DMPlex should be distributed by default.
None <https://docs.python.org/3/library/constants.html#None>

See also:

DMPlex, DMPlex.distributeGetDefault, DMPlex.distribute, DMPlexDistributeSetDefault <https://petsc.org/release/manualpages/DMPlex/DMPlexDistributeSetDefault.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1691 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1691>


Retrieve the name of the specific parallel distribution.

Not collective.

name -- The name of the specific parallel distribution.
str <https://docs.python.org/3/library/stdtypes.html#str>

See also:

DMPlex, DMPlex.distributionSetName, DMPlex.topologyView, DMPlex.topologyLoad, DMPlexDistributionGetName <https://petsc.org/release/manualpages/DMPlex/DMPlexDistributionGetName.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1732 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1732>


Set the name of the specific parallel distribution.

Logically collective.


See also:

DMPlex, DMPlex.distributionGetName, DMPlex.topologyView, DMPlex.topologyLoad, DMPlexDistributionSetName <https://petsc.org/release/manualpages/DMPlex/DMPlexDistributionSetName.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1711 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1711>


Generate a mesh.

Not collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, DM.refine <#petsc4py.PETSc.DM.refine>, Working with PETSc options <#petsc-options>, DMPlexGenerate <https://petsc.org/release/manualpages/DMPlex/DMPlexGenerate.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1308 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1308>


Return all points adjacent to the given point.

Not collective.

p (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
ArrayInt <#petsc4py.typing.ArrayInt>

See also:

DMPlex, DMPlex.distribute, DMPlexGetAdjacency <https://petsc.org/release/manualpages/DMPlex/DMPlexGetAdjacency.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1491 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1491>


Query whether adjacency in the mesh uses the point-to-point constraints.

Not collective.

See also:

DMPlex, DMPlex.getAdjacency, DMPlex.distribute, DMPlexGetAdjacencyUseAnchors <https://petsc.org/release/manualpages/DMPlex/DMPlexGetAdjacencyUseAnchors.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1476 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1476>



Return a global cell numbering for all cells on this process.

Collective the first time it is called.

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.getVertexNumbering, DMPlexGetCellNumbering <https://petsc.org/release/manualpages/DMPlex/DMPlexGetCellNumbering.html>


Source code at petsc4py/PETSc/DMPlex.pyx:909 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L909>

IS <#petsc4py.PETSc.IS>


Return the polytope type of a given cell.

Not collective.

p (int <https://docs.python.org/3/library/functions.html#int>) -- The cell.
PolytopeType <#petsc4py.PETSc.DM.PolytopeType>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.PolytopeType <#petsc4py.PETSc.DM.PolytopeType>, DMPlex.getCellTypeLabel, DMPlex.getDepth, DMPlexGetCellType <https://petsc.org/release/manualpages/DMPlex/DMPlexGetCellType.html>


Source code at petsc4py/PETSc/DMPlex.pyx:709 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L709>


Return the DMLabel <#petsc4py.PETSc.DMLabel> recording the polytope type of each cell.

Not collective.

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.getCellType, DM.createLabel <#petsc4py.PETSc.DM.createLabel>, DMPlexGetCellTypeLabel <https://petsc.org/release/manualpages/DMPlex/DMPlexGetCellTypeLabel.html>


Source code at petsc4py/PETSc/DMPlex.pyx:730 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L730>

DMLabel <#petsc4py.PETSc.DMLabel>


Return the interval for all mesh points [pStart, pEnd).

Not collective.


See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, DMPlex.setChart, DMPlexGetChart <https://petsc.org/release/manualpages/DMPlex/DMPlexGetChart.html>


Source code at petsc4py/PETSc/DMPlex.pyx:424 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L424>


Return the points on the in-edges for this point in the DAG.

Not collective.

p (int <https://docs.python.org/3/library/functions.html#int>) -- The point, which must lie in the chart set with DMPlex.setChart.
ArrayInt <#petsc4py.typing.ArrayInt>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.getConeSize, DMPlex.setCone, DMPlex.setChart, DMPlexGetCone <https://petsc.org/release/manualpages/DMPlex/DMPlexGetCone.html>


Source code at petsc4py/PETSc/DMPlex.pyx:515 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L515>


Return the orientations on the in-edges for this point in the DAG.

Not collective.

p (int <https://docs.python.org/3/library/functions.html#int>) -- The point, which must lie in the chart set with DMPlex.setChart.
ArrayInt <#petsc4py.typing.ArrayInt>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, DMPlex.getCone, DMPlex.setCone, DMPlex.setChart, DMPlexGetConeOrientation <https://petsc.org/release/manualpages/DMPlex/DMPlexGetConeOrientation.html>


Source code at petsc4py/PETSc/DMPlex.pyx:630 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L630>


Return the number of in-edges for this point in the DAG.

Not collective.

p (int <https://docs.python.org/3/library/functions.html#int>) -- The point, which must lie in the chart set with DMPlex.setChart.
int <https://docs.python.org/3/library/functions.html#int>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, DMPlex.setConeSize, DMPlex.setChart, DMPlexGetConeSize <https://petsc.org/release/manualpages/DMPlex/DMPlexGetConeSize.html>


Source code at petsc4py/PETSc/DMPlex.pyx:466 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L466>


Return the depth of the DAG representing this mesh.

Not collective.

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.getDepthStratum, DMPlex.symmetrize, DMPlexGetDepth <https://petsc.org/release/manualpages/DMPlex/DMPlexGetDepth.html>


Source code at petsc4py/PETSc/DMPlex.pyx:953 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L953>



Return the bounds [start, end) for all points at a certain depth.

Not collective.


See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.getHeightStratum, DMPlex.getDepth, DMPlex.symmetrize, DMPlex.interpolate, DMPlexGetDepthStratum <https://petsc.org/release/manualpages/DMPlex/DMPlexGetDepthStratum.html>


Source code at petsc4py/PETSc/DMPlex.pyx:968 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L968>


Return an array for the join of the set of points.

Not collective.

points (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- The input points.
ArrayInt <#petsc4py.typing.ArrayInt>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.getJoin, DMPlex.getMeet, DMPlexGetFullJoin <https://petsc.org/release/manualpages/DMPlex/DMPlexGetFullJoin.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1116 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1116>


Return the bounds [start, end) for all points at a certain height.

Not collective.


See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.getDepthStratum, DMPlex.getDepth, DMPlexGetHeightStratum <https://petsc.org/release/manualpages/DMPlex/DMPlexGetHeightStratum.html>


Source code at petsc4py/PETSc/DMPlex.pyx:995 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L995>


Return an array for the join of the set of points.

Not collective.

points (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- The input points.
ArrayInt <#petsc4py.typing.ArrayInt>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.getMeet, DMPlexGetJoin <https://petsc.org/release/manualpages/DMPlex/DMPlexGetJoin.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1090 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1090>


Return the maximum number of in-edges and out-edges of the DAG.

Not collective.


See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, DMPlex.setConeSize, DMPlex.setChart, DMPlexGetMaxSizes <https://petsc.org/release/manualpages/DMPlex/DMPlexGetMaxSizes.html>


Source code at petsc4py/PETSc/DMPlex.pyx:850 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L850>


Return an array for the meet of the set of points.

Not collective.

points (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- The input points.
ArrayInt <#petsc4py.typing.ArrayInt>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.getJoin, DMPlexGetMeet <https://petsc.org/release/manualpages/DMPlex/DMPlexGetMeet.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1064 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1064>


Return the minimum distance from any cell centroid to a face.

Not collective.

See also:

DMPlex, DM.getCoordinates <#petsc4py.PETSc.DM.getCoordinates>, DMPlexGetMinRadius <https://petsc.org/release/manualpages/DMPlex/DMPlexGetMinRadius.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1827 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1827>



Calculate a reordering of the mesh.

Collective.

otype (OrderingType <#petsc4py.PETSc.Mat.OrderingType>) -- Type of reordering, see Mat.OrderingType <#petsc4py.PETSc.Mat.OrderingType>.
perm -- The point permutation.
IS <#petsc4py.PETSc.IS>

See also:

DMPlex, DMPlex.permute, Mat.OrderingType <#petsc4py.PETSc.Mat.OrderingType>, Mat.getOrdering <#petsc4py.PETSc.Mat.getOrdering>, DMPlexGetOrdering <https://petsc.org/release/manualpages/DMPlex/DMPlexGetOrdering.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2154 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2154>


Return the mesh partitioner.

Not collective.

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, Partitioner <#petsc4py.PETSc.Partitioner>, Section <#petsc4py.PETSc.Section>, DMPlex.distribute, DMPlex.setPartitioner, Partitioner.create <#petsc4py.PETSc.Partitioner.create>, PetscPartitionerDMPlexPartition <https://petsc.org/release/manualpages/DMPlex/PetscPartitionerDMPlexPartition.html>, DMPlexGetPartitioner <https://petsc.org/release/manualpages/DMPlex/DMPlexGetPartitioner.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1534 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1534>

Partitioner <#petsc4py.PETSc.Partitioner>


Return the depth of a given point.

Not collective.


See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.getDepthStratum, DMPlex.getDepth, DMPlexGetPointDepth <https://petsc.org/release/manualpages/DMPlex/DMPlexGetPointDepth.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1022 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1022>


Return location of point data in global Vec <#petsc4py.PETSc.Vec>.

Not collective.

point (int <https://docs.python.org/3/library/functions.html#int>) -- The topological point.

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, int <https://docs.python.org/3/library/functions.html#int>]

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.getPointGlobalField, Section.getOffset <#petsc4py.PETSc.Section.getOffset>, Section.getDof <#petsc4py.PETSc.Section.getDof>, DMPlex.getPointLocal, DMPlexGetPointGlobal <https://petsc.org/release/manualpages/DMPlex/DMPlexGetPointGlobal.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1996 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1996>


Return location of point field data in global Vec <#petsc4py.PETSc.Vec>.

Not collective.



tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, int <https://docs.python.org/3/library/functions.html#int>]

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.getPointGlobal, Section.getOffset <#petsc4py.PETSc.Section.getOffset>, Section.getDof <#petsc4py.PETSc.Section.getDof>, DMPlex.getPointLocal, DMPlexGetPointGlobalField <https://petsc.org/release/manualpages/DMPlex/DMPlexGetPointGlobalField.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2024 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2024>


Return the height of a given point.

Not collective.


See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.getHeightStratum, DMPlexGetPointHeight <https://petsc.org/release/manualpages/DMPlex/DMPlexGetPointHeight.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1043 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1043>


Return location of point data in local Vec <#petsc4py.PETSc.Vec>.

Not collective.


See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.getPointLocalField, Section.getOffset <#petsc4py.PETSc.Section.getOffset>, Section.getDof <#petsc4py.PETSc.Section.getDof>, DMPlexGetPointLocal <https://petsc.org/release/manualpages/DMPlex/DMPlexGetPointLocal.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1937 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1937>


Return location of point field data in local Vec <#petsc4py.PETSc.Vec>.

Not collective.


See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.getPointLocal, Section.getOffset <#petsc4py.PETSc.Section.getOffset>, DMPlexGetPointLocalField <https://petsc.org/release/manualpages/DMPlex/DMPlexGetPointLocalField.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1965 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1965>


Retrieve the maximum cell volume for refinement.

Not collective.

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.refine <#petsc4py.PETSc.DM.refine>, DMPlex.setRefinementLimit, DMPlex.getRefinementUniform, DMPlex.setRefinementUniform, DMPlexGetRefinementLimit <https://petsc.org/release/manualpages/DMPlex/DMPlexGetRefinementLimit.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2138 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2138>



Retrieve the flag for uniform refinement.

Not collective.

refinementUniform -- The flag for uniform refinement.
bool <https://docs.python.org/3/library/functions.html#bool>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.refine <#petsc4py.PETSc.DM.refine>, DMPlex.setRefinementUniform, DMPlex.getRefinementLimit, DMPlex.setRefinementLimit, DMPlexGetRefinementUniform <https://petsc.org/release/manualpages/DMPlex/DMPlexGetRefinementUniform.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2097 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2097>


Return an IS <#petsc4py.PETSc.IS> covering the entire subdm chart.

Not collective.

iset -- The IS <#petsc4py.PETSc.IS> containing subdm's parent's points.
IS <#petsc4py.PETSc.IS>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlexGetSubpointIS <https://petsc.org/release/manualpages/DMPlex/DMPlexGetSubpointIS.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2302 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2302>


Return a DMLabel <#petsc4py.PETSc.DMLabel> with point dimension as values.

Not collective.

label -- The DMLabel <#petsc4py.PETSc.DMLabel> whose values are subdm's point dimensions.
DMLabel <#petsc4py.PETSc.DMLabel>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlexGetSubpointMap <https://petsc.org/release/manualpages/DMPlex/DMPlexGetSubpointMap.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2322 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2322>


Return the points on the out-edges for this point in the DAG.

Not collective.

p (int <https://docs.python.org/3/library/functions.html#int>) -- The point, which must lie in the chart set with DMPlex.setChart.
ArrayInt <#petsc4py.typing.ArrayInt>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.getSupportSize, DMPlex.setSupport, DMPlex.getCone, DMPlex.setChart, DMPlexGetSupport <https://petsc.org/release/manualpages/DMPlex/DMPlexGetSupport.html>


Source code at petsc4py/PETSc/DMPlex.pyx:795 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L795>


Return the number of out-edges for this point in the DAG.

Not collective.

p (int <https://docs.python.org/3/library/functions.html#int>) -- The point, which must lie in the chart set with DMPlex.setChart.
int <https://docs.python.org/3/library/functions.html#int>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, DMPlex.setConeSize, DMPlex.setChart, DMPlex.getConeSize, DMPlexGetSupportSize <https://petsc.org/release/manualpages/DMPlex/DMPlexGetSupportSize.html>


Source code at petsc4py/PETSc/DMPlex.pyx:746 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L746>


Return the points and orientations on the transitive closure of this point.

Not collective.


  • points (ArrayInt <#petsc4py.typing.ArrayInt>) -- The points.
  • orientations (ArrayInt <#petsc4py.typing.ArrayInt>) -- The orientations.

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[ArrayInt <#petsc4py.typing.ArrayInt>, ArrayInt <#petsc4py.typing.ArrayInt>]

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, DMPlex.setCone, DMPlex.setChart, DMPlex.getCone, DMPlexGetTransitiveClosure <https://petsc.org/release/manualpages/DMPlex/DMPlexGetTransitiveClosure.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1142 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1142>


Return an array of the values on the closure of a point.

Not collective.


ArrayScalar <#petsc4py.typing.ArrayScalar>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlexVecRestoreClosure <https://petsc.org/release/manualpages/DMPlex/DMPlexVecRestoreClosure.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1209 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1209>


Return a global vertex numbering for all vertices on this process.

Collective the first time it is called.

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.getCellNumbering, DMPlexGetVertexNumbering <https://petsc.org/release/manualpages/DMPlex/DMPlexGetVertexNumbering.html>


Source code at petsc4py/PETSc/DMPlex.pyx:924 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L924>

IS <#petsc4py.PETSc.IS>


Load on-disk vector data into a global vector.

Collective.

  • viewer (Viewer <#petsc4py.PETSc.Viewer>) -- The Viewer <#petsc4py.PETSc.Viewer> that represents the on-disk vector data.
  • sectiondm (DM <#petsc4py.PETSc.DM>) -- The DM <#petsc4py.PETSc.DM> that contains the global section on which vec is defined.
  • sf (SF <#petsc4py.PETSc.SF>) -- The SF <#petsc4py.PETSc.SF> that migrates the on-disk vector data into vec.
  • vec (Vec <#petsc4py.PETSc.Vec>) -- The global vector to set values of.

None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.topologyLoad, DMPlex.sectionLoad, DMPlex.localVectorLoad, DMPlex.globalVectorView, DMPlex.localVectorView, SF <#petsc4py.PETSc.SF>, Viewer <#petsc4py.PETSc.Viewer>, DMPlexGlobalVectorLoad <https://petsc.org/release/manualpages/DMPlex/DMPlexGlobalVectorLoad.html>


Source code at petsc4py/PETSc/DMPlex.pyx:3425 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3425>


Save a global vector.

Collective.

  • viewer (Viewer <#petsc4py.PETSc.Viewer>) -- The Viewer <#petsc4py.PETSc.Viewer> to save data with.
  • sectiondm (DM <#petsc4py.PETSc.DM>) -- The DM <#petsc4py.PETSc.DM> containing the global section on which vec is defined; may be the same as this DMPlex object.
  • vec (Vec <#petsc4py.PETSc.Vec>) -- The global vector to be saved.

None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.topologyView, DMPlex.sectionView, DMPlex.localVectorView, DMPlex.globalVectorLoad, DMPlex.localVectorLoad, DMPlexGlobalVectorView <https://petsc.org/release/manualpages/DMPlex/DMPlexGlobalVectorView.html>


Source code at petsc4py/PETSc/DMPlex.pyx:3272 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3272>


DMPlexInsertCone - Insert a point into the in-edges for the point p in the DAG.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, DMPlex.getCone, DMPlex.setChart, DMPlex.setConeSize, DM.setUp <#petsc4py.PETSc.DM.setUp>, DMPlexInsertCone <https://petsc.org/release/manualpages/DMPlex/DMPlexInsertCone.html>


Source code at petsc4py/PETSc/DMPlex.pyx:580 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L580>


Insert a point orientation for the in-edge for the point p in the DAG.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, DMPlex.getCone, DMPlex.setChart, DMPlex.setConeSize, DM.setUp <#petsc4py.PETSc.DM.setUp>, DMPlexInsertConeOrientation <https://petsc.org/release/manualpages/DMPlex/DMPlexInsertConeOrientation.html>


Source code at petsc4py/PETSc/DMPlex.pyx:605 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L605>


Convert to a mesh with all intermediate faces, edges, etc.

Collective.

See also:

DMPlex, DMPlex.uninterpolate, DMPlex.createFromCellList, DMPlexInterpolate <https://petsc.org/release/manualpages/DMPlex/DMPlexInterpolate.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1752 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1752>



Return the flag indicating if the mesh is distributed.

Collective.

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.distribute, DMPlexIsDistributed <https://petsc.org/release/manualpages/DMPlex/DMPlexIsDistributed.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1642 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1642>



Return the flag indicating if the first cell is a simplex.

Not collective.

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.getCellType, DMPlex.getHeightStratum, DMPlexIsSimplex <https://petsc.org/release/manualpages/DMPlex/DMPlexIsSimplex.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1656 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1656>



Add all other mesh pieces to complete the surface.

Not collective.

  • label (DMLabel <#petsc4py.PETSc.DMLabel>) -- A DMLabel <#petsc4py.PETSc.DMLabel> marking the surface.
  • bdlabel (DMLabel <#petsc4py.PETSc.DMLabel>) -- A DMLabel <#petsc4py.PETSc.DMLabel> marking the vertices on the boundary which will not be duplicated.
  • bdvalue (int <https://docs.python.org/3/library/functions.html#int>) -- Value of DMLabel <#petsc4py.PETSc.DMLabel> marking the vertices on the boundary.
  • flip (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag to flip the submesh normal and replace points on the other side.
  • split (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag to split faces incident on the surface boundary, rather than clamping those faces to the boundary
  • subdm (DMPlex <#petsc4py.PETSc.DMPlex>) -- The DMPlex associated with the label.

None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.labelComplete, DMPlexLabelCohesiveComplete <https://petsc.org/release/manualpages/DMPlex/DMPlexLabelCohesiveComplete.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1420 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1420>


Add the transitive closure to the surface.

Not collective.

label (DMLabel <#petsc4py.PETSc.DMLabel>) -- A DMLabel <#petsc4py.PETSc.DMLabel> marking the surface points.
None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.labelCohesiveComplete, DMPlexLabelComplete <https://petsc.org/release/manualpages/DMPlex/DMPlexLabelComplete.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1403 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1403>


Load labels into this DMPlex object.

Collective.

  • viewer (Viewer <#petsc4py.PETSc.Viewer>) -- The Viewer <#petsc4py.PETSc.Viewer> for the saved labels.
  • sfxc (SF <#petsc4py.PETSc.SF>) -- The SF <#petsc4py.PETSc.SF> returned by topologyLoad.

None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.load <#petsc4py.PETSc.DM.load>, DMPlex.topologyLoad, DMPlex.coordinatesLoad, DM.view <#petsc4py.PETSc.DM.view>, SF <#petsc4py.PETSc.SF>, Viewer <#petsc4py.PETSc.Viewer>, DMPlexLabelsLoad <https://petsc.org/release/manualpages/DMPlex/DMPlexLabelsLoad.html>


Source code at petsc4py/PETSc/DMPlex.pyx:3368 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3368>


Save DMPlex labels into a file.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer>) -- The Viewer <#petsc4py.PETSc.Viewer> for saving.
None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.view <#petsc4py.PETSc.DM.view>, DMPlex.topologyView, DMPlex.coordinatesView, DMPlex.labelsLoad, Viewer <#petsc4py.PETSc.Viewer>, DMPlexLabelsView <https://petsc.org/release/manualpages/DMPlex/DMPlexLabelsView.html>


Source code at petsc4py/PETSc/DMPlex.pyx:3233 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3233>


Load on-disk vector data into a local vector.

Collective.

  • viewer (Viewer <#petsc4py.PETSc.Viewer>) -- The Viewer <#petsc4py.PETSc.Viewer> that represents the on-disk vector data.
  • sectiondm (DM <#petsc4py.PETSc.DM>) -- The DM <#petsc4py.PETSc.DM> that contains the local section on which vec is defined.
  • sf (SF <#petsc4py.PETSc.SF>) -- The SF <#petsc4py.PETSc.SF> that migrates the on-disk vector data into vec.
  • vec (Vec <#petsc4py.PETSc.Vec>) -- The local vector to set values of.

None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.topologyLoad, DMPlex.sectionLoad, DMPlex.globalVectorLoad, DMPlex.globalVectorView, DMPlex.localVectorView, SF <#petsc4py.PETSc.SF>, Viewer <#petsc4py.PETSc.Viewer>, DMPlexLocalVectorLoad <https://petsc.org/release/manualpages/DMPlex/DMPlexLocalVectorLoad.html>


Source code at petsc4py/PETSc/DMPlex.pyx:3450 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3450>


Save a local vector.

Collective.

  • viewer (Viewer <#petsc4py.PETSc.Viewer>) -- The Viewer <#petsc4py.PETSc.Viewer> to save data with.
  • sectiondm (DM <#petsc4py.PETSc.DM>) -- The DM <#petsc4py.PETSc.DM> that contains the local section on which vec is defined; may be the same as this DMPlex object.
  • vec (Vec <#petsc4py.PETSc.Vec>) -- The local vector to be saved.

None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.topologyView, DMPlex.sectionView, DMPlex.globalVectorView, DMPlex.globalVectorLoad, DMPlex.localVectorLoad, DMPlexLocalVectorView <https://petsc.org/release/manualpages/DMPlex/DMPlexLocalVectorView.html>


Source code at petsc4py/PETSc/DMPlex.pyx:3296 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3296>


Mark all faces on the boundary.

Not collective.


DMLabel <#petsc4py.PETSc.DMLabel>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMLabel.create <#petsc4py.PETSc.DMLabel.create>, DM.createLabel <#petsc4py.PETSc.DM.createLabel>, DMPlexMarkBoundaryFaces <https://petsc.org/release/manualpages/DMPlex/DMPlexMarkBoundaryFaces.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1376 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1376>


Compute and return the unweighted average of two metrics.

Collective.

  • metric1 (Vec <#petsc4py.PETSc.Vec>) -- The first metric to be averaged.
  • metric2 (Vec <#petsc4py.PETSc.Vec>) -- The second metric to be averaged.
  • metricAvg (Vec <#petsc4py.PETSc.Vec>) -- The output averaged metric.

Vec <#petsc4py.PETSc.Vec>

See also:



Source code at petsc4py/PETSc/DMPlex.pyx:3083 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3083>


Compute and return the unweighted average of three metrics.

Collective.

  • metric1 (Vec <#petsc4py.PETSc.Vec>) -- The first metric to be averaged.
  • metric2 (Vec <#petsc4py.PETSc.Vec>) -- The second metric to be averaged.
  • metric3 (Vec <#petsc4py.PETSc.Vec>) -- The third metric to be averaged.
  • metricAvg (Vec <#petsc4py.PETSc.Vec>) -- The output averaged metric.

Vec <#petsc4py.PETSc.Vec>

See also:



Source code at petsc4py/PETSc/DMPlex.pyx:3105 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3105>


Create a Riemannian metric field.

Collective.


See also:

DMPlex.metricCreateUniform, DMPlex.metricCreateIsotropic, Working with PETSc options <#petsc-options>, DMPlexMetricCreate <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricCreate.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2914 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2914>


Construct an isotropic metric from an error indicator.

Collective.


Vec <#petsc4py.PETSc.Vec>

See also:

DMPlex.metricCreate, DMPlex.metricCreateUniform, DMPlexMetricCreateIsotropic <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricCreateIsotropic.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2959 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2959>


Construct a uniform isotropic metric.

Collective.


Vec <#petsc4py.PETSc.Vec>

See also:

DMPlex.metricCreate, DMPlex.metricCreateIsotropic, DMPlexMetricCreateUniform <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricCreateUniform.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2935 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2935>


Create the determinant field for a Riemannian metric.

Collective.

field (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- The field number to use.
  • determinant (Vec <#petsc4py.PETSc.Vec>) -- The determinant field.
  • dmDet (DM <#petsc4py.PETSc.DM>) -- The corresponding DM

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, DM <#petsc4py.PETSc.DM>]

See also:

DMPlex.metricCreateUniform, DMPlex.metricCreateIsotropic, DMPlex.metricCreate, DMPlexMetricDeterminantCreate <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricDeterminantCreate.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2982 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2982>


Enforce symmetric positive-definiteness of a metric.

Collective.


  • ometric (Vec <#petsc4py.PETSc.Vec>) -- The output metric.
  • determinant (Vec <#petsc4py.PETSc.Vec>) -- The output determinant.

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>]

See also:

DMPlex.metricNormalize, DMPlex.metricIntersection2, DMPlex.metricIntersection3, Working with PETSc options <#petsc-options>, DMPlexMetricEnforceSPD <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricEnforceSPD.html>


Source code at petsc4py/PETSc/DMPlex.pyx:3011 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3011>


Return the metric gradation factor.

Not collective.

See also:

DMPlex.metricSetGradationFactor, DMPlex.metricGetHausdorffNumber, DMPlexMetricGetGradationFactor <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricGetGradationFactor.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2865 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2865>



Return the metric Hausdorff number.

Not collective.

See also:

DMPlex.metricGetGradationFactor, DMPlex.metricSetHausdorffNumber, DMPlexMetricGetHausdorffNumber <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricGetHausdorffNumber.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2899 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2899>



Return the maximum tolerated metric anisotropy.

Not collective.

See also:

DMPlex.metricSetMaximumAnisotropy, DMPlex.metricGetMaximumMagnitude, DMPlexMetricGetMaximumAnisotropy <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricGetMaximumAnisotropy.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2763 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2763>



Return the maximum tolerated metric magnitude.

Not collective.

See also:

DMPlex.metricSetMaximumMagnitude, DMPlex.metricGetMinimumMagnitude, DMPlexMetricGetMaximumMagnitude <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricGetMaximumMagnitude.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2729 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2729>



Return the minimum tolerated metric magnitude.

Not collective.

See also:

DMPlex.metricSetMinimumMagnitude, DMPlex.metricGetMaximumMagnitude, DMPlexMetricGetMinimumMagnitude <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricGetMinimumMagnitude.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2695 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2695>



Return the order p for L-p normalization.

Not collective.

See also:

DMPlex.metricSetNormalizationOrder, DMPlex.metricGetTargetComplexity, DMPlexMetricGetNormalizationOrder <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricGetNormalizationOrder.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2831 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2831>



Return the number of parallel adaptation iterations.

Not collective.

See also:

DMPlex.metricSetNumIterations, DMPlex.metricGetVerbosity, DMPlexMetricGetNumIterations <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricGetNumIterations.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2661 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2661>



Return the target metric complexity.

Not collective.

See also:

DMPlex.metricSetTargetComplexity, DMPlex.metricGetNormalizationOrder, DMPlexMetricGetTargetComplexity <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricGetTargetComplexity.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2797 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2797>



Return the verbosity of the mesh adaptation package.

Not collective.

verbosity -- The verbosity, where -1 is silent and 10 is maximum.
int <https://docs.python.org/3/library/functions.html#int>

See also:

DMPlex.metricSetVerbosity, DMPlex.metricGetNumIterations, DMPlexMetricGetVerbosity <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricGetVerbosity.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2622 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2622>


Compute and return the intersection of two metrics.

Collective.

  • metric1 (Vec <#petsc4py.PETSc.Vec>) -- The first metric to be intersected.
  • metric2 (Vec <#petsc4py.PETSc.Vec>) -- The second metric to be intersected.
  • metricInt (Vec <#petsc4py.PETSc.Vec>) -- The output intersected metric.

Vec <#petsc4py.PETSc.Vec>

See also:

DMPlex.metricIntersection3, DMPlexMetricIntersection2 <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricIntersection2.html>


Source code at petsc4py/PETSc/DMPlex.pyx:3129 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3129>


Compute the intersection of three metrics.

Collective.

  • metric1 (Vec <#petsc4py.PETSc.Vec>) -- The first metric to be intersected.
  • metric2 (Vec <#petsc4py.PETSc.Vec>) -- The second metric to be intersected.
  • metric3 (Vec <#petsc4py.PETSc.Vec>) -- The third metric to be intersected.
  • metricInt (Vec <#petsc4py.PETSc.Vec>) -- The output intersected metric.

Vec <#petsc4py.PETSc.Vec>

See also:

DMPlex.metricIntersection2, DMPlexMetricIntersection3 <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricIntersection3.html>


Source code at petsc4py/PETSc/DMPlex.pyx:3151 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3151>


Return the flag indicating whether the metric is isotropic or not.

Not collective.

See also:

DMPlex.metricSetIsotropic, DMPlex.metricIsUniform, DMPlex.metricRestrictAnisotropyFirst, DMPlexMetricIsIsotropic <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricIsIsotropic.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2410 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2410>



Return the flag indicating whether the metric is uniform or not.

Not collective.

See also:

DMPlex.metricSetUniform, DMPlex.metricRestrictAnisotropyFirst, DMPlexMetricIsUniform <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricIsUniform.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2376 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2376>



Return the flag indicating whether node insertion and deletion are turned off.

Not collective.

See also:

DMPlex.metricSetNoInsertion, DMPlex.metricNoSwapping, DMPlex.metricNoMovement, DMPlex.metricNoSurf, DMPlexMetricNoInsertion <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricNoInsertion.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2479 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2479>



Return the flag indicating whether node movement is turned off.

Not collective.

See also:

DMPlex.metricSetNoMovement, DMPlex.metricNoInsertion, DMPlex.metricNoSwapping, DMPlex.metricNoSurf, DMPlexMetricNoMovement <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricNoMovement.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2551 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2551>



Return the flag indicating whether surface modification is turned off.

Not collective.

See also:

DMPlex.metricSetNoSurf, DMPlex.metricNoMovement, DMPlex.metricNoInsertion, DMPlex.metricNoSwapping, DMPlexMetricNoSurf <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricNoSurf.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2587 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2587>



Return the flag indicating whether facet swapping is turned off.

Not collective.

See also:

DMPlex.metricSetNoSwapping, DMPlex.metricNoInsertion, DMPlex.metricNoMovement, DMPlex.metricNoSurf, DMPlexMetricNoSwapping <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricNoSwapping.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2515 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2515>



Apply L-p normalization to a metric.

Collective.


  • ometric (Vec <#petsc4py.PETSc.Vec>) -- The output normalized metric.
  • determinant (Vec <#petsc4py.PETSc.Vec>) -- The output determinant.

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>]

See also:

DMPlex.metricEnforceSPD, DMPlex.metricIntersection2, DMPlex.metricIntersection3, Working with PETSc options <#petsc-options>, DMPlexMetricNormalize <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricNormalize.html>


Source code at petsc4py/PETSc/DMPlex.pyx:3047 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3047>


Return true if anisotropy is restricted before normalization.

Not collective.

See also:

DMPlex.metricIsIsotropic, DMPlex.metricSetRestrictAnisotropyFirst, DMPlexMetricRestrictAnisotropyFirst <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricRestrictAnisotropyFirst.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2444 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2444>



Configure the object from the options database.

Collective.

See also:

Working with PETSc options <#petsc-options>


Source code at petsc4py/PETSc/DMPlex.pyx:2344 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2344>



Set the metric gradation factor.

Logically collective.


See also:

DMPlex.metricGetGradationFactor, DMPlex.metricSetHausdorffNumber, DMPlexMetricSetGradationFactor <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricSetGradationFactor.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2846 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2846>


Set the metric Hausdorff number.

Logically collective.


See also:

DMPlex.metricSetGradationFactor, DMPlex.metricGetHausdorffNumber, DMPlexMetricSetHausdorffNumber <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricSetHausdorffNumber.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2880 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2880>


Record whether the metric is isotropic or not.

Logically collective.

isotropic (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag indicating whether the metric is isotropic or not.
None <https://docs.python.org/3/library/constants.html#None>

See also:

DMPlex.metricIsIsotropic, DMPlex.metricSetUniform, DMPlex.metricSetRestrictAnisotropyFirst, DMPlexMetricSetIsotropic <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricSetIsotropic.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2391 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2391>


Set the maximum tolerated metric anisotropy.

Logically collective.


See also:

DMPlex.metricGetMaximumAnisotropy, DMPlex.metricSetMaximumMagnitude, DMPlexMetricSetMaximumAnisotropy <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricSetMaximumAnisotropy.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2744 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2744>


Set the maximum tolerated metric magnitude.

Logically collective.


See also:

DMPlex.metricGetMaximumMagnitude, DMPlex.metricSetMinimumMagnitude, DMPlexMetricSetMaximumMagnitude <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricSetMaximumMagnitude.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2710 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2710>


Set the minimum tolerated metric magnitude.

Logically collective.


See also:

DMPlex.metricGetMinimumMagnitude, DMPlex.metricSetMaximumMagnitude, DMPlexMetricSetMinimumMagnitude <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricSetMinimumMagnitude.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2676 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2676>


Set the flag indicating whether node insertion should be turned off.

Logically collective.

noInsert (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag indicating whether node insertion and deletion should be turned off.
None <https://docs.python.org/3/library/constants.html#None>

See also:

DMPlex.metricNoInsertion, DMPlex.metricSetNoSwapping, DMPlex.metricSetNoMovement, DMPlex.metricSetNoSurf, DMPlexMetricSetNoInsertion <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricSetNoInsertion.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2459 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2459>


Set the flag indicating whether node movement should be turned off.

Logically collective.

noMove (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag indicating whether node movement should be turned off.
None <https://docs.python.org/3/library/constants.html#None>

See also:

DMPlex.metricNoMovement, DMPlex.metricSetNoInsertion, DMPlex.metricSetNoSwapping, DMPlex.metricSetNoSurf, DMPlexMetricSetNoMovement <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricSetNoMovement.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2531 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2531>


Set the flag indicating whether surface modification should be turned off.

Logically collective.

noSurf (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag indicating whether surface modification should be turned off.
None <https://docs.python.org/3/library/constants.html#None>

See also:

DMPlex.metricNoSurf, DMPlex.metricSetNoMovement, DMPlex.metricSetNoInsertion, DMPlex.metricSetNoSwapping, DMPlexMetricSetNoSurf <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricSetNoSurf.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2567 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2567>


Set the flag indicating whether facet swapping should be turned off.

Logically collective.

noSwap (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag indicating whether facet swapping should be turned off.
None <https://docs.python.org/3/library/constants.html#None>

See also:

DMPlex.metricNoSwapping, DMPlex.metricSetNoInsertion, DMPlex.metricSetNoMovement, DMPlex.metricSetNoSurf, DMPlexMetricSetNoSwapping <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricSetNoSwapping.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2495 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2495>


Set the order p for L-p normalization.

Logically collective.


See also:

DMPlex.metricGetNormalizationOrder, DMPlex.metricSetTargetComplexity, DMPlexMetricSetNormalizationOrder <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricSetNormalizationOrder.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2812 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2812>


Set the number of parallel adaptation iterations.

Logically collective.


See also:

DMPlex.metricSetVerbosity, DMPlex.metricGetNumIterations, DMPlexMetricSetNumIterations <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricSetNumIterations.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2642 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2642>


Record whether anisotropy is be restricted before normalization or after.

Logically collective.

restrictAnisotropyFirst (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag indicating if anisotropy is restricted before normalization or after.
None <https://docs.python.org/3/library/constants.html#None>

See also:

DMPlex.metricSetIsotropic, DMPlex.metricRestrictAnisotropyFirst, DMPlexMetricSetRestrictAnisotropyFirst <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricSetRestrictAnisotropyFirst.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2425 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2425>


Set the target metric complexity.

Logically collective.


See also:

DMPlex.metricGetTargetComplexity, DMPlex.metricSetNormalizationOrder, DMPlexMetricSetTargetComplexity <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricSetTargetComplexity.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2778 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2778>


Record whether the metric is uniform or not.

Logically collective.

uniform (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag indicating whether the metric is uniform or not.
None <https://docs.python.org/3/library/constants.html#None>

See also:

DMPlex.metricIsUniform, DMPlex.metricSetIsotropic, DMPlex.metricSetRestrictAnisotropyFirst, DMPlexMetricSetUniform <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricSetUniform.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2357 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2357>


Set the verbosity of the mesh adaptation package.

Logically collective.

verbosity (int <https://docs.python.org/3/library/functions.html#int>) -- The verbosity, where -1 is silent and 10 is maximum.
None <https://docs.python.org/3/library/constants.html#None>

See also:

DMPlex.metricGetVerbosity, DMPlex.metricSetNumIterations, DMPlexMetricSetVerbosity <https://petsc.org/release/manualpages/DMPlex/DMPlexMetricSetVerbosity.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2603 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2603>


Give a consistent orientation to the input mesh.

Collective.

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.create <#petsc4py.PETSc.DM.create>, DMPlexOrient <https://petsc.org/release/manualpages/DMPlex/DMPlexOrient.html>


Source code at petsc4py/PETSc/DMPlex.pyx:897 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L897>



Reorder the mesh according to the input permutation.

Collective.

perm (IS <#petsc4py.PETSc.IS>) -- The point permutation, perm[old point number] = new point number.
pdm -- The permuted DMPlex.
DMPlex

See also:

DMPlex, Mat.permute <#petsc4py.PETSc.Mat.permute>, DMPlexPermute <https://petsc.org/release/manualpages/DMPlex/DMPlexPermute.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2182 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2182>


Redistribute shared points in order to achieve better balancing.

Collective.


success -- Whether the graph partitioning was successful or not. Unsuccessful simply means no change to the partitioning.
bool <https://docs.python.org/3/library/functions.html#bool>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.distribute, Working with PETSc options <#petsc-options>, DMPlexRebalanceSharedPoints <https://petsc.org/release/manualpages/DMPlex/DMPlexRebalanceSharedPoints.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1551 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1551>


Return flag indicating whether the DMPlex should be reordered by default.

Not collective.

See also:


Source code at petsc4py/PETSc/DMPlex.pyx:2206 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2206>

ReorderDefaultFlag <#petsc4py.PETSc.DM.ReorderDefaultFlag>


Set flag indicating whether the DM should be reordered by default.

Logically collective.

  • reorder -- Flag for reordering.
  • flag (ReorderDefaultFlag <#petsc4py.PETSc.DM.ReorderDefaultFlag>)

None <https://docs.python.org/3/library/constants.html#None>

See also:

DMPlex.reorderGetDefault, DMPlexReorderSetDefault <https://petsc.org/release/manualpages/DMPlex/DMPlexReorderSetDefault.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2220 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2220>


Load section into a DM <#petsc4py.PETSc.DM>.

Collective.

  • viewer (Viewer <#petsc4py.PETSc.Viewer>) -- The Viewer <#petsc4py.PETSc.Viewer> that represents the on-disk section (sectionA).
  • sectiondm (DM <#petsc4py.PETSc.DM>) -- The DM <#petsc4py.PETSc.DM> into which the on-disk section (sectionA) is migrated.
  • sfxc (SF <#petsc4py.PETSc.SF>) -- The SF <#petsc4py.PETSc.SF> returned by topologyLoad.

  • gsf (SF <#petsc4py.PETSc.SF>) -- The SF <#petsc4py.PETSc.SF> that migrates any on-disk Vec <#petsc4py.PETSc.Vec> data associated with sectionA into a global Vec <#petsc4py.PETSc.Vec> associated with the sectiondm's global section (None <https://docs.python.org/3/library/constants.html#None> if not needed).
  • lsf (SF <#petsc4py.PETSc.SF>) -- The SF <#petsc4py.PETSc.SF> that migrates any on-disk Vec <#petsc4py.PETSc.Vec> data associated with sectionA into a local Vec <#petsc4py.PETSc.Vec> associated with the sectiondm's local section (None <https://docs.python.org/3/library/constants.html#None> if not needed).

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[SF <#petsc4py.PETSc.SF>, SF <#petsc4py.PETSc.SF>]

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.load <#petsc4py.PETSc.DM.load>, DMPlex.topologyLoad, DMPlex.coordinatesLoad, DMPlex.labelsLoad, DMPlex.globalVectorLoad, DMPlex.localVectorLoad, DMPlex.sectionView, SF <#petsc4py.PETSc.SF>, Viewer <#petsc4py.PETSc.Viewer>, DMPlexSectionLoad <https://petsc.org/release/manualpages/DMPlex/DMPlexSectionLoad.html>


Source code at petsc4py/PETSc/DMPlex.pyx:3388 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3388>


Save a section associated with a DMPlex.

Collective.

  • viewer (Viewer <#petsc4py.PETSc.Viewer>) -- The Viewer <#petsc4py.PETSc.Viewer> for saving.
  • sectiondm (DM <#petsc4py.PETSc.DM>) -- The DM <#petsc4py.PETSc.DM> that contains the section to be saved.

None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.view <#petsc4py.PETSc.DM.view>, DMPlex.topologyView, DMPlex.coordinatesView, DMPlex.labelsView, DMPlex.globalVectorView, DMPlex.localVectorView, DMPlex.sectionLoad, Viewer <#petsc4py.PETSc.Viewer>, DMPlexSectionView <https://petsc.org/release/manualpages/DMPlex/DMPlexSectionView.html>


Source code at petsc4py/PETSc/DMPlex.pyx:3251 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3251>


Define adjacency in the mesh using the point-to-point constraints.

Logically collective.

useAnchors (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag to use the constraints. If True <https://docs.python.org/3/library/constants.html#True>, then constrained points are omitted from DMPlex.getAdjacency, and their anchor points appear in their place.
None <https://docs.python.org/3/library/constants.html#None>

See also:

DMPlex, DMPlex.getAdjacency, DMPlex.distribute, DMPlexSetAdjacencyUseAnchors <https://petsc.org/release/manualpages/DMPlex/DMPlexSetAdjacencyUseAnchors.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1455 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1455>


Set the polytope type of a given cell.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.getCellTypeLabel, DMPlex.getDepth, DM.createLabel <#petsc4py.PETSc.DM.createLabel>, DMPlexSetCellType <https://petsc.org/release/manualpages/DMPlex/DMPlexSetCellType.html>


Source code at petsc4py/PETSc/DMPlex.pyx:687 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L687>


Set the interval for all mesh points [pStart, pEnd).

Not collective.


See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, DMPlex.getChart, DMPlexSetChart <https://petsc.org/release/manualpages/DMPlex/DMPlexSetChart.html>


Source code at petsc4py/PETSc/DMPlex.pyx:445 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L445>


Set the points on the in-edges for this point in the DAG.

Not collective.


See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, DMPlex.getCone, DMPlex.setChart, DMPlex.setConeSize, DM.setUp <#petsc4py.PETSc.DM.setUp>, DMPlex.setSupport, DMPlex.setSupportSize, DMPlexSetCone <https://petsc.org/release/manualpages/DMPlex/DMPlexSetCone.html>


Source code at petsc4py/PETSc/DMPlex.pyx:541 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L541>


Set the orientations on the in-edges for this point in the DAG.

Not collective.


See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, DMPlex.getConeOrientation, DMPlex.setCone, DMPlex.setChart, DMPlex.setConeSize, DM.setUp <#petsc4py.PETSc.DM.setUp>, DMPlexSetConeOrientation <https://petsc.org/release/manualpages/DMPlex/DMPlexSetConeOrientation.html>


Source code at petsc4py/PETSc/DMPlex.pyx:656 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L656>


Set the number of in-edges for this point in the DAG.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, DMPlex.getConeSize, DMPlex.setChart, DMPlexSetConeSize <https://petsc.org/release/manualpages/DMPlex/DMPlexSetConeSize.html>


Source code at petsc4py/PETSc/DMPlex.pyx:490 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L490>


Set an array of the values on the closure of point.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlexMatSetClosure <https://petsc.org/release/manualpages/DMPlex/DMPlexMatSetClosure.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1271 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1271>


Set the mesh partitioner.

Logically collective.

part (Partitioner <#petsc4py.PETSc.Partitioner>) -- The partitioner.
None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, Partitioner <#petsc4py.PETSc.Partitioner>, DMPlex.distribute, DMPlex.getPartitioner, Partitioner.create <#petsc4py.PETSc.Partitioner.create>, DMPlexSetPartitioner <https://petsc.org/release/manualpages/DMPlex/DMPlexSetPartitioner.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1516 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1516>


Set the maximum cell volume for refinement.

Logically collective.

refinementLimit (float <https://docs.python.org/3/library/functions.html#float>) -- The maximum cell volume in the refined mesh.
None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.refine <#petsc4py.PETSc.DM.refine>, DMPlex.getRefinementLimit, DMPlex.getRefinementUniform, DMPlex.setRefinementUniform, DMPlexSetRefinementLimit <https://petsc.org/release/manualpages/DMPlex/DMPlexSetRefinementLimit.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2118 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2118>


Set the flag for uniform refinement.

Logically collective.


See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.refine <#petsc4py.PETSc.DM.refine>, DMPlex.getRefinementUniform, DMPlex.getRefinementLimit, DMPlex.setRefinementLimit, DMPlexSetRefinementUniform <https://petsc.org/release/manualpages/DMPlex/DMPlexSetRefinementUniform.html>


Source code at petsc4py/PETSc/DMPlex.pyx:2077 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2077>


Set the points on the out-edges for this point in the DAG.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.setCone, DMPlex.setConeSize, DMPlex.create, DMPlex.getSupport, DMPlex.setChart, DMPlex.setSupportSize, DM.setUp <#petsc4py.PETSc.DM.setUp>, DMPlexSetSupport <https://petsc.org/release/manualpages/DMPlex/DMPlexSetSupport.html>


Source code at petsc4py/PETSc/DMPlex.pyx:821 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L821>


Set the number of out-edges for this point in the DAG.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, DMPlex.getSupportSize, DMPlex.setChart, DMPlexSetSupportSize <https://petsc.org/release/manualpages/DMPlex/DMPlexSetSupportSize.html>


Source code at petsc4py/PETSc/DMPlex.pyx:770 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L770>


Set the options used for the Tetgen mesh generator.

Not collective.


See also:

Working with PETSc options <#petsc-options>, DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.setTriangleOptions, DMPlex.generate, DMPlexTetgenSetOptions <https://petsc.org/release/manualpages/DMPlex/DMPlexTetgenSetOptions.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1356 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1356>


Set the options used for the Triangle mesh generator.

Not collective.


See also:

Working with PETSc options <#petsc-options>, DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.setTetGenOptions, DMPlex.generate, DMPlexTriangleSetOptions <https://petsc.org/release/manualpages/DMPlex/DMPlexTriangleSetOptions.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1336 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1336>


Set an array of the values on the closure of point.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlexVecSetClosure <https://petsc.org/release/manualpages/DMPlex/DMPlexVecSetClosure.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1239 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1239>


Calculate the strata of DAG.

Collective.

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, DMPlex.symmetrize, DMPlexStratify <https://petsc.org/release/manualpages/DMPlex/DMPlexStratify.html>


Source code at petsc4py/PETSc/DMPlex.pyx:885 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L885>



Create support (out-edge) information from cone (in-edge) information.

Not collective.

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlex.create, DMPlex.setChart, DMPlex.setConeSize, DMPlex.setCone, DMPlexSymmetrize <https://petsc.org/release/manualpages/DMPlex/DMPlexSymmetrize.html>


Source code at petsc4py/PETSc/DMPlex.pyx:872 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L872>



Load a topology into this DMPlex object.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer>) -- The Viewer <#petsc4py.PETSc.Viewer> for the saved topology
sfxc -- The SF <#petsc4py.PETSc.SF> that pushes points in [0, N) to the associated points in the loaded DMPlex, where N is the global number of points.
SF <#petsc4py.PETSc.SF>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.load <#petsc4py.PETSc.DM.load>, DMPlex.coordinatesLoad, DMPlex.labelsLoad, DM.view <#petsc4py.PETSc.DM.view>, SF <#petsc4py.PETSc.SF>, Viewer <#petsc4py.PETSc.Viewer>, DMPlexTopologyLoad <https://petsc.org/release/manualpages/DMPlex/DMPlexTopologyLoad.html>


Source code at petsc4py/PETSc/DMPlex.pyx:3322 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3322>


Save a DMPlex topology into a file.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer>) -- The Viewer <#petsc4py.PETSc.Viewer> for saving.
None <https://docs.python.org/3/library/constants.html#None>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DM.view <#petsc4py.PETSc.DM.view>, DMPlex.coordinatesView, DMPlex.labelsView, DMPlex.topologyLoad, Viewer <#petsc4py.PETSc.Viewer>, DMPlexTopologyView <https://petsc.org/release/manualpages/DMPlex/DMPlexTopologyView.html>


Source code at petsc4py/PETSc/DMPlex.pyx:3197 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3197>


Convert to a mesh with only cells and vertices.

Collective.

See also:

DMPlex, DMPlex.interpolate, DMPlex.createFromCellList, DMPlexUninterpolate <https://petsc.org/release/manualpages/DMPlex/DMPlexUninterpolate.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1767 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1767>



Return an array of values on the closure of p.

Not collective.


ArrayScalar <#petsc4py.typing.ArrayScalar>

See also:

DM <#petsc4py.PETSc.DM>, DMPlex, DMPlexVecRestoreClosure <https://petsc.org/release/manualpages/DMPlex/DMPlexVecRestoreClosure.html>


Source code at petsc4py/PETSc/DMPlex.pyx:1181 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1181>



petsc4py.PETSc.DMPlexTransform

Bases: Object <#petsc4py.PETSc.Object>

Mesh transformations.

Methods Summary

apply(dm) Apply a mesh transformation.
create([comm]) Create a mesh transformation.
destroy() Destroy a mesh transformation.
getType() Return the transformation type name.
setDM(dm) Set the DM <#petsc4py.PETSc.DM> for the transformation.
setFromOptions() Configure the transformation from the options database.
setType(tr_type) Set the transformation type.
setUp() Setup a mesh transformation.
view([viewer]) View the mesh transformation.

Methods Documentation

Apply a mesh transformation.

Collective.

Source code at petsc4py/PETSc/DMPlex.pyx:3499 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3499>

dm (DM <#petsc4py.PETSc.DM>)
DM <#petsc4py.PETSc.DM>





Set the DM <#petsc4py.PETSc.DM> for the transformation.

Logically collective.

Source code at petsc4py/PETSc/DMPlex.pyx:3578 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3578>



Configure the transformation from the options database.

Collective.

See also:

Working with PETSc options <#petsc-options>, DMPlexTransformSetFromOptions <https://petsc.org/release/manualpages/DMPlex/DMPlexTransformSetFromOptions.html>


Source code at petsc4py/PETSc/DMPlex.pyx:3587 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3587>



Set the transformation type.

Collective.

See also:


Source code at petsc4py/PETSc/DMPlex.pyx:3564 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3564>

tr_type (DMPlexTransformType <#petsc4py.PETSc.DMPlexTransformType> | str <https://docs.python.org/3/library/stdtypes.html#str>)
None <https://docs.python.org/3/library/constants.html#None>



View the mesh transformation.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> instance or None <https://docs.python.org/3/library/constants.html#None> for the default viewer.
None <https://docs.python.org/3/library/constants.html#None>

See also:

Viewer <#petsc4py.PETSc.Viewer>, DMPlexTransformView <https://petsc.org/release/manualpages/DMPlex/DMPlexTransformView.html>


Source code at petsc4py/PETSc/DMPlex.pyx:3599 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3599>



petsc4py.PETSc.DMPlexTransformType

Bases: object <https://docs.python.org/3/library/functions.html#object>

Transformation types.

Attributes Summary

EXTRUDE Object EXTRUDE of type str <https://docs.python.org/3/library/stdtypes.html#str>
REFINE1D Object REFINE1D of type str <https://docs.python.org/3/library/stdtypes.html#str>
REFINEALFELD Object REFINEALFELD of type str <https://docs.python.org/3/library/stdtypes.html#str>
REFINEBOUNDARYLAYER Object REFINEBOUNDARYLAYER of type str <https://docs.python.org/3/library/stdtypes.html#str>
REFINEPOWELLSABIN Object REFINEPOWELLSABIN of type str <https://docs.python.org/3/library/stdtypes.html#str>
REFINEREGULAR Object REFINEREGULAR of type str <https://docs.python.org/3/library/stdtypes.html#str>
REFINESBR Object REFINESBR of type str <https://docs.python.org/3/library/stdtypes.html#str>
REFINETOBOX Object REFINETOBOX of type str <https://docs.python.org/3/library/stdtypes.html#str>
REFINETOSIMPLEX Object REFINETOSIMPLEX of type str <https://docs.python.org/3/library/stdtypes.html#str>
TRANSFORMFILTER Object TRANSFORMFILTER of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation












petsc4py.PETSc.DMShell

Bases: DM <#petsc4py.PETSc.DM>

A shell DM object, used to manage user-defined problem data.

Methods Summary

create([comm]) Creates a shell DM object.
setCoarsen(coarsen[, args, kargs]) Set the routine used to coarsen the DMShell.
setCreateDomainDecomposition(decomp[, args, ...]) Set the routine used to create a domain decomposition.
setCreateDomainDecompositionScatters(scatter) Set the routine used to create the scatter contexts for domain decomposition.
setCreateFieldDecomposition(decomp[, args, ...]) Set the routine used to create a field decomposition.
setCreateGlobalVector(create_gvec[, args, kargs]) Set the routine to create a global vector.
setCreateInjection(create_injection[, args, ...]) Set the routine used to create the injection operator.
setCreateInterpolation(create_interpolation) Set the routine used to create the interpolation operator.
setCreateLocalVector(create_lvec[, args, kargs]) Set the routine to create a local vector.
setCreateMatrix(create_matrix[, args, kargs]) Set the routine to create a matrix.
setCreateRestriction(create_restriction[, ...]) Set the routine used to create the restriction operator.
setCreateSubDM(create_subdm[, args, kargs]) Set the routine used to create a sub DM from the DMShell.
setGlobalToLocal(begin, end[, begin_args, ...]) Set the routines used to perform a global to local scatter.
setGlobalToLocalVecScatter(gtol) Set a Scatter <#petsc4py.PETSc.Scatter> context for global to local communication.
setGlobalVector(gv) Set a template global vector.
setLocalToGlobal(begin, end[, begin_args, ...]) Set the routines used to perform a local to global scatter.
setLocalToGlobalVecScatter(ltog) Set a Scatter <#petsc4py.PETSc.Scatter> context for local to global communication.
setLocalToLocal(begin, end[, begin_args, ...]) Set the routines used to perform a local to local scatter.
setLocalToLocalVecScatter(ltol) Set a Scatter context for local to local communication.
setLocalVector(lv) Set a template local vector.
setMatrix(mat) Set a template matrix.
setRefine(refine[, args, kargs]) Set the routine used to refine the DMShell.

Methods Documentation

Creates a shell DM object.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/DMShell.pyx:4 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L4>



Set the routine used to create a domain decomposition.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMShell.pyx:560 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L560>


Set the routine used to create the scatter contexts for domain decomposition.

Logically collective.


See also:


Source code at petsc4py/PETSc/DMShell.pyx:592 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L592>


Set the routine used to create a field decomposition.

Logically collective.


See also:


Source code at petsc4py/PETSc/DMShell.pyx:528 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L528>




Set the routine used to create the interpolation operator.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMShell.pyx:432 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L432>




Set the routine used to create the restriction operator.

Logically collective.


See also:


Source code at petsc4py/PETSc/DMShell.pyx:496 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L496>



Set the routines used to perform a global to local scatter.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMShell.pyx:140 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L140>


Set a Scatter <#petsc4py.PETSc.Scatter> context for global to local communication.

Logically collective.

gtol (Scatter <#petsc4py.PETSc.Scatter>) -- The global to local Scatter <#petsc4py.PETSc.Scatter> context.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMShell.pyx:189 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L189>


Set a template global vector.

Logically collective.

gv (Vec <#petsc4py.PETSc.Vec>) -- Template vector.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMShell.pyx:42 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L42>


Set the routines used to perform a local to global scatter.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMShell.pyx:206 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L206>


Set a Scatter <#petsc4py.PETSc.Scatter> context for local to global communication.

Logically collective.

ltog (Scatter <#petsc4py.PETSc.Scatter>) -- The local to global Scatter <#petsc4py.PETSc.Scatter> context.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMShell.pyx:253 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L253>


Set the routines used to perform a local to local scatter.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMShell.pyx:270 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L270>


Set a Scatter context for local to local communication.

Logically collective.

ltol (Scatter <#petsc4py.PETSc.Scatter>) -- The local to local Scatter context.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMShell.pyx:319 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L319>


Set a template local vector.

Logically collective.

lv (Vec <#petsc4py.PETSc.Vec>) -- Template vector.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMShell.pyx:59 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L59>


Set a template matrix.

Collective.

mat (Mat <#petsc4py.PETSc.Mat>) -- The template matrix.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMShell.pyx:25 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L25>




petsc4py.PETSc.DMStag

Bases: DM <#petsc4py.PETSc.DM>

A DM object representing a "staggered grid" or a structured cell complex.

Enumerations

StencilLocation <#petsc4py.PETSc.DMStag.StencilLocation> Stencil location types.
StencilType <#petsc4py.PETSc.DMStag.StencilType> Stencil types.

petsc4py.PETSc.DMStag.StencilLocation

Bases: object <https://docs.python.org/3/library/functions.html#object>

Stencil location types.

Attributes Summary

BACK Constant BACK of type int <https://docs.python.org/3/library/functions.html#int>
BACK_DOWN Constant BACK_DOWN of type int <https://docs.python.org/3/library/functions.html#int>
BACK_DOWN_LEFT Constant BACK_DOWN_LEFT of type int <https://docs.python.org/3/library/functions.html#int>
BACK_DOWN_RIGHT Constant BACK_DOWN_RIGHT of type int <https://docs.python.org/3/library/functions.html#int>
BACK_LEFT Constant BACK_LEFT of type int <https://docs.python.org/3/library/functions.html#int>
BACK_RIGHT Constant BACK_RIGHT of type int <https://docs.python.org/3/library/functions.html#int>
BACK_UP Constant BACK_UP of type int <https://docs.python.org/3/library/functions.html#int>
BACK_UP_LEFT Constant BACK_UP_LEFT of type int <https://docs.python.org/3/library/functions.html#int>
BACK_UP_RIGHT Constant BACK_UP_RIGHT of type int <https://docs.python.org/3/library/functions.html#int>
DOWN Constant DOWN of type int <https://docs.python.org/3/library/functions.html#int>
DOWN_LEFT Constant DOWN_LEFT of type int <https://docs.python.org/3/library/functions.html#int>
DOWN_RIGHT Constant DOWN_RIGHT of type int <https://docs.python.org/3/library/functions.html#int>
ELEMENT Constant ELEMENT of type int <https://docs.python.org/3/library/functions.html#int>
FRONT Constant FRONT of type int <https://docs.python.org/3/library/functions.html#int>
FRONT_DOWN Constant FRONT_DOWN of type int <https://docs.python.org/3/library/functions.html#int>
FRONT_DOWN_LEFT Constant FRONT_DOWN_LEFT of type int <https://docs.python.org/3/library/functions.html#int>
FRONT_DOWN_RIGHT Constant FRONT_DOWN_RIGHT of type int <https://docs.python.org/3/library/functions.html#int>
FRONT_LEFT Constant FRONT_LEFT of type int <https://docs.python.org/3/library/functions.html#int>
FRONT_RIGHT Constant FRONT_RIGHT of type int <https://docs.python.org/3/library/functions.html#int>
FRONT_UP Constant FRONT_UP of type int <https://docs.python.org/3/library/functions.html#int>
FRONT_UP_LEFT Constant FRONT_UP_LEFT of type int <https://docs.python.org/3/library/functions.html#int>
FRONT_UP_RIGHT Constant FRONT_UP_RIGHT of type int <https://docs.python.org/3/library/functions.html#int>
LEFT Constant LEFT of type int <https://docs.python.org/3/library/functions.html#int>
NULLLOC Constant NULLLOC of type int <https://docs.python.org/3/library/functions.html#int>
RIGHT Constant RIGHT of type int <https://docs.python.org/3/library/functions.html#int>
UP Constant UP of type int <https://docs.python.org/3/library/functions.html#int>
UP_LEFT Constant UP_LEFT of type int <https://docs.python.org/3/library/functions.html#int>
UP_RIGHT Constant UP_RIGHT of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation






























petsc4py.PETSc.DMStag.StencilType


Methods Summary

VecSplitToDMDA(vec, loc, c) Return DMDA, Vec from a subgrid of a DMStag, its Vec.
create(dim[, dofs, sizes, boundary_types, ...]) Create a DMDA object.
createCompatibleDMStag(dofs) Create a compatible DMStag with different DOFs/stratum.
get1dCoordinatecArrays() Not implemented.
getBoundaryTypes() Return boundary types in each dimension.
getCorners() Return starting element index, width and number of partial elements.
getDim() Return the number of dimensions.
getDof() Get number of DOFs associated with each stratum of the grid.
getEntriesPerElement() Return the number of entries per element in the local representation.
getGhostCorners() Return starting element index and width of local region.
getGlobalSizes() Return global element counts in each dimension.
getIsFirstRank() Return whether this process is first in each dimension in the process grid.
getIsLastRank() Return whether this process is last in each dimension in the process grid.
getLocalSizes() Return local elementwise sizes in each dimension.
getLocationDof(loc) Return number of DOFs associated with a given point on the grid.
getLocationSlot(loc, c) Return index to use in accessing raw local arrays.
getOwnershipRanges() Return elements per process in each dimension.
getProcSizes() Return number of processes in each dimension.
getProductCoordinateLocationSlot(loc) Return slot for use with local product coordinate arrays.
getStencilType() Return elementwise ghost/halo stencil type.
getStencilWidth() Return elementwise stencil width.
getVecArray(vec) Not implemented.
migrateVec(vec, dmTo, vecTo) Transfer a vector between two DMStag objects.
setBoundaryTypes(boundary_types) Set the boundary types.
setCoordinateDMType(dmtype) Set the type to store coordinates.
setDof(dofs) Set DOFs/stratum.
setGlobalSizes(sizes) Set global element counts in each dimension.
setOwnershipRanges(ranges) Set elements per process in each dimension.
setProcSizes(sizes) Set the number of processes in each dimension in the global process grid.
setStencilType(stenciltype) Set elementwise ghost/halo stencil type.
setStencilWidth(swidth) Set elementwise stencil width.
setUniformCoordinates([xmin, xmax, ymin, ...]) Set the coordinates to be a uniform grid..
setUniformCoordinatesExplicit([xmin, xmax, ...]) Set coordinates to be a uniform grid, storing all values.
setUniformCoordinatesProduct([xmin, xmax, ...]) Create uniform coordinates, as a product of 1D arrays.

Attributes Summary

boundary_types Boundary types in each dimension.
corners The lower left corner and size of local region in each dimension.
dim The dimension.
dofs The number of DOFs associated with each stratum of the grid.
entries_per_element The number of entries per element in the local representation.
ghost_corners The lower left corner and size of local region in each dimension.
global_sizes Global element counts in each dimension.
local_sizes Local elementwise sizes in each dimension.
proc_sizes The number of processes in each dimension in the global decomposition.
stencil_type Stencil type.
stencil_width Elementwise stencil width.

Methods Documentation

Return DMDA, Vec from a subgrid of a DMStag, its Vec.

Collective.

If a c value of -k is provided, the first k DOFs for that position are extracted, padding with zero values if needed. If a non-negative value is provided, a single DOF is extracted.


tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[DMDA <#petsc4py.PETSc.DMDA>, Vec <#petsc4py.PETSc.Vec>]

See also:


Source code at petsc4py/PETSc/DMStag.pyx:790 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L790>


Create a DMDA object.

Collective.

Creates an object to manage data living on the elements and vertices / the elements, faces, and vertices / the elements, faces, edges, and vertices of a parallelized regular 1D / 2D / 3D grid.


Self

See also:


Source code at petsc4py/PETSc/DMStag.pyx:50 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L50>


Create a compatible DMStag with different DOFs/stratum.

Collective.

dofs (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, ...]) -- The number of DOFs on the strata in the new DMStag.
DM <#petsc4py.PETSc.DM>

See also:


Source code at petsc4py/PETSc/DMStag.pyx:766 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L766>




Return starting element index, width and number of partial elements.

Not collective.

The returned value is calculated excluding ghost points.

The number of extra partial elements is either 1 or 0. The value is 1 on right, top, and front non-periodic domain ("physical") boundaries, in the x, y, and z dimensions respectively, and otherwise 0.

See also:


Source code at petsc4py/PETSc/DMStag.pyx:363 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L363>





Return the number of entries per element in the local representation.

Not collective.

This is the natural block size for most local operations.

See also:


Source code at petsc4py/PETSc/DMStag.pyx:318 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L318>







Return local elementwise sizes in each dimension.

Not collective.

The returned value is calculated excluding ghost points.

See also:


Source code at petsc4py/PETSc/DMStag.pyx:400 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L400>



Return number of DOFs associated with a given point on the grid.

Not collective.

loc (StencilLocation <#petsc4py.PETSc.DMStag.StencilLocation>) -- The grid point.
int <https://docs.python.org/3/library/functions.html#int>

See also:


Source code at petsc4py/PETSc/DMStag.pyx:721 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L721>


Return index to use in accessing raw local arrays.

Not collective.


int <https://docs.python.org/3/library/functions.html#int>

See also:


Source code at petsc4py/PETSc/DMStag.pyx:678 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L678>




Return slot for use with local product coordinate arrays.

Not collective.

loc (StencilLocation <#petsc4py.PETSc.DMStag.StencilLocation>) -- The grid location.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMStag.pyx:701 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L701>


Return elementwise ghost/halo stencil type.

Not collective.

See also:


Source code at petsc4py/PETSc/DMStag.pyx:447 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L447>





Transfer a vector between two DMStag objects.

Collective.

Currently only implemented to migrate global vectors to global vectors.

  • vec (Vec <#petsc4py.PETSc.Vec>) -- The source vector.
  • dmTo (DM <#petsc4py.PETSc.DM>) -- The compatible destination object.
  • vecTo (Vec <#petsc4py.PETSc.Vec>) -- The destination vector.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMStag.pyx:743 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L743>



Set the type to store coordinates.

Logically collective.

dmtype (Type <#petsc4py.PETSc.DM.Type>) -- The type to store coordinates.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMStag.pyx:657 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L657>


Set DOFs/stratum.

Logically collective.

dofs (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, ...]) -- The number of points per 0-cell (vertex/node), 1-cell (element in 1D, edge in 2D and 3D), 2-cell (element in 2D, face in 3D), or 3-cell (element in 3D).
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMStag.pyx:224 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L224>


Set global element counts in each dimension.

Logically collective.


See also:


Source code at petsc4py/PETSc/DMStag.pyx:246 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L246>



Set the number of processes in each dimension in the global process grid.

Logically collective.


See also:


Source code at petsc4py/PETSc/DMStag.pyx:266 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L266>


Set elementwise ghost/halo stencil type.

Logically collective.

stenciltype (StencilType <#petsc4py.PETSc.DMStag.StencilType> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The elementwise ghost stencil type.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMStag.pyx:183 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L183>


Set elementwise stencil width.

Logically collective.

The width value is not used when StencilType.NONE <#petsc4py.PETSc.DMStag.StencilType.NONE> is specified.


See also:


Source code at petsc4py/PETSc/DMStag.pyx:163 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L163>


Set the coordinates to be a uniform grid..

Collective.

Local coordinates are populated, linearly extrapolated to ghost cells, including those outside the physical domain. This is also done in case of periodic boundaries, meaning that the same global point may have different coordinates in different local representations, which are equivalent assuming a periodicity implied by the arguments to this function, i.e., two points are equivalent if their difference is a multiple of xmax-xmin in the x dimension, ymax-ymin in the y dimension, and zmax-zmin in the z dimension.


None <https://docs.python.org/3/library/constants.html#None>

See also:

setUniformCoordinatesExplicit, setUniformCoordinatesProduct, DMStagSetUniformCoordinates <https://petsc.org/release/manualpages/DMStag/DMStagSetUniformCoordinates.html>


Source code at petsc4py/PETSc/DMStag.pyx:610 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L610>


Set coordinates to be a uniform grid, storing all values.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

setUniformCoordinatesProduct, setUniformCoordinates, DMStagSetUniformCoordinatesExplicit <https://petsc.org/release/manualpages/DMStag/DMStagSetUniformCoordinatesExplicit.html>


Source code at petsc4py/PETSc/DMStag.pyx:530 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L530>


Create uniform coordinates, as a product of 1D arrays.

Collective.

The per-dimension 1-dimensional DMStag objects that comprise the product always have active 0-cells (vertices, element boundaries) and 1-cells (element centers).


None <https://docs.python.org/3/library/constants.html#None>

See also:

setUniformCoordinatesExplicit, setUniformCoordinates, DMStagSetUniformCoordinatesProduct <https://petsc.org/release/manualpages/DMStag/DMStagSetUniformCoordinatesProduct.html>


Source code at petsc4py/PETSc/DMStag.pyx:568 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L568>


Attributes Documentation

Boundary types in each dimension.

Source code at petsc4py/PETSc/DMStag.pyx:866 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L866>


The lower left corner and size of local region in each dimension.

Source code at petsc4py/PETSc/DMStag.pyx:881 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L881>



The number of DOFs associated with each stratum of the grid.

Source code at petsc4py/PETSc/DMStag.pyx:841 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L841>


The number of entries per element in the local representation.

Source code at petsc4py/PETSc/DMStag.pyx:846 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L846>


The lower left corner and size of local region in each dimension.

Source code at petsc4py/PETSc/DMStag.pyx:886 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L886>


Global element counts in each dimension.

Source code at petsc4py/PETSc/DMStag.pyx:851 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L851>


Local elementwise sizes in each dimension.

Source code at petsc4py/PETSc/DMStag.pyx:856 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L856>


The number of processes in each dimension in the global decomposition.

Source code at petsc4py/PETSc/DMStag.pyx:861 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L861>



Elementwise stencil width.

Source code at petsc4py/PETSc/DMStag.pyx:876 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L876>




petsc4py.PETSc.DMSwarm

Bases: DM <#petsc4py.PETSc.DM>

A DM <#petsc4py.PETSc.DM> object used to represent arrays of data (fields) of arbitrary type.

Enumerations

CollectType <#petsc4py.PETSc.DMSwarm.CollectType> Swarm collection types.
MigrateType <#petsc4py.PETSc.DMSwarm.MigrateType> Swarm migration types.
PICLayoutType <#petsc4py.PETSc.DMSwarm.PICLayoutType> Swarm PIC layout types.
Type <#petsc4py.PETSc.DMSwarm.Type> Swarm types.

petsc4py.PETSc.DMSwarm.CollectType

Bases: object <https://docs.python.org/3/library/functions.html#object>

Swarm collection types.

Attributes Summary

COLLECT_BASIC Constant COLLECT_BASIC of type int <https://docs.python.org/3/library/functions.html#int>
COLLECT_DMDABOUNDINGBOX Constant COLLECT_DMDABOUNDINGBOX of type int <https://docs.python.org/3/library/functions.html#int>
COLLECT_GENERAL Constant COLLECT_GENERAL of type int <https://docs.python.org/3/library/functions.html#int>
COLLECT_USER Constant COLLECT_USER of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation






petsc4py.PETSc.DMSwarm.MigrateType

Bases: object <https://docs.python.org/3/library/functions.html#object>

Swarm migration types.

Attributes Summary

MIGRATE_BASIC Constant MIGRATE_BASIC of type int <https://docs.python.org/3/library/functions.html#int>
MIGRATE_DMCELLEXACT Constant MIGRATE_DMCELLEXACT of type int <https://docs.python.org/3/library/functions.html#int>
MIGRATE_DMCELLNSCATTER Constant MIGRATE_DMCELLNSCATTER of type int <https://docs.python.org/3/library/functions.html#int>
MIGRATE_USER Constant MIGRATE_USER of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation






petsc4py.PETSc.DMSwarm.PICLayoutType

Bases: object <https://docs.python.org/3/library/functions.html#object>

Swarm PIC layout types.

Attributes Summary

LAYOUT_GAUSS Constant LAYOUT_GAUSS of type int <https://docs.python.org/3/library/functions.html#int>
LAYOUT_REGULAR Constant LAYOUT_REGULAR of type int <https://docs.python.org/3/library/functions.html#int>
LAYOUT_SUBDIVISION Constant LAYOUT_SUBDIVISION of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation





petsc4py.PETSc.DMSwarm.Type


Methods Summary

addCellDM(celldm) Add a cell DM to the DMSwarm.
addNPoints(npoints) Add space for a number of new points in the DMSwarm.
addPoint() Add space for one new point in the DMSwarm.
collectViewCreate() Apply a collection method and gather points in neighbor ranks.
collectViewDestroy() Reset the DMSwarm to the size prior to calling collectViewCreate.
computeMoments(coord, weight) Return the moments defined in the active cell DM.
copyPoint(pi, pj) Copy point pi to point pj in the DMSwarm.
create([comm]) Create an empty DM object and set its type to DM.Type.SWARM <#petsc4py.PETSc.DM.Type.SWARM>.
createGlobalVectorFromField(fieldname) Create a global Vec <#petsc4py.PETSc.Vec> object associated with a given field.
createGlobalVectorFromFields(fieldnames) Create a global Vec <#petsc4py.PETSc.Vec> object associated with a given set of fields.
createLocalVectorFromField(fieldname) Create a local Vec <#petsc4py.PETSc.Vec> object associated with a given field.
createLocalVectorFromFields(fieldnames) Create a local Vec <#petsc4py.PETSc.Vec> object associated with a given set of fields.
destroyGlobalVectorFromField(fieldname) Destroy the global Vec <#petsc4py.PETSc.Vec> object associated with a given field.
destroyGlobalVectorFromFields(fieldnames) Destroy the global Vec <#petsc4py.PETSc.Vec> object associated with a given set of fields.
destroyLocalVectorFromField(fieldname) Destroy the local Vec <#petsc4py.PETSc.Vec> object associated with a given field.
destroyLocalVectorFromFields(fieldnames) Destroy the local Vec <#petsc4py.PETSc.Vec> object associated with a given set of fields.
finalizeFieldRegister() Finalize the registration of fields to a DMSwarm.
getCellDM() Return DM <#petsc4py.PETSc.DM> cell attached to DMSwarm.
getCellDMActive() Return the active cell DM in the DMSwarm.
getCellDMByName(name) Return the cell DM with the given name in the DMSwarm.
getCellDMNames() Return the names of all cell DMs in the DMSwarm.
getField(fieldname) Return arrays storing all entries associated with a field.
getLocalSize() Return the local length of fields registered.
getSize() Return the total length of fields registered.
initializeFieldRegister() Initiate the registration of fields to a DMSwarm.
insertPointUsingCellDM(layoutType, fill_param) Insert point coordinates within each cell.
migrate([remove_sent_points]) Relocate points defined in the DMSwarm to other MPI ranks.
projectFields(dm, fieldnames, vecs[, mode]) Project a set of DMSwarm fields onto the cell DM <#petsc4py.PETSc.DM>.
registerField(fieldname, blocksize[, dtype]) Register a field to a DMSwarm with a native PETSc data type.
removePoint() Remove the last point from the DMSwarm.
removePointAtIndex(index) Remove a specific point from the DMSwarm.
restoreField(fieldname) Restore accesses associated with a registered field.
setCellDM(dm) Attach a DM <#petsc4py.PETSc.DM> to a DMSwarm.
setCellDMActive(name) Activate a cell DM in the DMSwarm.
setLocalSizes(nlocal, buffer) Set the length of all registered fields on the DMSwarm.
setPointCoordinates(coordinates[, ...]) Set point coordinates in a DMSwarm from a user-defined list.
setPointCoordinatesCellwise(coordinates) Insert point coordinates within each cell.
setPointsUniformCoordinates(min, max, npoints) Set point coordinates in a DMSwarm on a regular (ijk) grid.
setType(dmswarm_type) Set particular flavor of DMSwarm.
sortGetAccess() Setup up a DMSwarm point sort context.
sortGetIsValid() Return whether the sort context is up-to-date.
sortGetNumberOfPointsPerCell(e) Return the number of points in a cell.
sortGetPointsPerCell(e) Create an array of point indices for all points in a cell.
sortGetSizes() Return the sizes associated with a DMSwarm point sorting context.
sortRestoreAccess() Invalidate the DMSwarm point sorting context.
vectorDefineField(fieldname) Set the fields from which to define a Vec <#petsc4py.PETSc.Vec> object.
viewFieldsXDMF(filename, fieldnames) Write a selection of DMSwarm fields to an XDMF3 file.
viewXDMF(filename) Write this DMSwarm fields to an XDMF3 file.

Methods Documentation

Add a cell DM to the DMSwarm.

Logically collective.

  • cellDM (CellDM <#petsc4py.PETSc.CellDM>) -- The cell DM object
  • celldm (CellDM <#petsc4py.PETSc.CellDM>)

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:956 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L956>


Add space for a number of new points in the DMSwarm.

Not collective.


See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:443 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L443>



Apply a collection method and gather points in neighbor ranks.

Collective.

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:559 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L559>



Reset the DMSwarm to the size prior to calling collectViewCreate.

Collective.

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:571 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L571>




Copy point pi to point pj in the DMSwarm.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:491 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L491>


Create an empty DM object and set its type to DM.Type.SWARM <#petsc4py.PETSc.DM.Type.SWARM>.

Collective.

DMs are the abstract objects in PETSc that mediate between meshes and discretizations and the algebraic solvers, time integrators, and optimization algorithms.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:39 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L39>


Create a global Vec <#petsc4py.PETSc.Vec> object associated with a given field.

Collective.

The vector must be returned to the DMSwarm using a matching call to destroyGlobalVectorFromField.

fieldname (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The textual name given to a registered field.
Vec <#petsc4py.PETSc.Vec>

See also:

destroyGlobalVectorFromField, DMSwarmCreateGlobalVectorFromField <https://petsc.org/release/manualpages/DMSwarm/DMSwarmCreateGlobalVectorFromField.html>


Source code at petsc4py/PETSc/DMSwarm.pyx:65 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L65>


Create a global Vec <#petsc4py.PETSc.Vec> object associated with a given set of fields.

Collective.

The vector must be returned to the DMSwarm using a matching call to destroyGlobalVectorFromFields.

fieldnames (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[str <https://docs.python.org/3/library/stdtypes.html#str>]) -- The textual name given to each registered field.
Vec <#petsc4py.PETSc.Vec>

See also:

destroyGlobalVectorFromFields, DMSwarmCreateGlobalVectorFromFields <https://petsc.org/release/manualpages/DMSwarm/DMSwarmCreateGlobalVectorFromFields.html>


Source code at petsc4py/PETSc/DMSwarm.pyx:109 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L109>


Create a local Vec <#petsc4py.PETSc.Vec> object associated with a given field.

Collective.

The vector must be returned to the DMSwarm using a matching call to destroyLocalVectorFromField.

fieldname (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The textual name given to a registered field.
Vec <#petsc4py.PETSc.Vec>

See also:

destroyLocalVectorFromField, DMSwarmCreateLocalVectorFromField <https://petsc.org/release/manualpages/DMSwarm/DMSwarmCreateLocalVectorFromField.html>


Source code at petsc4py/PETSc/DMSwarm.pyx:165 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L165>


Create a local Vec <#petsc4py.PETSc.Vec> object associated with a given set of fields.

Collective.

The vector must be returned to the DMSwarm using a matching call to destroyLocalVectorFromFields.

fieldnames (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[str <https://docs.python.org/3/library/stdtypes.html#str>]) -- The textual name given to each registered field.
Vec <#petsc4py.PETSc.Vec>

See also:

destroyLocalVectorFromFields, DMSwarmCreateLocalVectorFromFields <https://petsc.org/release/manualpages/DMSwarm/DMSwarmCreateLocalVectorFromFields.html>


Source code at petsc4py/PETSc/DMSwarm.pyx:209 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L209>


Destroy the global Vec <#petsc4py.PETSc.Vec> object associated with a given field.

Collective.


See also:

createGlobalVectorFromField, DMSwarmDestroyGlobalVectorFromField <https://petsc.org/release/manualpages/DMSwarm/DMSwarmDestroyGlobalVectorFromField.html>


Source code at petsc4py/PETSc/DMSwarm.pyx:89 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L89>


Destroy the global Vec <#petsc4py.PETSc.Vec> object associated with a given set of fields.

Collective.


See also:

createGlobalVectorFromFields, DMSwarmDestroyGlobalVectorFromFields <https://petsc.org/release/manualpages/DMSwarm/DMSwarmDestroyGlobalVectorFromFields.html>


Source code at petsc4py/PETSc/DMSwarm.pyx:139 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L139>


Destroy the local Vec <#petsc4py.PETSc.Vec> object associated with a given field.

Collective.


See also:

createLocalVectorFromField, DMSwarmDestroyLocalVectorFromField <https://petsc.org/release/manualpages/DMSwarm/DMSwarmDestroyLocalVectorFromField.html>


Source code at petsc4py/PETSc/DMSwarm.pyx:189 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L189>


Destroy the local Vec <#petsc4py.PETSc.Vec> object associated with a given set of fields.

Collective.


See also:

createLocalVectorFromFields, DMSwarmDestroyLocalVectorFromFields <https://petsc.org/release/manualpages/DMSwarm/DMSwarmDestroyLocalVectorFromFields.html>


Source code at petsc4py/PETSc/DMSwarm.pyx:239 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L239>


Finalize the registration of fields to a DMSwarm.

Collective.

See also:

initializeFieldRegister, DMSwarmFinalizeFieldRegister <https://petsc.org/release/manualpages/DMSwarm/DMSwarmFinalizeFieldRegister.html>


Source code at petsc4py/PETSc/DMSwarm.pyx:279 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L279>



Return DM <#petsc4py.PETSc.DM> cell attached to DMSwarm.

Collective.

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:600 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L600>

DM <#petsc4py.PETSc.DM>


Return the active cell DM in the DMSwarm.

Not collective.

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:992 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L992>

CellDM <#petsc4py.PETSc.CellDM>


Return the cell DM with the given name in the DMSwarm.

Not collective.

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:1009 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L1009>

name (str <https://docs.python.org/3/library/stdtypes.html#str>)
CellDM <#petsc4py.PETSc.CellDM>



Return arrays storing all entries associated with a field.

Not collective.

The returned array contains underlying values of the field.

The array must be returned to the DMSwarm using a matching call to restoreField.

fieldname (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The textual name to identify this field.
The type of the entries in the array will match the type of the field. The array is two dimensional with shape (num_points, blocksize).
numpy.ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:343 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L343>




Initiate the registration of fields to a DMSwarm.

Collective.

After all fields have been registered, you must call finalizeFieldRegister.

See also:

finalizeFieldRegister, DMSwarmInitializeFieldRegister <https://petsc.org/release/manualpages/DMSwarm/DMSwarmInitializeFieldRegister.html>


Source code at petsc4py/PETSc/DMSwarm.pyx:265 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L265>



Insert point coordinates within each cell.

Not collective.

  • layout_type -- Method used to fill each cell with the cell DM.
  • fill_param (int <https://docs.python.org/3/library/functions.html#int>) -- Parameter controlling how many points per cell are added (the meaning of this parameter is dependent on the layout type).
  • layoutType (PICLayoutType <#petsc4py.PETSc.DMSwarm.PICLayoutType>)

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:715 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L715>


Relocate points defined in the DMSwarm to other MPI ranks.

Collective.

remove_sent_points (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag indicating if sent points should be removed from the current MPI rank.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:540 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L540>


Project a set of DMSwarm fields onto the cell DM <#petsc4py.PETSc.DM>.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:924 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L924>





Restore accesses associated with a registered field.

Not collective.


See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:388 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L388>


Attach a DM <#petsc4py.PETSc.DM> to a DMSwarm.

Collective.

dm (DM <#petsc4py.PETSc.DM>) -- The DM <#petsc4py.PETSc.DM> to attach to the DMSwarm.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:583 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L583>



Set the length of all registered fields on the DMSwarm.

Not collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:291 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L291>


Set point coordinates in a DMSwarm from a user-defined list.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:679 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L679>


Insert point coordinates within each cell.

Not collective.

Point coordinates are defined over the reference cell.

coordinates (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[float <https://docs.python.org/3/library/functions.html#float>]) -- The coordinates (defined in the local coordinate system for each cell) to insert.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:737 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L737>


Set point coordinates in a DMSwarm on a regular (ijk) grid.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:635 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L635>


Set particular flavor of DMSwarm.

Collective.

dmswarm_type (Type <#petsc4py.PETSc.DMSwarm.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The DMSwarm type.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:617 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L617>


Setup up a DMSwarm point sort context.

Not collective.

The point sort context is used for efficient traversal of points within a cell.

You must call sortRestoreAccess when you no longer need access to the sort context.

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:812 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L812>



Return whether the sort context is up-to-date.

Not collective.

Returns the flag associated with a DMSwarm point sorting context.

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:886 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L886>





Return the sizes associated with a DMSwarm point sorting context.

Not collective.


See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:902 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L902>


Invalidate the DMSwarm point sorting context.

Not collective.

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:830 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L830>



Set the fields from which to define a Vec <#petsc4py.PETSc.Vec> object.

Collective.

The field will be used when DM.createLocalVec <#petsc4py.PETSc.DM.createLocalVec>, or DM.createGlobalVec <#petsc4py.PETSc.DM.createGlobalVec> is called.


See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:409 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L409>


Write a selection of DMSwarm fields to an XDMF3 file.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:764 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L764>


Write this DMSwarm fields to an XDMF3 file.

Collective.

filename (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The file name of the XDMF file (must have the extension .xmf).
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DMSwarm.pyx:793 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L793>




petsc4py.PETSc.DS

Bases: Object <#petsc4py.PETSc.Object>

Discrete System object.

Enumerations

Type <#petsc4py.PETSc.DS.Type> The Discrete System types.

petsc4py.PETSc.DS.Type


Methods Summary

create([comm]) Create an empty DS.
destroy() Destroy the discrete system.
getComponents() Return the number of components for each field on an evaluation point.
getCoordinateDimension() Return the coordinate dimension of the DS.
getDimensions() Return the size of the space for each field on an evaluation point.
getFieldIndex(disc) Return the index of the given field.
getNumFields() Return the number of fields in the DS.
getSpatialDimension() Return the spatial dimension of the DS.
getTotalComponents() Return the total number of components in this system.
getTotalDimensions() Return the total size of the approximation space for this system.
getType() Return the type of the discrete system.
setDiscretisation(f, disc) Set the discretization object for the given field.
setFromOptions() Set parameters in a DS from the options database.
setType(ds_type) Build a particular type of a discrete system.
setUp() Construct data structures for the discrete system.
view([viewer]) View a discrete system.

Methods Documentation

Create an empty DS.

Collective.

The type can then be set with setType.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/DS.pyx:53 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DS.pyx#L53>



Return the number of components for each field on an evaluation point.

Not collective.

See also:


Source code at petsc4py/PETSc/DS.pyx:246 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DS.pyx#L246>

ArrayInt <#petsc4py.typing.ArrayInt>


Return the coordinate dimension of the DS.

Not collective.

The coordinate dimension of the DS is the dimension of the space into which the discretiaztions are embedded.

See also:


Source code at petsc4py/PETSc/DS.pyx:153 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DS.pyx#L153>



Return the size of the space for each field on an evaluation point.

Not collective.

See also:


Source code at petsc4py/PETSc/DS.pyx:231 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DS.pyx#L231>

ArrayInt <#petsc4py.typing.ArrayInt>


Return the index of the given field.

Not collective.

disc (Object <#petsc4py.PETSc.Object>) -- The discretization object.
int <https://docs.python.org/3/library/functions.html#int>

See also:


Source code at petsc4py/PETSc/DS.pyx:184 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DS.pyx#L184>



Return the spatial dimension of the DS.

Not collective.

The spatial dimension of the DS is the topological dimension of the discretizations.

See also:


Source code at petsc4py/PETSc/DS.pyx:136 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DS.pyx#L136>




Return the total size of the approximation space for this system.

Not collective.

See also:


Source code at petsc4py/PETSc/DS.pyx:203 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DS.pyx#L203>




Set the discretization object for the given field.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DS.pyx:261 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DS.pyx#L261>


Set parameters in a DS from the options database.

Collective.

See also:

Working with PETSc options <#petsc-options>, PetscDSSetFromOptions <https://petsc.org/release/manualpages/DT/PetscDSSetFromOptions.html>


Source code at petsc4py/PETSc/DS.pyx:109 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DS.pyx#L109>



Build a particular type of a discrete system.

Collective.

ds_type (Type <#petsc4py.PETSc.DS.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of the discrete system.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DS.pyx:76 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DS.pyx#L76>



View a discrete system.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the system.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DS.pyx:21 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DS.pyx#L21>




petsc4py.PETSc.Device

Bases: object <https://docs.python.org/3/library/functions.html#object>

The device object.

Represents a handle to an accelerator (which may be the host).

See also:

DeviceContext <#petsc4py.PETSc.DeviceContext>, PetscDevice <https://petsc.org/release/manualpages/Sys/PetscDevice.html>


Enumerations

Type <#petsc4py.PETSc.Device.Type> The type of device.

petsc4py.PETSc.Device.Type

Bases: object <https://docs.python.org/3/library/functions.html#object>

The type of device.

See also:

Device <#petsc4py.PETSc.Device>, Device.create <#petsc4py.PETSc.Device.create>, Device.getDeviceType <#petsc4py.PETSc.Device.getDeviceType>, Device.type <#petsc4py.PETSc.Device.type>, PetscDeviceType <https://petsc.org/release/manualpages/Sys/PetscDeviceType.html>


Attributes Summary

CUDA Constant CUDA of type int <https://docs.python.org/3/library/functions.html#int>
DEFAULT Constant DEFAULT of type int <https://docs.python.org/3/library/functions.html#int>
HIP Constant HIP of type int <https://docs.python.org/3/library/functions.html#int>
HOST Constant HOST of type int <https://docs.python.org/3/library/functions.html#int>
SYCL Constant SYCL of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation







Methods Summary

configure() Configure and setup a device object.
create([dtype, device_id]) Create a device object.
destroy() Destroy a device object.
getDeviceId() Return the device id.
getDeviceType() Return the type of the device.
setDefaultType(device_type) Set the device type to be used as the default in subsequent calls to create.
view([viewer]) View a device object.

Attributes Summary

device_id The device id.
type The device type.

Methods Documentation


Create a device object.

Not collective.


Device <#petsc4py.PETSc.Device>

See also:


Source code at petsc4py/PETSc/Device.pyx:94 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L94>





Set the device type to be used as the default in subsequent calls to create.

Not collective.

See also:


Source code at petsc4py/PETSc/Device.pyx:195 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L195>



View a device object.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> instance or None <https://docs.python.org/3/library/constants.html#None> for the default viewer.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Device.pyx:144 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L144>


Attributes Documentation





petsc4py.PETSc.DeviceContext

Bases: Object <#petsc4py.PETSc.Object>

DeviceContext object.

Represents an abstract handle to a device context.

See also:

Device <#petsc4py.PETSc.Device>, PetscDeviceContext <https://petsc.org/release/manualpages/Sys/PetscDeviceContext.html>


Enumerations

DeviceJoinMode <#petsc4py.PETSc.DeviceContext.DeviceJoinMode> The type of join to perform.
StreamType <#petsc4py.PETSc.DeviceContext.StreamType> The type of stream.

petsc4py.PETSc.DeviceContext.DeviceJoinMode

Bases: object <https://docs.python.org/3/library/functions.html#object>

The type of join to perform.

See also:

DeviceContext <#petsc4py.PETSc.DeviceContext>, DeviceContext.join <#petsc4py.PETSc.DeviceContext.join>, DeviceContext.fork <#petsc4py.PETSc.DeviceContext.fork>, PetscDeviceContextJoinMode <https://petsc.org/release/manualpages/Sys/PetscDeviceContextJoinMode.html>


Attributes Summary

DESTROY Constant DESTROY of type int <https://docs.python.org/3/library/functions.html#int>
NO_SYNC Constant NO_SYNC of type int <https://docs.python.org/3/library/functions.html#int>
SYNC Constant SYNC of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation





petsc4py.PETSc.DeviceContext.StreamType

Bases: object <https://docs.python.org/3/library/functions.html#object>

The type of stream.

See also:

DeviceContext <#petsc4py.PETSc.DeviceContext>, DeviceContext.getStreamType <#petsc4py.PETSc.DeviceContext.getStreamType>, DeviceContext.setStreamType <#petsc4py.PETSc.DeviceContext.setStreamType>, PetscStreamType <https://petsc.org/release/manualpages/Sys/PetscStreamType.html>


Attributes Summary

DEFAULT Constant DEFAULT of type int <https://docs.python.org/3/library/functions.html#int>
DEFAULT_WITH_BARRIER Constant DEFAULT_WITH_BARRIER of type int <https://docs.python.org/3/library/functions.html#int>
NONBLOCKING Constant NONBLOCKING of type int <https://docs.python.org/3/library/functions.html#int>
NONBLOCKING_WITH_BARRIER Constant NONBLOCKING_WITH_BARRIER of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation






Methods Summary

create() Create an empty DeviceContext.
destroy() Destroy a device context.
duplicate() Duplicate a the device context.
fork(n[, stream_type]) Create multiple device contexts which are all logically dependent on this one.
getCurrent() Return the current device context.
getDevice() Get the Device <#petsc4py.PETSc.Device> which this instance is attached to.
getStreamType() Return the StreamType <#petsc4py.PETSc.DeviceContext.StreamType>.
idle() Return whether the underlying stream for the device context is idle.
join(join_mode, py_sub_ctxs) Join a set of device contexts on this one.
setCurrent(dctx) Set the current device context.
setDevice(device) Set the Device <#petsc4py.PETSc.Device> which this DeviceContext is attached to.
setFromOptions([comm]) Configure the DeviceContext from the options database.
setStreamType(stream_type) Set the StreamType <#petsc4py.PETSc.DeviceContext.StreamType>.
setUp() Set up the internal data structures for using the device context.
synchronize() Synchronize a device context.
waitFor(other) Make this instance wait for other.

Attributes Summary

current The current global device context.
device The device associated to the device context.
stream_type The stream type.

Methods Documentation

Create an empty DeviceContext.

Not collective.

See also:

destroy, Device <#petsc4py.PETSc.Device>, PetscDeviceContextCreate <https://petsc.org/release/manualpages/Device/PetscDeviceContextCreate.html>


Source code at petsc4py/PETSc/Device.pyx:240 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L240>




Duplicate a the device context.

Not collective.

See also:


Source code at petsc4py/PETSc/Device.pyx:348 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L348>

DeviceContext <#petsc4py.PETSc.DeviceContext>


Create multiple device contexts which are all logically dependent on this one.

Not collective.


list <https://docs.python.org/3/library/stdtypes.html#list>[DeviceContext <#petsc4py.PETSc.DeviceContext>]

Examples

The device contexts created must be destroyed using join.

>>> dctx = PETSc.DeviceContext().getCurrent()
>>> dctxs = dctx.fork(4)
>>> ... # perform computations
>>> # we can mix various join modes
>>> dctx.join(PETSc.DeviceContext.JoinMode.SYNC, dctxs[0:2])
>>> dctx.join(PETSc.DeviceContext.JoinMode.SYNC, dctxs[2:])
>>> ... # some more computations and joins
>>> # dctxs must be all destroyed with joinMode.DESTROY
>>> dctx.join(PETSc.DeviceContext.JoinMode.DESTROY, dctxs)

See also:


Source code at petsc4py/PETSc/Device.pyx:399 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L399>


Return the current device context.

Not collective.

See also:

current, setCurrent, PetscDeviceContextGetCurrentContext <https://petsc.org/release/manualpages/Device/PetscDeviceContextGetCurrentContext.html>


Source code at petsc4py/PETSc/Device.pyx:519 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L519>

DeviceContext <#petsc4py.PETSc.DeviceContext>


Get the Device <#petsc4py.PETSc.Device> which this instance is attached to.

Not collective.

See also:

setDevice, device, Device <#petsc4py.PETSc.Device>, PetscDeviceContextGetDevice <https://petsc.org/release/manualpages/Device/PetscDeviceContextGetDevice.html>


Source code at petsc4py/PETSc/Device.pyx:302 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L302>

Device <#petsc4py.PETSc.Device>


Return the StreamType <#petsc4py.PETSc.DeviceContext.StreamType>.

Not collective.

See also:

stream_type, setStreamType, PetscDeviceContextGetStreamType <https://petsc.org/release/manualpages/Device/PetscDeviceContextGetStreamType.html>


Source code at petsc4py/PETSc/Device.pyx:268 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L268>



Return whether the underlying stream for the device context is idle.

Not collective.

See also:


Source code at petsc4py/PETSc/Device.pyx:363 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L363>



Join a set of device contexts on this one.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Device.pyx:448 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L448>


Set the current device context.

Not collective.

dctx (DeviceContext <#petsc4py.PETSc.DeviceContext> | None <https://docs.python.org/3/library/constants.html#None>) -- The DeviceContext to set as current (or None <https://docs.python.org/3/library/constants.html#None> to use the default context).
None <https://docs.python.org/3/library/constants.html#None>

See also:

current, getCurrent, PetscDeviceContextSetCurrentContext <https://petsc.org/release/manualpages/Device/PetscDeviceContextSetCurrentContext.html>


Source code at petsc4py/PETSc/Device.pyx:535 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L535>


Set the Device <#petsc4py.PETSc.Device> which this DeviceContext is attached to.

Collective.

device (Device <#petsc4py.PETSc.Device>) -- The Device <#petsc4py.PETSc.Device> to which this instance is attached to.
None <https://docs.python.org/3/library/constants.html#None>

See also:

getDevice, device, Device <#petsc4py.PETSc.Device>, PetscDeviceContextSetDevice <https://petsc.org/release/manualpages/Device/PetscDeviceContextSetDevice.html>


Source code at petsc4py/PETSc/Device.pyx:317 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L317>


Configure the DeviceContext from the options database.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
None <https://docs.python.org/3/library/constants.html#None>

See also:

Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>, PetscDeviceContextSetFromOptions <https://petsc.org/release/manualpages/Device/PetscDeviceContextSetFromOptions.html>


Source code at petsc4py/PETSc/Device.pyx:500 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L500>


Set the StreamType <#petsc4py.PETSc.DeviceContext.StreamType>.

Not collective.

stream_type (StreamType <#petsc4py.PETSc.DeviceContext.StreamType> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of stream to set
None <https://docs.python.org/3/library/constants.html#None>

See also:

stream_type, getStreamType, PetscDeviceContextSetStreamType <https://petsc.org/release/manualpages/Device/PetscDeviceContextSetStreamType.html>


Source code at petsc4py/PETSc/Device.pyx:283 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L283>


Set up the internal data structures for using the device context.

Not collective.

See also:


Source code at petsc4py/PETSc/Device.pyx:336 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L336>



Synchronize a device context.

Not collective.

Notes

The underlying stream is considered idle after this routine returns, i.e. idle will return True.

See also:


Source code at petsc4py/PETSc/Device.pyx:483 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L483>



Make this instance wait for other.

Not collective.

other (DeviceContext <#petsc4py.PETSc.DeviceContext> | None <https://docs.python.org/3/library/constants.html#None>) -- The other DeviceContext to wait for
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Device.pyx:378 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L378>


Attributes Documentation

The current global device context.

Source code at petsc4py/PETSc/Device.pyx:574 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L574>


The device associated to the device context.

Source code at petsc4py/PETSc/Device.pyx:566 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L566>





petsc4py.PETSc.DualSpace

Bases: Object <#petsc4py.PETSc.Object>

Dual space to a linear space.

Enumerations

Type <#petsc4py.PETSc.DualSpace.Type> The dual space types.

petsc4py.PETSc.DualSpace.Type


Methods Summary

create([comm]) Create an empty DualSpace object.
destroy() Destroy the DualSpace object.
duplicate() Create a duplicate DualSpace object that is not set up.
getDM() Return the DM <#petsc4py.PETSc.DM> representing the reference cell of a DualSpace.
getDimension() Return the dimension of the dual space.
getFunctional(i) Return the i-th basis functional in the dual space.
getInteriorDimension() Return the interior dimension of the dual space.
getLagrangeContinuity() Return whether the element is continuous.
getLagrangeTensor() Return the tensor nature of the dual space.
getLagrangeTrimmed() Return the trimmed nature of the dual space.
getNumComponents() Return the number of components for this space.
getNumDof() Return the number of degrees of freedom for each spatial dimension.
getOrder() Return the order of the dual space.
getType() Return the type of the dual space object.
setDM(dm) Set the DM <#petsc4py.PETSc.DM> representing the reference cell.
setLagrangeContinuity(continuous) Indicate whether the element is continuous.
setLagrangeTensor(tensor) Set the tensor nature of the dual space.
setLagrangeTrimmed(trimmed) Set the trimmed nature of the dual space.
setNumComponents(nc) Set the number of components for this space.
setOrder(order) Set the order of the dual space.
setSimpleDimension(dim) Set the number of functionals in the dual space basis.
setSimpleFunctional(func, functional) Set the given basis element for this dual space.
setType(dualspace_type) Build a particular type of dual space.
setUp() Construct a basis for a DualSpace.
view([viewer]) View a DualSpace.

Methods Documentation

Create an empty DualSpace object.

Collective.

The type can then be set with setType.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Space.pyx:594 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L594>



Create a duplicate DualSpace object that is not set up.

Collective.

See also:


Source code at petsc4py/PETSc/Space.pyx:649 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L649>

DualSpace <#petsc4py.PETSc.DualSpace>


Return the DM <#petsc4py.PETSc.DM> representing the reference cell of a DualSpace.

Not collective.

See also:


Source code at petsc4py/PETSc/Space.pyx:662 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L662>

DM <#petsc4py.PETSc.DM>


Return the dimension of the dual space.

Not collective.

The dimension of the dual space, i.e. the number of basis functionals.

See also:


Source code at petsc4py/PETSc/Space.pyx:696 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L696>



Return the i-th basis functional in the dual space.

Not collective.

i (int <https://docs.python.org/3/library/functions.html#int>) -- The basis number.
Quad <#petsc4py.PETSc.Quad>

See also:


Source code at petsc4py/PETSc/Space.pyx:826 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L826>


Return the interior dimension of the dual space.

Not collective.

The interior dimension of the dual space, i.e. the number of basis functionals assigned to the interior of the reference domain.

See also:


Source code at petsc4py/PETSc/Space.pyx:847 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L847>



Return whether the element is continuous.

Not collective.

See also:

setLagrangeContinuity, PetscDualSpaceLagrangeGetContinuity <https://petsc.org/release/manualpages/DUALSPACE/PetscDualSpaceLagrangeGetContinuity.html>


Source code at petsc4py/PETSc/Space.pyx:864 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L864>



Return the tensor nature of the dual space.

Not collective.

See also:


Source code at petsc4py/PETSc/Space.pyx:896 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L896>



Return the trimmed nature of the dual space.

Not collective.

See also:



Source code at petsc4py/PETSc/Space.pyx:928 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L928>



Return the number of components for this space.

Not collective.

See also:


Source code at petsc4py/PETSc/Space.pyx:712 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L712>



Return the number of degrees of freedom for each spatial dimension.

Not collective.

See also:


Source code at petsc4py/PETSc/Space.pyx:810 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L810>

ArrayInt <#petsc4py.typing.ArrayInt>




Set the DM <#petsc4py.PETSc.DM> representing the reference cell.

Not collective.

dm (DM <#petsc4py.PETSc.DM>) -- The reference cell.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Space.pyx:679 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L679>


Indicate whether the element is continuous.

Not collective.


See also:

getLagrangeContinuity, PetscDualSpaceLagrangeSetContinuity <https://petsc.org/release/manualpages/DUALSPACE/PetscDualSpaceLagrangeSetContinuity.html>


Source code at petsc4py/PETSc/Space.pyx:878 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L878>


Set the tensor nature of the dual space.

Not collective.

tensor (bool <https://docs.python.org/3/library/functions.html#bool>) -- Whether the dual space has tensor layout (vs. simplicial).
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Space.pyx:910 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L910>


Set the trimmed nature of the dual space.

Not collective.

trimmed (bool <https://docs.python.org/3/library/functions.html#bool>) -- Whether the dual space represents to dual basis of a trimmed polynomial space (e.g. Raviart-Thomas and higher order / other form degree variants).
None <https://docs.python.org/3/library/constants.html#None>

See also:



Source code at petsc4py/PETSc/Space.pyx:942 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L942>


Set the number of components for this space.

Logically collective.


See also:


Source code at petsc4py/PETSc/Space.pyx:726 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L726>




Set the given basis element for this dual space.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Space.pyx:980 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L980>


Build a particular type of dual space.

Collective.

dualspace_type (Type <#petsc4py.PETSc.DualSpace.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The kind of space.
Self

See also:


Source code at petsc4py/PETSc/Space.pyx:758 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L758>



View a DualSpace.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the DualSpace.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Space.pyx:617 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L617>




petsc4py.PETSc.FE

Bases: Object <#petsc4py.PETSc.Object>

A PETSc object that manages a finite element space.

Enumerations

Type <#petsc4py.PETSc.FE.Type> The finite element types.

petsc4py.PETSc.FE.Type


Methods Summary

create([comm]) Create an empty FE object.
createDefault(dim, nc, isSimplex[, qorder, ...]) Create a FE for basic FEM computation.
createLagrange(dim, nc, isSimplex, k[, ...]) Create a FE for the basic Lagrange space of degree k.
destroy() Destroy the FE object.
getBasisSpace() Return the Space <#petsc4py.PETSc.Space> used for the approximation of the FE solution.
getDimension() Return the dimension of the finite element space on a cell.
getDualSpace() Return the DualSpace <#petsc4py.PETSc.DualSpace> used to define the inner product for the FE.
getFaceQuadrature() Return the Quad <#petsc4py.PETSc.Quad> used to calculate inner products on faces.
getNumComponents() Return the number of components in the element.
getNumDof() Return the number of DOFs.
getQuadrature() Return the Quad <#petsc4py.PETSc.Quad> used to calculate inner products.
getSpatialDimension() Return the spatial dimension of the element.
getTileSizes() Return the tile sizes for evaluation.
setBasisSpace(sp) Set the Space <#petsc4py.PETSc.Space> used for the approximation of the solution.
setDualSpace(dspace) Set the DualSpace <#petsc4py.PETSc.DualSpace> used to define the inner product.
setFaceQuadrature(quad) Set the Quad <#petsc4py.PETSc.Quad> used to calculate inner products on faces.
setFromOptions() Set parameters in a FE from the options database.
setNumComponents(comp) Set the number of field components in the element.
setQuadrature(quad) Set the Quad <#petsc4py.PETSc.Quad> used to calculate inner products.
setTileSizes(blockSize, numBlocks, ...) Set the tile sizes for evaluation.
setType(fe_type) Build a particular FE.
setUp() Construct data structures for the FE after the Type <#petsc4py.PETSc.FE.Type> has been set.
view([viewer]) View a FE object.

Methods Documentation

Create an empty FE object.

Collective.

The type can then be set with setType.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/FE.pyx:53 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L53>


Create a FE for basic FEM computation.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/FE.pyx:76 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L76>


Create a FE for the basic Lagrange space of degree k.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/FE.pyx:122 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L122>



Return the Space <#petsc4py.PETSc.Space> used for the approximation of the FE solution.

Not collective.

See also:


Source code at petsc4py/PETSc/FE.pyx:387 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L387>

Space <#petsc4py.PETSc.Space>


Return the dimension of the finite element space on a cell.

Not collective.

See also:


Source code at petsc4py/PETSc/FE.pyx:181 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L181>



Return the DualSpace <#petsc4py.PETSc.DualSpace> used to define the inner product for the FE.

Not collective.

See also:

setDualSpace, DualSpace <#petsc4py.PETSc.DualSpace>, PetscFEGetDualSpace <https://petsc.org/release/manualpages/FE/PetscFEGetDualSpace.html>


Source code at petsc4py/PETSc/FE.pyx:443 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L443>

DualSpace <#petsc4py.PETSc.DualSpace>


Return the Quad <#petsc4py.PETSc.Quad> used to calculate inner products on faces.

Not collective.

See also:



Source code at petsc4py/PETSc/FE.pyx:316 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L316>

Quad <#petsc4py.PETSc.Quad>


Return the number of components in the element.

Not collective.

See also:



Source code at petsc4py/PETSc/FE.pyx:209 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L209>



Return the number of DOFs.

Not collective.

Return the number of DOFs (dual basis vectors) associated with mesh points on the reference cell of a given dimension.

See also:


Source code at petsc4py/PETSc/FE.pyx:241 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L241>



Return the Quad <#petsc4py.PETSc.Quad> used to calculate inner products.

Not collective.

See also:


Source code at petsc4py/PETSc/FE.pyx:166 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L166>

Quad <#petsc4py.PETSc.Quad>




Set the Space <#petsc4py.PETSc.Space> used for the approximation of the solution.

Not collective.

sp (Space <#petsc4py.PETSc.Space>) -- The Space <#petsc4py.PETSc.Space> object.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/FE.pyx:402 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L402>


Set the DualSpace <#petsc4py.PETSc.DualSpace> used to define the inner product.

Not collective.

dspace (DualSpace <#petsc4py.PETSc.DualSpace>) -- The DualSpace <#petsc4py.PETSc.DualSpace> object.
None <https://docs.python.org/3/library/constants.html#None>

See also:

getDualSpace, DualSpace <#petsc4py.PETSc.DualSpace>, PetscFESetDualSpace <https://petsc.org/release/manualpages/FE/PetscFESetDualSpace.html>


Source code at petsc4py/PETSc/FE.pyx:458 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L458>


Set the Quad <#petsc4py.PETSc.Quad> used to calculate inner products on faces.

Not collective.

quad (Quad <#petsc4py.PETSc.Quad>) -- The Quad <#petsc4py.PETSc.Quad> object.
Quad <#petsc4py.PETSc.Quad>

See also:



Source code at petsc4py/PETSc/FE.pyx:349 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L349>


Set parameters in a FE from the options database.

Collective.

See also:

Working with PETSc options <#petsc-options>, PetscFESetFromOptions <https://petsc.org/release/manualpages/FE/PetscFESetFromOptions.html>


Source code at petsc4py/PETSc/FE.pyx:419 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L419>



Set the number of field components in the element.

Not collective.


See also:



Source code at petsc4py/PETSc/FE.pyx:223 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L223>


Set the Quad <#petsc4py.PETSc.Quad> used to calculate inner products.

Not collective.

quad (Quad <#petsc4py.PETSc.Quad>) -- The Quad <#petsc4py.PETSc.Quad> object.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/FE.pyx:331 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L331>


Set the tile sizes for evaluation.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/FE.pyx:286 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L286>


Build a particular FE.

Collective.

fe_type (Type <#petsc4py.PETSc.FE.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The kind of FEM space.
Self

See also:


Source code at petsc4py/PETSc/FE.pyx:367 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L367>


Construct data structures for the FE after the Type <#petsc4py.PETSc.FE.Type> has been set.

Collective.

See also:


Source code at petsc4py/PETSc/FE.pyx:431 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L431>



View a FE object.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the graph.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/FE.pyx:21 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L21>




petsc4py.PETSc.IS

Bases: Object <#petsc4py.PETSc.Object>

A collection of indices.

IS objects are used to index into vectors and matrices and to set up vector scatters.

See also:


Enumerations

Type <#petsc4py.PETSc.IS.Type> The index set types.

petsc4py.PETSc.IS.Type


Methods Summary

allGather() Concatenate index sets stored across processors.
buildTwoSided([toindx]) Create an index set describing a global mapping.
complement(nmin, nmax) Create a complement index set.
copy([result]) Copy the contents of the index set into another.
create([comm]) Create an IS.
createBlock(bsize, indices[, comm]) Create a blocked index set.
createGeneral(indices[, comm]) Create an IS with indices.
createStride(size[, first, step, comm]) Create an index set consisting of evenly spaced values.
destroy() Destroy the index set.
difference(iset) Return the difference between two index sets.
duplicate() Create a copy of the index set.
embed(iset, drop) Embed self into iset.
equal(iset) Return whether the index sets have the same set of indices or not.
expand(iset) Return the union of two (possibly unsorted) index sets.
getBlockIndices() Return the indices of an index set with type IS.Type.BLOCK <#petsc4py.PETSc.IS.Type.BLOCK>.
getBlockSize() Return the number of elements in a block.
getIndices() Return the indices of the index set.
getInfo() Return stride information for an index set with type IS.Type.STRIDE <#petsc4py.PETSc.IS.Type.STRIDE>.
getLocalSize() Return the process-local length of the index set.
getSize() Return the global length of an index set.
getSizes() Return the local and global sizes of the index set.
getStride() Return size and stride information.
getType() Return the index set type associated with the IS.
invertPermutation([nlocal]) Invert the index set.
isIdentity() Return whether the index set has been declared as an identity.
isPermutation() Return whether an index set has been declared to be a permutation.
isSorted() Return whether the indices have been sorted.
load(viewer) Load a stored index set.
partitioningCount([npart]) Return the number of elements per process after a partitioning.
partitioningToNumbering() Return the new global numbering after a partitioning.
renumber([mult]) Renumber the non-negative entries of an index set, starting from 0.
setBlockIndices(bsize, indices) Set the indices for an index set with type IS.Type.BLOCK <#petsc4py.PETSc.IS.Type.BLOCK>.
setBlockSize(bs) Set the block size of the index set.
setIdentity() Mark the index set as being an identity.
setIndices(indices) Set the indices of an index set.
setPermutation() Mark the index set as being a permutation.
setStride(size[, first, step]) Set the stride information for an index set with type IS.Type.STRIDE <#petsc4py.PETSc.IS.Type.STRIDE>.
setType(is_type) Set the type of the index set.
sort() Sort the indices of an index set.
sum(iset) Return the union of two (sorted) index sets.
toGeneral() Convert the index set type to IS.Type.GENERAL <#petsc4py.PETSc.IS.Type.GENERAL>.
union(iset) Return the union of two (possibly unsorted) index sets.
view([viewer]) Display the index set.

Attributes Summary

array View of the index set as an array of integers.
block_size The number of elements in a block.
identity True <https://docs.python.org/3/library/constants.html#True> if index set is an identity, False <https://docs.python.org/3/library/constants.html#False> otherwise.
indices The indices of the index set.
local_size The local size of the index set.
permutation True <https://docs.python.org/3/library/constants.html#True> if index set is a permutation, False <https://docs.python.org/3/library/constants.html#False> otherwise.
size The global size of the index set.
sizes The local and global sizes of the index set.
sorted True <https://docs.python.org/3/library/constants.html#True> if index set is sorted, False <https://docs.python.org/3/library/constants.html#False> otherwise.

Methods Documentation

Concatenate index sets stored across processors.

Collective.

The returned index set will be the same on every processor.

See also:


Source code at petsc4py/PETSc/IS.pyx:304 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L304>

IS <#petsc4py.PETSc.IS>


Create an index set describing a global mapping.

Collective.

This function generates an index set that contains new numbers from remote or local on the index set.

toindx (IS <#petsc4py.PETSc.IS> | None <https://docs.python.org/3/library/constants.html#None>) -- Index set describing which indices to send, default is to send natural numbering.
New index set containing the new numbers from remote or local.
IS

See also:


Source code at petsc4py/PETSc/IS.pyx:333 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L333>


Create a complement index set.

Collective.

The complement set of indices is all indices that are not in the provided set (and within the provided bounds).


IS <#petsc4py.PETSc.IS>

Notes

For a parallel index set, this will generate the local part of the complement on each process.

To generate the entire complement (on each process) of a parallel index set, first call IS.allGather and then call this method.

See also:


Source code at petsc4py/PETSc/IS.pyx:723 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L723>


Copy the contents of the index set into another.

Collective.

result (IS <#petsc4py.PETSc.IS> | None <https://docs.python.org/3/library/constants.html#None>) -- The target index set. If None <https://docs.python.org/3/library/constants.html#None> then IS.duplicate is called first.
The copied index set. If result is not None <https://docs.python.org/3/library/constants.html#None> then this is returned here.
IS

See also:


Source code at petsc4py/PETSc/IS.pyx:253 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L253>


Create an IS.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/IS.pyx:88 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L88>


Create a blocked index set.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/IS.pyx:171 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L171>


Create an IS with indices.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/IS.pyx:142 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L142>


Create an index set consisting of evenly spaced values.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/IS.pyx:204 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L204>



Return the difference between two index sets.

Collective.

iset (IS <#petsc4py.PETSc.IS>) -- Index set to compute the difference with.
Index set representing the difference between self and iset.
IS

See also:


Source code at petsc4py/PETSc/IS.pyx:699 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L699>


Create a copy of the index set.

Collective.

See also:


Source code at petsc4py/PETSc/IS.pyx:239 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L239>

IS <#petsc4py.PETSc.IS>


Embed self into iset.

Not collective.

The embedding is performed by finding the locations in iset that have the same indices as self.


The embedded index set.
IS

See also:


Source code at petsc4py/PETSc/IS.pyx:759 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L759>


Return whether the index sets have the same set of indices or not.

Collective.

iset (IS <#petsc4py.PETSc.IS>) -- The index set to compare indices with.
bool <https://docs.python.org/3/library/functions.html#bool>

See also:


Source code at petsc4py/PETSc/IS.pyx:599 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L599>


Return the union of two (possibly unsorted) index sets.

Collective.

To compute the union, expand concatenates the two index sets and removes any duplicates.

iset (IS <#petsc4py.PETSc.IS>) -- Index set to compute the union with.
The new, combined, index set.
IS

See also:


Source code at petsc4py/PETSc/IS.pyx:637 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L637>


Return the indices of an index set with type IS.Type.BLOCK <#petsc4py.PETSc.IS.Type.BLOCK>.

Not collective.

See also:


Source code at petsc4py/PETSc/IS.pyx:882 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L882>

ArrayInt <#petsc4py.typing.ArrayInt>



Return the indices of the index set.

Not collective.

See also:


Source code at petsc4py/PETSc/IS.pyx:838 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L838>

ArrayInt <#petsc4py.typing.ArrayInt>


Return stride information for an index set with type IS.Type.STRIDE <#petsc4py.PETSc.IS.Type.STRIDE>.

Not collective.


See also:


Source code at petsc4py/PETSc/IS.pyx:952 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L952>




Return the local and global sizes of the index set.

Not collective.


See also:

IS.getLocalSize, IS.getSize


Source code at petsc4py/PETSc/IS.pyx:464 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L464>




Invert the index set.

Collective.

For this to be correct the index set must be a permutation.

nlocal (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- The number of indices on this processor in the resulting index set, defaults to PETSC_DECIDE.
IS <#petsc4py.PETSc.IS>

See also:


Source code at petsc4py/PETSc/IS.pyx:363 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L363>


Return whether the index set has been declared as an identity.

Collective.

See also:


Source code at petsc4py/PETSc/IS.pyx:585 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L585>



Return whether an index set has been declared to be a permutation.

Logically collective.

See also:


Source code at petsc4py/PETSc/IS.pyx:558 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L558>




Load a stored index set.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer>) -- Binary file viewer, either Viewer.Type.BINARY <#petsc4py.PETSc.Viewer.Type.BINARY> or Viewer.Type.HDF5 <#petsc4py.PETSc.Viewer.Type.HDF5>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/IS.pyx:281 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L281>


Return the number of elements per process after a partitioning.

Collective.

Assuming that the index set represents a partitioning, determine the number of elements on each (partition) rank.

npart (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- The number of partitions, defaults to the size of the communicator.
ArrayInt <#petsc4py.typing.ArrayInt>

See also:


Source code at petsc4py/PETSc/IS.pyx:404 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L404>


Return the new global numbering after a partitioning.

Collective.

Assuming that the index set represents a partitioning, generate another index set with the new global node number in the new ordering.

See also:


Source code at petsc4py/PETSc/IS.pyx:387 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L387>

IS <#petsc4py.PETSc.IS>


Renumber the non-negative entries of an index set, starting from 0.

Collective.

mult (IS <#petsc4py.PETSc.IS> | None <https://docs.python.org/3/library/constants.html#None>) -- The multiplicity of each entry in self, default implies a multiplicity of 1.

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, IS <#petsc4py.PETSc.IS>]

See also:


Source code at petsc4py/PETSc/IS.pyx:790 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L790>


Set the indices for an index set with type IS.Type.BLOCK <#petsc4py.PETSc.IS.Type.BLOCK>.

Collective.


See also:


Source code at petsc4py/PETSc/IS.pyx:859 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L859>




Set the indices of an index set.

Logically collective.

The index set is assumed to be of type IS.Type.GENERAL <#petsc4py.PETSc.IS.Type.GENERAL>.

See also:


Source code at petsc4py/PETSc/IS.pyx:821 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L821>




Set the stride information for an index set with type IS.Type.STRIDE <#petsc4py.PETSc.IS.Type.STRIDE>.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/IS.pyx:904 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L904>




Return the union of two (sorted) index sets.

Collective.

iset (IS <#petsc4py.PETSc.IS>) -- The index set to compute the union with.
IS <#petsc4py.PETSc.IS>

See also:


Source code at petsc4py/PETSc/IS.pyx:618 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L618>



Return the union of two (possibly unsorted) index sets.

Collective.

This function will call either ISSum <https://petsc.org/release/manualpages/IS/ISSum.html> or ISExpand <https://petsc.org/release/manualpages/IS/ISExpand.html> depending on whether or not the input sets are already sorted.

Sequential only (as ISSum <https://petsc.org/release/manualpages/IS/ISSum.html> is sequential only).

iset (IS <#petsc4py.PETSc.IS>) -- Index set to compute the union with.
The new, combined, index set.
IS

See also:

IS.expand, IS.sum


Source code at petsc4py/PETSc/IS.pyx:664 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L664>


Display the index set.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- Viewer used to display the IS.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/IS.pyx:56 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L56>


Attributes Documentation

View of the index set as an array of integers.

Not collective.

Source code at petsc4py/PETSc/IS.pyx:1081 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1081>


The number of elements in a block.

Not collective.

See also:

IS.getBlockSize


Source code at petsc4py/PETSc/IS.pyx:1055 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1055>



The indices of the index set.

Not collective.

See also:

IS.getIndices


Source code at petsc4py/PETSc/IS.pyx:1068 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1068>


The local size of the index set.

Not collective.

See also:

IS.getLocalSize


Source code at petsc4py/PETSc/IS.pyx:1042 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1042>


True <https://docs.python.org/3/library/constants.html#True> if index set is a permutation, False <https://docs.python.org/3/library/constants.html#False> otherwise.

Logically collective.

See also:

IS.isPermutation


Source code at petsc4py/PETSc/IS.pyx:975 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L975>


The global size of the index set.

Not collective.

See also:

IS.getSize


Source code at petsc4py/PETSc/IS.pyx:1029 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1029>


The local and global sizes of the index set.

Not collective.

See also:

IS.getSizes


Source code at petsc4py/PETSc/IS.pyx:1016 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1016>





petsc4py.PETSc.InsertMode

Bases: object <https://docs.python.org/3/library/functions.html#object>

Insertion mode.

Most commonly used insertion modes are:

Insert provided value/s discarding previous value/s.
Add provided value/s to current value/s.
Insert the maximum of provided value/s and current value/s.

See also:


Attributes Summary

ADD Constant ADD of type int <https://docs.python.org/3/library/functions.html#int>
ADD_ALL Constant ADD_ALL of type int <https://docs.python.org/3/library/functions.html#int>
ADD_ALL_VALUES Constant ADD_ALL_VALUES of type int <https://docs.python.org/3/library/functions.html#int>
ADD_BC Constant ADD_BC of type int <https://docs.python.org/3/library/functions.html#int>
ADD_BC_VALUES Constant ADD_BC_VALUES of type int <https://docs.python.org/3/library/functions.html#int>
ADD_VALUES Constant ADD_VALUES of type int <https://docs.python.org/3/library/functions.html#int>
INSERT Constant INSERT of type int <https://docs.python.org/3/library/functions.html#int>
INSERT_ALL Constant INSERT_ALL of type int <https://docs.python.org/3/library/functions.html#int>
INSERT_ALL_VALUES Constant INSERT_ALL_VALUES of type int <https://docs.python.org/3/library/functions.html#int>
INSERT_BC Constant INSERT_BC of type int <https://docs.python.org/3/library/functions.html#int>
INSERT_BC_VALUES Constant INSERT_BC_VALUES of type int <https://docs.python.org/3/library/functions.html#int>
INSERT_VALUES Constant INSERT_VALUES of type int <https://docs.python.org/3/library/functions.html#int>
MAX Constant MAX of type int <https://docs.python.org/3/library/functions.html#int>
MAX_VALUES Constant MAX_VALUES of type int <https://docs.python.org/3/library/functions.html#int>
NOT_SET_VALUES Constant NOT_SET_VALUES of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation

















petsc4py.PETSc.KSP

Bases: Object <#petsc4py.PETSc.Object>

Abstract PETSc object that manages all Krylov methods.

This is the object that manages the linear solves in PETSc (even those such as direct solvers that do no use Krylov accelerators).

Notes

When a direct solver is used, but no Krylov solver is used, the KSP object is still used but with a Type.PREONLY <#petsc4py.PETSc.KSP.Type.PREONLY>, meaning that only application of the preconditioner is used as the linear solver.

See also:

create, setType, SNES <#petsc4py.PETSc.SNES>, TS <#petsc4py.PETSc.TS>, PC <#petsc4py.PETSc.PC>, Type.CG <#petsc4py.PETSc.KSP.Type.CG>, Type.GMRES <#petsc4py.PETSc.KSP.Type.GMRES>, KSP <https://petsc.org/release/manualpages/KSP/KSP.html>


Enumerations

ConvergedReason <#petsc4py.PETSc.KSP.ConvergedReason> KSP Converged Reason.
HPDDMType <#petsc4py.PETSc.KSP.HPDDMType> The HPDDM Krylov solver type.
NormType <#petsc4py.PETSc.KSP.NormType> KSP norm type.
Type <#petsc4py.PETSc.KSP.Type> KSP Type.

petsc4py.PETSc.KSP.ConvergedReason

Bases: object <https://docs.python.org/3/library/functions.html#object>

KSP Converged Reason.

Still iterating
Still iterating
Undocumented.
Undocumented.
∥r∥ <= rtolnorm(b) or rtolnorm(b - Ax₀)
∥r∥ <= atol
Used by the Type.PREONLY <#petsc4py.PETSc.KSP.Type.PREONLY> solver after the single iteration of the preconditioner is applied. Also used when the KSPConvergedSkip <https://petsc.org/release/manualpages/KSP/KSPConvergedSkip.html> convergence test routine is set in KSP.
Undocumented.
Undocumented.
Undocumented.
Undocumented.
Ran out of iterations before any convergence criteria was reached.
norm(r) >= dtol*norm(b)
A breakdown in the Krylov method was detected so the method could not continue to enlarge the Krylov space. Could be due to a singular matrix or preconditioner. In KSPHPDDM, this is also returned when some search directions within a block are collinear.
A breakdown in the KSPBICG method was detected so the method could not continue to enlarge the Krylov space.
It appears the operator or preconditioner is not symmetric and this Krylov method (Type.CG <#petsc4py.PETSc.KSP.Type.CG>, Type.MINRES <#petsc4py.PETSc.KSP.Type.MINRES>, Type.CR <#petsc4py.PETSc.KSP.Type.CR>) requires symmetry.
It appears the preconditioner is indefinite (has both positive and negative eigenvalues) and this Krylov method (Type.CG <#petsc4py.PETSc.KSP.Type.CG>) requires it to be positive definite.
Undocumented.
Undocumented.
It was not possible to build or use the requested preconditioner. This is usually due to a zero pivot in a factorization. It can also result from a failure in a subpreconditioner inside a nested preconditioner such as PC.Type.FIELDSPLIT <#petsc4py.PETSc.PC.Type.FIELDSPLIT>.

See also:


Attributes Summary

CONVERGED_ATOL Constant CONVERGED_ATOL of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_ATOL_NORMAL_EQUATIONS Constant CONVERGED_ATOL_NORMAL_EQUATIONS of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_HAPPY_BREAKDOWN Constant CONVERGED_HAPPY_BREAKDOWN of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_ITERATING Constant CONVERGED_ITERATING of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_ITS Constant CONVERGED_ITS of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_NEG_CURVE Constant CONVERGED_NEG_CURVE of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_RTOL Constant CONVERGED_RTOL of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_RTOL_NORMAL_EQUATIONS Constant CONVERGED_RTOL_NORMAL_EQUATIONS of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_STEP_LENGTH Constant CONVERGED_STEP_LENGTH of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_BREAKDOWN Constant DIVERGED_BREAKDOWN of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_BREAKDOWN_BICG Constant DIVERGED_BREAKDOWN_BICG of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_DTOL Constant DIVERGED_DTOL of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_INDEFINITE_MAT Constant DIVERGED_INDEFINITE_MAT of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_INDEFINITE_PC Constant DIVERGED_INDEFINITE_PC of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_MAX_IT Constant DIVERGED_MAX_IT of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_NANORINF Constant DIVERGED_NANORINF of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_NONSYMMETRIC Constant DIVERGED_NONSYMMETRIC of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_NULL Constant DIVERGED_NULL of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_PCSETUP_FAILED Constant DIVERGED_PCSETUP_FAILED of type int <https://docs.python.org/3/library/functions.html#int>
ITERATING Constant ITERATING of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation






















petsc4py.PETSc.KSP.HPDDMType

Bases: object <https://docs.python.org/3/library/functions.html#object>

The HPDDM Krylov solver type.

Attributes Summary

BCG Constant BCG of type int <https://docs.python.org/3/library/functions.html#int>
BFBCG Constant BFBCG of type int <https://docs.python.org/3/library/functions.html#int>
BGCRODR Constant BGCRODR of type int <https://docs.python.org/3/library/functions.html#int>
BGMRES Constant BGMRES of type int <https://docs.python.org/3/library/functions.html#int>
CG Constant CG of type int <https://docs.python.org/3/library/functions.html#int>
GCRODR Constant GCRODR of type int <https://docs.python.org/3/library/functions.html#int>
GMRES Constant GMRES of type int <https://docs.python.org/3/library/functions.html#int>
PREONLY Constant PREONLY of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation










petsc4py.PETSc.KSP.NormType

Bases: object <https://docs.python.org/3/library/functions.html#object>

KSP norm type.

The available norm types are:

Skips computing the norm, this should generally only be used if you are using the Krylov method as a smoother with a fixed small number of iterations. Implicitly sets KSPConvergedSkip <https://petsc.org/release/manualpages/KSP/KSPConvergedSkip.html> as KSP convergence test. Note that certain algorithms such as Type.GMRES <#petsc4py.PETSc.KSP.Type.GMRES> ALWAYS require the norm calculation, for these methods the norms are still computed, they are just not used in the convergence test.
The default for left preconditioned solves, uses the l₂ norm of the preconditioned residual P⁻¹(b - Ax).
Uses the l₂ norm of the true b - Ax residual.
Supported by Type.CG <#petsc4py.PETSc.KSP.Type.CG>, Type.CR <#petsc4py.PETSc.KSP.Type.CR>, Type.CGNE <#petsc4py.PETSc.KSP.Type.CGNE>, Type.CGS <#petsc4py.PETSc.KSP.Type.CGS>.

Attributes Summary

DEFAULT Constant DEFAULT of type int <https://docs.python.org/3/library/functions.html#int>
NATURAL Constant NATURAL of type int <https://docs.python.org/3/library/functions.html#int>
NO Constant NO of type int <https://docs.python.org/3/library/functions.html#int>
NONE Constant NONE of type int <https://docs.python.org/3/library/functions.html#int>
NORM_DEFAULT Constant NORM_DEFAULT of type int <https://docs.python.org/3/library/functions.html#int>
NORM_NATURAL Constant NORM_NATURAL of type int <https://docs.python.org/3/library/functions.html#int>
NORM_NONE Constant NORM_NONE of type int <https://docs.python.org/3/library/functions.html#int>
NORM_PRECONDITIONED Constant NORM_PRECONDITIONED of type int <https://docs.python.org/3/library/functions.html#int>
NORM_UNPRECONDITIONED Constant NORM_UNPRECONDITIONED of type int <https://docs.python.org/3/library/functions.html#int>
PRECONDITIONED Constant PRECONDITIONED of type int <https://docs.python.org/3/library/functions.html#int>
UNPRECONDITIONED Constant UNPRECONDITIONED of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation













petsc4py.PETSc.KSP.Type

Bases: object <https://docs.python.org/3/library/functions.html#object>

KSP Type.

The available types are:

The preconditioned Richardson iterative method KSPRICHARDSON <https://petsc.org/release/manualpages/KSP/KSPRICHARDSON.html>.
The preconditioned Chebyshev iterative method. KSPCHEBYSHEV <https://petsc.org/release/manualpages/KSP/KSPCHEBYSHEV.html>.
The Preconditioned Conjugate Gradient (PCG) iterative method. KSPCG <https://petsc.org/release/manualpages/KSP/KSPCG.html>
A pipelined conjugate gradient method (Gropp). KSPGROPPCG <https://petsc.org/release/manualpages/KSP/KSPGROPPCG.html>
A pipelined conjugate gradient method. KSPPIPECG <https://petsc.org/release/manualpages/KSP/KSPPIPECG.html>
Pipelined Conjugate Gradients with Residual Replacement. KSPPIPECGRR <https://petsc.org/release/manualpages/KSP/KSPPIPECGRR.html>
Deep pipelined (length l) Conjugate Gradient method. KSPPIPELCG <https://petsc.org/release/manualpages/KSP/KSPPIPELCG.html>
Pipelined predict-and-recompute conjugate gradient method. KSPPIPEPRCG <https://petsc.org/release/manualpages/KSP/KSPPIPEPRCG.html>
Pipelined conjugate gradient method with a single non-blocking reduction per two iterations. KSPPIPECG2 <https://petsc.org/release/manualpages/KSP/KSPPIPECG2.html>
Applies the preconditioned conjugate gradient method to the normal equations without explicitly forming AᵀA. KSPCGNE <https://petsc.org/release/manualpages/KSP/KSPCGNE.html>
Conjugate gradient method subject to a constraint on the solution norm. KSPNASH <https://petsc.org/release/manualpages/KSP/KSPNASH.html>
Conjugate gradient method subject to a constraint on the solution norm. KSPSTCG <https://petsc.org/release/manualpages/KSP/KSPSTCG.html>
Conjugate gradient method subject to a constraint on the solution norm. KSPGLTR <https://petsc.org/release/manualpages/KSP/KSPGLTR.html>
Flexible Conjugate Gradient method (FCG). Unlike most KSP methods this allows the preconditioner to be nonlinear. KSPFCG <https://petsc.org/release/manualpages/KSP/KSPFCG.html>
Pipelined, Flexible Conjugate Gradient method. KSPPIPEFCG <https://petsc.org/release/manualpages/KSP/KSPPIPEFCG.html>
Generalized Minimal Residual method with restart. KSPGMRES <https://petsc.org/release/manualpages/KSP/KSPGMRES.html>
Pipelined (1-stage) Flexible Generalized Minimal Residual method. KSPPIPEFGMRES <https://petsc.org/release/manualpages/KSP/KSPPIPEFGMRES.html>
Implements the Flexible Generalized Minimal Residual method. KSPFGMRES <https://petsc.org/release/manualpages/KSP/KSPFGMRES.html>
Augments the standard Generalized Minimal Residual method approximation space with approximations to the error from previous restart cycles. KSPLGMRES <https://petsc.org/release/manualpages/KSP/KSPLGMRES.html>
Deflated Generalized Minimal Residual method. In this implementation, the adaptive strategy allows to switch to the deflated GMRES when the stagnation occurs. KSPDGMRES <https://petsc.org/release/manualpages/KSP/KSPDGMRES.html>
Pipelined Generalized Minimal Residual method. KSPPGMRES <https://petsc.org/release/manualpages/KSP/KSPPGMRES.html>
A variant of Quasi Minimal Residual (QMR). KSPTCQMR <https://petsc.org/release/manualpages/KSP/KSPTCQMR.html>
Stabilized version of Biconjugate Gradient (BiCGStab) method. KSPBCGS <https://petsc.org/release/manualpages/KSP/KSPBCGS.html>
Improved Stabilized version of BiConjugate Gradient (IBiCGStab) method in an alternative form to have only a single global reduction operation instead of the usual 3 (or 4). KSPIBCGS <https://petsc.org/release/manualpages/KSP/KSPIBCGS.html>
Quasi- Minimal Residual variant of the Bi-CGStab algorithm (QMRCGStab) method. KSPQMRCGS <https://petsc.org/release/manualpages/KSP/KSPQMRCGS.html>
Flexible Stabilized version of BiConjugate Gradient (BiCGStab) method. KSPFBCGS <https://petsc.org/release/manualpages/KSP/KSPFBCGS.html>
A mathematically equivalent variant of flexible stabilized BiConjugate Gradient (BiCGStab). KSPFBCGSR <https://petsc.org/release/manualpages/KSP/KSPFBCGSR.html>
Variant of the L-step stabilized BiConjugate Gradient (BiCGStab(L)) algorithm. Uses "L-step" Minimal Residual (MR) polynomials. The variation concerns cases when some parameters are negative due to round-off. KSPBCGSL <https://petsc.org/release/manualpages/KSP/KSPBCGSL.html>
Pipelined stabilized BiConjugate Gradient (BiCGStab) method. KSPPIPEBCGS <https://petsc.org/release/manualpages/KSP/KSPPIPEBCGS.html>
Conjugate Gradient Squared method. KSPCGS <https://petsc.org/release/manualpages/KSP/KSPCGS.html>
A Transpose Tree Quasi- Minimal Residual (QMR). KSPCR <https://petsc.org/release/manualpages/KSP/KSPCR.html>
(Preconditioned) Conjugate Residuals (CR) method. KSPCR <https://petsc.org/release/manualpages/KSP/KSPCR.html>
Pipelined Conjugate Residual (CR) method. KSPPIPECR <https://petsc.org/release/manualpages/KSP/KSPPIPECR.html>
Least squares solver. KSPLSQR <https://petsc.org/release/manualpages/KSP/KSPLSQR.html>
Applies ONLY the preconditioner exactly once. This may be used in inner iterations, where it is desired to allow multiple iterations as well as the "0-iteration" case. It is commonly used with the direct solver preconditioners like PCLU and PCCHOLESKY. There is an alias of KSPNONE. KSPPREONLY <https://petsc.org/release/manualpages/KSP/KSPPREONLY.html>
No solver KSPNONE
Conjugate Gradient (CG) method subject to a constraint on the solution norm. KSPQCG <https://petsc.org/release/manualpages/KSP/KSPQCG.html>
Implements the Biconjugate gradient method (BiCG). Similar to running the conjugate gradient on the normal equations. KSPBICG <https://petsc.org/release/manualpages/KSP/KSPBICG.html>
Minimum Residual (MINRES) method. KSPMINRES <https://petsc.org/release/manualpages/KSP/KSPMINRES.html>
Symmetric LQ method (SymmLQ). Uses LQ decomposition (lower trapezoidal). KSPSYMMLQ <https://petsc.org/release/manualpages/KSP/KSPSYMMLQ.html>
Left Conjugate Direction (LCD) method. KSPLCD <https://petsc.org/release/manualpages/KSP/KSPLCD.html>
Python shell solver. Call Python function to implement solver. KSPPYTHON
Preconditioned flexible Generalized Conjugate Residual (GCR) method. KSPGCR <https://petsc.org/release/manualpages/KSP/KSPGCR.html>
Pipelined Generalized Conjugate Residual method. KSPPIPEGCR <https://petsc.org/release/manualpages/KSP/KSPPIPEGCR.html>
Two-Stage Iteration with least-squares Residual Minimization method. KSPTSIRM <https://petsc.org/release/manualpages/KSP/KSPTSIRM.html>
Conjugate Gradient method for Least-Squares problems. Supports non-square (rectangular) matrices. KSPCGLS <https://petsc.org/release/manualpages/KSP/KSPCGLS.html>
Dual-Primal (DP) Finite Element Tearing and Interconnect (FETI) method. KSPFETIDP <https://petsc.org/release/manualpages/KSP/KSPFETIDP.html>
Interface with the HPDDM library. This KSP may be used to further select methods that are currently not implemented natively in PETSc, e.g., GCRODR, a recycled Krylov method which is similar to KSPLGMRES. KSPHPDDM <https://petsc.org/release/manualpages/KSP/KSPHPDDM.html>

See also:

Working with PETSc options <#petsc-options>, KSPType <https://petsc.org/release/manualpages/KSP/KSPType.html>


Attributes Summary

BCGS Object BCGS of type str <https://docs.python.org/3/library/stdtypes.html#str>
BCGSL Object BCGSL of type str <https://docs.python.org/3/library/stdtypes.html#str>
BICG Object BICG of type str <https://docs.python.org/3/library/stdtypes.html#str>
CG Object CG of type str <https://docs.python.org/3/library/stdtypes.html#str>
CGLS Object CGLS of type str <https://docs.python.org/3/library/stdtypes.html#str>
CGNE Object CGNE of type str <https://docs.python.org/3/library/stdtypes.html#str>
CGS Object CGS of type str <https://docs.python.org/3/library/stdtypes.html#str>
CHEBYSHEV Object CHEBYSHEV of type str <https://docs.python.org/3/library/stdtypes.html#str>
CR Object CR of type str <https://docs.python.org/3/library/stdtypes.html#str>
DGMRES Object DGMRES of type str <https://docs.python.org/3/library/stdtypes.html#str>
FBCGS Object FBCGS of type str <https://docs.python.org/3/library/stdtypes.html#str>
FBCGSR Object FBCGSR of type str <https://docs.python.org/3/library/stdtypes.html#str>
FCG Object FCG of type str <https://docs.python.org/3/library/stdtypes.html#str>
FETIDP Object FETIDP of type str <https://docs.python.org/3/library/stdtypes.html#str>
FGMRES Object FGMRES of type str <https://docs.python.org/3/library/stdtypes.html#str>
GCR Object GCR of type str <https://docs.python.org/3/library/stdtypes.html#str>
GLTR Object GLTR of type str <https://docs.python.org/3/library/stdtypes.html#str>
GMRES Object GMRES of type str <https://docs.python.org/3/library/stdtypes.html#str>
GROPPCG Object GROPPCG of type str <https://docs.python.org/3/library/stdtypes.html#str>
HPDDM Object HPDDM of type str <https://docs.python.org/3/library/stdtypes.html#str>
IBCGS Object IBCGS of type str <https://docs.python.org/3/library/stdtypes.html#str>
LCD Object LCD of type str <https://docs.python.org/3/library/stdtypes.html#str>
LGMRES Object LGMRES of type str <https://docs.python.org/3/library/stdtypes.html#str>
LSQR Object LSQR of type str <https://docs.python.org/3/library/stdtypes.html#str>
MINRES Object MINRES of type str <https://docs.python.org/3/library/stdtypes.html#str>
NASH Object NASH of type str <https://docs.python.org/3/library/stdtypes.html#str>
NONE Object NONE of type str <https://docs.python.org/3/library/stdtypes.html#str>
PGMRES Object PGMRES of type str <https://docs.python.org/3/library/stdtypes.html#str>
PIPEBCGS Object PIPEBCGS of type str <https://docs.python.org/3/library/stdtypes.html#str>
PIPECG Object PIPECG of type str <https://docs.python.org/3/library/stdtypes.html#str>
PIPECG2 Object PIPECG2 of type str <https://docs.python.org/3/library/stdtypes.html#str>
PIPECGRR Object PIPECGRR of type str <https://docs.python.org/3/library/stdtypes.html#str>
PIPECR Object PIPECR of type str <https://docs.python.org/3/library/stdtypes.html#str>
PIPEFCG Object PIPEFCG of type str <https://docs.python.org/3/library/stdtypes.html#str>
PIPEFGMRES Object PIPEFGMRES of type str <https://docs.python.org/3/library/stdtypes.html#str>
PIPEGCR Object PIPEGCR of type str <https://docs.python.org/3/library/stdtypes.html#str>
PIPELCG Object PIPELCG of type str <https://docs.python.org/3/library/stdtypes.html#str>
PIPEPRCG Object PIPEPRCG of type str <https://docs.python.org/3/library/stdtypes.html#str>
PREONLY Object PREONLY of type str <https://docs.python.org/3/library/stdtypes.html#str>
PYTHON Object PYTHON of type str <https://docs.python.org/3/library/stdtypes.html#str>
QCG Object QCG of type str <https://docs.python.org/3/library/stdtypes.html#str>
QMRCGS Object QMRCGS of type str <https://docs.python.org/3/library/stdtypes.html#str>
RICHARDSON Object RICHARDSON of type str <https://docs.python.org/3/library/stdtypes.html#str>
STCG Object STCG of type str <https://docs.python.org/3/library/stdtypes.html#str>
SYMMLQ Object SYMMLQ of type str <https://docs.python.org/3/library/stdtypes.html#str>
TCQMR Object TCQMR of type str <https://docs.python.org/3/library/stdtypes.html#str>
TFQMR Object TFQMR of type str <https://docs.python.org/3/library/stdtypes.html#str>
TSIRM Object TSIRM of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation


















































Methods Summary

addConvergenceTest(converged[, args, kargs, ...]) Add the function to be used to determine convergence.
appendOptionsPrefix(prefix) Append to prefix used for all KSP options in the database.
buildResidual([r]) Return the residual of the linear system.
buildSolution([x]) Return the solution vector.
callConvergenceTest(its, rnorm) Call the convergence test callback.
computeEigenvalues() Compute the extreme eigenvalues for the preconditioned operator.
computeExtremeSingularValues() Compute the extreme singular values for the preconditioned operator.
create([comm]) Create the KSP context.
createPython([context, comm]) Create a linear solver of Python type.
destroy() Destroy KSP context.
getAppCtx() Return the user-defined context for the linear solver.
getCGObjectiveValue() Return the CG objective function value.
getComputeEigenvalues() Return flag indicating whether eigenvalues will be calculated.
getComputeSingularValues() Return flag indicating whether singular values will be calculated.
getConvergedReason() Use reason property.
getConvergenceHistory() Return array containing the residual history.
getConvergenceTest() Return the function to be used to determine convergence.
getDM() Return the DM <#petsc4py.PETSc.DM> that may be used by some preconditioners.
getErrorIfNotConverged() Return the flag indicating the solver will error if divergent.
getHPDDMType() Return the Krylov solver type.
getInitialGuessKnoll() Determine whether the KSP solver is using the Knoll trick.
getInitialGuessNonzero() Determine whether the KSP solver uses a zero initial guess.
getIterationNumber() Use its property.
getMonitor() Return function used to monitor the residual.
getNormType() Return the norm that is used for convergence testing.
getOperators() Return the matrix associated with the linear system.
getOptionsPrefix() Return the prefix used for all KSP options in the database.
getPC() Return the preconditioner.
getPCSide() Return the preconditioning side.
getPythonContext() Return the instance of the class implementing Python methods.
getPythonType() Return the fully qualified Python name of the class used by the solver.
getResidualNorm() Use norm property.
getRhs() Return the right-hand side vector for the linear system.
getSolution() Return the solution for the linear system to be solved.
getTolerances() Return various tolerances used by the KSP convergence tests.
getType() Return the KSP type as a string from the KSP object.
getWorkVecs([right, left]) Create working vectors.
logConvergenceHistory(rnorm) Add residual to convergence history.
matSolve(B, X) Solve a linear system with multiple right-hand sides.
matSolveTranspose(B, X) Solve the transpose of a linear system with multiple RHS.
monitor(its, rnorm) Run the user provided monitor routines, if they exist.
monitorCancel() Clear all monitors for a KSP object.
reset() Resets a KSP context.
setAppCtx(appctx) Set the optional user-defined context for the linear solver.
setComputeEigenvalues(flag) Set a flag to compute eigenvalues.
setComputeOperators(operators[, args, kargs]) Set routine to compute the linear operators.
setComputeRHS(rhs[, args, kargs]) Set routine to compute the right-hand side of the linear system.
setComputeSingularValues(flag) Set flag to calculate singular values.
setConvergedReason(reason) Use reason property.
setConvergenceHistory([length, reset]) Set the array used to hold the residual history.
setConvergenceTest(converged[, args, kargs]) Set the function to be used to determine convergence.
setDM(dm) Set the DM <#petsc4py.PETSc.DM> that may be used by some preconditioners.
setDMActive(flag) DM <#petsc4py.PETSc.DM> should be used to generate system matrix & RHS vector.
setErrorIfNotConverged(flag) Cause solve to generate an error if not converged.
setFromOptions() Set KSP options from the options database.
setGMRESRestart(restart) Set number of iterations at which KSP restarts.
setHPDDMType(hpddm_type) Set the Krylov solver type.
setInitialGuessKnoll(flag) Tell solver to use PC.apply <#petsc4py.PETSc.PC.apply> to compute the initial guess.
setInitialGuessNonzero(flag) Tell the iterative solver that the initial guess is nonzero.
setIterationNumber(its) Use its property.
setMonitor(monitor[, args, kargs]) Set additional function to monitor the residual.
setNormType(normtype) Set the norm that is used for convergence testing.
setOperators([A, P]) Set matrix associated with the linear system.
setOptionsPrefix(prefix) Set the prefix used for all KSP options in the database.
setPC(pc) Set the preconditioner.
setPCSide(side) Set the preconditioning side.
setPostSolve(postsolve[, args, kargs]) Set the function that is called at the end of each KSP.solve.
setPreSolve(presolve[, args, kargs]) Set the function that is called at the beginning of each KSP.solve.
setPythonContext([context]) Set the instance of the class implementing Python methods.
setPythonType(py_type) Set the fully qualified Python name of the class to be used.
setResidualNorm(rnorm) Use norm property.
setTolerances([rtol, atol, divtol, max_it]) Set various tolerances used by the KSP convergence testers.
setType(ksp_type) Build the KSP data structure for a particular Type <#petsc4py.PETSc.KSP.Type>.
setUp() Set up internal data structures for an iterative solver.
setUpOnBlocks() Set up the preconditioner for each block in a block method.
setUseFischerGuess(model, size) Use the Paul Fischer algorithm to compute initial guesses.
solve(b, x) Solve the linear system.
solveTranspose(b, x) Solve the transpose of a linear system.
view([viewer]) Print the KSP data structure.

Attributes Summary

appctx The solver application context.
atol The absolute tolerance of the solver.
divtol The divergence tolerance of the solver.
dm The solver DM <#petsc4py.PETSc.DM>.
guess_knoll Whether solver uses Knoll trick.
guess_nonzero Whether guess is non-zero.
history The convergence history of the solver.
is_converged Boolean indicating if the solver has converged.
is_diverged Boolean indicating if the solver has failed.
is_iterating Boolean indicating if the solver has not converged yet.
its The current number of iterations the solver has taken.
mat_op The system matrix operator.
mat_pc The preconditioner operator.
max_it The maximum number of iteration the solver may take.
norm The norm of the residual at the current iteration.
norm_type The norm used by the solver.
pc The PC <#petsc4py.PETSc.PC> of the solver.
pc_side The side on which preconditioning is performed.
reason The converged reason.
rtol The relative tolerance of the solver.
vec_rhs The right-hand side vector.
vec_sol The solution vector.

Methods Documentation

Add the function to be used to determine convergence.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

Notes

Cannot be mixed with a call to setConvergenceTest. It can only be called once. If called multiple times, it will generate an error.

See also:

setTolerances, getConvergenceTest, setConvergenceTest, KSPSetConvergenceTest <https://petsc.org/release/manualpages/KSP/KSPSetConvergenceTest.html>, KSPConvergedDefault <https://petsc.org/release/manualpages/KSP/KSPConvergedDefault.html>


Source code at petsc4py/PETSc/KSP.pyx:1065 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1065>


Append to prefix used for all KSP options in the database.

Logically collective.


Notes

A hyphen (-) must NOT be given at the beginning of the prefix name. The first character of all runtime options is AUTOMATICALLY the hyphen.

See also:


Source code at petsc4py/PETSc/KSP.pyx:575 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L575>


Return the residual of the linear system.

Collective.

r (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional vector to use for the result.
Vec <#petsc4py.PETSc.Vec>

See also:


Source code at petsc4py/PETSc/KSP.pyx:2063 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2063>


Return the solution vector.

Collective.

x (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional vector to store the solution.
Vec <#petsc4py.PETSc.Vec>

See also:


Source code at petsc4py/PETSc/KSP.pyx:2041 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2041>


Call the convergence test callback.

Collective.


Notes

This functionality is implemented in petsc4py.

Source code at petsc4py/PETSc/KSP.pyx:1121 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1121>


Compute the extreme eigenvalues for the preconditioned operator.

Not collective.

See also:


Source code at petsc4py/PETSc/KSP.pyx:2085 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2085>

ArrayComplex <#petsc4py.typing.ArrayComplex>




Create a linear solver of Python type.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

PETSc Python linear solver type <#petsc-python-ksp>, setType, setPythonContext, Type.PYTHON <#petsc4py.PETSc.KSP.Type.PYTHON>


Source code at petsc4py/PETSc/KSP.pyx:2154 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2154>



Return the user-defined context for the linear solver.

Not collective.

See also:

setAppCtx


Source code at petsc4py/PETSc/KSP.pyx:640 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L640>




Return flag indicating whether eigenvalues will be calculated.

Not collective.

Return the flag indicating that the extreme eigenvalues values will be calculated via a Lanczos or Arnoldi process as the linear system is solved.

See also:

setComputeEigenvalues, KSPSetComputeEigenvalues <https://petsc.org/release/manualpages/KSP/KSPSetComputeEigenvalues.html>


Source code at petsc4py/PETSc/KSP.pyx:1430 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1430>



Return flag indicating whether singular values will be calculated.

Not collective.

Return the flag indicating whether the extreme singular values will be calculated via a Lanczos or Arnoldi process as the linear system is solved.

See also:

setComputeSingularValues, KSPGetComputeSingularValues <https://petsc.org/release/manualpages/KSP/KSPGetComputeSingularValues.html>


Source code at petsc4py/PETSc/KSP.pyx:1474 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1474>



Use reason property.

Source code at petsc4py/PETSc/KSP.pyx:1876 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1876>

ConvergedReason <#petsc4py.PETSc.KSP.ConvergedReason>


Return array containing the residual history.

Not collective.

See also:

setConvergenceHistory, KSPGetResidualHistory <https://petsc.org/release/manualpages/KSP/KSPGetResidualHistory.html>


Source code at petsc4py/PETSc/KSP.pyx:1188 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1188>

ArrayReal <#petsc4py.typing.ArrayReal>


Return the function to be used to determine convergence.

Logically collective.

See also:


Source code at petsc4py/PETSc/KSP.pyx:1108 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1108>

KSPConvergenceTestFunction <#petsc4py.typing.KSPConvergenceTestFunction>


Return the DM <#petsc4py.PETSc.DM> that may be used by some preconditioners.

Not collective.

See also:

PETSc.KSP, DM <#petsc4py.PETSc.DM>, KSPGetDM <https://petsc.org/release/manualpages/KSP/KSPGetDM.html>


Source code at petsc4py/PETSc/KSP.pyx:654 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L654>

DM <#petsc4py.PETSc.DM>


Return the flag indicating the solver will error if divergent.

Not collective.

See also:


Source code at petsc4py/PETSc/KSP.pyx:1946 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1946>



Return the Krylov solver type.

Not collective.

See also:


Source code at petsc4py/PETSc/KSP.pyx:1914 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1914>

HPDDMType <#petsc4py.PETSc.KSP.HPDDMType>


Determine whether the KSP solver is using the Knoll trick.

Not collective.

This uses the Knoll trick; using PC.apply <#petsc4py.PETSc.PC.apply> to compute the initial guess.

See also:


Source code at petsc4py/PETSc/KSP.pyx:1550 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1550>





Return function used to monitor the residual.

Not collective.

See also:

Working with PETSc options <#petsc-options>, setMonitor, monitor, monitorCancel, KSPGetMonitorContext <https://petsc.org/release/manualpages/KSP/KSPGetMonitorContext.html>


Source code at petsc4py/PETSc/KSP.pyx:1266 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1266>

KSPMonitorFunction <#petsc4py.typing.KSPMonitorFunction>


Return the norm that is used for convergence testing.

Not collective.

See also:

NormType <#petsc4py.PETSc.KSP.NormType>, setNormType, KSPGetNormType <https://petsc.org/release/manualpages/KSP/KSPGetNormType.html>, KSPConvergedSkip <https://petsc.org/release/manualpages/KSP/KSPConvergedSkip.html>


Source code at petsc4py/PETSc/KSP.pyx:1390 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1390>

NormType <#petsc4py.PETSc.NormType>


Return the matrix associated with the linear system.

Collective.

Return the matrix associated with the linear system and a (possibly) different one used to construct the preconditioner.

  • A (Mat <#petsc4py.PETSc.Mat>) -- Matrix that defines the linear system.
  • P (Mat <#petsc4py.PETSc.Mat>) -- Matrix to be used in constructing the preconditioner, usually the same as A.

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>]

See also:

PETSc.KSP, solve, setOperators, KSPGetOperators <https://petsc.org/release/manualpages/KSP/KSPGetOperators.html>


Source code at petsc4py/PETSc/KSP.pyx:850 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L850>


Return the prefix used for all KSP options in the database.

Not collective.

See also:


Source code at petsc4py/PETSc/KSP.pyx:561 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L561>



Return the preconditioner.

Not collective.

See also:


Source code at petsc4py/PETSc/KSP.pyx:897 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L897>

PC <#petsc4py.PETSc.PC>


Return the preconditioning side.

Not collective.

See also:

Working with PETSc options <#petsc-options>, setPCSide, setNormType, getNormType, KSPGetPCSide <https://petsc.org/release/manualpages/KSP/KSPGetPCSide.html>


Source code at petsc4py/PETSc/KSP.pyx:1349 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1349>

Side <#petsc4py.PETSc.PC.Side>


Return the instance of the class implementing Python methods.

Not collective.

See also:

PETSc Python linear solver type <#petsc-python-ksp>, setPythonContext


Source code at petsc4py/PETSc/KSP.pyx:2195 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2195>



Return the fully qualified Python name of the class used by the solver.

Not collective.

See also:

PETSc Python linear solver type <#petsc-python-ksp>, setPythonContext, setPythonType, KSPPythonGetType <https://petsc.org/release/manualpages/KSP/KSPPythonGetType.html>


Source code at petsc4py/PETSc/KSP.pyx:2225 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2225>




Return the right-hand side vector for the linear system.

Not collective.

See also:


Source code at petsc4py/PETSc/KSP.pyx:1960 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1960>

Vec <#petsc4py.PETSc.Vec>


Return the solution for the linear system to be solved.

Not collective.

Note that this may not be the solution that is stored during the iterative process.

See also:


Source code at petsc4py/PETSc/KSP.pyx:1975 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1975>

Vec <#petsc4py.PETSc.Vec>


Return various tolerances used by the KSP convergence tests.

Not collective.

Return the relative, absolute, divergence, and maximum iteration tolerances used by the default KSP convergence tests.


See also:


Source code at petsc4py/PETSc/KSP.pyx:971 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L971>



Create working vectors.

Collective.



tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[list <https://docs.python.org/3/library/stdtypes.html#list>[Vec <#petsc4py.PETSc.Vec>], list <https://docs.python.org/3/library/stdtypes.html#list>[Vec <#petsc4py.PETSc.Vec>]] | list <https://docs.python.org/3/library/stdtypes.html#list>[Vec <#petsc4py.PETSc.Vec>] | None <https://docs.python.org/3/library/constants.html#None>

Source code at petsc4py/PETSc/KSP.pyx:1993 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1993>


Add residual to convergence history.

Logically collective.


Source code at petsc4py/PETSc/KSP.pyx:1203 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1203>


Solve a linear system with multiple right-hand sides.

Collective.

These are stored as a Mat.Type.DENSE <#petsc4py.PETSc.Mat.Type.DENSE>. Unlike solve, B and X must be different matrices.

  • B (Mat <#petsc4py.PETSc.Mat>) -- Block of right-hand sides.
  • X (Mat <#petsc4py.PETSc.Mat>) -- Block of solutions.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/KSP.pyx:1808 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1808>


Solve the transpose of a linear system with multiple RHS.

Collective.

  • B (Mat <#petsc4py.PETSc.Mat>) -- Block of right-hand sides.
  • X (Mat <#petsc4py.PETSc.Mat>) -- Block of solutions.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/KSP.pyx:1830 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1830>


Run the user provided monitor routines, if they exist.

Collective.

Notes

This routine is called by the KSP implementations. It does not typically need to be called by the user.

See also:


Source code at petsc4py/PETSc/KSP.pyx:1294 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1294>



Clear all monitors for a KSP object.

Logically collective.

See also:

Working with PETSc options <#petsc-options>, getMonitor, setMonitor, monitor, KSPMonitorCancel <https://petsc.org/release/manualpages/KSP/KSPMonitorCancel.html>


Source code at petsc4py/PETSc/KSP.pyx:1279 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1279>



Resets a KSP context.

Collective.

Resets a KSP context to the kspsetupcalled = 0 state and removes any allocated Vecs and Mats.

See also:


Source code at petsc4py/PETSc/KSP.pyx:1607 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1607>



Set the optional user-defined context for the linear solver.

Not collective.


Notes

The user context is a way for users to attach any information to the KSP that they may need later when interacting with the solver.

See also:

getAppCtx


Source code at petsc4py/PETSc/KSP.pyx:617 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L617>


Set a flag to compute eigenvalues.

Logically collective.

Set a flag so that the extreme eigenvalues values will be calculated via a Lanczos or Arnoldi process as the linear system is solved.


Notes

Currently this option is not valid for all iterative methods.

See also:

getComputeEigenvalues, KSPSetComputeEigenvalues <https://petsc.org/release/manualpages/KSP/KSPSetComputeEigenvalues.html>


Source code at petsc4py/PETSc/KSP.pyx:1404 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1404>


Set routine to compute the linear operators.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

Notes

The user provided function Operators <https://docs.python.org/3/reference/lexical_analysis.html#operators> will be called automatically at the very next call to solve. It will NOT be called at future solve calls unless either setComputeOperators or setOperators is called before that solve is called. This allows the same system to be solved several times with different right-hand side functions, but is a confusing API since one might expect it to be called for each solve.

To reuse the same preconditioner for the next solve and not compute a new one based on the most recently computed matrix call KSPSetReusePreconditioner <https://petsc.org/release/manualpages/KSP/KSPSetReusePreconditioner.html>.

See also:


Source code at petsc4py/PETSc/KSP.pyx:764 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L764>


Set routine to compute the right-hand side of the linear system.

Logically collective.


Notes

The routine you provide will be called each time you call solve to prepare the new right-hand side for that solve.

See also:


Source code at petsc4py/PETSc/KSP.pyx:730 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L730>


Set flag to calculate singular values.

Logically collective.

Set a flag so that the extreme singular values will be calculated via a Lanczos or Arnoldi process as the linear system is solved.


Notes

Currently this option is not valid for all iterative methods.

See also:

getComputeSingularValues, KSPSetComputeSingularValues <https://petsc.org/release/manualpages/KSP/KSPSetComputeSingularValues.html>


Source code at petsc4py/PETSc/KSP.pyx:1448 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1448>


Use reason property.

Source code at petsc4py/PETSc/KSP.pyx:1871 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1871>

reason (ConvergedReason <#petsc4py.PETSc.KSP.ConvergedReason>)
None <https://docs.python.org/3/library/constants.html#None>


Set the array used to hold the residual history.

Not collective.

If set, this array will contain the residual norms computed at each iteration of the solver.


Notes

If length is not provided or None <https://docs.python.org/3/library/constants.html#None> then a default array of length 10000 is allocated.

If the array is not long enough then once the iterations is longer than the array length solve stops recording the history.

See also:

getConvergenceHistory, KSPSetResidualHistory <https://petsc.org/release/manualpages/KSP/KSPSetResidualHistory.html>


Source code at petsc4py/PETSc/KSP.pyx:1144 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1144>


Set the function to be used to determine convergence.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

Notes

Must be called after the KSP type has been set so put this after a call to setType, or setFromOptions.

The default is a combination of relative and absolute tolerances. The residual value that is tested may be an approximation; routines that need exact values should compute them.

See also:

addConvergenceTest, ConvergedReason <#petsc4py.PETSc.KSP.ConvergedReason>, setTolerances, getConvergenceTest, buildResidual, KSPSetConvergenceTest <https://petsc.org/release/manualpages/KSP/KSPSetConvergenceTest.html>, KSPConvergedDefault <https://petsc.org/release/manualpages/KSP/KSPConvergedDefault.html>


Source code at petsc4py/PETSc/KSP.pyx:1000 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1000>


Set the DM <#petsc4py.PETSc.DM> that may be used by some preconditioners.

Logically collective.

dm (DM <#petsc4py.PETSc.DM>) -- The DM <#petsc4py.PETSc.DM> object, cannot be None <https://docs.python.org/3/library/constants.html#None>.
None <https://docs.python.org/3/library/constants.html#None>

Notes

If this is used then the KSP will attempt to use the DM <#petsc4py.PETSc.DM> to create the matrix and use the routine set with DM.setKSPComputeOperators <#petsc4py.PETSc.DM.setKSPComputeOperators>. Use setDMActive(False) to instead use the matrix you have provided with setOperators.

A DM <#petsc4py.PETSc.DM> can only be used for solving one problem at a time because information about the problem is stored on the DM <#petsc4py.PETSc.DM>, even when not using interfaces like DM.setKSPComputeOperators <#petsc4py.PETSc.DM.setKSPComputeOperators>. Use DM.clone <#petsc4py.PETSc.DM.clone> to get a distinct DM <#petsc4py.PETSc.DM> when solving different problems using the same function space.

See also:

PETSc.KSP, DM <#petsc4py.PETSc.DM>, DM.setKSPComputeOperators <#petsc4py.PETSc.DM.setKSPComputeOperators>, setOperators, DM.clone <#petsc4py.PETSc.DM.clone>, KSPSetDM <https://petsc.org/release/manualpages/KSP/KSPSetDM.html>


Source code at petsc4py/PETSc/KSP.pyx:671 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L671>


DM <#petsc4py.PETSc.DM> should be used to generate system matrix & RHS vector.

Logically collective.


Notes

By default setDM sets the DM <#petsc4py.PETSc.DM> as active, call setDMActive(False) after setDM(dm) to not have the KSP object use the DM <#petsc4py.PETSc.DM> to generate the matrices.

See also:

PETSc.KSP, DM <#petsc4py.PETSc.DM>, setDM, KSPSetDMActive <https://petsc.org/release/manualpages/KSP/KSPSetDMActive.html>


Source code at petsc4py/PETSc/KSP.pyx:704 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L704>



Set KSP options from the options database.

Collective.

This routine must be called before setUp if the user is to be allowed to set the Krylov type.

See also:

Working with PETSc options <#petsc-options>, KSPSetFromOptions <https://petsc.org/release/manualpages/KSP/KSPSetFromOptions.html>


Source code at petsc4py/PETSc/KSP.pyx:600 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L600>



Set number of iterations at which KSP restarts.

Logically collective.

Suitable KSPs are: KSPGMRES, KSPFGMRES and KSPLGMRES.


See also:


Source code at petsc4py/PETSc/KSP.pyx:2132 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2132>


Set the Krylov solver type.

Collective.

hpddm_type (HPDDMType <#petsc4py.PETSc.KSP.HPDDMType>) -- The type of Krylov solver to use.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/KSP.pyx:1896 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1896>


Tell solver to use PC.apply <#petsc4py.PETSc.PC.apply> to compute the initial guess.

Logically collective.

This is the Knoll trick.


See also:


Source code at petsc4py/PETSc/KSP.pyx:1530 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1530>


Tell the iterative solver that the initial guess is nonzero.

Logically collective.

Otherwise KSP assumes the initial guess is to be zero (and thus zeros it out before solving).


See also:


Source code at petsc4py/PETSc/KSP.pyx:1494 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1494>



Set additional function to monitor the residual.

Logically collective.

Set an ADDITIONAL function to be called at every iteration to monitor the residual/error etc.


Notes

The default is to do nothing. To print the residual, or preconditioned residual if setNormType(NORM_PRECONDITIONED) was called, use monitor as the monitoring routine, with a PETSc.Viewer.ASCII <#petsc4py.PETSc.Viewer.ASCII> as the context.

Several different monitoring routines may be set by calling setMonitor multiple times; all will be called in the order in which they were set.

See also:

Working with PETSc options <#petsc-options>, getMonitor, monitor, monitorCancel, KSPMonitorSet <https://petsc.org/release/manualpages/KSP/KSPMonitorSet.html>


Source code at petsc4py/PETSc/KSP.pyx:1219 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1219>


Set the norm that is used for convergence testing.

Logically collective.

normtype (NormType <#petsc4py.PETSc.NormType>) -- The norm type to use (see NormType <#petsc4py.PETSc.KSP.NormType>).
None <https://docs.python.org/3/library/constants.html#None>

Notes

Not all combinations of preconditioner side (see setPCSide) and norm type are supported by all Krylov methods. If only one is set, PETSc tries to automatically change the other to find a compatible pair. If no such combination is supported, PETSc will generate an error.

See also:

NormType <#petsc4py.PETSc.KSP.NormType>, Working with PETSc options <#petsc-options>, setUp, solve, destroy, setPCSide, getPCSide, NormType <#petsc4py.PETSc.KSP.NormType>, KSPSetNormType <https://petsc.org/release/manualpages/KSP/KSPSetNormType.html>, KSPConvergedSkip <https://petsc.org/release/manualpages/KSP/KSPConvergedSkip.html>, KSPSetCheckNormIteration <https://petsc.org/release/manualpages/KSP/KSPSetCheckNormIteration.html>


Source code at petsc4py/PETSc/KSP.pyx:1363 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1363>


Set matrix associated with the linear system.

Collective.

Set the matrix associated with the linear system and a (possibly) different one from which the preconditioner will be built.


None <https://docs.python.org/3/library/constants.html#None>

Notes

If you know the operator A has a null space you can use Mat.setNullSpace <#petsc4py.PETSc.Mat.setNullSpace> and Mat.setTransposeNullSpace <#petsc4py.PETSc.Mat.setTransposeNullSpace> to supply the null space to A and the KSP solvers will automatically use that null space as needed during the solution process.

All future calls to setOperators must use the same size matrices!

Passing None <https://docs.python.org/3/library/constants.html#None> for A or P removes the matrix that is currently used.

See also:

PETSc.KSP, solve, setComputeOperators, KSPSetOperators <https://petsc.org/release/manualpages/KSP/KSPSetOperators.html>


Source code at petsc4py/PETSc/KSP.pyx:809 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L809>


Set the prefix used for all KSP options in the database.

Logically collective.


Notes

A hyphen (-) must NOT be given at the beginning of the prefix name. The first character of all runtime options is AUTOMATICALLY the hyphen. For example, to distinguish between the runtime options for two different KSP contexts, one could call ` KSPSetOptionsPrefix(ksp1, "sys1_") KSPSetOptionsPrefix(ksp2, "sys2_") `

This would enable use of different options for each system, such as ` -sys1_ksp_type gmres -sys1_ksp_rtol 1.e-3 -sys2_ksp_type bcgs -sys2_ksp_rtol 1.e-4 `

See also:

Working with PETSc options <#petsc-options>, KSPSetOptionsPrefix <https://petsc.org/release/manualpages/KSP/KSPSetOptionsPrefix.html>


Source code at petsc4py/PETSc/KSP.pyx:523 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L523>


Set the preconditioner.

Collective.

Set the preconditioner to be used to calculate the application of the preconditioner on a vector.

pc (PC <#petsc4py.PETSc.PC>) -- The preconditioner object
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/KSP.pyx:877 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L877>


Set the preconditioning side.

Logically collective.

side (Side <#petsc4py.PETSc.PC.Side>) -- The preconditioning side (see PC.Side <#petsc4py.PETSc.PC.Side>).
None <https://docs.python.org/3/library/constants.html#None>

Notes

Left preconditioning is used by default for most Krylov methods except Type.FGMRES <#petsc4py.PETSc.KSP.Type.FGMRES> which only supports right preconditioning.

For methods changing the side of the preconditioner changes the norm type that is used, see setNormType.

Symmetric preconditioning is currently available only for the Type.QCG <#petsc4py.PETSc.KSP.Type.QCG> method. Note, however, that symmetric preconditioning can be emulated by using either right or left preconditioning and a pre or post processing step.

Setting the PC side often affects the default norm type. See setNormType for details.

See also:

PC.Side <#petsc4py.PETSc.PC.Side>, Working with PETSc options <#petsc-options>, getPCSide, setNormType, getNormType, KSPSetPCSide <https://petsc.org/release/manualpages/KSP/KSPSetPCSide.html>


Source code at petsc4py/PETSc/KSP.pyx:1315 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1315>


Set the function that is called at the end of each KSP.solve.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/KSP.pyx:1670 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1670>


Set the function that is called at the beginning of each KSP.solve.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/KSP.pyx:1637 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1637>


Set the instance of the class implementing Python methods.

Not collective.

See also:

PETSc Python linear solver type <#petsc-python-ksp>, getPythonContext


Source code at petsc4py/PETSc/KSP.pyx:2183 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2183>



Set the fully qualified Python name of the class to be used.

Collective.

See also:

PETSc Python linear solver type <#petsc-python-ksp>, setPythonContext, getPythonType, KSPPythonSetType <https://petsc.org/release/manualpages/KSP/KSPPythonSetType.html>


Source code at petsc4py/PETSc/KSP.pyx:2210 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2210>




Set various tolerances used by the KSP convergence testers.

Logically collective.

Set the relative, absolute, divergence, and maximum iteration tolerances used by the default KSP convergence testers.


None <https://docs.python.org/3/library/constants.html#None>

Notes

Use None <https://docs.python.org/3/library/constants.html#None> to retain the default value of any of the tolerances.

See also:

Working with PETSc options <#petsc-options>, getTolerances, setConvergenceTest, KSPSetTolerances <https://petsc.org/release/manualpages/KSP/KSPSetTolerances.html>, KSPConvergedDefault <https://petsc.org/release/manualpages/KSP/KSPConvergedDefault.html>


Source code at petsc4py/PETSc/KSP.pyx:914 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L914>


Build the KSP data structure for a particular Type <#petsc4py.PETSc.KSP.Type>.

Logically collective.


Notes

See Type <#petsc4py.PETSc.KSP.Type> for available methods (for instance, Type.CG <#petsc4py.PETSc.KSP.Type.CG> or Type.GMRES <#petsc4py.PETSc.KSP.Type.GMRES>).

Normally, it is best to use the setFromOptions command and then set the KSP type from the options database rather than by using this routine. Using the options database provides the user with maximum flexibility in evaluating the many different Krylov methods. This method is provided for those situations where it is necessary to set the iterative solver independently of the command line or options database. This might be the case, for example, when the choice of iterative solver changes during the execution of the program, and the user's application is taking responsibility for choosing the appropriate method. In other words, this routine is not for beginners.

See also:


Source code at petsc4py/PETSc/KSP.pyx:473 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L473>



Set up the preconditioner for each block in a block method.

Collective.

Methods include: block Jacobi, block Gauss-Seidel, and overlapping Schwarz methods.

See also:


Source code at petsc4py/PETSc/KSP.pyx:1622 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1622>



Use the Paul Fischer algorithm to compute initial guesses.

Logically collective.

Use the Paul Fischer algorithm or its variants to compute initial guesses for a set of solves with related right hand sides.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/KSP.pyx:1567 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1567>


Solve the linear system.

Collective.

  • b (Vec <#petsc4py.PETSc.Vec>) -- Right hand side vector.
  • x (Vec <#petsc4py.PETSc.Vec>) -- Solution vector.

None <https://docs.python.org/3/library/constants.html#None>

Notes

If one uses setDM then x or b need not be passed. Use getSolution to access the solution in this case.

The operator is specified with setOperators.

solve will normally return without generating an error regardless of whether the linear system was solved or if constructing the preconditioner failed. Call getConvergedReason to determine if the solver converged or failed and why. The option -ksp_error_if_not_converged or function setErrorIfNotConverged will cause solve to error as soon as an error occurs in the linear solver. In inner solves, DIVERGED_MAX_IT is not treated as an error because when using nested solvers it may be fine that inner solvers in the preconditioner do not converge during the solution process.

The number of iterations can be obtained from its.

If you provide a matrix that has a Mat.setNullSpace <#petsc4py.PETSc.Mat.setNullSpace> and Mat.setTransposeNullSpace <#petsc4py.PETSc.Mat.setTransposeNullSpace> this will use that information to solve singular systems in the least squares sense with a norm minimizing solution.

Ax = b where b = bₚ + bₜ where bₜ is not in the range of A (and hence by the fundamental theorem of linear algebra is in the nullspace(Aᵀ), see Mat.setNullSpace <#petsc4py.PETSc.Mat.setNullSpace>.

KSP first removes bₜ producing the linear system Ax = bₚ (which has multiple solutions) and solves this to find the ∥x∥ minimizing solution (and hence it finds the solution x orthogonal to the nullspace(A). The algorithm is simply in each iteration of the Krylov method we remove the nullspace(A) from the search direction thus the solution which is a linear combination of the search directions has no component in the nullspace(A).

We recommend always using Type.GMRES <#petsc4py.PETSc.KSP.Type.GMRES> for such singular systems. If nullspace(A) = nullspace(Aᵀ) (note symmetric matrices always satisfy this property) then both left and right preconditioning will work If nullspace(A) != nullspace(Aᵀ) then left preconditioning will work but right preconditioning may not work (or it may).

If using a direct method (e.g., via the KSP solver Type.PREONLY <#petsc4py.PETSc.KSP.Type.PREONLY> and a preconditioner such as PC.Type.LU <#petsc4py.PETSc.PC.Type.LU> or PC.Type.ILU <#petsc4py.PETSc.PC.Type.ILU>, then its=1. See setTolerances for more details.

Understanding Convergence

The routines setMonitor and computeEigenvalues provide information on additional options to monitor convergence and print eigenvalue information.

See also:

create, setUp, destroy, setTolerances, is_converged, solveTranspose, its, Mat.setNullSpace <#petsc4py.PETSc.Mat.setNullSpace>, Mat.setTransposeNullSpace <#petsc4py.PETSc.Mat.setTransposeNullSpace>, Type <#petsc4py.PETSc.KSP.Type>, setErrorIfNotConverged, KSPSolve <https://petsc.org/release/manualpages/KSP/KSPSolve.html>


Source code at petsc4py/PETSc/KSP.pyx:1703 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1703>


Solve the transpose of a linear system.

Collective.

  • b (Vec <#petsc4py.PETSc.Vec>) -- Right hand side vector.
  • x (Vec <#petsc4py.PETSc.Vec>) -- Solution vector.

None <https://docs.python.org/3/library/constants.html#None>

Notes

For complex numbers this solve the non-Hermitian transpose system.

See also:


Source code at petsc4py/PETSc/KSP.pyx:1784 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1784>


Print the KSP data structure.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- Viewer used to display the KSP.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/KSP.pyx:425 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L425>


Attributes Documentation

The solver application context.

Source code at petsc4py/PETSc/KSP.pyx:2242 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2242>


The absolute tolerance of the solver.

Source code at petsc4py/PETSc/KSP.pyx:2335 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2335>


The divergence tolerance of the solver.

Source code at petsc4py/PETSc/KSP.pyx:2343 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2343>


The solver DM <#petsc4py.PETSc.DM>.

Source code at petsc4py/PETSc/KSP.pyx:2252 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2252>


Whether solver uses Knoll trick.

Source code at petsc4py/PETSc/KSP.pyx:2294 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2294>


Whether guess is non-zero.

Source code at petsc4py/PETSc/KSP.pyx:2286 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2286>


The convergence history of the solver.

Source code at petsc4py/PETSc/KSP.pyx:2377 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2377>


Boolean indicating if the solver has converged.

Source code at petsc4py/PETSc/KSP.pyx:2397 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2397>


Boolean indicating if the solver has failed.

Source code at petsc4py/PETSc/KSP.pyx:2402 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2402>


Boolean indicating if the solver has not converged yet.

Source code at petsc4py/PETSc/KSP.pyx:2392 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2392>


The current number of iterations the solver has taken.

Source code at petsc4py/PETSc/KSP.pyx:2361 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2361>


The system matrix operator.

Source code at petsc4py/PETSc/KSP.pyx:2274 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2274>


The preconditioner operator.

Source code at petsc4py/PETSc/KSP.pyx:2279 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2279>


The maximum number of iteration the solver may take.

Source code at petsc4py/PETSc/KSP.pyx:2351 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2351>


The norm of the residual at the current iteration.

Source code at petsc4py/PETSc/KSP.pyx:2369 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2369>


The norm used by the solver.

Source code at petsc4py/PETSc/KSP.pyx:2317 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2317>


The PC <#petsc4py.PETSc.PC> of the solver.

Source code at petsc4py/PETSc/KSP.pyx:2304 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2304>


The side on which preconditioning is performed.

Source code at petsc4py/PETSc/KSP.pyx:2309 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2309>


The converged reason.

Source code at petsc4py/PETSc/KSP.pyx:2384 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2384>


The relative tolerance of the solver.

Source code at petsc4py/PETSc/KSP.pyx:2327 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2327>


The right-hand side vector.

Source code at petsc4py/PETSc/KSP.pyx:2267 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2267>





petsc4py.PETSc.LGMap

Bases: Object <#petsc4py.PETSc.Object>

Mapping from a local to a global ordering.

See also:


Enumerations

GLMapMode <#petsc4py.PETSc.LGMap.GLMapMode> Enum describing mapping behavior when global indices are missing.
Type <#petsc4py.PETSc.LGMap.Type> Local to global map types.

petsc4py.PETSc.LGMap.GLMapMode

Bases: object <https://docs.python.org/3/library/functions.html#object>

Enum describing mapping behavior when global indices are missing.

Give missing global indices a local index of -1.
Drop missing global indices.

See also:


Attributes Summary

DROP Constant DROP of type int <https://docs.python.org/3/library/functions.html#int>
MASK Constant MASK of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation




petsc4py.PETSc.LGMap.Type


Methods Summary

apply(indices[, result]) Convert a locally numbered list of integers to a global numbering.
applyBlock(indices[, result]) Convert a local block numbering to a global block numbering.
applyBlockInverse(indices[, mode]) Compute blocked local numbering from blocked global numbering.
applyIS(iset) Create an index set with global numbering from a local numbering.
applyInverse(indices[, mode]) Compute local numbering from global numbering.
create(indices[, bsize, comm]) Create a local-to-global mapping.
createIS(iset) Create a local-to-global mapping from an index set.
createSF(sf, start) Create a local-to-global mapping from a star forest.
destroy() Destroy the local-to-global mapping.
getBlockIndices() Return the global indices for each local block.
getBlockInfo() Determine the block indices shared with neighboring processes.
getBlockSize() Return the block size of the local-to-global mapping.
getIndices() Return the global indices for each local point in the mapping.
getInfo() Determine the indices shared with neighboring processes.
getSize() Return the local size of the local-to-global mapping.
load(viewer) Load a local-to-global mapping.
setFromOptions() Set mapping options from the options database.
setType(lgmap_type) Set the type of the local-to-global map.
view([viewer]) View the local-to-global mapping.

Attributes Summary

block_indices The global indices for each local block in the mapping.
block_info Mapping describing block indices shared with neighboring processes.
block_size The block size.
indices The global indices for each local point in the mapping.
info Mapping describing indices shared with neighboring processes.
size The local size.

Methods Documentation

Convert a locally numbered list of integers to a global numbering.

Not collective.


Indices in global numbering. If result is not None <https://docs.python.org/3/library/constants.html#None> then this is returned here.
ArrayInt <#petsc4py.typing.ArrayInt>

See also:



Source code at petsc4py/PETSc/IS.pyx:1471 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1471>


Convert a local block numbering to a global block numbering.

Not collective.


Block indices in global numbering. If result is not None <https://docs.python.org/3/library/constants.html#None> then this is returned here.
ArrayInt <#petsc4py.typing.ArrayInt>

See also:


Source code at petsc4py/PETSc/IS.pyx:1508 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1508>


Compute blocked local numbering from blocked global numbering.

Not collective.


Indices with a local block numbering.
ArrayInt <#petsc4py.typing.ArrayInt>

See also:


Source code at petsc4py/PETSc/IS.pyx:1609 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1609>


Create an index set with global numbering from a local numbering.

Collective.

iset (IS <#petsc4py.PETSc.IS>) -- Index set with local numbering.
Index set with global numbering.
IS <#petsc4py.PETSc.IS>

See also:


Source code at petsc4py/PETSc/IS.pyx:1545 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1545>


Compute local numbering from global numbering.

Not collective.


Indices with a local numbering.
ArrayInt <#petsc4py.typing.ArrayInt>

See also:


Source code at petsc4py/PETSc/IS.pyx:1570 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1570>


Create a local-to-global mapping.

Not collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/IS.pyx:1254 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1254>


Create a local-to-global mapping from an index set.

Not collective.

iset (IS <#petsc4py.PETSc.IS>) -- Index set containing the global numbers for each local number.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/IS.pyx:1289 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1289>


Create a local-to-global mapping from a star forest.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/IS.pyx:1310 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1310>



Return the global indices for each local block.

Not collective.

See also:


Source code at petsc4py/PETSc/IS.pyx:1385 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1385>

ArrayInt <#petsc4py.typing.ArrayInt>


Determine the block indices shared with neighboring processes.

Collective.

Mapping from neighboring processor number to an array of shared block indices (in local numbering).
dict <https://docs.python.org/3/library/stdtypes.html#dict>

See also:


Source code at petsc4py/PETSc/IS.pyx:1440 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1440>


Return the block size of the local-to-global mapping.

Not collective.

See also:


Source code at petsc4py/PETSc/IS.pyx:1347 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1347>



Return the global indices for each local point in the mapping.

Not collective.

See also:


Source code at petsc4py/PETSc/IS.pyx:1361 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1361>

ArrayInt <#petsc4py.typing.ArrayInt>


Determine the indices shared with neighboring processes.

Collective.

Mapping from neighboring processor number to an array of shared indices (in local numbering).
dict <https://docs.python.org/3/library/stdtypes.html#dict>

See also:


Source code at petsc4py/PETSc/IS.pyx:1411 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1411>


Return the local size of the local-to-global mapping.

Not collective.

See also:


Source code at petsc4py/PETSc/IS.pyx:1333 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1333>



Load a local-to-global mapping.

Collective.

See also:


Source code at petsc4py/PETSc/IS.pyx:1223 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1223>

viewer (Viewer <#petsc4py.PETSc.Viewer>)
Self <https://docs.python.org/3/library/typing.html#typing.Self>


Set mapping options from the options database.

Not collective.

See also:

Working with PETSc options <#petsc-options>, ISLocalToGlobalMappingSetFromOptions <https://petsc.org/release/manualpages/IS/ISLocalToGlobalMappingSetFromOptions.html>


Source code at petsc4py/PETSc/IS.pyx:1192 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1192>



Set the type of the local-to-global map.

Logically collective.

lgmap_type (Type <#petsc4py.PETSc.LGMap.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of the local-to-global mapping.
None <https://docs.python.org/3/library/constants.html#None>

Notes

Use -islocaltoglobalmapping_type to set the type in the options database.

See also:

Working with PETSc options <#petsc-options>, ISLocalToGlobalMappingSetType <https://petsc.org/release/manualpages/IS/ISLocalToGlobalMappingSetType.html>


Source code at petsc4py/PETSc/IS.pyx:1168 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1168>


View the local-to-global mapping.

Not collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- Viewer instance, defaults to an instance of Viewer.Type.ASCII <#petsc4py.PETSc.Viewer.Type.ASCII>.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/IS.pyx:1204 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1204>


Attributes Documentation

The global indices for each local block in the mapping.

Not collective.

See also:

LGMap.getBlockIndices, ISLocalToGlobalMappingGetBlockIndices <https://petsc.org/release/manualpages/IS/ISLocalToGlobalMappingGetBlockIndices.html>


Source code at petsc4py/PETSc/IS.pyx:1688 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1688>


Mapping describing block indices shared with neighboring processes.

Collective.

See also:

LGMap.getBlockInfo, ISLocalToGlobalMappingGetBlockInfo <https://petsc.org/release/manualpages/IS/ISLocalToGlobalMappingGetBlockInfo.html>


Source code at petsc4py/PETSc/IS.pyx:1714 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1714>


The block size.

Not collective.

See also:

LGMap.getBlockSize


Source code at petsc4py/PETSc/IS.pyx:1662 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1662>


The global indices for each local point in the mapping.

Not collective.

See also:

LGMap.getIndices, ISLocalToGlobalMappingGetIndices <https://petsc.org/release/manualpages/IS/ISLocalToGlobalMappingGetIndices.html>


Source code at petsc4py/PETSc/IS.pyx:1675 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1675>


Mapping describing indices shared with neighboring processes.

Collective.

See also:


Source code at petsc4py/PETSc/IS.pyx:1701 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1701>


The local size.

Not collective.

See also:

LGMap.getSize


Source code at petsc4py/PETSc/IS.pyx:1649 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1649>




petsc4py.PETSc.Log

Bases: object <https://docs.python.org/3/library/functions.html#object>

Logging support.

Methods Summary

Class(name) Create a log class.
Event(name[, klass]) Create a log event.
EventDecorator([name, klass]) Decorate a function with a PETSc <#module-petsc4py.PETSc> event.
Stage(name) Create a log stage.
addFlops(flops) Add floating point operations to the current event.
begin() Turn on logging of objects and events.
getCPUTime() Return the CPU time.
getFlops() Return the number of flops used on this processor since the program began.
getTime() Return the current time of day in seconds.
isActive() Return whether logging is currently in progress.
logFlops(flops) Add floating point operations to the current event.
view([viewer]) Print the log.

Methods Documentation

Create a log class.

Not collective.

name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- Class name.
klass -- The log class. If a class already exists with name name then it is reused.
LogClass <#petsc4py.PETSc.LogClass>

See also:


Source code at petsc4py/PETSc/Log.pyx:45 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L45>


Create a log event.

Not collective.


event -- The log event. If an event already exists with name name then it is reused.
LogEvent <#petsc4py.PETSc.LogEvent>

See also:


Source code at petsc4py/PETSc/Log.pyx:79 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L79>



Create a log stage.

Not collective.

name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- Stage name.
stage -- The log stage. If a stage already exists with name name then it is reused.
LogStage <#petsc4py.PETSc.LogStage>

See also:


Source code at petsc4py/PETSc/Log.pyx:11 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L11>


Add floating point operations to the current event.

Not collective.


Notes

This method exists for backward compatibility.

See also:


Source code at petsc4py/PETSc/Log.pyx:170 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L170>




Return the number of flops used on this processor since the program began.

Not collective.

Number of floating point operations.
float <https://docs.python.org/3/library/functions.html#float>

See also:


Source code at petsc4py/PETSc/Log.pyx:193 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L193>





Print the log.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> instance or None <https://docs.python.org/3/library/constants.html#None> for the default viewer.
None <https://docs.python.org/3/library/constants.html#None>

See also:

Working with PETSc options <#petsc-options>, PetscLogView <https://petsc.org/release/manualpages/Log/PetscLogView.html>


Source code at petsc4py/PETSc/Log.pyx:130 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L130>



petsc4py.PETSc.LogClass

Bases: object <https://docs.python.org/3/library/functions.html#object>

Logging support.

Methods Summary

activate() Activate the log class.
deactivate() Deactivate the log class.
getActive() Not implemented.
getName() Return the log class name.
setActive(flag) Activate or deactivate the log class.

Attributes Summary

active Log class activation.
id The log class identifier.
name The log class name.

Methods Documentation






Attributes Documentation


The log class identifier.

Source code at petsc4py/PETSc/Log.pyx:463 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L463>




petsc4py.PETSc.LogEvent

Bases: object <https://docs.python.org/3/library/functions.html#object>

Logging support.

Methods Summary

activate() Indicate that the event should be logged.
begin(*objs) Log the beginning of a user event.
deactivate() Indicate that the event should not be logged.
end(*objs) Log the end of a user event.
getActive() Not implemented.
getActiveAll() Not implemented.
getName() The current event name.
getPerfInfo([stage]) Get the performance information about the given event in the given event.
setActive(flag) Indicate whether or not the event should be logged.
setActiveAll(flag) Turn on logging of all events.

Attributes Summary

active Event activation.
active_all All events activation.
id The log event identifier.
name The current event name.

Methods Documentation


Log the beginning of a user event.

Collective.

*objs -- objects associated with the event
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Log.pyx:558 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L558>



Log the end of a user event.

Collective.

*objs -- Objects associated with the event.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Log.pyx:577 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L577>





Get the performance information about the given event in the given event.

Not collective.

stage (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- The stage number.
info -- This structure is filled with the performance information.
dict <https://docs.python.org/3/library/stdtypes.html#dict>

See also:


Source code at petsc4py/PETSc/Log.pyx:705 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L705>




Attributes Documentation



The log event identifier.

Source code at petsc4py/PETSc/Log.pyx:540 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L540>


The current event name.

Source code at petsc4py/PETSc/Log.pyx:603 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L603>



petsc4py.PETSc.LogStage

Bases: object <https://docs.python.org/3/library/functions.html#object>

Logging support for different stages.

Methods Summary

activate() Activate the stage.
deactivate() Deactivate the stage.
getActive() Check if the stage is activated.
getName() Return the current stage name.
getVisible() Return whether the stage is visible.
pop() Pop a stage from the logging stack.
push() Push a stage on the logging stack.
setActive(flag) Activate or deactivate the current stage.
setVisible(flag) Set the visibility of the stage.

Attributes Summary

active Whether the stage is activate.
id The log stage identifier.
name The current stage name.
visible Whether the stage is visible.

Methods Documentation





Return whether the stage is visible.

Not collective.

See also:

LogStage.setVisible, PetscLogStageSetVisible <https://petsc.org/release/manualpages/Log/PetscLogStageSetVisible.html>


Source code at petsc4py/PETSc/Log.pyx:403 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L403>



Pop a stage from the logging stack.

Logically collective.

See also:


Source code at petsc4py/PETSc/Log.pyx:309 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L309>



Push a stage on the logging stack.

Logically collective.

See also:


Source code at petsc4py/PETSc/Log.pyx:297 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L297>





Attributes Documentation

Whether the stage is activate.

Source code at petsc4py/PETSc/Log.pyx:393 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L393>


The log stage identifier.

Source code at petsc4py/PETSc/Log.pyx:277 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L277>


The current stage name.

Source code at petsc4py/PETSc/Log.pyx:330 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L330>


Whether the stage is visible.

Source code at petsc4py/PETSc/Log.pyx:436 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L436>



petsc4py.PETSc.Mat

Bases: Object <#petsc4py.PETSc.Object>

Matrix object.

Mat is described in the PETSc manual <https://petsc.org/release/manual/mat.html>.

See also:


Enumerations

AssemblyType <#petsc4py.PETSc.Mat.AssemblyType> Matrix assembly type.
DuplicateOption <#petsc4py.PETSc.Mat.DuplicateOption> Matrix duplicate option.
FactorShiftType <#petsc4py.PETSc.Mat.FactorShiftType> Factored matrix shift type.
InfoType <#petsc4py.PETSc.Mat.InfoType> Matrix info type.
Option <#petsc4py.PETSc.Mat.Option> Matrix option.
OrderingType <#petsc4py.PETSc.Mat.OrderingType> Factored matrix ordering type.
SORType <#petsc4py.PETSc.Mat.SORType> Matrix SOR type.
SolverType <#petsc4py.PETSc.Mat.SolverType> Factored matrix solver type.
Stencil <#petsc4py.PETSc.Mat.Stencil> Associate structured grid coordinates with matrix indices.
Structure <#petsc4py.PETSc.Mat.Structure> Matrix modification structure.
Type <#petsc4py.PETSc.Mat.Type> Matrix type.

petsc4py.PETSc.Mat.AssemblyType


petsc4py.PETSc.Mat.DuplicateOption

Bases: object <https://docs.python.org/3/library/functions.html#object>

Matrix duplicate option.

See also:


Attributes Summary

COPY_VALUES Constant COPY_VALUES of type int <https://docs.python.org/3/library/functions.html#int>
DO_NOT_COPY_VALUES Constant DO_NOT_COPY_VALUES of type int <https://docs.python.org/3/library/functions.html#int>
SHARE_NONZERO_PATTERN Constant SHARE_NONZERO_PATTERN of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation





petsc4py.PETSc.Mat.FactorShiftType

Bases: object <https://docs.python.org/3/library/functions.html#object>

Factored matrix shift type.

See also:


Attributes Summary

INBLOCKS Constant INBLOCKS of type int <https://docs.python.org/3/library/functions.html#int>
NONE Constant NONE of type int <https://docs.python.org/3/library/functions.html#int>
NONZERO Constant NONZERO of type int <https://docs.python.org/3/library/functions.html#int>
NZ Constant NZ of type int <https://docs.python.org/3/library/functions.html#int>
PD Constant PD of type int <https://docs.python.org/3/library/functions.html#int>
POSITIVE_DEFINITE Constant POSITIVE_DEFINITE of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation








petsc4py.PETSc.Mat.InfoType


petsc4py.PETSc.Mat.Option

Bases: object <https://docs.python.org/3/library/functions.html#object>

Matrix option.

See also:


Attributes Summary

ERROR_LOWER_TRIANGULAR Constant ERROR_LOWER_TRIANGULAR of type int <https://docs.python.org/3/library/functions.html#int>
FORCE_DIAGONAL_ENTRIES Constant FORCE_DIAGONAL_ENTRIES of type int <https://docs.python.org/3/library/functions.html#int>
GETROW_UPPERTRIANGULAR Constant GETROW_UPPERTRIANGULAR of type int <https://docs.python.org/3/library/functions.html#int>
HERMITIAN Constant HERMITIAN of type int <https://docs.python.org/3/library/functions.html#int>
IGNORE_LOWER_TRIANGULAR Constant IGNORE_LOWER_TRIANGULAR of type int <https://docs.python.org/3/library/functions.html#int>
IGNORE_OFF_PROC_ENTRIES Constant IGNORE_OFF_PROC_ENTRIES of type int <https://docs.python.org/3/library/functions.html#int>
IGNORE_ZERO_ENTRIES Constant IGNORE_ZERO_ENTRIES of type int <https://docs.python.org/3/library/functions.html#int>
KEEP_NONZERO_PATTERN Constant KEEP_NONZERO_PATTERN of type int <https://docs.python.org/3/library/functions.html#int>
NEW_NONZERO_ALLOCATION_ERR Constant NEW_NONZERO_ALLOCATION_ERR of type int <https://docs.python.org/3/library/functions.html#int>
NEW_NONZERO_LOCATIONS Constant NEW_NONZERO_LOCATIONS of type int <https://docs.python.org/3/library/functions.html#int>
NEW_NONZERO_LOCATION_ERR Constant NEW_NONZERO_LOCATION_ERR of type int <https://docs.python.org/3/library/functions.html#int>
NO_OFF_PROC_ENTRIES Constant NO_OFF_PROC_ENTRIES of type int <https://docs.python.org/3/library/functions.html#int>
NO_OFF_PROC_ZERO_ROWS Constant NO_OFF_PROC_ZERO_ROWS of type int <https://docs.python.org/3/library/functions.html#int>
OPTION_MAX Constant OPTION_MAX of type int <https://docs.python.org/3/library/functions.html#int>
OPTION_MIN Constant OPTION_MIN of type int <https://docs.python.org/3/library/functions.html#int>
ROW_ORIENTED Constant ROW_ORIENTED of type int <https://docs.python.org/3/library/functions.html#int>
SORTED_FULL Constant SORTED_FULL of type int <https://docs.python.org/3/library/functions.html#int>
SPD Constant SPD of type int <https://docs.python.org/3/library/functions.html#int>
STRUCTURALLY_SYMMETRIC Constant STRUCTURALLY_SYMMETRIC of type int <https://docs.python.org/3/library/functions.html#int>
STRUCTURE_ONLY Constant STRUCTURE_ONLY of type int <https://docs.python.org/3/library/functions.html#int>
SUBMAT_SINGLEIS Constant SUBMAT_SINGLEIS of type int <https://docs.python.org/3/library/functions.html#int>
SUBSET_OFF_PROC_ENTRIES Constant SUBSET_OFF_PROC_ENTRIES of type int <https://docs.python.org/3/library/functions.html#int>
SYMMETRIC Constant SYMMETRIC of type int <https://docs.python.org/3/library/functions.html#int>
SYMMETRY_ETERNAL Constant SYMMETRY_ETERNAL of type int <https://docs.python.org/3/library/functions.html#int>
UNUSED_NONZERO_LOCATION_ERR Constant UNUSED_NONZERO_LOCATION_ERR of type int <https://docs.python.org/3/library/functions.html#int>
USE_HASH_TABLE Constant USE_HASH_TABLE of type int <https://docs.python.org/3/library/functions.html#int>
USE_INODES Constant USE_INODES of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation





























petsc4py.PETSc.Mat.OrderingType

Bases: object <https://docs.python.org/3/library/functions.html#object>

Factored matrix ordering type.

See also:


Attributes Summary

AMD Object AMD of type str <https://docs.python.org/3/library/stdtypes.html#str>
METISND Object METISND of type str <https://docs.python.org/3/library/stdtypes.html#str>
NATURAL Object NATURAL of type str <https://docs.python.org/3/library/stdtypes.html#str>
ND Object ND of type str <https://docs.python.org/3/library/stdtypes.html#str>
OWD Object OWD of type str <https://docs.python.org/3/library/stdtypes.html#str>
QMD Object QMD of type str <https://docs.python.org/3/library/stdtypes.html#str>
RCM Object RCM of type str <https://docs.python.org/3/library/stdtypes.html#str>
ROWLENGTH Object ROWLENGTH of type str <https://docs.python.org/3/library/stdtypes.html#str>
SPECTRAL Object SPECTRAL of type str <https://docs.python.org/3/library/stdtypes.html#str>
WBM Object WBM of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation












petsc4py.PETSc.Mat.SORType

Bases: object <https://docs.python.org/3/library/functions.html#object>

Matrix SOR type.

See also:


Attributes Summary

APPLY_LOWER Constant APPLY_LOWER of type int <https://docs.python.org/3/library/functions.html#int>
APPLY_UPPER Constant APPLY_UPPER of type int <https://docs.python.org/3/library/functions.html#int>
BACKWARD_SWEEP Constant BACKWARD_SWEEP of type int <https://docs.python.org/3/library/functions.html#int>
EISENSTAT Constant EISENSTAT of type int <https://docs.python.org/3/library/functions.html#int>
FORWARD_SWEEP Constant FORWARD_SWEEP of type int <https://docs.python.org/3/library/functions.html#int>
LOCAL_BACKWARD_SWEEP Constant LOCAL_BACKWARD_SWEEP of type int <https://docs.python.org/3/library/functions.html#int>
LOCAL_FORWARD_SWEEP Constant LOCAL_FORWARD_SWEEP of type int <https://docs.python.org/3/library/functions.html#int>
LOCAL_SYMMETRIC_SWEEP Constant LOCAL_SYMMETRIC_SWEEP of type int <https://docs.python.org/3/library/functions.html#int>
SYMMETRY_SWEEP Constant SYMMETRY_SWEEP of type int <https://docs.python.org/3/library/functions.html#int>
ZERO_INITIAL_GUESS Constant ZERO_INITIAL_GUESS of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation












petsc4py.PETSc.Mat.SolverType

Bases: object <https://docs.python.org/3/library/functions.html#object>

Factored matrix solver type.

See also:


Attributes Summary

BAS Object BAS of type str <https://docs.python.org/3/library/stdtypes.html#str>
CHOLMOD Object CHOLMOD of type str <https://docs.python.org/3/library/stdtypes.html#str>
CUDA Object CUDA of type str <https://docs.python.org/3/library/stdtypes.html#str>
CUSPARSE Object CUSPARSE of type str <https://docs.python.org/3/library/stdtypes.html#str>
ELEMENTAL Object ELEMENTAL of type str <https://docs.python.org/3/library/stdtypes.html#str>
ESSL Object ESSL of type str <https://docs.python.org/3/library/stdtypes.html#str>
KLU Object KLU of type str <https://docs.python.org/3/library/stdtypes.html#str>
LUSOL Object LUSOL of type str <https://docs.python.org/3/library/stdtypes.html#str>
MATLAB Object MATLAB of type str <https://docs.python.org/3/library/stdtypes.html#str>
MKL_CPARDISO Object MKL_CPARDISO of type str <https://docs.python.org/3/library/stdtypes.html#str>
MKL_PARDISO Object MKL_PARDISO of type str <https://docs.python.org/3/library/stdtypes.html#str>
MUMPS Object MUMPS of type str <https://docs.python.org/3/library/stdtypes.html#str>
PASTIX Object PASTIX of type str <https://docs.python.org/3/library/stdtypes.html#str>
PETSC Object PETSC of type str <https://docs.python.org/3/library/stdtypes.html#str>
SCALAPACK Object SCALAPACK of type str <https://docs.python.org/3/library/stdtypes.html#str>
SPQR Object SPQR of type str <https://docs.python.org/3/library/stdtypes.html#str>
STRUMPACK Object STRUMPACK of type str <https://docs.python.org/3/library/stdtypes.html#str>
SUPERLU Object SUPERLU of type str <https://docs.python.org/3/library/stdtypes.html#str>
SUPERLU_DIST Object SUPERLU_DIST of type str <https://docs.python.org/3/library/stdtypes.html#str>
UMFPACK Object UMFPACK of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation






















petsc4py.PETSc.Mat.Stencil

Bases: object <https://docs.python.org/3/library/functions.html#object>

Associate structured grid coordinates with matrix indices.

See also:


Attributes Summary

c Field component.
field Field component.
i First logical grid coordinate.
index Logical grid coordinates (i, j, k).
j Second logical grid coordinate.
k Third logical grid coordinate.

Attributes Documentation



First logical grid coordinate.

Source code at petsc4py/PETSc/Mat.pyx:296 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L296>


Logical grid coordinates (i, j, k).

Source code at petsc4py/PETSc/Mat.pyx:328 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L328>


Second logical grid coordinate.

Source code at petsc4py/PETSc/Mat.pyx:304 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L304>


Third logical grid coordinate.

Source code at petsc4py/PETSc/Mat.pyx:312 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L312>



petsc4py.PETSc.Mat.Structure

Bases: object <https://docs.python.org/3/library/functions.html#object>

Matrix modification structure.

See also:


Attributes Summary

DIFFERENT Constant DIFFERENT of type int <https://docs.python.org/3/library/functions.html#int>
DIFFERENT_NONZERO_PATTERN Constant DIFFERENT_NONZERO_PATTERN of type int <https://docs.python.org/3/library/functions.html#int>
DIFFERENT_NZ Constant DIFFERENT_NZ of type int <https://docs.python.org/3/library/functions.html#int>
SAME Constant SAME of type int <https://docs.python.org/3/library/functions.html#int>
SAME_NONZERO_PATTERN Constant SAME_NONZERO_PATTERN of type int <https://docs.python.org/3/library/functions.html#int>
SAME_NZ Constant SAME_NZ of type int <https://docs.python.org/3/library/functions.html#int>
SUBSET Constant SUBSET of type int <https://docs.python.org/3/library/functions.html#int>
SUBSET_NONZERO_PATTERN Constant SUBSET_NONZERO_PATTERN of type int <https://docs.python.org/3/library/functions.html#int>
SUBSET_NZ Constant SUBSET_NZ of type int <https://docs.python.org/3/library/functions.html#int>
UNKNOWN Constant UNKNOWN of type int <https://docs.python.org/3/library/functions.html#int>
UNKNOWN_NONZERO_PATTERN Constant UNKNOWN_NONZERO_PATTERN of type int <https://docs.python.org/3/library/functions.html#int>
UNKNOWN_NZ Constant UNKNOWN_NZ of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation














petsc4py.PETSc.Mat.Type

Bases: object <https://docs.python.org/3/library/functions.html#object>

Matrix type.

See also:


Attributes Summary

AIJ Object AIJ of type str <https://docs.python.org/3/library/stdtypes.html#str>
AIJCRL Object AIJCRL of type str <https://docs.python.org/3/library/stdtypes.html#str>
AIJCUSPARSE Object AIJCUSPARSE of type str <https://docs.python.org/3/library/stdtypes.html#str>
AIJMKL Object AIJMKL of type str <https://docs.python.org/3/library/stdtypes.html#str>
AIJPERM Object AIJPERM of type str <https://docs.python.org/3/library/stdtypes.html#str>
AIJSELL Object AIJSELL of type str <https://docs.python.org/3/library/stdtypes.html#str>
AIJVIENNACL Object AIJVIENNACL of type str <https://docs.python.org/3/library/stdtypes.html#str>
BAIJ Object BAIJ of type str <https://docs.python.org/3/library/stdtypes.html#str>
BAIJMKL Object BAIJMKL of type str <https://docs.python.org/3/library/stdtypes.html#str>
BLOCKMAT Object BLOCKMAT of type str <https://docs.python.org/3/library/stdtypes.html#str>
COMPOSITE Object COMPOSITE of type str <https://docs.python.org/3/library/stdtypes.html#str>
CONSTANTDIAGONAL Object CONSTANTDIAGONAL of type str <https://docs.python.org/3/library/stdtypes.html#str>
DENSE Object DENSE of type str <https://docs.python.org/3/library/stdtypes.html#str>
DENSECUDA Object DENSECUDA of type str <https://docs.python.org/3/library/stdtypes.html#str>
DENSEHIP Object DENSEHIP of type str <https://docs.python.org/3/library/stdtypes.html#str>
DIAGONAL Object DIAGONAL of type str <https://docs.python.org/3/library/stdtypes.html#str>
DUMMY Object DUMMY of type str <https://docs.python.org/3/library/stdtypes.html#str>
ELEMENTAL Object ELEMENTAL of type str <https://docs.python.org/3/library/stdtypes.html#str>
FFT Object FFT of type str <https://docs.python.org/3/library/stdtypes.html#str>
FFTW Object FFTW of type str <https://docs.python.org/3/library/stdtypes.html#str>
H2OPUS Object H2OPUS of type str <https://docs.python.org/3/library/stdtypes.html#str>
HERMITIANTRANSPOSE Object HERMITIANTRANSPOSE of type str <https://docs.python.org/3/library/stdtypes.html#str>
HYPRE Object HYPRE of type str <https://docs.python.org/3/library/stdtypes.html#str>
HYPRESSTRUCT Object HYPRESSTRUCT of type str <https://docs.python.org/3/library/stdtypes.html#str>
HYPRESTRUCT Object HYPRESTRUCT of type str <https://docs.python.org/3/library/stdtypes.html#str>
IS Object IS of type str <https://docs.python.org/3/library/stdtypes.html#str>
KAIJ Object KAIJ of type str <https://docs.python.org/3/library/stdtypes.html#str>
LMVM Object LMVM of type str <https://docs.python.org/3/library/stdtypes.html#str>
LMVMBADBROYDEN Object LMVMBADBROYDEN of type str <https://docs.python.org/3/library/stdtypes.html#str>
LMVMBFGS Object LMVMBFGS of type str <https://docs.python.org/3/library/stdtypes.html#str>
LMVMBROYDEN Object LMVMBROYDEN of type str <https://docs.python.org/3/library/stdtypes.html#str>
LMVMDBFGS Object LMVMDBFGS of type str <https://docs.python.org/3/library/stdtypes.html#str>
LMVMDDFP Object LMVMDDFP of type str <https://docs.python.org/3/library/stdtypes.html#str>
LMVMDFP Object LMVMDFP of type str <https://docs.python.org/3/library/stdtypes.html#str>
LMVMDIAGBBROYDEN Object LMVMDIAGBBROYDEN of type str <https://docs.python.org/3/library/stdtypes.html#str>
LMVMDQN Object LMVMDQN of type str <https://docs.python.org/3/library/stdtypes.html#str>
LMVMSR1 Object LMVMSR1 of type str <https://docs.python.org/3/library/stdtypes.html#str>
LMVMSYMBADBROYDEN Object LMVMSYMBADBROYDEN of type str <https://docs.python.org/3/library/stdtypes.html#str>
LMVMSYMBROYDEN Object LMVMSYMBROYDEN of type str <https://docs.python.org/3/library/stdtypes.html#str>
LOCALREF Object LOCALREF of type str <https://docs.python.org/3/library/stdtypes.html#str>
LRC Object LRC of type str <https://docs.python.org/3/library/stdtypes.html#str>
MAIJ Object MAIJ of type str <https://docs.python.org/3/library/stdtypes.html#str>
MFFD Object MFFD of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPIADJ Object MPIADJ of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPIAIJ Object MPIAIJ of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPIAIJCRL Object MPIAIJCRL of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPIAIJCUSPARSE Object MPIAIJCUSPARSE of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPIAIJMKL Object MPIAIJMKL of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPIAIJPERM Object MPIAIJPERM of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPIAIJSELL Object MPIAIJSELL of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPIAIJVIENNACL Object MPIAIJVIENNACL of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPIBAIJ Object MPIBAIJ of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPIBAIJMKL Object MPIBAIJMKL of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPIDENSE Object MPIDENSE of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPIDENSECUDA Object MPIDENSECUDA of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPIDENSEHIP Object MPIDENSEHIP of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPIKAIJ Object MPIKAIJ of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPIMAIJ Object MPIMAIJ of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPISBAIJ Object MPISBAIJ of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPISELL Object MPISELL of type str <https://docs.python.org/3/library/stdtypes.html#str>
NEST Object NEST of type str <https://docs.python.org/3/library/stdtypes.html#str>
NORMAL Object NORMAL of type str <https://docs.python.org/3/library/stdtypes.html#str>
NORMALHERMITIAN Object NORMALHERMITIAN of type str <https://docs.python.org/3/library/stdtypes.html#str>
PREALLOCATOR Object PREALLOCATOR of type str <https://docs.python.org/3/library/stdtypes.html#str>
PYTHON Object PYTHON of type str <https://docs.python.org/3/library/stdtypes.html#str>
SAME Object SAME of type str <https://docs.python.org/3/library/stdtypes.html#str>
SBAIJ Object SBAIJ of type str <https://docs.python.org/3/library/stdtypes.html#str>
SCATTER Object SCATTER of type str <https://docs.python.org/3/library/stdtypes.html#str>
SCHURCOMPLEMENT Object SCHURCOMPLEMENT of type str <https://docs.python.org/3/library/stdtypes.html#str>
SELL Object SELL of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQAIJ Object SEQAIJ of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQAIJCRL Object SEQAIJCRL of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQAIJCUSPARSE Object SEQAIJCUSPARSE of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQAIJMKL Object SEQAIJMKL of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQAIJPERM Object SEQAIJPERM of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQAIJSELL Object SEQAIJSELL of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQAIJVIENNACL Object SEQAIJVIENNACL of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQBAIJ Object SEQBAIJ of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQBAIJMKL Object SEQBAIJMKL of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQCUFFT Object SEQCUFFT of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQDENSE Object SEQDENSE of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQDENSECUDA Object SEQDENSECUDA of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQDENSEHIP Object SEQDENSEHIP of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQKAIJ Object SEQKAIJ of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQMAIJ Object SEQMAIJ of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQSBAIJ Object SEQSBAIJ of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQSELL Object SEQSELL of type str <https://docs.python.org/3/library/stdtypes.html#str>
SHELL Object SHELL of type str <https://docs.python.org/3/library/stdtypes.html#str>
SUBMATRIX Object SUBMATRIX of type str <https://docs.python.org/3/library/stdtypes.html#str>
TRANSPOSE Object TRANSPOSE of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation




























































































Methods Summary

H2OpusCompress(tol) Compress a hierarchical matrix.
H2OpusLowRankUpdate(U[, V, s]) Perform a low-rank update of the form self += sUVᵀ.
H2OpusOrthogonalize() Orthogonalize the basis tree of a hierarchical matrix.
SOR(b, x[, omega, sortype, shift, its, lits]) Compute relaxation (SOR, Gauss-Seidel) sweeps.
appendOptionsPrefix([prefix]) Append to the prefix used for searching for options in the database.
assemble([assembly]) Assemble the matrix.
assemblyBegin([assembly]) Begin an assembling stage of the matrix.
assemblyEnd([assembly]) Complete an assembling stage of the matrix initiated with assemblyBegin.
axpy(alpha, X[, structure]) Perform the matrix summation self + = ɑ·X.
aypx(alpha, X[, structure]) Perform the matrix summation self = ɑ·self + X.
bindToCPU(flg) Mark a matrix to temporarily stay on the CPU.
boundToCPU() Query if a matrix is bound to the CPU.
chop(tol) Set entries smallest of tol (in absolute values) to zero.
conjugate([out]) Return the conjugate matrix.
convert([mat_type, out]) Convert the matrix type.
copy([result, structure]) Return a copy of the matrix.
create([comm]) Create the matrix.
createAIJ(size[, bsize, nnz, csr, comm]) Create a sparse Type.AIJ <#petsc4py.PETSc.Mat.Type.AIJ> matrix, optionally preallocating.
createAIJCRL(size[, bsize, nnz, csr, comm]) Create a sparse Type.AIJCRL <#petsc4py.PETSc.Mat.Type.AIJCRL> matrix.
createAIJWithArrays(size, csr[, bsize, comm]) Create a sparse Type.AIJ <#petsc4py.PETSc.Mat.Type.AIJ> matrix with data in CSR format.
createBAIJ(size, bsize[, nnz, csr, comm]) Create a sparse blocked Type.BAIJ <#petsc4py.PETSc.Mat.Type.BAIJ> matrix, optionally preallocating.
createConstantDiagonal(size, diag[, comm]) Create a diagonal matrix of type Type.CONSTANTDIAGONAL <#petsc4py.PETSc.Mat.Type.CONSTANTDIAGONAL>.
createDense(size[, bsize, array, comm]) Create a Type.DENSE <#petsc4py.PETSc.Mat.Type.DENSE> matrix.
createDenseCUDA(size[, bsize, array, ...]) Create a Type.DENSECUDA <#petsc4py.PETSc.Mat.Type.DENSECUDA> matrix with optional host and device data.
createDiagonal(diag) Create a diagonal matrix of type Type.DIAGONAL <#petsc4py.PETSc.Mat.Type.DIAGONAL>.
createH2OpusFromMat(A[, coordinates, dist, ...]) Create a hierarchical Type.H2OPUS <#petsc4py.PETSc.Mat.Type.H2OPUS> matrix sampling from a provided operator.
createHermitianTranspose(mat) Create a Type.HERMITIANTRANSPOSE <#petsc4py.PETSc.Mat.Type.HERMITIANTRANSPOSE> matrix that behaves like (A*)ᵀ.
createIS(size[, bsize, lgmapr, lgmapc, comm]) Create a Type.IS <#petsc4py.PETSc.Mat.Type.IS> matrix representing globally unassembled operators.
createLRC(A, U, c, V) Create a low-rank correction Type.LRC <#petsc4py.PETSc.Mat.Type.LRC> matrix representing A + UCVᵀ.
createNest(mats[, isrows, iscols, comm]) Create a Type.NEST <#petsc4py.PETSc.Mat.Type.NEST> matrix containing multiple submatrices.
createNormal(mat) Create a Type.NORMAL <#petsc4py.PETSc.Mat.Type.NORMAL> matrix representing AᵀA.
createNormalHermitian(mat) Create a Type.NORMALHERMITIAN <#petsc4py.PETSc.Mat.Type.NORMALHERMITIAN> matrix representing (A*)ᵀA.
createPython(size[, context, comm]) Create a Type.PYTHON <#petsc4py.PETSc.Mat.Type.PYTHON> matrix.
createSBAIJ(size, bsize[, nnz, csr, comm]) Create a sparse Type.SBAIJ <#petsc4py.PETSc.Mat.Type.SBAIJ> matrix in symmetric block format.
createScatter(scatter[, comm]) Create a Type.SCATTER <#petsc4py.PETSc.Mat.Type.SCATTER> matrix from a vector scatter.
createSchurComplement(A00, Ap00, A01, A10[, A11]) Create a Type.SCHURCOMPLEMENT <#petsc4py.PETSc.Mat.Type.SCHURCOMPLEMENT> matrix.
createSubMatrices(isrows[, iscols, submats]) Return several sequential submatrices.
createSubMatrix(isrow[, iscol, submat]) Return a submatrix.
createSubMatrixVirtual(A, isrow[, iscol]) Create a Type.SUBMATRIX <#petsc4py.PETSc.Mat.Type.SUBMATRIX> matrix that acts as a submatrix.
createTranspose(mat) Create a Type.TRANSPOSE <#petsc4py.PETSc.Mat.Type.TRANSPOSE> matrix that behaves like Aᵀ.
createVecLeft() Return a left vector, a vector that the matrix vector product can be stored in.
createVecRight() Return a right vector, a vector that the matrix can be multiplied against.
createVecs([side]) Return vectors that can be used in matrix vector products.
destroy() Destroy the matrix.
diagonalScale([L, R]) Perform left and/or right diagonal scaling of the matrix.
duplicate([copy]) Return a clone of the matrix.
equal(mat) Return the result of matrix comparison.
factorCholesky(isperm[, options]) Perform an in-place Cholesky factorization.
factorICC(isperm[, options]) Perform an in-place an incomplete Cholesky factorization.
factorILU(isrow, iscol[, options]) Perform an in-place ILU factorization.
factorLU(isrow, iscol[, options]) Perform an in-place LU factorization.
factorNumericCholesky(mat[, options]) Not implemented.
factorNumericLU(mat[, options]) Not implemented.
factorSymbolicCholesky(isperm[, options]) Not implemented.
factorSymbolicICC(isperm[, options]) Not implemented.
factorSymbolicILU(isrow, iscol[, options]) Not implemented.
factorSymbolicLU(mat, isrow, iscol[, options]) Not implemented.
findZeroRows() Return the index set of empty rows.
fixISLocalEmpty([fix]) Compress out zero local rows from the local matrices.
getBlockSize() Return the matrix block size.
getBlockSizes() Return the row and column block sizes.
getColumnIJ([symmetric, compressed]) Return the CSC representation of the local sparsity pattern.
getColumnVector(column[, result]) Return the columnᵗʰ column vector of the matrix.
getDM() Return the DM defining the data layout of the matrix.
getDenseArray([readonly]) Return the array where the data is stored.
getDenseColumnVec(i[, mode]) Return the iᵗʰ column vector of the dense matrix.
getDenseLDA() Return the leading dimension of the array used by the dense matrix.
getDenseLocalMatrix() Return the local part of the dense matrix.
getDenseSubMatrix([rbegin, rend, cbegin, cend]) Get access to a submatrix of a Type.DENSE <#petsc4py.PETSc.Mat.Type.DENSE> matrix.
getDiagonal([result]) Return the diagonal of the matrix.
getDiagonalBlock() Return the part of the matrix associated with the on-process coupling.
getISAllowRepeated() Get the flag for repeated entries in the local to global map.
getISLocalMat() Return the local matrix stored inside a Type.IS <#petsc4py.PETSc.Mat.Type.IS> matrix.
getInertia() Return the inertia from a factored matrix.
getInfo([info]) Return summary information.
getLGMap() Return the local-to-global mappings.
getLMVMJ0() Get the initial Jacobian of the LMVM matrix.
getLMVMJ0KSP() Get the KSP of the LMVM matrix.
getLRCMats() Return the constituents of a Type.LRC <#petsc4py.PETSc.Mat.Type.LRC> matrix.
getLocalSize() Return the local number of rows and columns.
getLocalSubMatrix(isrow, iscol[, submat]) Return a reference to a submatrix specified in local numbering.
getMumpsCntl(icntl) Return the MUMPS parameter, CNTL[icntl].
getMumpsIcntl(icntl) Return the MUMPS parameter, ICNTL[icntl].
getMumpsInfo(icntl) Return the MUMPS parameter, INFO[icntl].
getMumpsInfog(icntl) Return the MUMPS parameter, INFOG[icntl].
getMumpsRinfo(icntl) Return the MUMPS parameter, RINFO[icntl].
getMumpsRinfog(icntl) Return the MUMPS parameter, RINFOG[icntl].
getNearNullSpace() Return the near-nullspace.
getNestISs() Return the index sets representing the row and column spaces.
getNestLocalISs() Return the local index sets representing the row and column spaces.
getNestSize() Return the number of rows and columns of the matrix.
getNestSubMatrix(i, j) Return a single submatrix.
getNullSpace() Return the nullspace.
getOption(option) Return the option value.
getOptionsPrefix() Return the prefix used for searching for options in the database.
getOrdering(ord_type) Return a reordering for a matrix to improve a LU factorization.
getOwnershipIS() Return the ranges of rows and columns owned by each process as index sets.
getOwnershipRange() Return the locally owned range of rows.
getOwnershipRangeColumn() Return the locally owned range of columns.
getOwnershipRanges() Return the range of rows owned by each process.
getOwnershipRangesColumn() Return the range of columns owned by each process.
getPythonContext() Return the instance of the class implementing the required Python methods.
getPythonType() Return the fully qualified Python name of the class used by the matrix.
getRedundantMatrix(nsubcomm[, subcomm, out]) Return redundant matrices on subcommunicators.
getRow(row) Return the column indices and values for the requested row.
getRowIJ([symmetric, compressed]) Return the CSR representation of the local sparsity pattern.
getRowSum([result]) Return the row-sum vector.
getSchurComplementSubMatrices() Return Schur complement sub-matrices.
getSize() Return the global number of rows and columns.
getSizes() Return the tuple of matrix layouts.
getTransposeMat() Return the internal matrix of a Type.TRANSPOSE <#petsc4py.PETSc.Mat.Type.TRANSPOSE> matrix.
getTransposeNullSpace() Return the transpose nullspace.
getType() Return the type of the matrix.
getValue(row, col) Return the value in the (row, col) position.
getValues(rows, cols[, values]) Return the values in the zip(rows, cols) positions.
getValuesCSR() Return the CSR representation of the local part of the matrix.
getVecType() Return the vector type used by the matrix.
hermitianTranspose([out]) Return the transposed Hermitian matrix.
imagPart([out]) Return the imaginary part of the matrix.
increaseOverlap(iset[, overlap]) Increase the overlap of a index set.
invertBlockDiagonal() Return the inverse of the block-diagonal entries.
isAssembled() The boolean flag indicating if the matrix is assembled.
isHermitian([tol]) Return the boolean indicating if the matrix is Hermitian.
isHermitianKnown() Return the 2-tuple indicating if the matrix is known to be Hermitian.
isLinear([n]) Return whether the Mat is a linear operator.
isStructurallySymmetric() Return the boolean indicating if the matrix is structurally symmetric.
isSymmetric([tol]) Return the boolean indicating if the matrix is symmetric.
isSymmetricKnown() Return the 2-tuple indicating if the matrix is known to be symmetric.
isTranspose([mat, tol]) Return the result of matrix comparison with transposition.
kron(mat[, result]) Compute C, the Kronecker product of A and B.
load(viewer) Load a matrix.
matMatMult(B, C[, result, fill]) Perform matrix-matrix-matrix multiplication D=ABC.
matMult(mat[, result, fill]) Perform matrix-matrix multiplication C=AB.
matSolve(B, X) Solve AX=B, given a factored matrix A.
matTransposeMult(mat[, result, fill]) Perform matrix-matrix multiplication C=ABᵀ.
mult(x, y) Perform the matrix vector product y = A @ x.
multAdd(x, v, y) Perform the matrix vector product with addition y = A @ x + v.
multHermitian(x, y) Perform the Hermitian matrix vector product y = A^H @ x.
multHermitianAdd(x, v, y) Perform the Hermitian matrix vector product with addition y = A^H @ x + v.
multTranspose(x, y) Perform the transposed matrix vector product y = A^T @ x.
multTransposeAdd(x, v, y) Perform the transposed matrix vector product with addition y = A^T @ x + v.
norm([norm_type]) Compute the requested matrix norm.
permute(row, col) Return the permuted matrix.
preallocatorPreallocate(A[, fill]) Preallocate memory for a matrix using a preallocator matrix.
ptap(P[, result, fill]) Creates the matrix product C = PᵀAP.
rart(R[, result, fill]) Create the matrix product C = RARᵀ.
realPart([out]) Return the real part of the matrix.
reorderForNonzeroDiagonal(isrow, iscol[, atol]) Change a matrix ordering to remove zeros from the diagonal.
restoreDenseColumnVec(i[, mode, V]) Restore the iᵗʰ column vector of the dense matrix.
restoreDenseSubMatrix(mat) Restore access to a submatrix of a Type.DENSE <#petsc4py.PETSc.Mat.Type.DENSE> matrix.
restoreISLocalMat(local) Restore the local matrix obtained with getISLocalMat.
restoreLocalSubMatrix(isrow, iscol, submat) Restore a reference to a submatrix obtained with getLocalSubMatrix.
retrieveValues() Retrieve a copy of the matrix values previously stored with storeValues.
scale(alpha) Scale the matrix.
setBlockSize(bsize) Set the matrix block size (same for rows and columns).
setBlockSizes(row_bsize, col_bsize) Set the row and column block sizes.
setDM(dm) Set the DM defining the data layout of the matrix.
setDenseLDA(lda) Set the leading dimension of the array used by the dense matrix.
setDiagonal(diag[, addv]) Set the diagonal values of the matrix.
setFromOptions() Configure the matrix from the options database.
setISAllowRepeated([allow]) Allow repeated entries in the local to global map.
setISLocalMat(local) Set the local matrix stored inside a Type.IS <#petsc4py.PETSc.Mat.Type.IS>.
setISPreallocation(nnz, onnz) Preallocate memory for a Type.IS <#petsc4py.PETSc.Mat.Type.IS> parallel matrix.
setLGMap(rmap[, cmap]) Set the local-to-global mappings.
setLMVMJ0(J0) Set the initial Jacobian of the LMVM matrix.
setLMVMJ0KSP(ksp) Set the KSP of the LMVM matrix.
setLRCMats(A, U[, c, V]) Set the constituents of a Type.LRC <#petsc4py.PETSc.Mat.Type.LRC> matrix.
setMumpsCntl(icntl, val) Set a MUMPS parameter, CNTL[icntl] = val.
setMumpsIcntl(icntl, ival) Set a MUMPS parameter, ICNTL[icntl] = ival.
setNearNullSpace(nsp) Set the near-nullspace.
setNestVecType(vec_type) Set the vector type for a Type.NEST <#petsc4py.PETSc.Mat.Type.NEST> matrix.
setNullSpace(nsp) Set the nullspace.
setOption(option, flag) Set option.
setOptionsPrefix([prefix]) Set the prefix used for searching for options in the database.
setPreallocationCOO(coo_i, coo_j) Set preallocation using coordinate format with global indices.
setPreallocationCOOLocal(coo_i, coo_j) Set preallocation using coordinate format with local indices.
setPreallocationCSR(csr) Preallocate memory for the matrix with a CSR layout.
setPreallocationDense(array) Set the array used for storing matrix elements for a dense matrix.
setPreallocationNNZ(nnz) Preallocate memory for the matrix with a non-zero pattern.
setPythonContext(context) Set the instance of the class implementing the required Python methods.
setPythonType(py_type) Set the fully qualified Python name of the class to be used.
setRandom([random]) Set random values in the matrix.
setSizes(size[, bsize]) Set the local, global and block sizes.
setStencil(dims[, starts, dof]) Set matrix stencil.
setTransposeNullSpace(nsp) Set the transpose nullspace.
setTransposePrecursor(out) Set transpose precursor.
setType(mat_type) Set the matrix type.
setUnfactored() Set a factored matrix to be treated as unfactored.
setUp() Set up the internal data structures for using the matrix.
setValue(row, col, value[, addv]) Set a value to the (row, col) entry of the matrix.
setValueBlockedStagStencil(row, col, value) Not implemented.
setValueBlockedStencil(row, col, value[, addv]) Set a block of values to row and col stencil.
setValueLocal(row, col, value[, addv]) Set a value to the (row, col) entry of the matrix in local ordering.
setValueStagStencil(row, col, value[, addv]) Not implemented.
setValueStencil(row, col, value[, addv]) Set a value to row and col stencil.
setValues(rows, cols, values[, addv]) Set values to the rows ⊗ cols entries of the matrix.
setValuesBlocked(rows, cols, values[, addv]) Set values to the rows ⊗ col block entries of the matrix.
setValuesBlockedCSR(I, J, V[, addv]) Set values stored in block CSR format.
setValuesBlockedIJV(I, J, V[, addv, rowmap]) Set a subset of values stored in block CSR format.
setValuesBlockedLocal(rows, cols, values[, addv]) Set values to the rows ⊗ col block entries of the matrix in local ordering.
setValuesBlockedLocalCSR(I, J, V[, addv]) Set values stored in block CSR format.
setValuesBlockedLocalIJV(I, J, V[, addv, rowmap]) Set a subset of values stored in block CSR format.
setValuesBlockedLocalRCV(R, C, V[, addv]) Undocumented.
setValuesBlockedRCV(R, C, V[, addv]) Undocumented.
setValuesCOO(coo_v[, addv]) Set values after preallocation with coordinate format.
setValuesCSR(I, J, V[, addv]) Set values stored in CSR format.
setValuesIJV(I, J, V[, addv, rowmap]) Set a subset of values stored in CSR format.
setValuesLocal(rows, cols, values[, addv]) Set values to the rows ⊗ col entries of the matrix in local ordering.
setValuesLocalCSR(I, J, V[, addv]) Set values stored in CSR format.
setValuesLocalIJV(I, J, V[, addv, rowmap]) Set a subset of values stored in CSR format.
setValuesLocalRCV(R, C, V[, addv]) Undocumented.
setValuesRCV(R, C, V[, addv]) Undocumented.
setVariableBlockSizes(blocks) Set diagonal point-blocks of the matrix.
setVecType(vec_type) Set the vector type.
shift(alpha) Shift the matrix.
solve(b, x) Solve Ax=b, given a factored matrix.
solveAdd(b, y, x) Solve x=y+A⁻¹b, given a factored matrix.
solveBackward(b, x) Solve Ux=b, given a factored matrix A=LU.
solveForward(b, x) Solve Lx = b, given a factored matrix A = LU.
solveTranspose(b, x) Solve Aᵀx=b, given a factored matrix.
solveTransposeAdd(b, y, x) Solve x=y+A⁻ᵀb, given a factored matrix.
storeValues() Stash a copy of the matrix values.
toDLPack([mode]) Return a DLPack PyCapsule <https://docs.python.org/3/c-api/capsule.html#c.PyCapsule> wrapping the vector data.
transpose([out]) Return the transposed matrix.
transposeMatMult(mat[, result, fill]) Perform matrix-matrix multiplication C=AᵀB.
view([viewer]) View the matrix.
zeroEntries() Zero the entries of the matrix.
zeroRows(rows[, diag, x, b]) Zero selected rows of the matrix.
zeroRowsColumns(rows[, diag, x, b]) Zero selected rows and columns of the matrix.
zeroRowsColumnsLocal(rows[, diag, x, b]) Zero selected rows and columns of the matrix in local ordering.
zeroRowsColumnsStencil(rows[, diag, x, b]) Zero selected rows and columns of the matrix.
zeroRowsLocal(rows[, diag, x, b]) Zero selected rows of the matrix in local ordering.

Attributes Summary

assembled The boolean flag indicating if the matrix is assembled.
block_size Matrix block size.
block_sizes Matrix row and column block sizes.
hermitian The boolean flag indicating if the matrix is Hermitian.
local_size Matrix local size.
owner_range Matrix local row range.
owner_ranges Matrix row ranges.
size Matrix global size.
sizes Matrix local and global sizes.
structsymm The boolean flag indicating if the matrix is structurally symmetric.
symmetric The boolean flag indicating if the matrix is symmetric.

Methods Documentation


Perform a low-rank update of the form self += sUVᵀ.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Mat.pyx:5143 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5143>




Append to the prefix used for searching for options in the database.

Logically collective.

See also:

Working with PETSc options <#petsc-options>, setOptionsPrefix, MatAppendOptionsPrefix <https://petsc.org/release/manualpages/Mat/MatAppendOptionsPrefix.html>


Source code at petsc4py/PETSc/Mat.pyx:1845 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1845>



Assemble the matrix.

Collective.

assembly (MatAssemblySpec <#petsc4py.typing.MatAssemblySpec>) -- The assembly type.
None <https://docs.python.org/3/library/constants.html#None>

See also:

assemblyBegin, assemblyEnd


Source code at petsc4py/PETSc/Mat.pyx:3470 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3470>


Begin an assembling stage of the matrix.

Collective.

assembly (MatAssemblySpec <#petsc4py.typing.MatAssemblySpec>) -- The assembly type.
None <https://docs.python.org/3/library/constants.html#None>

See also:

assemblyEnd, assemble, MatAssemblyBegin <https://petsc.org/release/manualpages/Mat/MatAssemblyBegin.html>


Source code at petsc4py/PETSc/Mat.pyx:3434 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3434>


Complete an assembling stage of the matrix initiated with assemblyBegin.

Collective.

assembly (MatAssemblySpec <#petsc4py.typing.MatAssemblySpec>) -- The assembly type.
None <https://docs.python.org/3/library/constants.html#None>

See also:

assemblyBegin, assemble, MatAssemblyEnd <https://petsc.org/release/manualpages/Mat/MatAssemblyEnd.html>


Source code at petsc4py/PETSc/Mat.pyx:3452 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3452>


Perform the matrix summation self + = ɑ·X.

Collective.

  • alpha (Scalar <#petsc4py.typing.Scalar>) -- The scalar.
  • X (Mat <#petsc4py.PETSc.Mat>) -- The matrix to be added.
  • structure (Structure <#petsc4py.PETSc.Mat.Structure> | None <https://docs.python.org/3/library/constants.html#None>) -- The structure of the operation.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:4285 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4285>


Perform the matrix summation self = ɑ·self + X.

Collective.

  • alpha (Scalar <#petsc4py.typing.Scalar>) -- The scalar.
  • X (Mat <#petsc4py.PETSc.Mat>) -- The matrix to be added.
  • structure (Structure <#petsc4py.PETSc.Mat.Structure> | None <https://docs.python.org/3/library/constants.html#None>) -- The structure of the operation.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:4308 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4308>





Return the conjugate matrix.

Collective.

out (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional return matrix. If None <https://docs.python.org/3/library/constants.html#None>, the operation is performed in-place. Otherwise, the operation is performed on out.
Mat <#petsc4py.PETSc.Mat>

See also:


Source code at petsc4py/PETSc/Mat.pyx:2307 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2307>


Convert the matrix type.

Collective.


Mat <#petsc4py.PETSc.Mat>

See also:


Source code at petsc4py/PETSc/Mat.pyx:2163 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2163>


Return a copy of the matrix.

Collective.


Mat <#petsc4py.PETSc.Mat>

See also:


Source code at petsc4py/PETSc/Mat.pyx:2118 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2118>


Create the matrix.

Collective.

Once created, the user should call setType or setFromOptions before using the matrix. Alternatively, specific creation routines such as createAIJ or createBAIJ can be used.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Mat.pyx:491 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L491>


Create a sparse Type.AIJ <#petsc4py.PETSc.Mat.Type.AIJ> matrix, optionally preallocating.

Collective.

To preallocate the matrix the user can either pass nnz or csr describing the sparsity. If neither is set then preallocation will not occur. Consult the PETSc manual <https://petsc.org/release/manual/mat.html#sec-matsparse> for more information.


Self

See also:


Source code at petsc4py/PETSc/Mat.pyx:696 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L696>


Create a sparse Type.AIJCRL <#petsc4py.PETSc.Mat.Type.AIJCRL> matrix.

Collective.

This is similar to Type.AIJ <#petsc4py.PETSc.Mat.Type.AIJ> matrices but stores some additional information that improves vectorization for the matrix-vector product.

To preallocate the matrix the user can either pass nnz or csr describing the sparsity. If neither is set then preallocation will not occur. Consult the PETSc manual <https://petsc.org/release/manual/mat.html#sec-matsparse> for more information.


Self

See also:


Source code at petsc4py/PETSc/Mat.pyx:829 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L829>


Create a sparse Type.AIJ <#petsc4py.PETSc.Mat.Type.AIJ> matrix with data in CSR format.

Collective.


Self

Notes

For Type.SEQAIJ <#petsc4py.PETSc.Mat.Type.SEQAIJ> matrices, the csr data is not copied. For Type.MPIAIJ <#petsc4py.PETSc.Mat.Type.MPIAIJ> matrices, the csr data is not copied only in the case it represents on-process and off-process information.

See also:


Source code at petsc4py/PETSc/Mat.pyx:1023 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1023>


Create a sparse blocked Type.BAIJ <#petsc4py.PETSc.Mat.Type.BAIJ> matrix, optionally preallocating.

Collective.

To preallocate the matrix the user can either pass nnz or csr describing the sparsity. If neither is set then preallocation will not occur. Consult the PETSc manual <https://petsc.org/release/manual/mat.html#sec-matsparse> for more information.


Self

See also:


Source code at petsc4py/PETSc/Mat.pyx:741 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L741>


Create a diagonal matrix of type Type.CONSTANTDIAGONAL <#petsc4py.PETSc.Mat.Type.CONSTANTDIAGONAL>.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

createDiagonal


Source code at petsc4py/PETSc/Mat.pyx:1655 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1655>


Create a Type.DENSE <#petsc4py.PETSc.Mat.Type.DENSE> matrix.

Collective.


Self

See also:


Source code at petsc4py/PETSc/Mat.pyx:1114 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1114>


Create a Type.DENSECUDA <#petsc4py.PETSc.Mat.Type.DENSECUDA> matrix with optional host and device data.

Collective.


Self

See also:


Source code at petsc4py/PETSc/Mat.pyx:1150 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1150>


Create a diagonal matrix of type Type.DIAGONAL <#petsc4py.PETSc.Mat.Type.DIAGONAL>.

Collective.

diag (Vec <#petsc4py.PETSc.Vec>) -- The vector holding diagonal values.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

createConstantDiagonal


Source code at petsc4py/PETSc/Mat.pyx:1688 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1688>


Create a hierarchical Type.H2OPUS <#petsc4py.PETSc.Mat.Type.H2OPUS> matrix sampling from a provided operator.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

Notes

See MatCreateH2OpusFromMat <https://petsc.org/release/manualpages/Mat/MatCreateH2OpusFromMat.html> for the appropriate database options.

See also:

Working with PETSc options <#petsc-options>, MatCreateH2OpusFromMat <https://petsc.org/release/manualpages/Mat/MatCreateH2OpusFromMat.html>


Source code at petsc4py/PETSc/Mat.pyx:1521 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1521>


Create a Type.HERMITIANTRANSPOSE <#petsc4py.PETSc.Mat.Type.HERMITIANTRANSPOSE> matrix that behaves like (A*)ᵀ.

Collective.

mat (Mat <#petsc4py.PETSc.Mat>) -- Matrix A to represent the hermitian transpose of.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

Notes

The Hermitian transpose is never actually formed.

See also:

createNormal, createNormalHermitian, MATHERMITIANTRANSPOSEVIRTUAL <https://petsc.org/release/manualpages/Mat/MATHERMITIANTRANSPOSEVIRTUAL.html>, MatCreateHermitianTranspose <https://petsc.org/release/manualpages/Mat/MatCreateHermitianTranspose.html>


Source code at petsc4py/PETSc/Mat.pyx:1350 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1350>


Create a Type.IS <#petsc4py.PETSc.Mat.Type.IS> matrix representing globally unassembled operators.

Collective.


Self

See also:


Source code at petsc4py/PETSc/Mat.pyx:1602 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1602>


Create a low-rank correction Type.LRC <#petsc4py.PETSc.Mat.Type.LRC> matrix representing A + UCVᵀ.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

Notes

The matrix A + UCVᵀ is never actually formed.

C is a diagonal matrix (represented as a vector) of order k, where k is the number of columns of both U and V.

If A is None <https://docs.python.org/3/library/constants.html#None> then the new object behaves like a low-rank matrix UCVᵀ.

Use the same matrix for V and U (or V=None) for a symmetric low-rank correction, A + UCUᵀ.

If c is None <https://docs.python.org/3/library/constants.html#None> then the low-rank correction is just U*Vᵀ. If a sequential c vector is used for a parallel matrix, PETSc assumes that the values of the vector are consistently set across processors.

See also:


Source code at petsc4py/PETSc/Mat.pyx:1375 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1375>


Create a Type.NEST <#petsc4py.PETSc.Mat.Type.NEST> matrix containing multiple submatrices.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Mat.pyx:1454 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1454>


Create a Type.NORMAL <#petsc4py.PETSc.Mat.Type.NORMAL> matrix representing AᵀA.

Collective.

mat (Mat <#petsc4py.PETSc.Mat>) -- The (possibly rectangular) matrix A.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

Notes

The product AᵀA is never actually formed. Instead A and Aᵀ are used during mult and various other matrix operations.

See also:


Source code at petsc4py/PETSc/Mat.pyx:1255 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1255>


Create a Type.NORMALHERMITIAN <#petsc4py.PETSc.Mat.Type.NORMALHERMITIAN> matrix representing (A*)ᵀA.

Collective.

mat (Mat <#petsc4py.PETSc.Mat>) -- The (possibly rectangular) matrix A.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

Notes

The product (A*)ᵀA is never actually formed.

See also:


Source code at petsc4py/PETSc/Mat.pyx:1325 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1325>


Create a Type.PYTHON <#petsc4py.PETSc.Mat.Type.PYTHON> matrix.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

PETSc Python matrix type <#petsc-python-mat>, setType, setPythonContext, Type.PYTHON <#petsc4py.PETSc.Mat.Type.PYTHON>


Source code at petsc4py/PETSc/Mat.pyx:1711 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1711>


Create a sparse Type.SBAIJ <#petsc4py.PETSc.Mat.Type.SBAIJ> matrix in symmetric block format.

Collective.

To preallocate the matrix the user can either pass nnz or csr describing the sparsity. If neither is set then preallocation will not occur. Consult the PETSc manual <https://petsc.org/release/manual/mat.html#sec-matsparse> for more information.


Self

See also:



Source code at petsc4py/PETSc/Mat.pyx:785 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L785>


Create a Type.SCATTER <#petsc4py.PETSc.Mat.Type.SCATTER> matrix from a vector scatter.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Mat.pyx:1231 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1231>


Create a Type.SCHURCOMPLEMENT <#petsc4py.PETSc.Mat.Type.SCHURCOMPLEMENT> matrix.

Collective.

  • A00 (Mat <#petsc4py.PETSc.Mat>) -- the upper-left block of the original matrix A = [A00 A01; A10 A11].
  • Ap00 (Mat <#petsc4py.PETSc.Mat>) -- used to construct the preconditioner used in ksp(A00,Ap00) to approximate the action of A00^{-1}.
  • A01 (Mat <#petsc4py.PETSc.Mat>) -- the upper-right block of the original matrix A = [A00 A01; A10 A11].
  • A10 (Mat <#petsc4py.PETSc.Mat>) -- the lower-left block of the original matrix A = [A00 A01; A10 A11].
  • A11 (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional lower-right block of the original matrix A = [A00 A01; A10 A11].

Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Mat.pyx:4101 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4101>


Return several sequential submatrices.

Collective.


Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Mat <#petsc4py.PETSc.Mat>]

See also:


Source code at petsc4py/PETSc/Mat.pyx:4044 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4044>


Return a submatrix.

Collective.


Mat <#petsc4py.PETSc.Mat>

See also:


Source code at petsc4py/PETSc/Mat.pyx:4014 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4014>


Create a Type.SUBMATRIX <#petsc4py.PETSc.Mat.Type.SUBMATRIX> matrix that acts as a submatrix.

Collective.

  • A (Mat <#petsc4py.PETSc.Mat>) -- Matrix to extract submatrix from.
  • isrow (IS <#petsc4py.PETSc.IS>) -- Rows present in the submatrix.
  • iscol (IS <#petsc4py.PETSc.IS> | None <https://docs.python.org/3/library/constants.html#None>) -- Columns present in the submatrix, defaults to isrow.

Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Mat.pyx:1429 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1429>


Create a Type.TRANSPOSE <#petsc4py.PETSc.Mat.Type.TRANSPOSE> matrix that behaves like Aᵀ.

Collective.

mat (Mat <#petsc4py.PETSc.Mat>) -- Matrix A to represent the transpose of.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

Notes

The transpose is never actually formed. Instead multTranspose is called whenever the matrix-vector product is computed.

See also:


Source code at petsc4py/PETSc/Mat.pyx:1280 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1280>


Return a left vector, a vector that the matrix vector product can be stored in.

Collective.

See also:

createVecs, createVecRight, MatCreateVecs <https://petsc.org/release/manualpages/Mat/MatCreateVecs.html>


Source code at petsc4py/PETSc/Mat.pyx:3570 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3570>

Vec <#petsc4py.PETSc.Vec>


Return a right vector, a vector that the matrix can be multiplied against.

Collective.

See also:

createVecs, createVecLeft, MatCreateVecs <https://petsc.org/release/manualpages/Mat/MatCreateVecs.html>


Source code at petsc4py/PETSc/Mat.pyx:3556 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3556>

Vec <#petsc4py.PETSc.Vec>


Return vectors that can be used in matrix vector products.

Collective.

side (Literal <https://docs.python.org/3/library/typing.html#typing.Literal>['r', 'R', 'right', 'Right', 'RIGHT', 'l', 'L', 'left', 'Left', 'LEFT'] | None) -- If None <https://docs.python.org/3/library/constants.html#None> returns a 2-tuple of vectors (right, left). Otherwise it just return a left or right vector.
Vec <#petsc4py.PETSc.Vec> | tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>]

Notes

right vectors are vectors in the column space of the matrix. left vectors are vectors in the row space of the matrix.

See also:

createVecLeft, createVecRight, MatCreateVecs <https://petsc.org/release/manualpages/Mat/MatCreateVecs.html>


Source code at petsc4py/PETSc/Mat.pyx:3517 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3517>



Perform left and/or right diagonal scaling of the matrix.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3709 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3709>


Return a clone of the matrix.

Collective.

copy (DuplicateOption <#petsc4py.PETSc.Mat.DuplicateOption> | bool <https://docs.python.org/3/library/functions.html#bool>) -- If True <https://docs.python.org/3/library/constants.html#True>, it also copies the values.
Mat <#petsc4py.PETSc.Mat>

See also:


Source code at petsc4py/PETSc/Mat.pyx:2098 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2098>


Return the result of matrix comparison.

Collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:2351 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2351>



Perform an in-place Cholesky factorization.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:4816 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4816>


Perform an in-place an incomplete Cholesky factorization.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:4849 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4849>


Perform an in-place ILU factorization.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:4782 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4782>


Perform an in-place LU factorization.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:4744 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4744>







Not implemented.

Source code at petsc4py/PETSc/Mat.pyx:4774 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4774>

  • mat (Mat <#petsc4py.PETSc.Mat>)
  • isrow (IS <#petsc4py.PETSc.IS>)
  • iscol (IS <#petsc4py.PETSc.IS>)

None <https://docs.python.org/3/library/constants.html#None>


Return the index set of empty rows.

Collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:3503 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3503>

IS <#petsc4py.PETSc.IS>


Compress out zero local rows from the local matrices.

Collective.

fix (bool <https://docs.python.org/3/library/functions.html#bool>) -- When True <https://docs.python.org/3/library/constants.html#True>, new local matrices and local to global maps are generated during the final assembly process.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:4949 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4949>




Return the CSC representation of the local sparsity pattern.

Collective.


tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[ArrayInt <#petsc4py.typing.ArrayInt>, ArrayInt <#petsc4py.typing.ArrayInt>]

See also:


Source code at petsc4py/PETSc/Mat.pyx:2629 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2629>


Return the columnᵗʰ column vector of the matrix.

Collective.


Vec <#petsc4py.PETSc.Vec>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3590 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3590>


Return the DM defining the data layout of the matrix.

Not collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:5826 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5826>

DM <#petsc4py.PETSc.DM>


Return the array where the data is stored.

Not collective.

readonly (bool <https://docs.python.org/3/library/functions.html#bool>) -- Enable to obtain a read only array.
ArrayScalar <#petsc4py.typing.ArrayScalar>

See also:


Source code at petsc4py/PETSc/Mat.pyx:5571 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5571>


Return the iᵗʰ column vector of the dense matrix.

Collective.


Vec <#petsc4py.PETSc.Vec>

See also:


Source code at petsc4py/PETSc/Mat.pyx:5677 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5677>


Return the leading dimension of the array used by the dense matrix.

Not collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:5557 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5557>



Return the local part of the dense matrix.

Not collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:5609 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5609>

Mat <#petsc4py.PETSc.Mat>


Get access to a submatrix of a Type.DENSE <#petsc4py.PETSc.Mat.Type.DENSE> matrix.

Collective.


Mat <#petsc4py.PETSc.Mat>

See also:

restoreDenseSubMatrix, MatDenseGetSubMatrix <https://petsc.org/release/manualpages/Mat/MatDenseGetSubMatrix.html>


Source code at petsc4py/PETSc/Mat.pyx:5624 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5624>


Return the diagonal of the matrix.

Collective.

result (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional vector to store the result.
Vec <#petsc4py.PETSc.Vec>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3645 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3645>


Return the part of the matrix associated with the on-process coupling.

Not collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:3986 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3986>

Mat <#petsc4py.PETSc.Mat>


Get the flag for repeated entries in the local to global map.

Not collective.

See also:



Source code at petsc4py/PETSc/Mat.pyx:4935 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4935>



Return the local matrix stored inside a Type.IS <#petsc4py.PETSc.Mat.Type.IS> matrix.

Not collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:4968 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4968>

Mat <#petsc4py.PETSc.Mat>


Return the inertia from a factored matrix.

Collective.

The matrix must have been factored by calling factorCholesky.


See also:


Source code at petsc4py/PETSc/Mat.pyx:4878 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4878>



Return the local-to-global mappings.

Not collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:2916 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2916>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[LGMap <#petsc4py.PETSc.LGMap>, LGMap <#petsc4py.PETSc.LGMap>]


Get the initial Jacobian of the LMVM matrix.

Not collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:5171 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5171>

Mat <#petsc4py.PETSc.Mat>


Get the KSP of the LMVM matrix.

Not collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:5202 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5202>

Mat <#petsc4py.PETSc.Mat>


Return the constituents of a Type.LRC <#petsc4py.PETSc.Mat.Type.LRC> matrix.

Not collective.

  • A (Mat) -- The A matrix.
  • U (Mat) -- The first dense rectangular matrix.
  • c (Vec <#petsc4py.PETSc.Vec>) -- The sequential vector containing the diagonal of C.
  • V (Mat) -- The second dense rectangular matrix.

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>, Vec <#petsc4py.PETSc.Vec>, Mat <#petsc4py.PETSc.Mat>]

See also:


Source code at petsc4py/PETSc/Mat.pyx:5050 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5050>



Return a reference to a submatrix specified in local numbering.

Collective.


Mat <#petsc4py.PETSc.Mat>

See also:

restoreLocalSubMatrix, MatGetLocalSubMatrix <https://petsc.org/release/manualpages/Mat/MatGetLocalSubMatrix.html>


Source code at petsc4py/PETSc/Mat.pyx:4156 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4156>


Return the MUMPS parameter, CNTL[icntl].

Logically collective.

See also:

Working with PETSc options <#petsc-options>, MatMumpsGetCntl <https://petsc.org/release/manualpages/Mat/MatMumpsGetCntl.html>


Source code at petsc4py/PETSc/Mat.pyx:5292 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5292>



Return the MUMPS parameter, ICNTL[icntl].

Logically collective.

See also:

Working with PETSc options <#petsc-options>, MatMumpsGetIcntl <https://petsc.org/release/manualpages/Mat/MatMumpsGetIcntl.html>


Source code at petsc4py/PETSc/Mat.pyx:5256 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5256>




Return the MUMPS parameter, INFOG[icntl].

Logically collective.


See also:


Source code at petsc4py/PETSc/Mat.pyx:5327 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5327>


Return the MUMPS parameter, RINFO[icntl].

Logically collective.


See also:


Source code at petsc4py/PETSc/Mat.pyx:5347 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5347>


Return the MUMPS parameter, RINFOG[icntl].

Logically collective.


See also:


Source code at petsc4py/PETSc/Mat.pyx:5367 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5367>


Return the near-nullspace.

Not collective.

See also:

getNullSpace, setNearNullSpace, MatSetNearNullSpace <https://petsc.org/release/manualpages/Mat/MatSetNearNullSpace.html>


Source code at petsc4py/PETSc/Mat.pyx:3818 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3818>

NullSpace <#petsc4py.PETSc.NullSpace>


Return the index sets representing the row and column spaces.

Not collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:5758 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5758>



Return the local index sets representing the row and column spaces.

Not collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:5779 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5779>




Return a single submatrix.

Not collective.


Mat <#petsc4py.PETSc.Mat>

See also:


Source code at petsc4py/PETSc/Mat.pyx:5800 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5800>


Return the nullspace.

Not collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:3764 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3764>

NullSpace <#petsc4py.PETSc.NullSpace>


Return the option value.

Not collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:1896 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1896>

option (Option <#petsc4py.PETSc.Mat.Option>)
bool <https://docs.python.org/3/library/functions.html#bool>


Return the prefix used for searching for options in the database.

Not collective.

See also:

Working with PETSc options <#petsc-options>, setOptionsPrefix, MatGetOptionsPrefix <https://petsc.org/release/manualpages/Mat/MatGetOptionsPrefix.html>


Source code at petsc4py/PETSc/Mat.pyx:1831 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1831>



Return a reordering for a matrix to improve a LU factorization.

Collective.

ord_type (OrderingType <#petsc4py.PETSc.Mat.OrderingType>) -- The type of reordering.
  • rp (IS <#petsc4py.PETSc.IS>) -- The row permutation indices.
  • cp (IS <#petsc4py.PETSc.IS>) -- The column permutation indices.

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[IS <#petsc4py.PETSc.IS>, IS <#petsc4py.PETSc.IS>]

See also:


Source code at petsc4py/PETSc/Mat.pyx:4688 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4688>


Return the ranges of rows and columns owned by each process as index sets.

Not collective.

See also:

getOwnershipRanges, getOwnershipRangesColumn, MatGetOwnershipIS <https://petsc.org/release/manualpages/Mat/MatGetOwnershipIS.html>


Source code at petsc4py/PETSc/Mat.pyx:2063 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2063>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[IS <#petsc4py.PETSc.IS>, IS <#petsc4py.PETSc.IS>]




Return the range of rows owned by each process.

Not collective.

The returned array is the result of exclusive scan of the local sizes.

See also:


Source code at petsc4py/PETSc/Mat.pyx:2010 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2010>

ArrayInt <#petsc4py.typing.ArrayInt>


Return the range of columns owned by each process.

Not collective.

See also:

getOwnershipRangeColumn, MatGetOwnershipRangesColumn <https://petsc.org/release/manualpages/Mat/MatGetOwnershipRangesColumn.html>


Source code at petsc4py/PETSc/Mat.pyx:2045 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2045>

ArrayInt <#petsc4py.typing.ArrayInt>


Return the instance of the class implementing the required Python methods.

Not collective.

See also:

PETSc Python matrix type <#petsc-python-mat>, setPythonContext


Source code at petsc4py/PETSc/Mat.pyx:1765 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1765>



Return the fully qualified Python name of the class used by the matrix.

Not collective.

See also:

PETSc Python matrix type <#petsc-python-mat>, setPythonContext, setPythonType, MatPythonGetType <https://petsc.org/release/manualpages/Mat/MatPythonGetType.html>


Source code at petsc4py/PETSc/Mat.pyx:1800 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1800>



Return redundant matrices on subcommunicators.

Collective.


Mat <#petsc4py.PETSc.Mat>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3615 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3615>


Return the column indices and values for the requested row.

Not collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:2578 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2578>

row (int <https://docs.python.org/3/library/functions.html#int>)
tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[ArrayInt <#petsc4py.typing.ArrayInt>, ArrayScalar <#petsc4py.typing.ArrayScalar>]


Return the CSR representation of the local sparsity pattern.

Collective.


tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[ArrayInt <#petsc4py.typing.ArrayInt>, ArrayInt <#petsc4py.typing.ArrayInt>]

See also:


Source code at petsc4py/PETSc/Mat.pyx:2598 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2598>


Return the row-sum vector.

Collective.

result (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional vector to store the result.
Vec <#petsc4py.PETSc.Vec>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3667 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3667>


Return Schur complement sub-matrices.

Collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:4135 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4135>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>]



Return the tuple of matrix layouts.

Not collective.

See also:

getLocalSize, getSize


Source code at petsc4py/PETSc/Mat.pyx:1952 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1952>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[LayoutSizeSpec <#petsc4py.typing.LayoutSizeSpec>, LayoutSizeSpec <#petsc4py.typing.LayoutSizeSpec>]


Return the internal matrix of a Type.TRANSPOSE <#petsc4py.PETSc.Mat.Type.TRANSPOSE> matrix.

Not collective.

mat -- Matrix A of type Type.TRANSPOSE <#petsc4py.PETSc.Mat.Type.TRANSPOSE>.
Mat <#petsc4py.PETSc.Mat>

See also:


Source code at petsc4py/PETSc/Mat.pyx:1305 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1305>


Return the transpose nullspace.

Not collective.

See also:

getNullSpace, setTransposeNullSpace, MatGetTransposeNullSpace <https://petsc.org/release/manualpages/Mat/MatGetTransposeNullSpace.html>


Source code at petsc4py/PETSc/Mat.pyx:3791 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3791>

NullSpace <#petsc4py.PETSc.NullSpace>


Return the type of the matrix.

Not collective.

See also:

setType, Type <#petsc4py.PETSc.Mat.Type>, MatGetType <https://petsc.org/release/manualpages/Mat/MatGetType.html>


Source code at petsc4py/PETSc/Mat.pyx:1910 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1910>



Return the value in the (row, col) position.

Not collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:2503 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2503>

Scalar <#petsc4py.typing.Scalar>


Return the values in the zip(rows, cols) positions.

Not collective.


ArrayScalar <#petsc4py.typing.ArrayScalar>

See also:


Source code at petsc4py/PETSc/Mat.pyx:2519 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2519>


Return the CSR representation of the local part of the matrix.

Not collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:2540 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2540>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[ArrayInt <#petsc4py.typing.ArrayInt>, ArrayInt <#petsc4py.typing.ArrayInt>, ArrayScalar <#petsc4py.typing.ArrayScalar>]



Return the transposed Hermitian matrix.

Collective.

out (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional return matrix. If None <https://docs.python.org/3/library/constants.html#None>, inplace transposition is performed. Otherwise, the matrix is reused.
Mat <#petsc4py.PETSc.Mat>

See also:


Source code at petsc4py/PETSc/Mat.pyx:2234 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2234>


Return the imaginary part of the matrix.

Collective.

out (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional return matrix. If None <https://docs.python.org/3/library/constants.html#None>, the operation is performed in-place. Otherwise, the operation is performed on out.
Mat <#petsc4py.PETSc.Mat>

See also:



Source code at petsc4py/PETSc/Mat.pyx:2284 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2284>



Return the inverse of the block-diagonal entries.

Collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:3731 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3731>

ArrayScalar <#petsc4py.typing.ArrayScalar>


The boolean flag indicating if the matrix is assembled.

Not collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:3489 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3489>






Return the boolean indicating if the matrix is structurally symmetric.

Not collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:2458 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2458>





Return the result of matrix comparison with transposition.

Collective.


See also:


Source code at petsc4py/PETSc/Mat.pyx:2365 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2365>


Compute C, the Kronecker product of A and B.

Collective.


result -- The resultant matrix C, the Kronecker product of A and B.
Mat

See also:


Source code at petsc4py/PETSc/Mat.pyx:4617 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4617>



Perform matrix-matrix-matrix multiplication D=ABC.

Neighborwise collective.


result -- The resultant product matrix D.
Mat

See also:


Source code at petsc4py/PETSc/Mat.pyx:4572 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4572>


Perform matrix-matrix multiplication C=AB.

Neighborwise collective.


result -- The resultant product matrix C.
Mat

Notes

To determine the correct fill value, run with -info and search for the string "Fill ratio" to see the value actually needed.

See also:


Source code at petsc4py/PETSc/Mat.pyx:4333 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4333>


Solve AX=B, given a factored matrix A.

Neighborwise collective.

  • B (Mat <#petsc4py.PETSc.Mat>) -- The right-hand side matrix of type Type.DENSE <#petsc4py.PETSc.Mat.Type.DENSE>. Can be of type Type.AIJ <#petsc4py.PETSc.Mat.Type.AIJ> if using MUMPS.
  • X (Mat <#petsc4py.PETSc.Mat>) -- The output solution matrix, must be different than B.

None <https://docs.python.org/3/library/constants.html#None>

See also:

KSP.create <#petsc4py.PETSc.KSP.create>, MatMatSolve <https://petsc.org/release/manualpages/Mat/MatMatSolve.html>


Source code at petsc4py/PETSc/Mat.pyx:5517 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5517>


Perform matrix-matrix multiplication C=ABᵀ.

Neighborwise collective.


result -- The resultant product matrix C.
Mat

Notes

To determine the correct fill value, run with -info and search for the string "Fill ratio" to see the value actually needed.

See also:


Source code at petsc4py/PETSc/Mat.pyx:4380 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4380>


Perform the matrix vector product y = A @ x.

Collective.

  • x (Vec <#petsc4py.PETSc.Vec>) -- The input vector.
  • y (Vec <#petsc4py.PETSc.Vec>) -- The output vector.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3835 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3835>


Perform the matrix vector product with addition y = A @ x + v.

Collective.

  • x (Vec <#petsc4py.PETSc.Vec>) -- The input vector for the matrix-vector product.
  • v (Vec <#petsc4py.PETSc.Vec>) -- The input vector to be added to.
  • y (Vec <#petsc4py.PETSc.Vec>) -- The output vector.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3854 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3854>


Perform the Hermitian matrix vector product y = A^H @ x.

Collective.

  • x (Vec <#petsc4py.PETSc.Vec>) -- The input vector for the Hermitian matrix-vector product.
  • y (Vec <#petsc4py.PETSc.Vec>) -- The output vector.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3915 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3915>


Perform the Hermitian matrix vector product with addition y = A^H @ x + v.

Collective.

  • x (Vec <#petsc4py.PETSc.Vec>) -- The input vector for the Hermitian matrix-vector product.
  • v (Vec <#petsc4py.PETSc.Vec>) -- The input vector to be added to.
  • y (Vec <#petsc4py.PETSc.Vec>) -- The output vector.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3934 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3934>


Perform the transposed matrix vector product y = A^T @ x.

Collective.

  • x (Vec <#petsc4py.PETSc.Vec>) -- The input vector.
  • y (Vec <#petsc4py.PETSc.Vec>) -- The output vector.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3875 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3875>


Perform the transposed matrix vector product with addition y = A^T @ x + v.

Collective.

  • x (Vec <#petsc4py.PETSc.Vec>) -- The input vector for the transposed matrix-vector product.
  • v (Vec <#petsc4py.PETSc.Vec>) -- The input vector to be added to.
  • y (Vec <#petsc4py.PETSc.Vec>) -- The output vector.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3894 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3894>


Compute the requested matrix norm.

Collective.

A 2-tuple is returned if NormType.NORM_1_AND_2 <#petsc4py.PETSc.NormType.NORM_1_AND_2> is specified.

See also:


Source code at petsc4py/PETSc/Mat.pyx:4205 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4205>



Return the permuted matrix.

Collective.

  • row (IS <#petsc4py.PETSc.IS>) -- Row permutation.
  • col (IS <#petsc4py.PETSc.IS>) -- Column permutation.

Mat <#petsc4py.PETSc.Mat>

See also:


Source code at petsc4py/PETSc/Mat.pyx:2330 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2330>


Preallocate memory for a matrix using a preallocator matrix.

Collective.

The current matrix (self) must be of type Type.PREALLOCATOR <#petsc4py.PETSc.Mat.Type.PREALLOCATOR>.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:1000 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1000>


Creates the matrix product C = PᵀAP.

Neighborwise collective.


result -- The resultant product matrix C.
Mat

Notes

To determine the correct fill value, run with -info and search for the string "Fill ratio" to see the value actually needed.

An alternative approach to this function is to use MatProductCreate <https://petsc.org/release/manualpages/Mat/MatProductCreate.html> and set the desired options before the computation is done.

See also:


Source code at petsc4py/PETSc/Mat.pyx:4474 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4474>


Create the matrix product C = RARᵀ.

Neighborwise collective.


result -- The resultant product matrix C.
Mat

Notes

To determine the correct fill value, run with -info and search for the string "Fill ratio" to see the value actually needed.

See also:


Source code at petsc4py/PETSc/Mat.pyx:4525 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4525>


Return the real part of the matrix.

Collective.

out (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional return matrix. If None <https://docs.python.org/3/library/constants.html#None>, the operation is performed in-place. Otherwise, the operation is performed on out.
Mat <#petsc4py.PETSc.Mat>

See also:


Source code at petsc4py/PETSc/Mat.pyx:2261 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2261>


Change a matrix ordering to remove zeros from the diagonal.

Collective.

  • isrow (IS <#petsc4py.PETSc.IS>) -- The row reordering.
  • iscol (IS <#petsc4py.PETSc.IS>) -- The column reordering.
  • atol (float <https://docs.python.org/3/library/functions.html#float>) -- The absolute tolerance. Values along the diagonal whose absolute value are smaller than this tolerance are moved off the diagonal.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:4716 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4716>


Restore the iᵗʰ column vector of the dense matrix.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:5709 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5709>


Restore access to a submatrix of a Type.DENSE <#petsc4py.PETSc.Mat.Type.DENSE> matrix.

Collective.

mat (Mat <#petsc4py.PETSc.Mat>) -- the matrix obtained from getDenseSubMatrix.
None <https://docs.python.org/3/library/constants.html#None>

See also:



Source code at petsc4py/PETSc/Mat.pyx:5658 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5658>


Restore the local matrix obtained with getISLocalMat.

Not collective.

local (Mat <#petsc4py.PETSc.Mat>) -- The local matrix.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:4983 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4983>


Restore a reference to a submatrix obtained with getLocalSubMatrix.

Collective.

  • isrow (IS <#petsc4py.PETSc.IS>) -- Row index set.
  • iscol (IS <#petsc4py.PETSc.IS>) -- Column index set.
  • submat (Mat <#petsc4py.PETSc.Mat>) -- The submatrix.

None <https://docs.python.org/3/library/constants.html#None>

See also:



Source code at petsc4py/PETSc/Mat.pyx:4182 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4182>


Retrieve a copy of the matrix values previously stored with storeValues.

Collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:3422 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3422>




Set the matrix block size (same for rows and columns).

Logically collective.


See also:

setBlockSizes, setSizes, MatSetBlockSize <https://petsc.org/release/manualpages/Mat/MatSetBlockSize.html>


Source code at petsc4py/PETSc/Mat.pyx:589 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L589>



Set the DM defining the data layout of the matrix.

Not collective.

dm (DM <#petsc4py.PETSc.DM>) -- The DM <#petsc4py.PETSc.DM>.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:5843 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5843>


Set the leading dimension of the array used by the dense matrix.

Not collective.


See also:


Source code at petsc4py/PETSc/Mat.pyx:5539 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5539>


Set the diagonal values of the matrix.

Collective.

  • diag (Vec <#petsc4py.PETSc.Vec>) -- Vector storing diagonal values.
  • addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3689 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3689>


Configure the matrix from the options database.

Collective.

See also:

Working with PETSc options <#petsc-options>, MatSetFromOptions <https://petsc.org/release/manualpages/Mat/MatSetFromOptions.html>


Source code at petsc4py/PETSc/Mat.pyx:1859 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1859>



Allow repeated entries in the local to global map.

Logically collective.


See also:



Source code at petsc4py/PETSc/Mat.pyx:4917 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4917>


Set the local matrix stored inside a Type.IS <#petsc4py.PETSc.Mat.Type.IS>.

Not collective.

local (Mat <#petsc4py.PETSc.Mat>) -- The local matrix.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:5000 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5000>


Preallocate memory for a Type.IS <#petsc4py.PETSc.Mat.Type.IS> parallel matrix.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Mat.pyx:5017 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5017>


Set the local-to-global mappings.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:2896 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2896>


Set the initial Jacobian of the LMVM matrix.

Logically collective.

J0 (Mat <#petsc4py.PETSc.Mat>) -- The initial Jacobian matrix.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:5185 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5185>


Set the KSP of the LMVM matrix.

Logically collective.

ksp (KSP <#petsc4py.PETSc.KSP>) -- The KSP.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:5216 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5216>


Set the constituents of a Type.LRC <#petsc4py.PETSc.Mat.Type.LRC> matrix.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:5082 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5082>


Set a MUMPS parameter, CNTL[icntl] = val.

Logically collective.


See also:

Working with PETSc options <#petsc-options>, MatMumpsSetCntl <https://petsc.org/release/manualpages/Mat/MatMumpsSetCntl.html>


Source code at petsc4py/PETSc/Mat.pyx:5271 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5271>


Set a MUMPS parameter, ICNTL[icntl] = ival.

Logically collective.


See also:

Working with PETSc options <#petsc-options>, MatMumpsSetIcntl <https://petsc.org/release/manualpages/Mat/MatMumpsSetIcntl.html>


Source code at petsc4py/PETSc/Mat.pyx:5235 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5235>


Set the near-nullspace.

Collective.

See also:

setNullSpace, getNearNullSpace, MatSetNearNullSpace <https://petsc.org/release/manualpages/Mat/MatSetNearNullSpace.html>


Source code at petsc4py/PETSc/Mat.pyx:3806 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3806>

nsp (NullSpace <#petsc4py.PETSc.NullSpace>)
None <https://docs.python.org/3/library/constants.html#None>


Set the vector type for a Type.NEST <#petsc4py.PETSc.Mat.Type.NEST> matrix.

Collective.

vec_type (Type <#petsc4py.PETSc.Vec.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- Vector type used when creating vectors with createVecs.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:675 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L675>


Set the nullspace.

Collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:3752 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3752>

nsp (NullSpace <#petsc4py.PETSc.NullSpace>)
None <https://docs.python.org/3/library/constants.html#None>



Set the prefix used for searching for options in the database.

Logically collective.

See also:

Working with PETSc options <#petsc-options>, getOptionsPrefix, MatSetOptionsPrefix <https://petsc.org/release/manualpages/Mat/MatSetOptionsPrefix.html>


Source code at petsc4py/PETSc/Mat.pyx:1817 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1817>



Set preallocation using coordinate format with global indices.

Collective.


See also:

setValuesCOO, setPreallocationNNZ, setPreallocationCSR, MatSetPreallocationCOO <https://petsc.org/release/manualpages/Mat/MatSetPreallocationCOO.html>


Source code at petsc4py/PETSc/Mat.pyx:902 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L902>



Preallocate memory for the matrix with a CSR layout.

Collective.

Correct preallocation can result in a dramatic reduction in matrix assembly time.

csr (CSRIndicesSpec <#petsc4py.typing.CSRIndicesSpec>) -- Local matrix data in compressed sparse row layout format.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

Notes

Must use the block-compressed form with Type.BAIJ <#petsc4py.PETSc.Mat.Type.BAIJ> and Type.SBAIJ <#petsc4py.PETSc.Mat.Type.SBAIJ>.

See also:


Source code at petsc4py/PETSc/Mat.pyx:966 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L966>


Set the array used for storing matrix elements for a dense matrix.

Collective.

array (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>]) -- Array that will be used to store matrix data.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Mat.pyx:1207 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1207>


Preallocate memory for the matrix with a non-zero pattern.

Collective.

Correct preallocation can result in a dramatic reduction in matrix assembly time.

nnz (NNZSpec <#petsc4py.typing.NNZSpec>) -- The number of non-zeros per row for the local portion of the matrix, or a 2-tuple for the on-process and off-process part of the matrix.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Mat.pyx:876 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L876>


Set the instance of the class implementing the required Python methods.

Logically collective.

Notes

In order to use the matrix, Mat.setUp must be called after having set the context. Pass None <https://docs.python.org/3/library/constants.html#None> to reset the matrix to its initial state.

See also:

PETSc Python matrix type <#petsc-python-mat>, getPythonContext, setPythonType


Source code at petsc4py/PETSc/Mat.pyx:1748 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1748>



Set the fully qualified Python name of the class to be used.

Collective.

Notes

In order to use the matrix, Mat.setUp must be called after having set the type.

See also:

PETSc Python matrix type <#petsc-python-mat>, setPythonContext, getPythonType, MatPythonSetType <https://petsc.org/release/manualpages/Mat/MatPythonSetType.html>


Source code at petsc4py/PETSc/Mat.pyx:1780 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1780>



Set random values in the matrix.

Collective.

random (Random <#petsc4py.PETSc.Random> | None <https://docs.python.org/3/library/constants.html#None>) -- The random number generator object or None <https://docs.python.org/3/library/constants.html#None> for the default.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:4266 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4266>


Set the local, global and block sizes.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

Examples

Create a Mat with n rows and columns and the same local and global sizes.

>>> mat = PETSc.Mat().create()
>>> mat.setFromOptions()
>>> mat.setSizes(n)

Create a Mat with nr rows, nc columns and the same local and global sizes.

>>> mat = PETSc.Mat().create()
>>> mat.setFromOptions()
>>> mat.setSizes([nr, nc])

Create a Mat with nrl local rows, nrg global rows, ncl local columns and ncg global columns.

>>> mat = PETSc.Mat().create()
>>> mat.setFromOptions()
>>> mat.setSizes([[nrl, nrg], [ncl, ncg]])

See also:


Source code at petsc4py/PETSc/Mat.pyx:536 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L536>



Set the transpose nullspace.

Collective.

See also:

setNullSpace, getTransposeNullSpace, MatSetTransposeNullSpace <https://petsc.org/release/manualpages/Mat/MatSetTransposeNullSpace.html>


Source code at petsc4py/PETSc/Mat.pyx:3779 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3779>

nsp (NullSpace <#petsc4py.PETSc.NullSpace>)
None <https://docs.python.org/3/library/constants.html#None>



Set the matrix type.

Collective.


See also:


Source code at petsc4py/PETSc/Mat.pyx:517 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L517>




Set a value to the (row, col) entry of the matrix.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:2659 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2659>



Set a block of values to row and col stencil.

Not collective.

  • row (Stencil <#petsc4py.PETSc.Mat.Stencil>) -- Row stencil.
  • col (Stencil <#petsc4py.PETSc.Mat.Stencil>) -- Column stencil.
  • value (Sequence[Scalar <#petsc4py.typing.Scalar>]) -- The scalar values.
  • addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3208 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3208>


Set a value to the (row, col) entry of the matrix in local ordering.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:2933 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2933>



Set a value to row and col stencil.

Not collective.

  • row (Stencil <#petsc4py.PETSc.Mat.Stencil>) -- Row stencil.
  • col (Stencil <#petsc4py.PETSc.Mat.Stencil>) -- Column stencil.
  • value (Sequence[Scalar <#petsc4py.typing.Scalar>]) -- The scalar values.
  • addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3174 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3174>


Set values to the rows ⊗ cols entries of the matrix.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:2691 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2691>


Set values to the rows ⊗ col block entries of the matrix.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:2803 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2803>


Set values stored in block CSR format.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:2868 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2868>


Set a subset of values stored in block CSR format.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:2837 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2837>


Set values to the rows ⊗ col block entries of the matrix in local ordering.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3057 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3057>


Set values stored in block CSR format.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3122 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3122>


Set a subset of values stored in block CSR format.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3091 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3091>




Set values after preallocation with coordinate format.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:2754 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2754>




Set values to the rows ⊗ col entries of the matrix in local ordering.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:2966 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2966>


Set values stored in CSR format.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3029 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3029>






Set the vector type.

Collective.

vec_type (Type <#petsc4py.PETSc.Vec.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- Vector type used when creating vectors with createVecs.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:642 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L642>



Solve Ax=b, given a factored matrix.

Neighborwise collective.

The vectors b and x cannot be the same. Most users should employ the KSP <#petsc4py.PETSc.KSP> interface for linear solvers instead of working directly with matrix algebra routines.

  • b (Vec <#petsc4py.PETSc.Vec>) -- The right-hand side vector.
  • x (Vec <#petsc4py.PETSc.Vec>) -- The output solution vector, must be different than b.

None <https://docs.python.org/3/library/constants.html#None>

See also:

KSP.create <#petsc4py.PETSc.KSP.create>, solveTranspose, MatSolve <https://petsc.org/release/manualpages/Mat/MatSolve.html>


Source code at petsc4py/PETSc/Mat.pyx:5427 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5427>


Solve x=y+A⁻¹b, given a factored matrix.

Neighborwise collective.

The vectors b and x cannot be the same.

  • b (Vec <#petsc4py.PETSc.Vec>) -- The right-hand side vector.
  • y (Vec <#petsc4py.PETSc.Vec>) -- The vector to be added
  • x (Vec <#petsc4py.PETSc.Vec>) -- The output solution vector, must be different than b.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:5471 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5471>


Solve Ux=b, given a factored matrix A=LU.

Neighborwise collective.

  • b (Vec <#petsc4py.PETSc.Vec>) -- The right-hand side vector.
  • x (Vec <#petsc4py.PETSc.Vec>) -- The output solution vector.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:5408 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5408>


Solve Lx = b, given a factored matrix A = LU.

Neighborwise collective.

  • b (Vec <#petsc4py.PETSc.Vec>) -- The right-hand side vector.
  • x (Vec <#petsc4py.PETSc.Vec>) -- The output solution vector.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:5389 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5389>


Solve Aᵀx=b, given a factored matrix.

Neighborwise collective.

The vectors b and x cannot be the same.

  • b (Vec <#petsc4py.PETSc.Vec>) -- The right-hand side vector.
  • x (Vec <#petsc4py.PETSc.Vec>) -- The output solution vector, must be different than b.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:5450 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5450>


Solve x=y+A⁻ᵀb, given a factored matrix.

Neighborwise collective.

The vectors b and x cannot be the same.

  • b (Vec <#petsc4py.PETSc.Vec>) -- The right-hand side vector.
  • y (Vec <#petsc4py.PETSc.Vec>) -- The vector to be added
  • x (Vec <#petsc4py.PETSc.Vec>) -- The output solution vector, must be different than b.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:5494 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5494>



Return a DLPack PyCapsule <https://docs.python.org/3/c-api/capsule.html#c.PyCapsule> wrapping the vector data.

Source code at petsc4py/PETSc/Mat.pyx:5931 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5931>

mode (AccessModeSpec <#petsc4py.typing.AccessModeSpec>)
Any <https://docs.python.org/3/library/typing.html#typing.Any>


Return the transposed matrix.

Collective.

out (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional return matrix. If None <https://docs.python.org/3/library/constants.html#None>, inplace transposition is performed. Otherwise, the matrix is reused.
Mat <#petsc4py.PETSc.Mat>

See also:


Source code at petsc4py/PETSc/Mat.pyx:2195 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2195>


Perform matrix-matrix multiplication C=AᵀB.

Neighborwise collective.


result -- The resultant product matrix C.
Mat

Notes

To determine the correct fill value, run with -info and search for the string "Fill ratio" to see the value actually needed.

See also:


Source code at petsc4py/PETSc/Mat.pyx:4427 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4427>


View the matrix.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> instance or None <https://docs.python.org/3/library/constants.html#None> for the default viewer.
None <https://docs.python.org/3/library/constants.html#None>

Notes

Viewers with type Viewer.Type.ASCII <#petsc4py.PETSc.Viewer.Type.ASCII> are only recommended for small matrices on small numbers of processes. Larger matrices should use a binary format like Viewer.Type.BINARY <#petsc4py.PETSc.Viewer.Type.BINARY>.

See also:

load, Viewer <#petsc4py.PETSc.Viewer>, MatView <https://petsc.org/release/manualpages/Mat/MatView.html>


Source code at petsc4py/PETSc/Mat.pyx:453 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L453>



Zero selected rows of the matrix.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3242 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3242>


Zero selected rows and columns of the matrix.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3308 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3308>


Zero selected rows and columns of the matrix in local ordering.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3342 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3342>


Zero selected rows and columns of the matrix.

Collective.

  • rows (Sequence[Stencil <#petsc4py.PETSc.Mat.Stencil>]) -- Iterable of stencil rows and columns.
  • diag (Scalar <#petsc4py.typing.Scalar>) -- Scalar value to be inserted into the diagonal.
  • x (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional solution vector to be modified for zeroed rows.
  • b (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional right-hand side vector to be modified. It will be adjusted with provided solution entries.

None <https://docs.python.org/3/library/constants.html#None>

See also:

zeroRowsLocal, zeroRowsColumns, MatZeroRowsColumnsStencil <https://petsc.org/release/manualpages/Mat/MatZeroRowsColumnsStencil.html>


Source code at petsc4py/PETSc/Mat.pyx:3376 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3376>


Zero selected rows of the matrix in local ordering.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:3275 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3275>


Attributes Documentation

The boolean flag indicating if the matrix is assembled.

Source code at petsc4py/PETSc/Mat.pyx:5906 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5906>



Matrix row and column block sizes.

Source code at petsc4py/PETSc/Mat.pyx:5889 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5889>


The boolean flag indicating if the matrix is Hermitian.

Source code at petsc4py/PETSc/Mat.pyx:5914 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5914>






Matrix local and global sizes.

Source code at petsc4py/PETSc/Mat.pyx:5866 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5866>


The boolean flag indicating if the matrix is structurally symmetric.

Source code at petsc4py/PETSc/Mat.pyx:5918 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5918>


The boolean flag indicating if the matrix is symmetric.

Source code at petsc4py/PETSc/Mat.pyx:5910 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5910>




petsc4py.PETSc.MatPartitioning

Bases: Object <#petsc4py.PETSc.Object>

Object for managing the partitioning of a matrix or graph.

Enumerations

Type <#petsc4py.PETSc.MatPartitioning.Type> The partitioning types.

petsc4py.PETSc.MatPartitioning.Type

Bases: object <https://docs.python.org/3/library/functions.html#object>

The partitioning types.

Attributes Summary

PARTITIONINGAVERAGE Object PARTITIONINGAVERAGE of type str <https://docs.python.org/3/library/stdtypes.html#str>
PARTITIONINGCHACO Object PARTITIONINGCHACO of type str <https://docs.python.org/3/library/stdtypes.html#str>
PARTITIONINGCURRENT Object PARTITIONINGCURRENT of type str <https://docs.python.org/3/library/stdtypes.html#str>
PARTITIONINGHIERARCH Object PARTITIONINGHIERARCH of type str <https://docs.python.org/3/library/stdtypes.html#str>
PARTITIONINGPARMETIS Object PARTITIONINGPARMETIS of type str <https://docs.python.org/3/library/stdtypes.html#str>
PARTITIONINGPARTY Object PARTITIONINGPARTY of type str <https://docs.python.org/3/library/stdtypes.html#str>
PARTITIONINGPTSCOTCH Object PARTITIONINGPTSCOTCH of type str <https://docs.python.org/3/library/stdtypes.html#str>
PARTITIONINGSQUARE Object PARTITIONINGSQUARE of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation










Methods Summary

apply(partitioning) Return a partitioning for the graph represented by a sparse matrix.
create([comm]) Create a partitioning context.
destroy() Destroy the partitioning context.
getType() Return the partitioning method.
setAdjacency(adj) Set the adjacency graph (matrix) of the thing to be partitioned.
setFromOptions() Set parameters in the partitioner from the options database.
setType(matpartitioning_type) Set the type of the partitioner to use.
view([viewer]) View the partitioning data structure.

Methods Documentation

Return a partitioning for the graph represented by a sparse matrix.

Collective.

For each local node this tells the processor number that that node is assigned to.

See also:


Source code at petsc4py/PETSc/MatPartitioning.pyx:144 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/MatPartitioning.pyx#L144>

partitioning (IS <#petsc4py.PETSc.IS>)
None <https://docs.python.org/3/library/constants.html#None>


Create a partitioning context.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/MatPartitioning.pyx:62 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/MatPartitioning.pyx#L62>




Set the adjacency graph (matrix) of the thing to be partitioned.

Collective.

adj (Mat <#petsc4py.PETSc.Mat>) -- The adjacency matrix, this can be any Mat.Type <#petsc4py.PETSc.Mat.Type> but the natural representation is Mat.Type.MPIADJ <#petsc4py.PETSc.Mat.Type.MPIADJ>.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/MatPartitioning.pyx:126 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/MatPartitioning.pyx#L126>


Set parameters in the partitioner from the options database.

Collective.

See also:

Working with PETSc options <#petsc-options>, MatPartitioningSetFromOptions <https://petsc.org/release/manualpages/MatGraphOperations/MatPartitioningSetFromOptions.html>


Source code at petsc4py/PETSc/MatPartitioning.pyx:114 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/MatPartitioning.pyx#L114>



Set the type of the partitioner to use.

Collective.

matpartitioning_type (Type <#petsc4py.PETSc.MatPartitioning.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The partitioner type.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/MatPartitioning.pyx:81 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/MatPartitioning.pyx#L81>


View the partitioning data structure.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the graph.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/MatPartitioning.pyx:29 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/MatPartitioning.pyx#L29>




petsc4py.PETSc.NormType

Bases: object <https://docs.python.org/3/library/functions.html#object>

Norm type.

Commonly used norm types:

The one norm.
The two norm.
The Frobenius norm.
The infinity norm.

See also:


Attributes Summary

FRB Constant FRB of type int <https://docs.python.org/3/library/functions.html#int>
FROBENIUS Constant FROBENIUS of type int <https://docs.python.org/3/library/functions.html#int>
INF Constant INF of type int <https://docs.python.org/3/library/functions.html#int>
INFINITY Constant INFINITY of type int <https://docs.python.org/3/library/functions.html#int>
MAX Constant MAX of type int <https://docs.python.org/3/library/functions.html#int>
N1 Constant N1 of type int <https://docs.python.org/3/library/functions.html#int>
N12 Constant N12 of type int <https://docs.python.org/3/library/functions.html#int>
N2 Constant N2 of type int <https://docs.python.org/3/library/functions.html#int>
NORM_1 Constant NORM_1 of type int <https://docs.python.org/3/library/functions.html#int>
NORM_1_AND_2 Constant NORM_1_AND_2 of type int <https://docs.python.org/3/library/functions.html#int>
NORM_2 Constant NORM_2 of type int <https://docs.python.org/3/library/functions.html#int>
NORM_FROBENIUS Constant NORM_FROBENIUS of type int <https://docs.python.org/3/library/functions.html#int>
NORM_INFINITY Constant NORM_INFINITY of type int <https://docs.python.org/3/library/functions.html#int>
NORM_MAX Constant NORM_MAX of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation
















petsc4py.PETSc.NullSpace

Bases: Object <#petsc4py.PETSc.Object>

Nullspace object.

See also:


Methods Summary

create([constant, vectors, comm]) Create the null space.
createRigidBody(coords) Create rigid body modes from coordinates.
destroy() Destroy the null space.
getFunction() Return the callback to remove the nullspace.
getVecs() Return the vectors defining the null space.
hasConstant() Return whether the null space contains the constant.
remove(vec) Remove all components of a null space from a vector.
setFunction(function[, args, kargs]) Set the callback to remove the nullspace.
test(mat) Return if the claimed null space is valid for a matrix.
view([viewer]) View the null space.

Methods Documentation

Create the null space.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Mat.pyx:6055 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L6055>


Create rigid body modes from coordinates.

Collective.

coords (Vec <#petsc4py.PETSc.Vec>) -- The block coordinates of each node. Requires the block size to have been set.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Mat.pyx:6091 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L6091>



Return the callback to remove the nullspace.

Not collective.

See also:

setFunction


Source code at petsc4py/PETSc/Mat.pyx:6182 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L6182>

MatNullFunction <#petsc4py.typing.MatNullFunction>


Return the vectors defining the null space.

Not collective.

See also:


Source code at petsc4py/PETSc/Mat.pyx:6160 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L6160>




Remove all components of a null space from a vector.

Collective.

vec (Vec <#petsc4py.PETSc.Vec>) -- The vector from which the null space is removed.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Mat.pyx:6196 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L6196>



Return if the claimed null space is valid for a matrix.

Collective.

mat (Mat <#petsc4py.PETSc.Mat>) -- The matrix to check.
bool <https://docs.python.org/3/library/functions.html#bool>

See also:


Source code at petsc4py/PETSc/Mat.pyx:6213 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L6213>


View the null space.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> instance or None <https://docs.python.org/3/library/constants.html#None> for the default viewer.
None <https://docs.python.org/3/library/constants.html#None>

See also:

Viewer <#petsc4py.PETSc.Viewer>, MatNullSpaceView <https://petsc.org/release/manualpages/Mat/MatNullSpaceView.html>


Source code at petsc4py/PETSc/Mat.pyx:6023 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L6023>



petsc4py.PETSc.Object

Bases: object <https://docs.python.org/3/library/functions.html#object>

Base class wrapping a PETSc object.

See also:


Methods Summary

appendOptionsPrefix(prefix) Append to the prefix used for searching for options in the database.
compose(name, obj) Associate a PETSc object using a key string.
decRef() Decrement the object reference count.
destroy() Destroy the object.
destroyOptionsHandlers() Clear all the option handlers.
getAttr(name) Return the attribute associated with a given name.
getClassId() Return the class identifier of the object.
getClassName() Return the class name of the object.
getComm() Return the communicator of the object.
getDict() Return the dictionary of attributes.
getId() Return the unique identifier of the object.
getName() Return the name of the object.
getOptionsPrefix() Return the prefix used for searching for options in the database.
getRefCount() Return the reference count of the object.
getTabLevel() Return the PETSc object tab level.
getType() Return the object type name.
incRef() Increment the object reference count.
incrementTabLevel(tab[, parent]) Increment the PETSc object tab level.
query(name) Query for the PETSc object associated with a key string.
setAttr(name, attr) Set an the attribute associated with a given name.
setFromOptions() Configure the object from the options database.
setName(name) Associate a name to the object.
setOptionsHandler(handler) Set the callback for processing extra options.
setOptionsPrefix(prefix) Set the prefix used for searching for options in the database.
setTabLevel(level) Set the PETSc object tab level.
stateGet() Return the PETSc object state.
stateIncrease() Increment the PETSc object state.
stateSet(state) Set the PETSc object state.
view([viewer]) Display the object.
viewFromOptions(name[, objpre]) View the object via command line options.

Attributes Summary

classid The class identifier.
comm The object communicator.
fortran Fortran handle.
handle Handle for ctypes support.
id The object identifier.
klass The class name.
name The object name.
prefix Options prefix.
refcount Reference count.
type Object type.

Methods Documentation

Append to the prefix used for searching for options in the database.

Logically collective.

See also:

Working with PETSc options <#petsc-options>, setOptionsPrefix, PetscObjectAppendOptionsPrefix <https://petsc.org/release/manualpages/Sys/PetscObjectAppendOptionsPrefix.html>


Source code at petsc4py/PETSc/Object.pyx:138 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L138>



Associate a PETSc object using a key string.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Object.pyx:329 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L329>


Decrement the object reference count.

Logically collective.

See also:


Source code at petsc4py/PETSc/Object.pyx:389 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L389>




Clear all the option handlers.

Collective.

See also:

Working with PETSc options <#petsc-options>, setOptionsHandler, PetscObjectDestroyOptionsHandlers <https://petsc.org/release/manualpages/Sys/PetscObjectDestroyOptionsHandlers.html>


Source code at petsc4py/PETSc/Object.pyx:213 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L213>



Return the attribute associated with a given name.

Not collective.

See also:

setAttr, getDict


Source code at petsc4py/PETSc/Object.pyx:408 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L408>





Return the communicator of the object.

Not collective.

See also:


Source code at petsc4py/PETSc/Object.pyx:228 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L228>

Comm <#petsc4py.PETSc.Comm>


Return the dictionary of attributes.

Not collective.

See also:

setAttr, getAttr


Source code at petsc4py/PETSc/Object.pyx:436 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L436>





Return the prefix used for searching for options in the database.

Not collective.

See also:

Working with PETSc options <#petsc-options>, setOptionsPrefix, PetscObjectGetOptionsPrefix <https://petsc.org/release/manualpages/Sys/PetscObjectGetOptionsPrefix.html>


Source code at petsc4py/PETSc/Object.pyx:124 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L124>




Return the PETSc object tab level.

Not collective.

See also:

setTabLevel, incrementTabLevel, PetscObjectGetTabLevel <https://petsc.org/release/manualpages/Sys/PetscObjectGetTabLevel.html>


Source code at petsc4py/PETSc/Object.pyx:518 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L518>




Increment the object reference count.

Logically collective.

See also:


Source code at petsc4py/PETSc/Object.pyx:372 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L372>




Query for the PETSc object associated with a key string.

Not collective.

See also:


Source code at petsc4py/PETSc/Object.pyx:352 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L352>

name (str <https://docs.python.org/3/library/stdtypes.html#str>)
Object <#petsc4py.PETSc.Object>



Configure the object from the options database.

Collective.

Classes that do not implement setFromOptions use this method that, in turn, calls PetscObjectSetFromOptions <https://petsc.org/release/manualpages/Sys/PetscObjectSetFromOptions.html>.

See also:

Working with PETSc options <#petsc-options>, PetscObjectSetFromOptions <https://petsc.org/release/manualpages/Sys/PetscObjectSetFromOptions.html>


Source code at petsc4py/PETSc/Object.pyx:152 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L152>




Set the callback for processing extra options.

Logically collective.

handler (PetscOptionsHandlerFunction <#petsc4py.typing.PetscOptionsHandlerFunction> | None <https://docs.python.org/3/library/constants.html#None>) -- The callback function, called at the end of a setFromOptions invocation for the given class.
None <https://docs.python.org/3/library/constants.html#None>

See also:

Working with PETSc options <#petsc-options>, Mat.setFromOptions <#petsc4py.PETSc.Mat.setFromOptions>, KSP.setFromOptions <#petsc4py.PETSc.KSP.setFromOptions>, PetscObjectAddOptionsHandler <https://petsc.org/release/manualpages/Sys/PetscObjectAddOptionsHandler.html>


Source code at petsc4py/PETSc/Object.pyx:190 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L190>


Set the prefix used for searching for options in the database.

Logically collective.

See also:

Working with PETSc options <#petsc-options>, getOptionsPrefix, PetscObjectSetOptionsPrefix <https://petsc.org/release/manualpages/Sys/PetscObjectSetOptionsPrefix.html>


Source code at petsc4py/PETSc/Object.pyx:110 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L110>




Return the PETSc object state.

Not collective.

See also:

stateSet, stateIncrease, PetscObjectStateGet <https://petsc.org/release/manualpages/Sys/PetscObjectStateGet.html>


Source code at petsc4py/PETSc/Object.pyx:462 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L462>



Increment the PETSc object state.

Logically collective.

See also:



Source code at petsc4py/PETSc/Object.pyx:450 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L450>




Display the object.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> instance or None <https://docs.python.org/3/library/constants.html#None> for the default viewer.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Object.pyx:62 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L62>


View the object via command line options.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

Working with PETSc options <#petsc-options>, PetscObjectViewFromOptions <https://petsc.org/release/manualpages/Sys/PetscObjectViewFromOptions.html>


Source code at petsc4py/PETSc/Object.pyx:167 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L167>


Attributes Documentation

The class identifier.

Source code at petsc4py/PETSc/Object.pyx:563 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L563>


The object communicator.

Source code at petsc4py/PETSc/Object.pyx:550 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L550>



Handle for ctypes support.

Source code at petsc4py/PETSc/Object.pyx:585 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L585>


The object identifier.

Source code at petsc4py/PETSc/Object.pyx:568 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L568>








petsc4py.PETSc.Options

Bases: object <https://docs.python.org/3/library/functions.html#object>

The options database object.

A dictionary-like object to store and operate with command line options.

prefix (str <https://docs.python.org/3/library/stdtypes.html#str>, optional) -- Optional string to prepend to all the options.

Examples

Create an option database and operate with it.

>>> from petsc4py import PETSc
>>> opts = PETSc.Options()
>>> opts['a'] = 1 # insert the command-line option '-a 1'
>>> if 'a' in opts: # if the option is present
>>>     val = opts['a'] # return the option value as 'str'
>>> a_int = opts.getInt('a') # return the option value as 'int'
>>> a_bool = opts.getBool('a') # return the option value as 'bool'

Read command line and use default values.

>>> from petsc4py import PETSc
>>> opts = PETSc.Options()
>>> b_float = opts.getReal('b', 1) # return the value or 1.0 if not present

Read command line options prepended with a prefix.

>>> from petsc4py import PETSc
>>> opts = PETSc.Options('prefix_')
>>> opts.getString('b', 'some_default_string') # read -prefix_b xxx

See also:

Working with PETSc options <#petsc-options>


Methods Summary

clear() Clear an options database.
create() Create an options database.
delValue(name) Delete an option from the database.
destroy() Destroy an options database.
getAll() Return all the options and their values.
getBool(name[, default]) Return the boolean value associated with the option.
getBoolArray(name[, default]) Return the boolean values associated with the option.
getInt(name[, default]) Return the integer value associated with the option.
getIntArray(name[, default]) Return the integer array associated with the option.
getReal(name[, default]) Return the real value associated with the option.
getRealArray(name[, default]) Return the real array associated with the option.
getScalar(name[, default]) Return the scalar value associated with the option.
getScalarArray(name[, default]) Return the scalar array associated with the option.
getString(name[, default]) Return the string associated with the option.
hasName(name) Return the boolean indicating if the option is in the database.
insertString(string) Insert a string in the options database.
prefixPop() Pop a prefix for the options database.
prefixPush(prefix) Push a prefix for the options database.
setValue(name, value) Set a value for an option.
used(name) Return the boolean indicating if the option was queried from the database.
view([viewer]) View the options database.

Attributes Summary

prefix Prefix for options.

Methods Documentation






Return the boolean value associated with the option.

Not collective.


See also:


Source code at petsc4py/PETSc/Options.pyx:226 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L226>


Return the boolean values associated with the option.

Not collective.


ArrayBool <#petsc4py.typing.ArrayBool>

See also:


Source code at petsc4py/PETSc/Options.pyx:246 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L246>


Return the integer value associated with the option.

Not collective.


See also:


Source code at petsc4py/PETSc/Options.pyx:266 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L266>


Return the integer array associated with the option.

Not collective.


ArrayInt <#petsc4py.typing.ArrayInt>

See also:


Source code at petsc4py/PETSc/Options.pyx:286 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L286>


Return the real value associated with the option.

Not collective.


See also:


Source code at petsc4py/PETSc/Options.pyx:306 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L306>


Return the real array associated with the option.

Not collective.


ArrayReal <#petsc4py.typing.ArrayReal>

See also:


Source code at petsc4py/PETSc/Options.pyx:326 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L326>


Return the scalar value associated with the option.

Not collective.


Scalar <#petsc4py.typing.Scalar>

See also:


Source code at petsc4py/PETSc/Options.pyx:346 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L346>


Return the scalar array associated with the option.

Not collective.


ArrayScalar <#petsc4py.typing.ArrayScalar>

See also:


Source code at petsc4py/PETSc/Options.pyx:366 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L366>





Pop a prefix for the options database.

Logically collective.

See also:


Source code at petsc4py/PETSc/Options.pyx:131 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L131>



Push a prefix for the options database.

Logically collective.

See also:


Source code at petsc4py/PETSc/Options.pyx:116 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L116>





View the options database.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> instance or None <https://docs.python.org/3/library/constants.html#None> for the default viewer.
None <https://docs.python.org/3/library/constants.html#None>

See also:

Viewer <#petsc4py.PETSc.Viewer>, PetscOptionsView <https://petsc.org/release/manualpages/Sys/PetscOptionsView.html>


Source code at petsc4py/PETSc/Options.pyx:97 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L97>


Attributes Documentation



petsc4py.PETSc.PC

Bases: Object <#petsc4py.PETSc.Object>

Preconditioners.

PC is described in the PETSc manual <https://petsc.org/release/manual/ksp.html#sec-ksppc>. Calling the PC with a vector as an argument will apply the preconditioner as shown in the example below.

Examples

>>> from petsc4py import PETSc
>>> v = PETSc.Vec().createWithArray([1, 2])
>>> m = PETSc.Mat().createDense(2, array=[[1, 0], [0, 1]])
>>> pc = PETSc.PC().create()
>>> pc.setOperators(m)
>>> u = pc(v) # u is created internally
>>> pc.apply(v, u) # u can also be passed as second argument
    

See also:


Enumerations

ASMType <#petsc4py.PETSc.PC.ASMType> The ASM subtype.
CompositeType <#petsc4py.PETSc.PC.CompositeType> The composite type.
DeflationSpaceType <#petsc4py.PETSc.PC.DeflationSpaceType> The deflation space subtype.
FailedReason <#petsc4py.PETSc.PC.FailedReason> The reason the preconditioner has failed.
FieldSplitSchurFactType <#petsc4py.PETSc.PC.FieldSplitSchurFactType> The field split Schur factorization type.
FieldSplitSchurPreType <#petsc4py.PETSc.PC.FieldSplitSchurPreType> The field split Schur subtype.
GAMGType <#petsc4py.PETSc.PC.GAMGType> The GAMG subtype.
GASMType <#petsc4py.PETSc.PC.GASMType> The GASM subtype.
HPDDMCoarseCorrectionType <#petsc4py.PETSc.PC.HPDDMCoarseCorrectionType> The HPDDM coarse correction type.
MGCycleType <#petsc4py.PETSc.PC.MGCycleType> The MG cycle type.
MGType <#petsc4py.PETSc.PC.MGType> The MG subtype.
PatchConstructType <#petsc4py.PETSc.PC.PatchConstructType> The patch construction type.
Side <#petsc4py.PETSc.PC.Side> The manner in which the preconditioner is applied.
Type <#petsc4py.PETSc.PC.Type> The preconditioner method.

petsc4py.PETSc.PC.ASMType


petsc4py.PETSc.PC.CompositeType

Bases: object <https://docs.python.org/3/library/functions.html#object>

The composite type.

Attributes Summary

ADDITIVE Constant ADDITIVE of type int <https://docs.python.org/3/library/functions.html#int>
MULTIPLICATIVE Constant MULTIPLICATIVE of type int <https://docs.python.org/3/library/functions.html#int>
SCHUR Constant SCHUR of type int <https://docs.python.org/3/library/functions.html#int>
SPECIAL Constant SPECIAL of type int <https://docs.python.org/3/library/functions.html#int>
SYMMETRIC_MULTIPLICATIVE Constant SYMMETRIC_MULTIPLICATIVE of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation







petsc4py.PETSc.PC.DeflationSpaceType

Bases: object <https://docs.python.org/3/library/functions.html#object>

The deflation space subtype.

Attributes Summary

AGGREGATION Constant AGGREGATION of type int <https://docs.python.org/3/library/functions.html#int>
BIORTH22 Constant BIORTH22 of type int <https://docs.python.org/3/library/functions.html#int>
DB16 Constant DB16 of type int <https://docs.python.org/3/library/functions.html#int>
DB2 Constant DB2 of type int <https://docs.python.org/3/library/functions.html#int>
DB4 Constant DB4 of type int <https://docs.python.org/3/library/functions.html#int>
DB8 Constant DB8 of type int <https://docs.python.org/3/library/functions.html#int>
HAAR Constant HAAR of type int <https://docs.python.org/3/library/functions.html#int>
MEYER Constant MEYER of type int <https://docs.python.org/3/library/functions.html#int>
USER Constant USER of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation











petsc4py.PETSc.PC.FailedReason

Bases: object <https://docs.python.org/3/library/functions.html#object>

The reason the preconditioner has failed.

Attributes Summary

FACTOR_NUMERIC_ZEROPIVOT Constant FACTOR_NUMERIC_ZEROPIVOT of type int <https://docs.python.org/3/library/functions.html#int>
FACTOR_OTHER Constant FACTOR_OTHER of type int <https://docs.python.org/3/library/functions.html#int>
FACTOR_OUTMEMORY Constant FACTOR_OUTMEMORY of type int <https://docs.python.org/3/library/functions.html#int>
FACTOR_STRUCT_ZEROPIVOT Constant FACTOR_STRUCT_ZEROPIVOT of type int <https://docs.python.org/3/library/functions.html#int>
NOERROR Constant NOERROR of type int <https://docs.python.org/3/library/functions.html#int>
SETUP_ERROR Constant SETUP_ERROR of type int <https://docs.python.org/3/library/functions.html#int>
SUBPC_ERROR Constant SUBPC_ERROR of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation









petsc4py.PETSc.PC.FieldSplitSchurFactType


petsc4py.PETSc.PC.FieldSplitSchurPreType


petsc4py.PETSc.PC.GAMGType


petsc4py.PETSc.PC.GASMType


petsc4py.PETSc.PC.HPDDMCoarseCorrectionType


petsc4py.PETSc.PC.MGCycleType


petsc4py.PETSc.PC.MGType


petsc4py.PETSc.PC.PatchConstructType


petsc4py.PETSc.PC.Side

Bases: object <https://docs.python.org/3/library/functions.html#object>

The manner in which the preconditioner is applied.

Attributes Summary

L Constant L of type int <https://docs.python.org/3/library/functions.html#int>
LEFT Constant LEFT of type int <https://docs.python.org/3/library/functions.html#int>
R Constant R of type int <https://docs.python.org/3/library/functions.html#int>
RIGHT Constant RIGHT of type int <https://docs.python.org/3/library/functions.html#int>
S Constant S of type int <https://docs.python.org/3/library/functions.html#int>
SYMMETRIC Constant SYMMETRIC of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation








petsc4py.PETSc.PC.Type

Bases: object <https://docs.python.org/3/library/functions.html#object>

The preconditioner method.

Attributes Summary

ASM Object ASM of type str <https://docs.python.org/3/library/stdtypes.html#str>
BDDC Object BDDC of type str <https://docs.python.org/3/library/stdtypes.html#str>
BJACOBI Object BJACOBI of type str <https://docs.python.org/3/library/stdtypes.html#str>
CHOLESKY Object CHOLESKY of type str <https://docs.python.org/3/library/stdtypes.html#str>
CHOWILUVIENNACL Object CHOWILUVIENNACL of type str <https://docs.python.org/3/library/stdtypes.html#str>
COMPOSITE Object COMPOSITE of type str <https://docs.python.org/3/library/stdtypes.html#str>
CP Object CP of type str <https://docs.python.org/3/library/stdtypes.html#str>
DEFLATION Object DEFLATION of type str <https://docs.python.org/3/library/stdtypes.html#str>
EISENSTAT Object EISENSTAT of type str <https://docs.python.org/3/library/stdtypes.html#str>
EXOTIC Object EXOTIC of type str <https://docs.python.org/3/library/stdtypes.html#str>
FIELDSPLIT Object FIELDSPLIT of type str <https://docs.python.org/3/library/stdtypes.html#str>
GALERKIN Object GALERKIN of type str <https://docs.python.org/3/library/stdtypes.html#str>
GAMG Object GAMG of type str <https://docs.python.org/3/library/stdtypes.html#str>
GASM Object GASM of type str <https://docs.python.org/3/library/stdtypes.html#str>
H2OPUS Object H2OPUS of type str <https://docs.python.org/3/library/stdtypes.html#str>
HMG Object HMG of type str <https://docs.python.org/3/library/stdtypes.html#str>
HPDDM Object HPDDM of type str <https://docs.python.org/3/library/stdtypes.html#str>
HYPRE Object HYPRE of type str <https://docs.python.org/3/library/stdtypes.html#str>
ICC Object ICC of type str <https://docs.python.org/3/library/stdtypes.html#str>
ILU Object ILU of type str <https://docs.python.org/3/library/stdtypes.html#str>
JACOBI Object JACOBI of type str <https://docs.python.org/3/library/stdtypes.html#str>
KACZMARZ Object KACZMARZ of type str <https://docs.python.org/3/library/stdtypes.html#str>
KSP Object KSP of type str <https://docs.python.org/3/library/stdtypes.html#str>
LMVM Object LMVM of type str <https://docs.python.org/3/library/stdtypes.html#str>
LSC Object LSC of type str <https://docs.python.org/3/library/stdtypes.html#str>
LU Object LU of type str <https://docs.python.org/3/library/stdtypes.html#str>
MAT Object MAT of type str <https://docs.python.org/3/library/stdtypes.html#str>
MG Object MG of type str <https://docs.python.org/3/library/stdtypes.html#str>
ML Object ML of type str <https://docs.python.org/3/library/stdtypes.html#str>
NN Object NN of type str <https://docs.python.org/3/library/stdtypes.html#str>
NONE Object NONE of type str <https://docs.python.org/3/library/stdtypes.html#str>
PARMS Object PARMS of type str <https://docs.python.org/3/library/stdtypes.html#str>
PATCH Object PATCH of type str <https://docs.python.org/3/library/stdtypes.html#str>
PBJACOBI Object PBJACOBI of type str <https://docs.python.org/3/library/stdtypes.html#str>
PFMG Object PFMG of type str <https://docs.python.org/3/library/stdtypes.html#str>
PYTHON Object PYTHON of type str <https://docs.python.org/3/library/stdtypes.html#str>
QR Object QR of type str <https://docs.python.org/3/library/stdtypes.html#str>
REDISTRIBUTE Object REDISTRIBUTE of type str <https://docs.python.org/3/library/stdtypes.html#str>
REDUNDANT Object REDUNDANT of type str <https://docs.python.org/3/library/stdtypes.html#str>
ROWSCALINGVIENNACL Object ROWSCALINGVIENNACL of type str <https://docs.python.org/3/library/stdtypes.html#str>
SAVIENNACL Object SAVIENNACL of type str <https://docs.python.org/3/library/stdtypes.html#str>
SHELL Object SHELL of type str <https://docs.python.org/3/library/stdtypes.html#str>
SOR Object SOR of type str <https://docs.python.org/3/library/stdtypes.html#str>
SPAI Object SPAI of type str <https://docs.python.org/3/library/stdtypes.html#str>
SVD Object SVD of type str <https://docs.python.org/3/library/stdtypes.html#str>
SYSPFMG Object SYSPFMG of type str <https://docs.python.org/3/library/stdtypes.html#str>
TELESCOPE Object TELESCOPE of type str <https://docs.python.org/3/library/stdtypes.html#str>
TFS Object TFS of type str <https://docs.python.org/3/library/stdtypes.html#str>
VPBJACOBI Object VPBJACOBI of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation



















































Methods Summary

addCompositePCType(pc_type) Add a PC of the given type to the composite PC.
appendOptionsPrefix(prefix) Append to the prefix used for all the PC options.
apply(x, y) Apply the PC to a vector.
applySymmetricLeft(x, y) Apply the left part of a symmetric PC to a vector.
applySymmetricRight(x, y) Apply the right part of a symmetric PC to a vector.
applyTranspose(x, y) Apply the transpose of the PC to a vector.
create([comm]) Create an empty PC.
createPython([context, comm]) Create a preconditioner of Python type.
destroy() Destroy the PC that was created with create.
getASMSubKSP() Return the local KSP <#petsc4py.PETSc.KSP> object for all blocks on this process.
getBJacobiSubKSP() Return the local KSP <#petsc4py.PETSc.KSP> object for all blocks on this process.
getCompositePC(n) Return a component of the composite PC.
getDM() Return the DM <#petsc4py.PETSc.DM> associated with the PC.
getDeflationCoarseKSP() Return the coarse problem KSP <#petsc4py.PETSc.KSP>.
getDeflationPC() Return the additional preconditioner.
getFactorMatrix() Return the factored matrix.
getFactorSolverType() Return the solver package used to perform the factorization.
getFailedReason() Return the reason the PC terminated.
getFieldSplitSchurGetSubKSP() Return the KSP <#petsc4py.PETSc.KSP> for the Schur complement based splits.
getFieldSplitSubIS(splitname) Return the IS <#petsc4py.PETSc.IS> associated with a given name.
getFieldSplitSubKSP() Return the KSP <#petsc4py.PETSc.KSP> for all splits.
getHPDDMCoarseCorrectionType() Return the coarse correction type.
getHPDDMComplexities() Compute the grid and operator complexities.
getHPDDMSTShareSubKSP() Return true if the KSP <#petsc4py.PETSc.KSP> in SLEPc ST and the subdomain solver is shared.
getHYPREType() Return the Type.HYPRE <#petsc4py.PETSc.PC.Type.HYPRE> type.
getKSP() Return the KSP <#petsc4py.PETSc.KSP> if the PC is Type.KSP <#petsc4py.PETSc.PC.Type.KSP>.
getMGCoarseSolve() Return the KSP <#petsc4py.PETSc.KSP> used on the coarse grid.
getMGInterpolation(level) Return the interpolation operator for the given level.
getMGLevels() Return the number of MG <#petsc4py.PETSc.PC.Type.MG> levels.
getMGRScale(level) Return the pointwise scaling for the restriction operator on the given level.
getMGRestriction(level) Return the restriction operator for the given level.
getMGSmoother(level) Return the KSP <#petsc4py.PETSc.KSP> to be used as a smoother.
getMGSmootherDown(level) Return the KSP <#petsc4py.PETSc.KSP> to be used as a smoother before coarse grid correction.
getMGSmootherUp(level) Return the KSP <#petsc4py.PETSc.KSP> to be used as a smoother after coarse grid correction.
getMGType() Return the form of multigrid.
getOperators() Return the matrices associated with a linear system.
getOptionsPrefix() Return the prefix used for all the PC options.
getPatchSubKSP() Return the local KSP <#petsc4py.PETSc.KSP> object for all blocks on this process.
getPythonContext() Return the instance of the class implementing the required Python methods.
getPythonType() Return the fully qualified Python name of the class used by the preconditioner.
getType() Return the preconditioner type.
getUseAmat() Return the flag to indicate if PC is applied to A or P.
matApply(x, y) Apply the PC to many vectors stored as Mat.Type.DENSE <#petsc4py.PETSc.Mat.Type.DENSE>.
matApplyTranspose(x, y) Apply the transpose of the PC to many vectors stored as Mat.Type.DENSE <#petsc4py.PETSc.Mat.Type.DENSE>.
reset() Reset the PC, removing any allocated vectors and matrices.
setASMLocalSubdomains(nsd[, is_sub, is_local]) Set the local subdomains.
setASMOverlap(overlap) Set the overlap between a pair of subdomains.
setASMSortIndices(dosort) Set to sort subdomain indices.
setASMTotalSubdomains(nsd[, is_sub, is_local]) Set the subdomains for all processes.
setASMType(asmtype) Set the type of restriction and interpolation.
setBDDCChangeOfBasisMat(T[, interior]) Set a user defined change of basis for degrees of freedom.
setBDDCCoarseningRatio(cratio) Set the coarsening ratio used in the multilevel version.
setBDDCDirichletBoundaries(bndr) Set the IS <#petsc4py.PETSc.IS> defining Dirichlet boundaries for the global problem.
setBDDCDirichletBoundariesLocal(bndr) Set the IS <#petsc4py.PETSc.IS> defining Dirichlet boundaries in local ordering.
setBDDCDiscreteGradient(G[, order, field, ...]) Set the discrete gradient.
setBDDCDivergenceMat(div[, trans, l2l]) Set the linear operator representing ∫ div(u)•p dx.
setBDDCDofsSplitting(isfields) Set the index set(s) defining fields of the global matrix.
setBDDCDofsSplittingLocal(isfields) Set the index set(s) defining fields of the local subdomain matrix.
setBDDCLevels(levels) Set the maximum number of additional levels allowed.
setBDDCLocalAdjacency(csr) Provide a custom connectivity graph for local dofs.
setBDDCNeumannBoundaries(bndr) Set the IS <#petsc4py.PETSc.IS> defining Neumann boundaries for the global problem.
setBDDCNeumannBoundariesLocal(bndr) Set the IS <#petsc4py.PETSc.IS> defining Neumann boundaries in local ordering.
setBDDCPrimalVerticesIS(primv) Set additional user defined primal vertices.
setBDDCPrimalVerticesLocalIS(primv) Set additional user defined primal vertices.
setCompositeType(ctype) Set the type of composite preconditioner.
setCoordinates(coordinates) Set the coordinates for the nodes on the local process.
setDM(dm) Set the DM <#petsc4py.PETSc.DM> that may be used by some preconditioners.
setDeflationCoarseMat(mat) Set the coarse problem matrix.
setDeflationCorrectionFactor(fact) Set the coarse problem correction factor.
setDeflationInitOnly(flg) Set to only perform the initialization.
setDeflationLevels(levels) Set the maximum level of deflation nesting.
setDeflationProjectionNullSpaceMat(mat) Set the projection null space matrix.
setDeflationReductionFactor(red) Set the reduction factor for the preconditioner.
setDeflationSpace(W, transpose) Set the deflation space matrix or its (Hermitian) transpose.
setDeflationSpaceToCompute(space_type, size) Set the deflation space type.
setFactorLevels(levels) Set the number of levels of fill.
setFactorOrdering([ord_type, nzdiag, reuse]) Set options for the matrix factorization reordering.
setFactorPivot([zeropivot, inblocks]) Set options for matrix factorization pivoting.
setFactorSetUpSolverType() Set up the factorization solver.
setFactorShift([shift_type, amount]) Set options for shifting diagonal entries of a matrix.
setFactorSolverType(solver) Set the solver package used to perform the factorization.
setFailedReason(reason) Set the reason the PC terminated.
setFieldSplitFields(bsize, *fields) Sets the elements for the field split.
setFieldSplitIS(*fields) Set the elements for the field split by IS <#petsc4py.PETSc.IS>.
setFieldSplitSchurFactType(ctype) Set the type of approximate block factorization.
setFieldSplitSchurPreType(ptype[, pre]) Set from what operator the PC is constructed.
setFieldSplitType(ctype) Set the type of composition of a field split preconditioner.
setFromOptions() Set various PC parameters from user options.
setGAMGLevels(levels) Set the maximum number of levels.
setGAMGSmooths(smooths) Set the number of smoothing steps used on all levels.
setGAMGType(gamgtype) Set the type of algorithm.
setGASMOverlap(overlap) Set the overlap between a pair of subdomains.
setGASMType(gasmtype) Set the type of restriction and interpolation.
setHPDDMAuxiliaryMat(uis, uaux) Set the auxiliary matrix used by the preconditioner.
setHPDDMCoarseCorrectionType(correction_type) Set the coarse correction type.
setHPDDMDeflationMat(uis, U) Set the deflation space used to assemble a coarse operator.
setHPDDMHasNeumannMat(has) Set to indicate that the Mat <#petsc4py.PETSc.Mat> passed to the PC is the local Neumann matrix.
setHPDDMRHSMat(B) Set the right-hand side matrix of the preconditioner.
setHYPREAMSSetInteriorNodes(interior) Set the list of interior nodes to a zero conductivity region.
setHYPREDiscreteCurl(mat) Set the discrete curl matrix.
setHYPREDiscreteGradient(mat) Set the discrete gradient matrix.
setHYPRESetAlphaPoissonMatrix(mat) Set the vector Poisson matrix.
setHYPRESetBetaPoissonMatrix([mat]) Set the Posson matrix.
setHYPRESetEdgeConstantVectors(ozz, zoz[, zzo]) Set the representation of the constant vector fields in the edge element basis.
setHYPRESetInterpolations(dim[, RT_Pi_Full, ...]) Set the interpolation matrices.
setHYPREType(hypretype) Set the Type.HYPRE <#petsc4py.PETSc.PC.Type.HYPRE> type.
setMGCycleType(cycle_type) Set the type of cycles.
setMGCycleTypeOnLevel(level, cycle_type) Set the type of cycle on the given level.
setMGInterpolation(level, mat) Set the interpolation operator for the given level.
setMGLevels(levels) Set the number of MG <#petsc4py.PETSc.PC.Type.MG> levels.
setMGR(level, r) Set the vector where the residual is stored.
setMGRScale(level, rscale) Set the pointwise scaling for the restriction operator on the given level.
setMGRestriction(level, mat) Set the restriction operator for the given level.
setMGRhs(level, rhs) Set the vector where the right-hand side is stored.
setMGType(mgtype) Set the form of multigrid.
setMGX(level, x) Set the vector where the solution is stored.
setOperators([A, P]) Set the matrices associated with the linear system.
setOptionsPrefix(prefix) Set the prefix used for all the PC options.
setPatchCellNumbering(sec) Set the cell numbering.
setPatchComputeFunction(function[, args, kargs]) Set compute operator callbacks.
setPatchComputeFunctionInteriorFacets(function) Set compute operator callbacks.
setPatchComputeOperator(operator[, args, kargs]) Set compute operator callbacks.
setPatchComputeOperatorInteriorFacets(operator) Set compute operator callbacks.
setPatchConstructType(typ[, operator, args, ...]) Set compute operator callbacks.
setPatchDiscretisationInfo(dms, bs, ...) Set discretisation info.
setPythonContext(context) Set the instance of the class implementing the required Python methods.
setPythonType(py_type) Set the fully qualified Python name of the class to be used.
setReusePreconditioner(flag) Set to indicate the preconditioner is to be reused.
setSPAIBlockSize(n) Set the block size of the preconditioner.
setSPAICacheSize(size) Set the cache size.
setSPAIEpsilon(val) Set the tolerance for the preconditioner.
setSPAIMax(maxval) Set the size of working buffers in the preconditioner.
setSPAIMaxNew(maxval) Set the maximum number of new non-zero candidates per step.
setSPAINBSteps(nbsteps) Set the maximum number of improvement steps per row.
setSPAISp(sym) Set to specify a symmetric sparsity pattern.
setSPAIVerbose(level) Set the verbosity level.
setType(pc_type) Set the preconditioner type.
setUp() Set up the internal data structures for the PC.
setUpOnBlocks() Set up the PC for each block.
setUseAmat(flag) Set to indicate to apply PC to A and not P.
view([viewer]) View the PC object.

Methods Documentation

Add a PC of the given type to the composite PC.

Collective.

pc_type (Type <#petsc4py.PETSc.PC.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of the preconditioner to add.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:1700 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1700>


Append to the prefix used for all the PC options.

Logically collective.


See also:

Working with PETSc options <#petsc-options>, PCAppendOptionsPrefix <https://petsc.org/release/manualpages/PC/PCAppendOptionsPrefix.html>


Source code at petsc4py/PETSc/PC.pyx:354 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L354>


Apply the PC to a vector.

Collective.

  • x (Vec <#petsc4py.PETSc.Vec>) -- The input vector.
  • y (Vec <#petsc4py.PETSc.Vec>) -- The output vector, cannot be the same as x.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:580 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L580>


Apply the left part of a symmetric PC to a vector.

Collective.

  • x (Vec <#petsc4py.PETSc.Vec>) -- The input vector.
  • y (Vec <#petsc4py.PETSc.Vec>) -- The output vector, cannot be the same as x.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:659 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L659>


Apply the right part of a symmetric PC to a vector.

Collective.

  • x (Vec <#petsc4py.PETSc.Vec>) -- The input vector.
  • y (Vec <#petsc4py.PETSc.Vec>) -- The output vector, cannot be the same as x.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:678 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L678>


Apply the transpose of the PC to a vector.

Collective.

For complex numbers this applies the non-Hermitian transpose.

  • x (Vec <#petsc4py.PETSc.Vec>) -- The input vector.
  • y (Vec <#petsc4py.PETSc.Vec>) -- The output vector, cannot be the same as x.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:618 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L618>


Create an empty PC.

Collective.

The default preconditioner for sparse matrices is ILU <#petsc4py.PETSc.PC.Type.ILU> or ICC <#petsc4py.PETSc.PC.Type.ICC> with 0 fill on one process and block Jacobi (BJACOBI <#petsc4py.PETSc.PC.Type.BJACOBI>) with ILU <#petsc4py.PETSc.PC.Type.ILU> or ICC <#petsc4py.PETSc.PC.Type.ICC> in parallel. For dense matrices it is always None <https://docs.python.org/3/library/constants.html#None>.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/PC.pyx:263 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L263>


Create a preconditioner of Python type.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

PETSc Python preconditioner type <#petsc-python-pc>, setType, setPythonContext, PC.Type.PYTHON <#petsc4py.PETSc.PC.Type.PYTHON>


Source code at petsc4py/PETSc/PC.pyx:760 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L760>



Return the local KSP <#petsc4py.PETSc.KSP> object for all blocks on this process.

Not collective.

See also:


Source code at petsc4py/PETSc/PC.pyx:981 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L981>



Return the local KSP <#petsc4py.PETSc.KSP> object for all blocks on this process.

Not collective.

See also:


Source code at petsc4py/PETSc/PC.pyx:842 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L842>




Return the DM <#petsc4py.PETSc.DM> associated with the PC.

Not collective.

See also:


Source code at petsc4py/PETSc/PC.pyx:699 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L699>

DM <#petsc4py.PETSc.DM>


Return the coarse problem KSP <#petsc4py.PETSc.KSP>.

Not collective.

See also:


Source code at petsc4py/PETSc/PC.pyx:2945 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2945>

KSP <#petsc4py.PETSc.KSP>


Return the additional preconditioner.

Not collective.

See also:


Source code at petsc4py/PETSc/PC.pyx:2960 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2960>

PC <#petsc4py.PETSc.PC>


Return the factored matrix.

Not collective.

See also:


Source code at petsc4py/PETSc/PC.pyx:1469 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1469>

Mat <#petsc4py.PETSc.Mat>


Return the solver package used to perform the factorization.

Not collective.

See also:


Source code at petsc4py/PETSc/PC.pyx:1325 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1325>



Return the reason the PC terminated.

Not collective.

After a call to KSPCheckDot() or KSPCheckNorm() inside a KSPSolve(), or after a call to PCReduceFailedReason() this is the maximum reason over all ranks in the PC communicator and hence logically collective. Otherwise it is the local value.

See also:


Source code at petsc4py/PETSc/PC.pyx:519 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L519>

FailedReason <#petsc4py.PETSc.PC.FailedReason>


Return the KSP <#petsc4py.PETSc.KSP> for the Schur complement based splits.

Not collective.

See also:


Source code at petsc4py/PETSc/PC.pyx:1580 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1580>



Return the IS <#petsc4py.PETSc.IS> associated with a given name.

Not collective.

See also:


Source code at petsc4py/PETSc/PC.pyx:1600 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1600>



Return the KSP <#petsc4py.PETSc.KSP> for all splits.

Not collective.

See also:


Source code at petsc4py/PETSc/PC.pyx:1560 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1560>



Return the coarse correction type.

Not collective.

See also:


Source code at petsc4py/PETSc/PC.pyx:2597 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2597>

HPDDMCoarseCorrectionType <#petsc4py.PETSc.PC.HPDDMCoarseCorrectionType>



Return true if the KSP <#petsc4py.PETSc.KSP> in SLEPc ST and the subdomain solver is shared.

Not collective.

See also:


Source code at petsc4py/PETSc/PC.pyx:2611 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2611>



Return the Type.HYPRE <#petsc4py.PETSc.PC.Type.HYPRE> type.

Not collective.

See also:


Source code at petsc4py/PETSc/PC.pyx:1111 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1111>



Return the KSP <#petsc4py.PETSc.KSP> if the PC is Type.KSP <#petsc4py.PETSc.PC.Type.KSP>.

Not collective.

See also:


Source code at petsc4py/PETSc/PC.pyx:1721 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1721>

KSP <#petsc4py.PETSc.KSP>


Return the KSP <#petsc4py.PETSc.KSP> used on the coarse grid.

Not collective.

See also:


Source code at petsc4py/PETSc/PC.pyx:1797 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1797>

KSP <#petsc4py.PETSc.KSP>


Return the interpolation operator for the given level.

Logically collective.

level (int <https://docs.python.org/3/library/functions.html#int>) -- The level where interpolation is defined from level-1 to level.
Mat <#petsc4py.PETSc.Mat>

See also:


Source code at petsc4py/PETSc/PC.pyx:1832 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1832>


Return the number of MG <#petsc4py.PETSc.PC.Type.MG> levels.

Not collective.

See also:


Source code at petsc4py/PETSc/PC.pyx:1765 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1765>



Return the pointwise scaling for the restriction operator on the given level.

Logically collective.

level (int <https://docs.python.org/3/library/functions.html#int>) -- The level where restriction is defined from level to level-1.
Vec <#petsc4py.PETSc.Vec>

See also:


Source code at petsc4py/PETSc/PC.pyx:1914 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1914>


Return the restriction operator for the given level.

Logically collective.

level (int <https://docs.python.org/3/library/functions.html#int>) -- The level where restriction is defined from level to level-1.
Mat <#petsc4py.PETSc.Mat>

See also:


Source code at petsc4py/PETSc/PC.pyx:1873 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1873>


Return the KSP <#petsc4py.PETSc.KSP> to be used as a smoother.

Not collective.

level (int <https://docs.python.org/3/library/functions.html#int>) -- The level of the smoother.
KSP <#petsc4py.PETSc.KSP>

See also:

getMGSmootherDown, getMGSmootherUp, PCMGGetSmoother <https://petsc.org/release/manualpages/PC/PCMGGetSmoother.html>


Source code at petsc4py/PETSc/PC.pyx:1935 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1935>


Return the KSP <#petsc4py.PETSc.KSP> to be used as a smoother before coarse grid correction.

Not collective.

level (int <https://docs.python.org/3/library/functions.html#int>) -- The level of the smoother.
KSP <#petsc4py.PETSc.KSP>

See also:

getMGSmoother, getMGSmootherUp, PCMGGetSmootherDown <https://petsc.org/release/manualpages/PC/PCMGGetSmootherDown.html>


Source code at petsc4py/PETSc/PC.pyx:1956 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1956>


Return the KSP <#petsc4py.PETSc.KSP> to be used as a smoother after coarse grid correction.

Not collective.

level (int <https://docs.python.org/3/library/functions.html#int>) -- The level of the smoother.
KSP <#petsc4py.PETSc.KSP>

See also:

getMGSmootherDown, getMGSmoother, PCMGGetSmootherUp <https://petsc.org/release/manualpages/PC/PCMGGetSmootherUp.html>


Source code at petsc4py/PETSc/PC.pyx:1977 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1977>


Return the form of multigrid.

Logically collective.

See also:


Source code at petsc4py/PETSc/PC.pyx:1738 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1738>

MGType <#petsc4py.PETSc.PC.MGType>


Return the matrices associated with a linear system.

Not collective.

See also:


Source code at petsc4py/PETSc/PC.pyx:415 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L415>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>]


Return the prefix used for all the PC options.

Not collective.

See also:

Working with PETSc options <#petsc-options>, PCGetOptionsPrefix <https://petsc.org/release/manualpages/PC/PCGetOptionsPrefix.html>


Source code at petsc4py/PETSc/PC.pyx:340 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L340>



Return the local KSP <#petsc4py.PETSc.KSP> object for all blocks on this process.

Not collective.

Source code at petsc4py/PETSc/PC.pyx:2407 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2407>



Return the instance of the class implementing the required Python methods.

Not collective.

See also:

PETSc Python preconditioner type <#petsc-python-pc>, setPythonContext


Source code at petsc4py/PETSc/PC.pyx:797 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L797>



Return the fully qualified Python name of the class used by the preconditioner.

Not collective.

See also:

PETSc Python preconditioner type <#petsc-python-pc>, setPythonContext, setPythonType, PCPythonGetType <https://petsc.org/release/manualpages/PC/PCPythonGetType.html>


Source code at petsc4py/PETSc/PC.pyx:826 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L826>




Return the flag to indicate if PC is applied to A or P.

Logically collective.

flag -- True if A is used and False if P.
bool <https://docs.python.org/3/library/functions.html#bool>

See also:


Source code at petsc4py/PETSc/PC.pyx:457 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L457>


Apply the PC to many vectors stored as Mat.Type.DENSE <#petsc4py.PETSc.Mat.Type.DENSE>.

Collective.

  • x (Mat <#petsc4py.PETSc.Mat>) -- The input matrix.
  • y (Mat <#petsc4py.PETSc.Mat>) -- The output matrix, cannot be the same as x.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:599 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L599>


Apply the transpose of the PC to many vectors stored as Mat.Type.DENSE <#petsc4py.PETSc.Mat.Type.DENSE>.

Collective.

  • x (Mat <#petsc4py.PETSc.Mat>) -- The input matrix.
  • y (Mat <#petsc4py.PETSc.Mat>) -- The output matrix, cannot be the same as x.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:640 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L640>



Set the local subdomains.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

setASMTotalSubdomains, PCASMSetLocalSubdomains <https://petsc.org/release/manualpages/PC/PCASMSetLocalSubdomains.html>


Source code at petsc4py/PETSc/PC.pyx:895 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L895>


Set the overlap between a pair of subdomains.

Logically collective.


See also:


Source code at petsc4py/PETSc/PC.pyx:877 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L877>



Set the subdomains for all processes.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

setASMLocalSubdomains, PCASMSetTotalSubdomains <https://petsc.org/release/manualpages/PC/PCASMSetTotalSubdomains.html>


Source code at petsc4py/PETSc/PC.pyx:938 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L938>


Set the type of restriction and interpolation.

Logically collective.

asmtype (ASMType <#petsc4py.PETSc.PC.ASMType>) -- The type of ASM you wish to use.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:859 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L859>


Set a user defined change of basis for degrees of freedom.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2200 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2200>


Set the coarsening ratio used in the multilevel version.

Logically collective.


See also:


Source code at petsc4py/PETSc/PC.pyx:2255 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2255>


Set the IS <#petsc4py.PETSc.IS> defining Dirichlet boundaries for the global problem.

Collective.

bndr (IS <#petsc4py.PETSc.IS>) -- The parallel IS <#petsc4py.PETSc.IS> defining Dirichlet boundaries.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2291 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2291>


Set the IS <#petsc4py.PETSc.IS> defining Dirichlet boundaries in local ordering.

Collective.

bndr (IS <#petsc4py.PETSc.IS>) -- The parallel IS <#petsc4py.PETSc.IS> defining Dirichlet boundaries in local ordering.
None <https://docs.python.org/3/library/constants.html#None>

See also:

setBDDCDirichletBoundaries, PCBDDCSetDirichletBoundariesLocal <https://petsc.org/release/manualpages/PC/PCBDDCSetDirichletBoundariesLocal.html>


Source code at petsc4py/PETSc/PC.pyx:2308 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2308>


Set the discrete gradient.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2164 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2164>


Set the linear operator representing ∫ div(u)•p dx.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2138 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2138>


Set the index set(s) defining fields of the global matrix.

Collective.

isfields (IS <#petsc4py.PETSc.IS> | Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[IS <#petsc4py.PETSc.IS>]) -- The sequence of IS <#petsc4py.PETSc.IS> describing the fields in global ordering.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2359 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2359>


Set the index set(s) defining fields of the local subdomain matrix.

Collective.

Not all nodes need to be listed. Unlisted nodes will belong to the complement field.

isfields (IS <#petsc4py.PETSc.IS> | Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[IS <#petsc4py.PETSc.IS>]) -- The sequence of IS <#petsc4py.PETSc.IS> describing the fields in local ordering.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2381 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2381>


Set the maximum number of additional levels allowed.

Logically collective.


See also:


Source code at petsc4py/PETSc/PC.pyx:2273 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2273>


Provide a custom connectivity graph for local dofs.

Not collective.

csr (CSRIndicesSpec <#petsc4py.typing.CSRIndicesSpec>) -- Compressed sparse row layout information.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2108 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2108>


Set the IS <#petsc4py.PETSc.IS> defining Neumann boundaries for the global problem.

Collective.

bndr (IS <#petsc4py.PETSc.IS>) -- The parallel IS <#petsc4py.PETSc.IS> defining Neumann boundaries.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2325 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2325>


Set the IS <#petsc4py.PETSc.IS> defining Neumann boundaries in local ordering.

Collective.

bndr (IS <#petsc4py.PETSc.IS>) -- The parallel IS <#petsc4py.PETSc.IS> defining Neumann boundaries in local ordering.
None <https://docs.python.org/3/library/constants.html#None>

See also:

setBDDCNeumannBoundaries, PCBDDCSetNeumannBoundariesLocal <https://petsc.org/release/manualpages/PC/PCBDDCSetNeumannBoundariesLocal.html>


Source code at petsc4py/PETSc/PC.pyx:2342 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2342>


Set additional user defined primal vertices.

Collective.

primv (IS <#petsc4py.PETSc.IS>) -- The IS <#petsc4py.PETSc.IS> of primal vertices in global numbering.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2221 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2221>


Set additional user defined primal vertices.

Collective.

primv (IS <#petsc4py.PETSc.IS>) -- The IS <#petsc4py.PETSc.IS> of primal vertices in local numbering.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2238 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2238>


Set the type of composite preconditioner.

Logically collective.

ctype (CompositeType <#petsc4py.PETSc.PC.CompositeType>) -- The type of composition.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:1661 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1661>



Set the DM <#petsc4py.PETSc.DM> that may be used by some preconditioners.

Logically collective.

dm (DM <#petsc4py.PETSc.DM>) -- The DM <#petsc4py.PETSc.DM> object.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:716 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L716>


Set the coarse problem matrix.

Collective.

mat (Mat <#petsc4py.PETSc.Mat>) -- The coarse problem matrix.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2928 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2928>



Set to only perform the initialization.

Logically collective.

Sets initial guess to the solution on the deflation space but does not apply the deflation preconditioner. The additional preconditioner is still applied.


See also:


Source code at petsc4py/PETSc/PC.pyx:2793 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2793>



Set the projection null space matrix.

Collective.

mat (Mat <#petsc4py.PETSc.Mat>) -- The projection null space matrix.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2911 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2911>



Set the deflation space matrix or its (Hermitian) transpose.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2890 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2890>


Set the deflation space type.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2869 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2869>





Set up the factorization solver.

Collective.

This can be called after KSP.setOperators <#petsc4py.PETSc.KSP.setOperators> or PC.setOperators, causes MatGetFactor <https://petsc.org/release/manualpages/Mat/MatGetFactor.html> to be called so then one may set the options for that particular factorization object.

See also:

Working with PETSc options <#petsc-options>, PCFactorSetUpMatSolverType <https://petsc.org/release/manualpages/PC/PCFactorSetUpMatSolverType.html>


Source code at petsc4py/PETSc/PC.pyx:1339 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1339>



Set options for shifting diagonal entries of a matrix.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:1421 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1421>


Set the solver package used to perform the factorization.

Logically collective.

solver (SolverType <#petsc4py.PETSc.Mat.SolverType> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The solver package used to factorize.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:1306 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1306>


Set the reason the PC terminated.

Logically collective.

reason (FailedReason <#petsc4py.PETSc.PC.FailedReason> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- the reason the PC terminated
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:501 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L501>



Set the elements for the field split by IS <#petsc4py.PETSc.IS>.

Logically collective.

Solve options for this split will be available under the prefix -fieldsplit_SPLITNAME_*.

fields (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[str <https://docs.python.org/3/library/stdtypes.html#str>, IS <#petsc4py.PETSc.IS>]) -- A sequence of tuples containing the split name and the IS <#petsc4py.PETSc.IS> that defines the elements in the split.
None <https://docs.python.org/3/library/constants.html#None>

See also:

Working with PETSc options <#petsc-options>, PCFieldSplitSetIS <https://petsc.org/release/manualpages/PC/PCFieldSplitSetIS.html>


Source code at petsc4py/PETSc/PC.pyx:1504 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1504>


Set the type of approximate block factorization.

Collective.

ctype (FieldSplitSchurFactType <#petsc4py.PETSc.PC.FieldSplitSchurFactType>) -- The type indicating which blocks to retain.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:1616 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1616>


Set from what operator the PC is constructed.

Collective.

  • ptype (FieldSplitSchurPreType <#petsc4py.PETSc.PC.FieldSplitSchurPreType>) -- The type of matrix to use for preconditioning the Schur complement.
  • pre (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The optional matrix to use for preconditioning.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:1634 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1634>


Set the type of composition of a field split preconditioner.

Collective.

ctype (CompositeType <#petsc4py.PETSc.PC.CompositeType>) -- The type of composition.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:1486 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1486>


Set various PC parameters from user options.

Collective.

See also:

Working with PETSc options <#petsc-options>, PCSetFromOptions <https://petsc.org/release/manualpages/PC/PCSetFromOptions.html>


Source code at petsc4py/PETSc/PC.pyx:373 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L373>




Set the number of smoothing steps used on all levels.

Logically collective.


See also:


Source code at petsc4py/PETSc/PC.pyx:1091 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1091>


Set the type of algorithm.

Collective.

gamgtype (GAMGType <#petsc4py.PETSc.PC.GAMGType> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of GAMG <#petsc4py.PETSc.PC.Type.GAMG>
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:1054 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1054>


Set the overlap between a pair of subdomains.

Logically collective.


See also:


Source code at petsc4py/PETSc/PC.pyx:1034 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1034>


Set the type of restriction and interpolation.

Logically collective.

gasmtype (GASMType <#petsc4py.PETSc.PC.GASMType>) -- The type of GASM <#petsc4py.PETSc.PC.Type.GASM>.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:1016 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1016>


Set the auxiliary matrix used by the preconditioner.

Logically collective.

  • uis (IS <#petsc4py.PETSc.IS>) -- The IS <#petsc4py.PETSc.IS> of the local auxiliary matrix
  • uaux (Mat <#petsc4py.PETSc.Mat>) -- The auxiliary sequential matrix

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2511 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2511>


Set the coarse correction type.

Collective.

correction_type (HPDDMCoarseCorrectionType <#petsc4py.PETSc.PC.HPDDMCoarseCorrectionType>) -- The type of coarse correction to apply.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2579 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2579>


Set the deflation space used to assemble a coarse operator.

Logically collective.

  • uis (IS <#petsc4py.PETSc.IS>) -- The IS <#petsc4py.PETSc.IS> of the local deflation matrix.
  • U (Mat <#petsc4py.PETSc.Mat>) -- The deflation sequential matrix of type Mat.Type.DENSE <#petsc4py.PETSc.Mat.Type.DENSE>.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2625 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2625>


Set to indicate that the Mat <#petsc4py.PETSc.Mat> passed to the PC is the local Neumann matrix.

Logically collective.

has (bool <https://docs.python.org/3/library/functions.html#bool>) -- Enable to indicate the matrix is the local Neumann matrix.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2561 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2561>


Set the right-hand side matrix of the preconditioner.

Logically collective.

B (Mat <#petsc4py.PETSc.Mat>) -- The right-hand side sequential matrix.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2530 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2530>


Set the list of interior nodes to a zero conductivity region.

Collective.

interior (Vec <#petsc4py.PETSc.Vec>) -- A vector where a value of 1.0 indicates an interior node.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:1287 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1287>


Set the discrete curl matrix.

Collective.

mat (Mat <#petsc4py.PETSc.Mat>) -- The discrete curl.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:1145 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1145>


Set the discrete gradient matrix.

Collective.

mat (Mat <#petsc4py.PETSc.Mat>) -- The discrete gradient.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:1162 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1162>


Set the vector Poisson matrix.

Collective.

mat (Mat <#petsc4py.PETSc.Mat>) -- The vector Poisson matrix.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:1179 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1179>



Set the representation of the constant vector fields in the edge element basis.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:1263 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1263>


Set the interpolation matrices.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:1215 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1215>


Set the Type.HYPRE <#petsc4py.PETSc.PC.Type.HYPRE> type.

Collective.

hypretype (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The name of the type, one of "euclid", "pilut", "parasails", "boomeramg", "ams", "ads"
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:1125 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1125>


Set the type of cycles.

Logically collective.

cycle_type (MGCycleType <#petsc4py.PETSc.PC.MGCycleType>) -- The type of multigrid cycles to use.
None <https://docs.python.org/3/library/constants.html#None>

See also:

setMGCycleTypeOnLevel, PCMGSetCycleType <https://petsc.org/release/manualpages/PC/PCMGSetCycleType.html>


Source code at petsc4py/PETSc/PC.pyx:1998 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1998>


Set the type of cycle on the given level.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2016 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2016>


Set the interpolation operator for the given level.

Logically collective.

  • level -- The level where interpolation is defined from level-1 to level.
  • mat (Mat <#petsc4py.PETSc.Mat>) -- The interpolation operator

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:1812 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1812>


Set the number of MG <#petsc4py.PETSc.PC.Type.MG> levels.

Logically collective.


See also:


Source code at petsc4py/PETSc/PC.pyx:1779 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1779>


Set the vector where the residual is stored.

Logically collective.

If not provided, one will be set internally. Will be cleaned up in destroy.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2083 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2083>


Set the pointwise scaling for the restriction operator on the given level.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:1894 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1894>


Set the restriction operator for the given level.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:1853 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1853>


Set the vector where the right-hand side is stored.

Logically collective.

If not provided, one will be set internally. Will be cleaned up in destroy.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2037 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2037>


Set the form of multigrid.

Logically collective.

See also:


Source code at petsc4py/PETSc/PC.pyx:1752 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1752>

mgtype (MGType <#petsc4py.PETSc.PC.MGType>)
None <https://docs.python.org/3/library/constants.html#None>


Set the vector where the solution is stored.

Logically collective.

If not provided, one will be set internally. Will be cleaned up in destroy.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2060 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2060>


Set the matrices associated with the linear system.

Logically collective.

Passing None <https://docs.python.org/3/library/constants.html#None> for A or P removes the matrix that is currently used. PETSc does not reset the matrix entries of either A or P to zero after a linear solve; the user is completely responsible for matrix assembly. See Mat.zeroEntries <#petsc4py.PETSc.Mat.zeroEntries> to zero all elements of a matrix.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:385 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L385>


Set the prefix used for all the PC options.

Logically collective.


See also:

Working with PETSc options <#petsc-options>, PCSetOptionsPrefix <https://petsc.org/release/manualpages/PC/PCSetOptionsPrefix.html>


Source code at petsc4py/PETSc/PC.pyx:321 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L321>









Set the instance of the class implementing the required Python methods.

Not collective.

See also:

PETSc Python preconditioner type <#petsc-python-pc>, getPythonContext


Source code at petsc4py/PETSc/PC.pyx:785 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L785>



Set the fully qualified Python name of the class to be used.

Collective.

See also:

PETSc Python preconditioner type <#petsc-python-pc>, setPythonContext, getPythonType, PCPythonSetType <https://petsc.org/release/manualpages/PC/PCPythonSetType.html>


Source code at petsc4py/PETSc/PC.pyx:812 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L812>



Set to indicate the preconditioner is to be reused.

Logically collective.

Normally if the A matrix inside a PC changes, the PC automatically updates itself using information from the changed matrix. Enable this option prevents this.


See also:


Source code at petsc4py/PETSc/PC.pyx:476 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L476>





Set the size of working buffers in the preconditioner.

Logically collective.

maxval (int <https://docs.python.org/3/library/functions.html#int>) -- Number of entries in the work arrays to be allocated, defaults to 5000.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/PC.pyx:2682 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2682>


Set the maximum number of new non-zero candidates per step.

Logically collective.


See also:


Source code at petsc4py/PETSc/PC.pyx:2701 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2701>


Set the maximum number of improvement steps per row.

Logically collective.


See also:


Source code at petsc4py/PETSc/PC.pyx:2664 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2664>


Set to specify a symmetric sparsity pattern.

Logically collective.


See also:


Source code at petsc4py/PETSc/PC.pyx:2773 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2773>



Set the preconditioner type.

Collective.

pc_type (Type <#petsc4py.PETSc.PC.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The preconditioner type.
None <https://docs.python.org/3/library/constants.html#None>

See also:

Working with PETSc options <#petsc-options>, getType, TSSetType <https://petsc.org/release/manualpages/TS/TSSetType.html>


Source code at petsc4py/PETSc/PC.pyx:288 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L288>



Set up the PC for each block.

Collective.

For nested preconditioners such as BJACOBI <#petsc4py.PETSc.PC.Type.BJACOBI>, setUp is not called on each sub-KSP <#petsc4py.PETSc.KSP> when setUp is called on the outer PC. This routine ensures it is called.

See also:


Source code at petsc4py/PETSc/PC.pyx:564 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L564>



Set to indicate to apply PC to A and not P.

Logically collective.

Sets a flag to indicate that when the preconditioner needs to apply (part of) the operator during the preconditioning process, it applies to A provided to TS.setRHSJacobian <#petsc4py.PETSc.TS.setRHSJacobian>, TS.setIJacobian <#petsc4py.PETSc.TS.setIJacobian>, SNES.setJacobian <#petsc4py.PETSc.SNES.setJacobian>, KSP.setOperators <#petsc4py.PETSc.KSP.setOperators> or PC.setOperators not the P.


See also:


Source code at petsc4py/PETSc/PC.pyx:431 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L431>





petsc4py.PETSc.Partitioner

Bases: Object <#petsc4py.PETSc.Object>

A graph partitioner.

Enumerations

Type <#petsc4py.PETSc.Partitioner.Type> The partitioner types.

petsc4py.PETSc.Partitioner.Type

Bases: object <https://docs.python.org/3/library/functions.html#object>

The partitioner types.

Attributes Summary

CHACO Object CHACO of type str <https://docs.python.org/3/library/stdtypes.html#str>
GATHER Object GATHER of type str <https://docs.python.org/3/library/stdtypes.html#str>
MATPARTITIONING Object MATPARTITIONING of type str <https://docs.python.org/3/library/stdtypes.html#str>
MULTISTAGE Object MULTISTAGE of type str <https://docs.python.org/3/library/stdtypes.html#str>
PARMETIS Object PARMETIS of type str <https://docs.python.org/3/library/stdtypes.html#str>
PTSCOTCH Object PTSCOTCH of type str <https://docs.python.org/3/library/stdtypes.html#str>
SHELL Object SHELL of type str <https://docs.python.org/3/library/stdtypes.html#str>
SIMPLE Object SIMPLE of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation










Methods Summary

create([comm]) Create an empty partitioner object.
destroy() Destroy the partitioner object.
getType() Return the partitioner type.
reset() Reset data structures of the partitioner.
setFromOptions() Set parameters in the partitioner from the options database.
setShellPartition(numProcs[, sizes, points]) Set a custom partition for a mesh.
setType(part_type) Build a particular type of the partitioner.
setUp() Construct data structures for the partitioner.
view([viewer]) View the partitioner.

Methods Documentation

Create an empty partitioner object.

Collective.

The type can be set with setType.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Partitioner.pyx:58 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Partitioner.pyx#L58>





Set parameters in the partitioner from the options database.

Collective.

See also:

Working with PETSc options <#petsc-options>, PetscPartitionerSetFromOptions <https://petsc.org/release/manualpages/MatGraphOperations/PetscPartitionerSetFromOptions.html>


Source code at petsc4py/PETSc/Partitioner.pyx:114 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Partitioner.pyx#L114>




Build a particular type of the partitioner.

Collective.

part_type (Type <#petsc4py.PETSc.Partitioner.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The kind of partitioner.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Partitioner.pyx:81 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Partitioner.pyx#L81>



View the partitioner.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the graph.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Partitioner.pyx:26 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Partitioner.pyx#L26>




petsc4py.PETSc.Quad

Bases: Object <#petsc4py.PETSc.Object>

Quadrature rule for integration.

Methods Summary

create([comm]) Create a Quad object.
destroy() Destroy the Quad object.
duplicate() Create a deep copy of the Quad object.
getData() Return the data defining the Quad.
getNumComponents() Return the number of components for functions to be integrated.
getOrder() Return the order of the method in the Quad.
setNumComponents(nc) Return the number of components for functions to be integrated.
setOrder(order) Set the order of the method in the Quad.
view([viewer]) View a Quad object.

Methods Documentation

Create a Quad object.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/DT.pyx:28 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DT.pyx#L28>



Create a deep copy of the Quad object.

Collective.

See also:


Source code at petsc4py/PETSc/DT.pyx:49 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DT.pyx#L49>

Quad <#petsc4py.PETSc.Quad>


Return the data defining the Quad.

Not collective.

  • points (ArrayReal <#petsc4py.typing.ArrayReal>) -- The coordinates of the quadrature points.
  • weights (ArrayReal <#petsc4py.typing.ArrayReal>) -- The quadrature weights.

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[ArrayReal <#petsc4py.typing.ArrayReal>, ArrayReal <#petsc4py.typing.ArrayReal>]

See also:


Source code at petsc4py/PETSc/DT.pyx:76 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DT.pyx#L76>


Return the number of components for functions to be integrated.

Not collective.

See also:

setNumComponents, PetscQuadratureGetNumComponents <https://petsc.org/release/manualpages/DT/PetscQuadratureGetNumComponents.html>


Source code at petsc4py/PETSc/DT.pyx:104 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DT.pyx#L104>



Return the order of the method in the Quad.

Not collective.

See also:


Source code at petsc4py/PETSc/DT.pyx:136 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DT.pyx#L136>



Return the number of components for functions to be integrated.

Not collective.


See also:

getNumComponents, PetscQuadratureSetNumComponents <https://petsc.org/release/manualpages/DT/PetscQuadratureSetNumComponents.html>


Source code at petsc4py/PETSc/DT.pyx:118 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DT.pyx#L118>


Set the order of the method in the Quad.

Not collective.

order (int <https://docs.python.org/3/library/functions.html#int>) -- The order of the quadrature, i.e. the highest degree polynomial that is exactly integrated.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DT.pyx:150 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DT.pyx#L150>


View a Quad object.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the graph.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/DT.pyx:9 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DT.pyx#L9>



petsc4py.PETSc.Random

Bases: Object <#petsc4py.PETSc.Object>

The random number generator object.

See also:


Enumerations

Type <#petsc4py.PETSc.Random.Type> The random number generator type.

petsc4py.PETSc.Random.Type


Methods Summary

create([comm]) Create a random number generator object.
destroy() Destroy the random number generator object.
getInterval() Return the interval containing the random numbers generated.
getSeed() Return the random number generator seed.
getType() Return the type of the random number generator object.
getValue() Generate a scalar random number.
getValueReal() Generate a real random number.
setFromOptions() Configure the random number generator from the options database.
setInterval(interval) Set the interval of the random number generator.
setSeed([seed]) Set the seed of random number generator.
setType(rnd_type) Set the type of the random number generator object.
view([viewer]) View a random number generator object.

Attributes Summary

interval The interval of the generated random numbers.
seed The seed of the random number generator.

Methods Documentation

Create a random number generator object.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>, PetscRandomCreate <https://petsc.org/release/manualpages/Sys/PetscRandomCreate.html>


Source code at petsc4py/PETSc/Random.pyx:74 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Random.pyx#L74>



Return the interval containing the random numbers generated.

Not collective.

See also:


Source code at petsc4py/PETSc/Random.pyx:199 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Random.pyx#L199>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Scalar <#petsc4py.typing.Scalar>, Scalar <#petsc4py.typing.Scalar>]



Return the type of the random number generator object.

Not collective.

See also:


Source code at petsc4py/PETSc/Random.pyx:112 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Random.pyx#L112>



Generate a scalar random number.

Not collective.

See also:


Source code at petsc4py/PETSc/Random.pyx:138 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Random.pyx#L138>

Scalar <#petsc4py.typing.Scalar>



Configure the random number generator from the options database.

Collective.

See also:

Working with PETSc options <#petsc-options>, PetscRandomSetFromOptions <https://petsc.org/release/manualpages/Sys/PetscRandomSetFromOptions.html>


Source code at petsc4py/PETSc/Random.pyx:126 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Random.pyx#L126>



Set the interval of the random number generator.

Not collective.

See also:


Source code at petsc4py/PETSc/Random.pyx:214 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Random.pyx#L214>

interval (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Scalar <#petsc4py.typing.Scalar>, Scalar <#petsc4py.typing.Scalar>])
None <https://docs.python.org/3/library/constants.html#None>



Set the type of the random number generator object.

Collective.

rnd_type (Type <#petsc4py.PETSc.Random.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of the generator.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Random.pyx:93 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Random.pyx#L93>


View a random number generator object.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> instance or None <https://docs.python.org/3/library/constants.html#None> for the default viewer.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Random.pyx:41 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Random.pyx#L41>


Attributes Documentation

The interval of the generated random numbers.

Source code at petsc4py/PETSc/Random.pyx:241 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Random.pyx#L241>


The seed of the random number generator.

Source code at petsc4py/PETSc/Random.pyx:233 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Random.pyx#L233>




petsc4py.PETSc.Regressor

Bases: Object <#petsc4py.PETSc.Object>

Regression solver.

REGRESSOR is described in the PETSc manual <https://petsc.org/release/manual/regressor.html>.

See also:


Enumerations

LinearType <#petsc4py.PETSc.Regressor.LinearType> Linear regressor type.
Type <#petsc4py.PETSc.Regressor.Type> REGRESSOR solver type.

petsc4py.PETSc.Regressor.LinearType


petsc4py.PETSc.Regressor.Type


Methods Summary

create([comm]) Create a REGRESSOR solver.
destroy() Destroy the solver.
fit(X, y) Fit the regression problem.
getLinearCoefficients() Get a vector of the fitted coefficients from a linear regression model.
getLinearIntercept() Get the intercept from a linear regression model.
getLinearKSP() Returns the KSP <#petsc4py.PETSc.KSP> context used by the linear regressor.
getLinearType() Return the type of the linear regressor.
getTAO() Return the underlying TAO <#petsc4py.PETSc.TAO> object .
getType() Return the type of the solver.
predict(X, y) Predict the regression problem.
reset() Destroy internal data structures of the solver.
setFromOptions() Configure the solver from the options database.
setLinearFitIntercept(flag) Set a flag to indicate that the intercept should be calculated.
setLinearType(lineartype) Set the type of linear regression to be performed.
setLinearUseKSP(flag) Set a flag to indicate that KSP <#petsc4py.PETSc.KSP> instead of TAO <#petsc4py.PETSc.TAO> solvers should be used.
setRegularizerWeight(weight) Set the weight to be used for the regularizer.
setType(regressor_type) Set the type of the solver.
setUp() Set up the internal data structures for using the solver.
view([viewer]) View the solver.

Methods Documentation

Create a REGRESSOR solver.

Collective.

comm -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>, PetscRegressorCreate <https://petsc.org/release/manualpages/PetscRegressor/PetscRegressorCreate.html>


Source code at petsc4py/PETSc/Regressor.pyx:61 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L61>



Fit the regression problem.

Collective.

  • X (Mat <#petsc4py.PETSc.Mat>) -- The matrix of training data
  • y (Vec <#petsc4py.PETSc.Vec>) -- The vector of target values from the training dataset

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Regressor.pyx:116 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L116>


Get a vector of the fitted coefficients from a linear regression model.

Not collective.

See also:


Source code at petsc4py/PETSc/Regressor.pyx:266 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L266>

Vec <#petsc4py.PETSc.Vec>


Get the intercept from a linear regression model.

Not collective.

See also:



Source code at petsc4py/PETSc/Regressor.pyx:280 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L280>

Scalar <#petsc4py.typing.Scalar>


Returns the KSP <#petsc4py.PETSc.KSP> context used by the linear regressor.

Not collective.

See also:


Source code at petsc4py/PETSc/Regressor.pyx:252 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L252>

KSP <#petsc4py.PETSc.KSP>


Return the type of the linear regressor.

Not collective.

See also:


Source code at petsc4py/PETSc/Regressor.pyx:304 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L304>

RegressorLinearType <#petsc4py.PETSc.RegressorLinearType>


Return the underlying TAO <#petsc4py.PETSc.TAO> object .

Not collective.

See also:


Source code at petsc4py/PETSc/Regressor.pyx:154 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L154>

TAO <#petsc4py.PETSc.TAO>



Predict the regression problem.

Collective.

  • X (Mat <#petsc4py.PETSc.Mat>) -- The matrix of unlabeled observations
  • y (Vec <#petsc4py.PETSc.Vec>) -- The vector of predicted labels

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Regressor.pyx:135 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L135>



Configure the solver from the options database.

Collective.

See also:

Working with PETSc options <#petsc-options>, PetscRegressorSetFromOptions <https://petsc.org/release/manualpages/PetscRegressor/PetscRegressorSetFromOptions.html>


Source code at petsc4py/PETSc/Regressor.pyx:93 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L93>




Set the type of linear regression to be performed.

Logically collective.

See also:


Source code at petsc4py/PETSc/Regressor.pyx:293 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L293>

lineartype (RegressorLinearType <#petsc4py.PETSc.RegressorLinearType>)
None <https://docs.python.org/3/library/constants.html#None>


Set a flag to indicate that KSP <#petsc4py.PETSc.KSP> instead of TAO <#petsc4py.PETSc.TAO> solvers should be used.

Logically collective.

See also:


Source code at petsc4py/PETSc/Regressor.pyx:240 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L240>




Set the type of the solver.

Logically collective.

regressor_type (Type <#petsc4py.PETSc.Regressor.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of the solver.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Regressor.pyx:193 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L193>



View the solver.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> instance or None <https://docs.python.org/3/library/constants.html#None> for the default viewer.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Regressor.pyx:42 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L42>




petsc4py.PETSc.RegressorLinearType


petsc4py.PETSc.SF

Bases: Object <#petsc4py.PETSc.Object>

Star Forest object for communication.

SF is used for setting up and managing the communication of certain entries of arrays and Vec <#petsc4py.PETSc.Vec> between MPI processes.

Enumerations

Type <#petsc4py.PETSc.SF.Type> The star forest types.

petsc4py.PETSc.SF.Type

Bases: object <https://docs.python.org/3/library/functions.html#object>

The star forest types.

Attributes Summary

ALLGATHER Object ALLGATHER of type str <https://docs.python.org/3/library/stdtypes.html#str>
ALLGATHERV Object ALLGATHERV of type str <https://docs.python.org/3/library/stdtypes.html#str>
ALLTOALL Object ALLTOALL of type str <https://docs.python.org/3/library/stdtypes.html#str>
BASIC Object BASIC of type str <https://docs.python.org/3/library/stdtypes.html#str>
GATHER Object GATHER of type str <https://docs.python.org/3/library/stdtypes.html#str>
GATHERV Object GATHERV of type str <https://docs.python.org/3/library/stdtypes.html#str>
NEIGHBOR Object NEIGHBOR of type str <https://docs.python.org/3/library/stdtypes.html#str>
WINDOW Object WINDOW of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation










Methods Summary

bcastBegin(unit, rootdata, leafdata, op) Begin pointwise broadcast.
bcastEnd(unit, rootdata, leafdata, op) End a broadcast & reduce operation started with bcastBegin.
compose(sf) Compose a new SF.
computeDegree() Compute and return the degree of each root vertex.
create([comm]) Create a star forest communication context.
createEmbeddedLeafSF(selected) Remove edges from all but the selected leaves.
createEmbeddedRootSF(selected) Remove edges from all but the selected roots.
createInverse() Create the inverse map.
createSectionSF(rootSection, remoteOffsets, ...) Create an expanded SF of DOFs.
destroy() Destroy the star forest.
distributeSection(rootSection[, leafSection]) Create a new, reorganized Section <#petsc4py.PETSc.Section>.
fetchAndOpBegin(unit, rootdata, leafdata, ...) Begin fetch and update operation.
fetchAndOpEnd(unit, rootdata, leafdata, ...) End operation started in a matching call to fetchAndOpBegin.
gatherBegin(unit, leafdata, multirootdata) Begin pointwise gather of all leaves into multi-roots.
gatherEnd(unit, leafdata, multirootdata) End gather operation that was started with gatherBegin.
getGraph() Return star forest graph.
getMulti() Return the inner SF implementing gathers and scatters.
getType() Return the type name of the star forest.
reduceBegin(unit, leafdata, rootdata, op) Begin reduction of leafdata into rootdata.
reduceEnd(unit, leafdata, rootdata, op) End a reduction operation started with reduceBegin.
reset() Reset a star forest so that different sizes or neighbors can be used.
scatterBegin(unit, multirootdata, leafdata) Begin pointwise scatter operation.
scatterEnd(unit, multirootdata, leafdata) End scatter operation that was started with scatterBegin.
setFromOptions() Set options using the options database.
setGraph(nroots, local, remote) Set star forest graph.
setRankOrder(flag) Sort multi-points for gathers and scatters by rank order.
setType(sf_type) Set the type of the star forest.
setUp() Set up communication structures.
view([viewer]) View a star forest.

Methods Documentation

Begin pointwise broadcast.

Collective.

Root values are reduced to leaf values. This call has to be concluded with a call to bcastEnd.


See also:


Source code at petsc4py/PETSc/SF.pyx:434 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L434>



Compose a new SF.

Collective.

Puts the sf under this object in a top (roots) down (leaves) view.

sf (SF <#petsc4py.PETSc.SF>) -- SF to put under this object.
SF <#petsc4py.PETSc.SF>

See also:


Source code at petsc4py/PETSc/SF.pyx:413 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L413>


Compute and return the degree of each root vertex.

Collective.

See also:


Source code at petsc4py/PETSc/SF.pyx:279 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L279>

ArrayInt <#petsc4py.typing.ArrayInt>


Create a star forest communication context.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/SF.pyx:63 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L63>


Remove edges from all but the selected leaves.

Collective.

Does not remap indices.

selected (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Indices of the selected roots on this process.
SF <#petsc4py.PETSc.SF>

See also:


Source code at petsc4py/PETSc/SF.pyx:321 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L321>


Remove edges from all but the selected roots.

Collective.

Does not remap indices.

selected (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Indices of the selected roots on this process.
SF <#petsc4py.PETSc.SF>

See also:


Source code at petsc4py/PETSc/SF.pyx:297 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L297>


Create the inverse map.

Collective.

Create the inverse map given a PetscSF in which all vertices have degree 1.

See also:


Source code at petsc4py/PETSc/SF.pyx:262 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L262>

SF <#petsc4py.PETSc.SF>


Create an expanded SF of DOFs.

Collective.

Assumes the input SF relates points.


SF <#petsc4py.PETSc.SF>

See also:


Source code at petsc4py/PETSc/SF.pyx:345 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L345>



Create a new, reorganized Section <#petsc4py.PETSc.Section>.

Collective.

Moves from the root to the leaves of the SF.


tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[ArrayInt <#petsc4py.typing.ArrayInt>, Section <#petsc4py.PETSc.Section>]

See also:


Source code at petsc4py/PETSc/SF.pyx:378 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L378>


Begin fetch and update operation.

Collective.

This operation fetches values from root and updates atomically by applying an operation using the leaf value.

This call has to be completed with fetchAndOpEnd.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SF.pyx:642 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L642>


End operation started in a matching call to fetchAndOpBegin.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SF.pyx:678 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L678>


Begin pointwise gather of all leaves into multi-roots.

Collective.

This call has to be completed with gatherEnd.


See also:


Source code at petsc4py/PETSc/SF.pyx:592 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L592>


End gather operation that was started with gatherBegin.

Collective.


See also:


Source code at petsc4py/PETSc/SF.pyx:618 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L618>


Return star forest graph.

Not collective.

The number of leaves can be determined from the size of ilocal.

  • nroots (int <https://docs.python.org/3/library/functions.html#int>) -- Number of root vertices on the current process (these are possible targets for other process to attach leaves).
  • ilocal (ArrayInt <#petsc4py.typing.ArrayInt>) -- Locations of leaves in leafdata buffers.
  • iremote (ArrayInt <#petsc4py.typing.ArrayInt>) -- Remote locations of root vertices for each leaf on the current process.

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, ArrayInt <#petsc4py.typing.ArrayInt>, ArrayInt <#petsc4py.typing.ArrayInt>]

See also:


Source code at petsc4py/PETSc/SF.pyx:155 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L155>


Return the inner SF implementing gathers and scatters.

Collective.

See also:


Source code at petsc4py/PETSc/SF.pyx:247 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L247>

SF <#petsc4py.PETSc.SF>





Reset a star forest so that different sizes or neighbors can be used.

Collective.

See also:


Source code at petsc4py/PETSc/SF.pyx:141 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L141>



Begin pointwise scatter operation.

Collective.

Operation is from multi-roots to leaves. This call has to be completed with scatterEnd.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SF.pyx:543 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L543>


End scatter operation that was started with scatterBegin.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SF.pyx:569 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L569>


Set options using the options database.

Logically collective.

See also:

Working with PETSc options <#petsc-options>, PetscSFSetFromOptions <https://petsc.org/release/manualpages/PetscSF/PetscSFSetFromOptions.html>


Source code at petsc4py/PETSc/SF.pyx:117 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L117>



Set star forest graph.

Collective.

The number of leaves argument can be determined from the size of local and/or remote.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SF.pyx:190 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L190>



Set the type of the star forest.

Collective.

sf_type (Type <#petsc4py.PETSc.SF.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The star forest type.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SF.pyx:84 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L84>



View a star forest.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the graph.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SF.pyx:31 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L31>




petsc4py.PETSc.SNES

Bases: Object <#petsc4py.PETSc.Object>

Nonlinear equations solver.

SNES is described in the PETSc manual <https://petsc.org/release/manual/snes.html>.

See also:


Enumerations

ConvergedReason <#petsc4py.PETSc.SNES.ConvergedReason> SNES solver termination reason.
NewtonALCorrectionType <#petsc4py.PETSc.SNES.NewtonALCorrectionType> SNESNEWTONAL correction type.
NormSchedule <#petsc4py.PETSc.SNES.NormSchedule> SNES norm schedule.
Type <#petsc4py.PETSc.SNES.Type> SNES solver type.

petsc4py.PETSc.SNES.ConvergedReason

Bases: object <https://docs.python.org/3/library/functions.html#object>

SNES solver termination reason.

See also:


Attributes Summary

CONVERGED_FNORM_ABS Constant CONVERGED_FNORM_ABS of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_FNORM_RELATIVE Constant CONVERGED_FNORM_RELATIVE of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_ITERATING Constant CONVERGED_ITERATING of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_ITS Constant CONVERGED_ITS of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_SNORM_RELATIVE Constant CONVERGED_SNORM_RELATIVE of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_DTOL Constant DIVERGED_DTOL of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_FNORM_NAN Constant DIVERGED_FNORM_NAN of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_FUNCTION_COUNT Constant DIVERGED_FUNCTION_COUNT of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_FUNCTION_DOMAIN Constant DIVERGED_FUNCTION_DOMAIN of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_INNER Constant DIVERGED_INNER of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_JACOBIAN_DOMAIN Constant DIVERGED_JACOBIAN_DOMAIN of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_LINEAR_SOLVE Constant DIVERGED_LINEAR_SOLVE of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_LINE_SEARCH Constant DIVERGED_LINE_SEARCH of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_LOCAL_MIN Constant DIVERGED_LOCAL_MIN of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_MAX_IT Constant DIVERGED_MAX_IT of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_TR_DELTA Constant DIVERGED_TR_DELTA of type int <https://docs.python.org/3/library/functions.html#int>
ITERATING Constant ITERATING of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation



















petsc4py.PETSc.SNES.NewtonALCorrectionType


petsc4py.PETSc.SNES.NormSchedule

Bases: object <https://docs.python.org/3/library/functions.html#object>

SNES norm schedule.

See also:


Attributes Summary

ALWAYS Constant ALWAYS of type int <https://docs.python.org/3/library/functions.html#int>
DEFAULT Constant DEFAULT of type int <https://docs.python.org/3/library/functions.html#int>
FINAL_ONLY Constant FINAL_ONLY of type int <https://docs.python.org/3/library/functions.html#int>
INITIAL_FINAL_ONLY Constant INITIAL_FINAL_ONLY of type int <https://docs.python.org/3/library/functions.html#int>
INITIAL_ONLY Constant INITIAL_ONLY of type int <https://docs.python.org/3/library/functions.html#int>
NONE Constant NONE of type int <https://docs.python.org/3/library/functions.html#int>
NORM_ALWAYS Constant NORM_ALWAYS of type int <https://docs.python.org/3/library/functions.html#int>
NORM_DEFAULT Constant NORM_DEFAULT of type int <https://docs.python.org/3/library/functions.html#int>
NORM_FINAL_ONLY Constant NORM_FINAL_ONLY of type int <https://docs.python.org/3/library/functions.html#int>
NORM_INITIAL_FINAL_ONLY Constant NORM_INITIAL_FINAL_ONLY of type int <https://docs.python.org/3/library/functions.html#int>
NORM_INITIAL_ONLY Constant NORM_INITIAL_ONLY of type int <https://docs.python.org/3/library/functions.html#int>
NORM_NONE Constant NORM_NONE of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation














petsc4py.PETSc.SNES.Type

Bases: object <https://docs.python.org/3/library/functions.html#object>

SNES solver type.

See also:


Attributes Summary

ANDERSON Object ANDERSON of type str <https://docs.python.org/3/library/stdtypes.html#str>
ASPIN Object ASPIN of type str <https://docs.python.org/3/library/stdtypes.html#str>
COMPOSITE Object COMPOSITE of type str <https://docs.python.org/3/library/stdtypes.html#str>
FAS Object FAS of type str <https://docs.python.org/3/library/stdtypes.html#str>
KSPONLY Object KSPONLY of type str <https://docs.python.org/3/library/stdtypes.html#str>
KSPTRANSPOSEONLY Object KSPTRANSPOSEONLY of type str <https://docs.python.org/3/library/stdtypes.html#str>
MS Object MS of type str <https://docs.python.org/3/library/stdtypes.html#str>
NASM Object NASM of type str <https://docs.python.org/3/library/stdtypes.html#str>
NCG Object NCG of type str <https://docs.python.org/3/library/stdtypes.html#str>
NEWTONAL Object NEWTONAL of type str <https://docs.python.org/3/library/stdtypes.html#str>
NEWTONLS Object NEWTONLS of type str <https://docs.python.org/3/library/stdtypes.html#str>
NEWTONTR Object NEWTONTR of type str <https://docs.python.org/3/library/stdtypes.html#str>
NGMRES Object NGMRES of type str <https://docs.python.org/3/library/stdtypes.html#str>
NGS Object NGS of type str <https://docs.python.org/3/library/stdtypes.html#str>
NRICHARDSON Object NRICHARDSON of type str <https://docs.python.org/3/library/stdtypes.html#str>
PATCH Object PATCH of type str <https://docs.python.org/3/library/stdtypes.html#str>
PYTHON Object PYTHON of type str <https://docs.python.org/3/library/stdtypes.html#str>
QN Object QN of type str <https://docs.python.org/3/library/stdtypes.html#str>
SHELL Object SHELL of type str <https://docs.python.org/3/library/stdtypes.html#str>
VINEWTONRSLS Object VINEWTONRSLS of type str <https://docs.python.org/3/library/stdtypes.html#str>
VINEWTONSSLS Object VINEWTONSSLS of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation























Methods Summary

appendOptionsPrefix(prefix) Append to the prefix used for searching for options in the database.
callConvergenceTest(its, xnorm, ynorm, fnorm) Compute the convergence test.
computeFunction(x, f) Compute the function.
computeJacobian(x, J[, P]) Compute the Jacobian.
computeNGS(x[, b]) Compute a nonlinear Gauss-Seidel step.
computeObjective(x) Compute the value of the objective function.
converged(its, xnorm, ynorm, fnorm) Compute the convergence test and update the solver converged reason.
create([comm]) Create a SNES solver.
createPython([context, comm]) Create a nonlinear solver of Python type.
destroy() Destroy the solver.
getApplicationContext() Return the application context.
getCompositeNumber() Return the number of solvers in the composite.
getCompositeSNES(n) Return the n-th solver in the composite.
getConvergedReason() Return the termination flag.
getConvergenceHistory() Return the convergence history.
getConvergenceTest() Return the callback to used as convergence test.
getDM() Return the DM <#petsc4py.PETSc.DM> associated with the solver.
getDivergenceTolerance() Get the divergence tolerance parameter used in the convergence tests.
getErrorIfNotConverged() Return the flag indicating error on divergence.
getFASCoarseSolve() Return the SNES used at the coarsest level of the FAS hierarchy.
getFASCycleSNES(level) Return the SNES corresponding to a particular level of the FAS hierarchy.
getFASInjection(level) Return the Mat <#petsc4py.PETSc.Mat> used to apply the injection from level-1 to level.
getFASInterpolation(level) Return the Mat <#petsc4py.PETSc.Mat> used to apply the interpolation from level-1 to level.
getFASLevels() Return the number of levels used.
getFASRestriction(level) Return the Mat <#petsc4py.PETSc.Mat> used to apply the restriction from level-1 to level.
getFASSmoother(level) Return the smoother used at a given level of the FAS hierarchy.
getFASSmootherDown(level) Return the downsmoother used at a given level of the FAS hierarchy.
getFASSmootherUp(level) Return the upsmoother used at a given level of the FAS hierarchy.
getFunction() Return the callback to compute the nonlinear function.
getFunctionEvaluations() Return the current number of function evaluations.
getFunctionNorm() Return the function norm.
getInitialGuess() Return the callback to compute the initial guess.
getIterationNumber() Return the current iteration number.
getJacobian() Return the matrices used to compute the Jacobian and the callback tuple.
getKSP() Return the linear solver used by the nonlinear solver.
getKSPFailures() Return the current number of linear solve failures.
getLineSearch() Return the linesearch object associated with this SNES.
getLinearSolveIterations() Return the total number of linear iterations.
getMaxFunctionEvaluations() Return the maximum allowed number of function evaluations.
getMaxKSPFailures() Return the maximum allowed number of linear solve failures.
getMaxStepFailures() Return the maximum allowed number of step failures.
getMonitor() Return the callback used to monitor solver convergence.
getNASMNumber() Return the number of solvers in NASM.
getNASMSNES(n) Return the n-th solver in NASM.
getNGS() Return the nonlinear Gauss-Seidel callback tuple.
getNPC() Return the nonlinear preconditioner associated with the solver.
getNPCSide() Return the nonlinear preconditioning side.
getNewtonALLoadParameter() Return the load parameter for SNESNEWTONAL.
getNormSchedule() Return the norm schedule.
getObjective() Return the objective callback tuple.
getOptionsPrefix() Return the prefix used for searching for options in the database.
getParamsEW() Get the parameters of the Eisenstat and Walker trick.
getPythonContext() Return the instance of the class implementing the required Python methods.
getPythonType() Return the fully qualified Python name of the class used by the solver.
getRhs() Return the vector holding the right-hand side.
getSolution() Return the vector holding the solution.
getSolutionUpdate() Return the vector holding the solution update.
getStepFailures() Return the current number of step failures.
getTRTolerances() Return the tolerance parameters used for the trust region.
getTRUpdateParameters() Return the update parameters used for the trust region.
getTolerances() Return the tolerance parameters used in the solver convergence tests.
getType() Return the type of the solver.
getUpdate() Return the callback to compute the update at the beginning of each step.
getUseEW() Return the flag indicating if the solver uses the Eisenstat-Walker trick.
getUseFD() Return true if the solver uses color finite-differencing for the Jacobian.
getUseKSP() Return the flag indicating if the solver uses a linear solver.
getUseMF() Return the flag indicating if the solver uses matrix-free finite-differencing.
getVIInactiveSet() Return the index set for the inactive set.
getVariableBounds() Get the vectors for the variable bounds.
hasNPC() Return a boolean indicating whether the solver has a nonlinear preconditioner.
logConvergenceHistory(norm[, linear_its]) Log residual norm and linear iterations.
monitor(its, rnorm) Monitor the solver.
monitorCancel() Cancel all the monitors of the solver.
reset() Reset the solver.
setApplicationContext(appctx) Set the application context.
setConvergedReason(reason) Set the termination flag.
setConvergenceHistory([length, reset]) Set the convergence history.
setConvergenceTest(converged[, args, kargs]) Set the callback to use as convergence test.
setDM(dm) Associate a DM <#petsc4py.PETSc.DM> with the solver.
setDivergenceTolerance(dtol) Set the divergence tolerance parameter used in the convergence tests.
setErrorIfNotConverged(flag) Immediately generate an error if the solver has not converged.
setFASInjection(level, mat) Set the Mat <#petsc4py.PETSc.Mat> to be used to apply the injection from level-1 to level.
setFASInterpolation(level, mat) Set the Mat <#petsc4py.PETSc.Mat> to be used to apply the interpolation from level-1 to level.
setFASLevels(levels[, comms]) Set the number of levels to use with FAS.
setFASRScale(level, vec) Set the scaling factor of the restriction operator from level to level-1.
setFASRestriction(level, mat) Set the Mat <#petsc4py.PETSc.Mat> to be used to apply the restriction from level-1 to level.
setForceIteration(force) Force solve to take at least one iteration.
setFromOptions() Configure the solver from the options database.
setFunction(function[, f, args, kargs]) Set the callback to compute the nonlinear function.
setFunctionNorm(norm) Set the function norm value.
setInitialGuess(initialguess[, args, kargs]) Set the callback to compute the initial guess.
setIterationNumber(its) Set the current iteration number.
setJacobian(jacobian[, J, P, args, kargs]) Set the callback to compute the Jacobian.
setKSP(ksp) Set the linear solver that will be used by the nonlinear solver.
setLineSearch(linesearch) Set the linesearch object to be used by this SNES.
setLineSearchPreCheck(precheck[, args, kargs]) Set the callback that will be called before applying the linesearch.
setMaxFunctionEvaluations(max_funcs) Set the maximum allowed number of function evaluations.
setMaxKSPFailures(max_fails) Set the maximum allowed number of linear solve failures.
setMaxStepFailures(max_fails) Set the maximum allowed number of step failures.
setMonitor(monitor[, args, kargs]) Set the callback used to monitor solver convergence.
setNGS(ngs[, args, kargs]) Set the callback to compute nonlinear Gauss-Seidel.
setNPC(snes) Set the nonlinear preconditioner.
setNPCSide(side) Set the nonlinear preconditioning side.
setNewtonALCorrectionType(corrtype) Set the correction type for SNESNEWTONAL.
setNewtonALFunction(function[, args, kargs]) Set the callback to compute the tangent load vector for SNESNEWTONAL.
setNormSchedule(normsched) Set the norm schedule.
setObjective(objective[, args, kargs]) Set the callback to compute the objective function.
setOptionsPrefix(prefix) Set the prefix used for searching for options in the database.
setParamsEW([version, rtol_0, rtol_max, ...]) Set the parameters for the Eisenstat and Walker trick.
setPatchCellNumbering(sec) Set cell patch numbering.
setPatchComputeFunction(function[, args, kargs]) Set patch compute function.
setPatchComputeOperator(operator[, args, kargs]) Set patch compute operator.
setPatchConstructType(typ[, operator, args, ...]) Set patch construct type.
setPatchDiscretisationInfo(dms, bs, ...) Set patch discretisation information.
setPythonContext(context) Set the instance of the class implementing the required Python methods.
setPythonType(py_type) Set the fully qualified Python name of the class to be used.
setResetCounters([reset]) Set the flag to reset the counters.
setSolution(vec) Set the vector used to store the solution.
setTRTolerances([delta_min, delta_max, delta_0]) Set the tolerance parameters used for the trust region.
setTRUpdateParameters([eta1, eta2, eta3, t1, t2]) Set the update parameters used for the trust region.
setTolerances([rtol, atol, stol, max_it]) Set the tolerance parameters used in the solver convergence tests.
setType(snes_type) Set the type of the solver.
setUp() Set up the internal data structures for using the solver.
setUpMatrices() Ensures that matrices are available for Newton-like methods.
setUpdate(update[, args, kargs]) Set the callback to compute update at the beginning of each step.
setUseEW([flag]) Tell the solver to use the Eisenstat-Walker trick.
setUseFD([flag]) Set the boolean flag to use coloring finite-differencing for Jacobian assembly.
setUseKSP([flag]) Set the boolean flag indicating to use a linear solver.
setUseMF([flag]) Set the boolean flag indicating to use matrix-free finite-differencing.
setVariableBounds(xl, xu) Set the vector for the variable bounds.
solve([b, x]) Solve the nonlinear equations.
view([viewer]) View the solver.

Attributes Summary

appctx Application context.
atol Absolute residual tolerance.
dm DM <#petsc4py.PETSc.DM>.
history Convergence history.
is_converged Boolean indicating if the solver has converged.
is_diverged Boolean indicating if the solver has failed.
is_iterating Boolean indicating if the solver has not converged yet.
its Number of iterations.
ksp Linear solver.
linesearch The linesearch object associated with this SNES.
max_funcs Maximum number of function evaluations.
max_it Maximum number of iterations.
norm Function norm.
npc Nonlinear preconditioner.
reason Converged reason.
rtol Relative residual tolerance.
stol Solution update tolerance.
use_ew Use the Eisenstat-Walker trick.
use_fd Boolean indicating if the solver uses coloring finite-differencing.
use_ksp Boolean indicating if the solver uses a linear solver.
use_mf Boolean indicating if the solver uses matrix-free finite-differencing.
vec_rhs Right-hand side vector.
vec_sol Solution vector.
vec_upd Update vector.

Methods Documentation

Append to the prefix used for searching for options in the database.

Logically collective.

See also:

Working with PETSc options <#petsc-options>, setOptionsPrefix, SNESAppendOptionsPrefix <https://petsc.org/release/manualpages/SNES/SNESAppendOptionsPrefix.html>


Source code at petsc4py/PETSc/SNES.pyx:241 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L241>



Compute the convergence test.

Collective.


ConvergedReason <#petsc4py.PETSc.SNES.ConvergedReason>

See also:

setConvergenceTest, getConvergenceTest


Source code at petsc4py/PETSc/SNES.pyx:1340 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1340>


Compute the function.

Collective.

  • x (Vec <#petsc4py.PETSc.Vec>) -- The input state vector.
  • f (Vec <#petsc4py.PETSc.Vec>) -- The output vector.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SNES.pyx:1041 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1041>


Compute the Jacobian.

Collective.

  • x (Vec <#petsc4py.PETSc.Vec>) -- The input state vector.
  • J (Mat <#petsc4py.PETSc.Mat>) -- The output Jacobian matrix.
  • P (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The output Jacobian matrix used to construct the preconditioner.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SNES.pyx:1060 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1060>


Compute a nonlinear Gauss-Seidel step.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SNES.pyx:1147 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1147>


Compute the value of the objective function.

Collective.

x (Vec <#petsc4py.PETSc.Vec>) -- The input state vector.
float <https://docs.python.org/3/library/functions.html#float>

See also:


Source code at petsc4py/PETSc/SNES.pyx:1083 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1083>


Compute the convergence test and update the solver converged reason.

Collective.


See also:

setConvergenceTest, getConvergenceTest, SNESConverged <https://petsc.org/release/manualpages/SNES/SNESConverged.html>


Source code at petsc4py/PETSc/SNES.pyx:1370 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1370>


Create a SNES solver.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>, SNESCreate <https://petsc.org/release/manualpages/SNES/SNESCreate.html>


Source code at petsc4py/PETSc/SNES.pyx:159 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L159>


Create a nonlinear solver of Python type.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

PETSc Python nonlinear solver type (TODO) <#petsc-python-snes>, setType, setPythonContext, Type.PYTHON <#petsc4py.PETSc.SNES.Type.PYTHON>


Source code at petsc4py/PETSc/SNES.pyx:2208 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2208>





Return the n-th solver in the composite.

Not collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:2292 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2292>



Return the termination flag.

Not collective.

See also:



Source code at petsc4py/PETSc/SNES.pyx:1753 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1753>

ConvergedReason <#petsc4py.PETSc.SNES.ConvergedReason>


Return the convergence history.

Not collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:1421 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1421>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[ArrayReal <#petsc4py.typing.ArrayReal>, ArrayInt <#petsc4py.typing.ArrayInt>]


Return the callback to used as convergence test.

Not collective.

See also:

setConvergenceTest, callConvergenceTest


Source code at petsc4py/PETSc/SNES.pyx:1328 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1328>

SNESConvergedFunction <#petsc4py.typing.SNESConvergedFunction>


Return the DM <#petsc4py.PETSc.DM> associated with the solver.

Not collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:293 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L293>

DM <#petsc4py.PETSc.DM>


Get the divergence tolerance parameter used in the convergence tests.

Not collective.

See also:

setDivergenceTolerance, getTolerances, SNESGetDivergenceTolerance <https://petsc.org/release/manualpages/SNES/SNESGetDivergenceTolerance.html>


Source code at petsc4py/PETSc/SNES.pyx:1253 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1253>



Return the flag indicating error on divergence.

Not collective.

See also:

setErrorIfNotConverged, SNESGetErrorIfNotConverged <https://petsc.org/release/manualpages/SNES/SNESGetErrorIfNotConverged.html>


Source code at petsc4py/PETSc/SNES.pyx:1780 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1780>



Return the SNES used at the coarsest level of the FAS hierarchy.

Not collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:608 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L608>

SNES <#petsc4py.PETSc.SNES>


Return the SNES corresponding to a particular level of the FAS hierarchy.

Not collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:591 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L591>



Return the Mat <#petsc4py.PETSc.Mat> used to apply the injection from level-1 to level.

Not collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:514 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L514>



Return the Mat <#petsc4py.PETSc.Mat> used to apply the interpolation from level-1 to level.

Not collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:454 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L454>




Return the Mat <#petsc4py.PETSc.Mat> used to apply the restriction from level-1 to level.

Not collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:484 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L484>



Return the smoother used at a given level of the FAS hierarchy.

Not collective.

See also:

setFASLevels, getFASCoarseSolve, getFASSmootherDown, getFASSmootherUp, SNESFASGetSmoother <https://petsc.org/release/manualpages/SNESFAS/SNESFASGetSmoother.html>, SNESFAS <https://petsc.org/release/manualpages/SNESFAS/SNESFAS.html>


Source code at petsc4py/PETSc/SNES.pyx:623 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L623>



Return the downsmoother used at a given level of the FAS hierarchy.

Not collective.

See also:

setFASLevels, getFASCoarseSolve, getFASSmoother, getFASSmootherUp, SNESFASGetSmootherDown <https://petsc.org/release/manualpages/SNESFAS/SNESFASGetSmootherDown.html>, SNESFAS <https://petsc.org/release/manualpages/SNESFAS/SNESFAS.html>


Source code at petsc4py/PETSc/SNES.pyx:640 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L640>



Return the upsmoother used at a given level of the FAS hierarchy.

Not collective.

See also:

setFASLevels, getFASCoarseSolve, getFASSmoother, getFASSmootherDown, SNESFASGetSmootherUp <https://petsc.org/release/manualpages/SNESFAS/SNESFASGetSmootherUp.html>, SNESFAS <https://petsc.org/release/manualpages/SNESFAS/SNESFAS.html>


Source code at petsc4py/PETSc/SNES.pyx:657 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L657>



Return the callback to compute the nonlinear function.

Not collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:857 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L857>

SNESFunction <#petsc4py.typing.SNESFunction>


Return the current number of function evaluations.

Not collective.

See also:

setMaxFunctionEvaluations, SNESGetNumberFunctionEvals <https://petsc.org/release/manualpages/SNES/SNESGetNumberFunctionEvals.html>


Source code at petsc4py/PETSc/SNES.pyx:1574 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1574>




Return the callback to compute the initial guess.

Not collective.

See also:

setInitialGuess


Source code at petsc4py/PETSc/SNES.pyx:810 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L810>

SNESGuessFunction <#petsc4py.typing.SNESGuessFunction>



Return the matrices used to compute the Jacobian and the callback tuple.

Not collective.

  • J (Mat <#petsc4py.PETSc.Mat>) -- The matrix to store the Jacobian.
  • P (Mat <#petsc4py.PETSc.Mat>) -- The matrix to construct the preconditioner.
  • callback (SNESJacobianFunction <#petsc4py.typing.SNESJacobianFunction>) -- callback, positional and keyword arguments.

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>, SNESJacobianFunction <#petsc4py.typing.SNESJacobianFunction>]

See also:


Source code at petsc4py/PETSc/SNES.pyx:969 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L969>


Return the linear solver used by the nonlinear solver.

Not collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:1950 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1950>

KSP <#petsc4py.PETSc.KSP>


Return the current number of linear solve failures.

Not collective.

See also:



Source code at petsc4py/PETSc/SNES.pyx:1656 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1656>



Return the linesearch object associated with this SNES.

Not collective.

See also:

setLineSearch, linesearch, SNESGetLineSearch <https://petsc.org/release/manualpages/SNES/SNESGetLineSearch.html>


Source code at petsc4py/PETSc/SNES.pyx:2617 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2617>

SNESLineSearch <#petsc4py.PETSc.SNESLineSearch>



Return the maximum allowed number of function evaluations.

Not collective.

See also:

setMaxFunctionEvaluations, SNESSetTolerances <https://petsc.org/release/manualpages/SNES/SNESSetTolerances.html>


Source code at petsc4py/PETSc/SNES.pyx:1558 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1558>



Return the maximum allowed number of linear solve failures.

Not collective.

See also:



Source code at petsc4py/PETSc/SNES.pyx:1642 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1642>



Return the maximum allowed number of step failures.

Not collective.

See also:

setMaxStepFailures, SNESGetMaxNonlinearStepFailures <https://petsc.org/release/manualpages/SNES/SNESGetMaxNonlinearStepFailures.html>


Source code at petsc4py/PETSc/SNES.pyx:1601 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1601>



Return the callback used to monitor solver convergence.

Not collective.

See also:

setMonitor


Source code at petsc4py/PETSc/SNES.pyx:1493 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1493>





Return the nonlinear Gauss-Seidel callback tuple.

Not collective.

See also:

setNGS, computeNGS


Source code at petsc4py/PETSc/SNES.pyx:1133 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1133>

SNESNGSFunction <#petsc4py.typing.SNESNGSFunction>


Return the nonlinear preconditioner associated with the solver.

Not collective.

See also:

setNPC, hasNPC, setNPCSide, getNPCSide, SNESGetNPC <https://petsc.org/release/manualpages/SNES/SNESGetNPC.html>


Source code at petsc4py/PETSc/SNES.pyx:676 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L676>

SNES <#petsc4py.PETSc.SNES>


Return the nonlinear preconditioning side.

Not collective.

See also:

setNPC, getNPC, hasNPC, setNPCSide, SNESGetNPCSide <https://petsc.org/release/manualpages/SNES/SNESGetNPCSide.html>


Source code at petsc4py/PETSc/SNES.pyx:729 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L729>

Side <#petsc4py.PETSc.PC.Side>


Return the load parameter for SNESNEWTONAL.

Not collective.

See also:

setNewtonALFunction, setNewtonALCorrectionType, SNESNewtonALGetLoadParameter <https://petsc.org/release/manualpages/SNES/SNESNewtonALGetLoadParameter.html>


Source code at petsc4py/PETSc/SNES.pyx:2685 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2685>



Return the norm schedule.

Not collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:1279 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1279>

NormSchedule <#petsc4py.PETSc.SNES.NormSchedule>


Return the objective callback tuple.

Not collective.

See also:

setObjective


Source code at petsc4py/PETSc/SNES.pyx:1027 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1027>

SNESObjFunction <#petsc4py.typing.SNESObjFunction>


Return the prefix used for searching for options in the database.

Not collective.

See also:

Working with PETSc options <#petsc-options>, setOptionsPrefix, SNESGetOptionsPrefix <https://petsc.org/release/manualpages/SNES/SNESGetOptionsPrefix.html>


Source code at petsc4py/PETSc/SNES.pyx:227 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L227>




Return the instance of the class implementing the required Python methods.

Not collective.

See also:

PETSc Python nonlinear solver type (TODO) <#petsc-python-snes>, setPythonContext


Source code at petsc4py/PETSc/SNES.pyx:2245 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2245>



Return the fully qualified Python name of the class used by the solver.

Not collective.

See also:

PETSc Python nonlinear solver type (TODO) <#petsc-python-snes>, setPythonContext, setPythonType, SNESPythonGetType <https://petsc.org/release/manualpages/SNES/SNESPythonGetType.html>


Source code at petsc4py/PETSc/SNES.pyx:2275 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2275>



Return the vector holding the right-hand side.

Not collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:1879 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1879>

Vec <#petsc4py.PETSc.Vec>


Return the vector holding the solution.

Not collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:1894 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1894>

Vec <#petsc4py.PETSc.Vec>


Return the vector holding the solution update.

Not collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:1921 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1921>

Vec <#petsc4py.PETSc.Vec>


Return the current number of step failures.

Not collective.

See also:

getMaxStepFailures, SNESGetNonlinearStepFailures <https://petsc.org/release/manualpages/SNES/SNESGetNonlinearStepFailures.html>


Source code at petsc4py/PETSc/SNES.pyx:1615 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1615>



Return the tolerance parameters used for the trust region.

Not collective.


See also:

setTRTolerances, getTRUpdateParameters, SNESNewtonTRGetTolerances <https://petsc.org/release/manualpages/SNES/SNESNewtonTRGetTolerances.html>


Source code at petsc4py/PETSc/SNES.pyx:351 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L351>





Return the callback to compute the update at the beginning of each step.

Not collective.

See also:

setUpdate


Source code at petsc4py/PETSc/SNES.pyx:918 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L918>

SNESUpdateFunction <#petsc4py.typing.SNESUpdateFunction>


Return the flag indicating if the solver uses the Eisenstat-Walker trick.

Not collective.

See also:



Source code at petsc4py/PETSc/SNES.pyx:1988 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1988>



Return true if the solver uses color finite-differencing for the Jacobian.

Not collective.

See also:

setUseFD


Source code at petsc4py/PETSc/SNES.pyx:2148 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2148>



Return the flag indicating if the solver uses a linear solver.

Not collective.

See also:

setUseKSP


Source code at petsc4py/PETSc/SNES.pyx:2092 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2092>



Return the flag indicating if the solver uses matrix-free finite-differencing.

Not collective.

See also:

setUseMF


Source code at petsc4py/PETSc/SNES.pyx:2121 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2121>



Return the index set for the inactive set.

Not collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:2191 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2191>

IS <#petsc4py.PETSc.IS>


Get the vectors for the variable bounds.

Collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:2176 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2176>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>]


Return a boolean indicating whether the solver has a nonlinear preconditioner.

Not collective.

See also:

setNPC, getNPC, setNPCSide, getNPCSide, SNESHasNPC <https://petsc.org/release/manualpages/SNES/SNESHasNPC.html>


Source code at petsc4py/PETSc/SNES.pyx:691 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L691>




Monitor the solver.

Collective.

  • its -- Current number of iterations.
  • rnorm -- Current value of the residual norm.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SNES.pyx:1520 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1520>





Set the termination flag.

Collective.

See also:



Source code at petsc4py/PETSc/SNES.pyx:1740 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1740>

reason (ConvergedReason <#petsc4py.PETSc.SNES.ConvergedReason>)
None <https://docs.python.org/3/library/constants.html#None>



Set the callback to use as convergence test.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

getConvergenceTest, callConvergenceTest, SNESSetConvergenceTest <https://petsc.org/release/manualpages/SNES/SNESSetConvergenceTest.html>


Source code at petsc4py/PETSc/SNES.pyx:1293 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1293>


Associate a DM <#petsc4py.PETSc.DM> with the solver.

Not collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:310 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L310>



Set the divergence tolerance parameter used in the convergence tests.

Logically collective.


See also:

getDivergenceTolerance, setTolerances, SNESSetDivergenceTolerance <https://petsc.org/release/manualpages/SNES/SNESSetDivergenceTolerance.html>


Source code at petsc4py/PETSc/SNES.pyx:1236 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1236>



Set the Mat <#petsc4py.PETSc.Mat> to be used to apply the injection from level-1 to level.

Collective.

See also:

getFASInjection, setFASInterpolation, setFASRestriction, SNESFASSetInjection <https://petsc.org/release/manualpages/SNESFAS/SNESFASSetInjection.html>, SNESFAS <https://petsc.org/release/manualpages/SNESFAS/SNESFAS.html>


Source code at petsc4py/PETSc/SNES.pyx:500 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L500>



Set the Mat <#petsc4py.PETSc.Mat> to be used to apply the interpolation from level-1 to level.

Collective.

See also:

getFASInterpolation, setFASRestriction, setFASInjection, SNESFASSetInterpolation <https://petsc.org/release/manualpages/SNESFAS/SNESFASSetInterpolation.html>, SNESFAS <https://petsc.org/release/manualpages/SNESFAS/SNESFAS.html>


Source code at petsc4py/PETSc/SNES.pyx:440 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L440>



Set the number of levels to use with FAS.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SNES.pyx:543 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L543>


Set the scaling factor of the restriction operator from level to level-1.

Collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:530 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L530>



Set the Mat <#petsc4py.PETSc.Mat> to be used to apply the restriction from level-1 to level.

Collective.

See also:

setFASRScale, getFASRestriction, setFASInterpolation, setFASInjection, SNESFASSetRestriction <https://petsc.org/release/manualpages/SNESFAS/SNESFASSetRestriction.html>, SNESFAS <https://petsc.org/release/manualpages/SNESFAS/SNESFAS.html>


Source code at petsc4py/PETSc/SNES.pyx:470 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L470>




Configure the solver from the options database.

Collective.

See also:

Working with PETSc options <#petsc-options>, SNESSetFromOptions <https://petsc.org/release/manualpages/SNES/SNESSetFromOptions.html>


Source code at petsc4py/PETSc/SNES.pyx:255 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L255>



Set the callback to compute the nonlinear function.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SNES.pyx:822 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L822>


Set the function norm value.

Collective.

This is only of use to implementers of custom SNES types.

See also:


Source code at petsc4py/PETSc/SNES.pyx:1836 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1836>



Set the callback to compute the initial guess.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SNES.pyx:779 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L779>


Set the current iteration number.

Collective.

This is only of use to implementers of custom SNES types.

See also:



Source code at petsc4py/PETSc/SNES.pyx:1794 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1794>



Set the callback to compute the Jacobian.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SNES.pyx:930 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L930>


Set the linear solver that will be used by the nonlinear solver.

Logically collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:1938 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1938>



Set the linesearch object to be used by this SNES.

Logically collective.

See also:

getLineSearch, linesearch, SNESSetLineSearch <https://petsc.org/release/manualpages/SNES/SNESSetLineSearch.html>


Source code at petsc4py/PETSc/SNES.pyx:2632 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2632>

linesearch (SNESLineSearch <#petsc4py.PETSc.SNESLineSearch>)
None <https://docs.python.org/3/library/constants.html#None>


Set the callback that will be called before applying the linesearch.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SNES.pyx:745 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L745>





Set the callback used to monitor solver convergence.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SNES.pyx:1460 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1460>


Set the callback to compute nonlinear Gauss-Seidel.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SNES.pyx:1102 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1102>


Set the nonlinear preconditioner.

Logically collective.

See also:

getNPC, hasNPC, setNPCSide, getNPCSide, SNESSetNPC <https://petsc.org/release/manualpages/SNES/SNESSetNPC.html>


Source code at petsc4py/PETSc/SNES.pyx:705 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L705>



Set the nonlinear preconditioning side.

Collective.

See also:

setNPC, getNPC, hasNPC, getNPCSide, SNESSetNPCSide <https://petsc.org/release/manualpages/SNES/SNESSetNPCSide.html>


Source code at petsc4py/PETSc/SNES.pyx:717 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L717>



Set the correction type for SNESNEWTONAL.

Logically collective.

See also:

getNewtonALLoadParameter, SNESNewtonALSetCorrectionType <https://petsc.org/release/manualpages/SNES/SNESNewtonALSetCorrectionType.html>


Source code at petsc4py/PETSc/SNES.pyx:2700 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2700>

corrtype (NewtonALCorrectionType <#petsc4py.PETSc.SNES.NewtonALCorrectionType>)
None <https://docs.python.org/3/library/constants.html#None>


Set the callback to compute the tangent load vector for SNESNEWTONAL.

Logically collective.


See also:

getNewtonALLoadParameter, SNESNewtonALSetFunction <https://petsc.org/release/manualpages/SNES/SNESNewtonALSetFunction.html>


Source code at petsc4py/PETSc/SNES.pyx:2654 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2654>


Set the norm schedule.

Collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:1267 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1267>

normsched (NormSchedule <#petsc4py.PETSc.SNES.NormSchedule>)
None <https://docs.python.org/3/library/constants.html#None>


Set the callback to compute the objective function.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SNES.pyx:996 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L996>


Set the prefix used for searching for options in the database.

Logically collective.

See also:

Working with PETSc options <#petsc-options>, SNESSetOptionsPrefix <https://petsc.org/release/manualpages/SNES/SNESSetOptionsPrefix.html>


Source code at petsc4py/PETSc/SNES.pyx:213 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L213>



Set the parameters for the Eisenstat and Walker trick.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

setUseEW, getParamsEW, SNESKSPSetParametersEW <https://petsc.org/release/manualpages/SNES/SNESKSPSetParametersEW.html>


Source code at petsc4py/PETSc/SNES.pyx:2002 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2002>







Set the instance of the class implementing the required Python methods.

Not collective.

See also:

PETSc Python nonlinear solver type (TODO) <#petsc-python-snes>, getPythonContext


Source code at petsc4py/PETSc/SNES.pyx:2233 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2233>



Set the fully qualified Python name of the class to be used.

Collective.

See also:

PETSc Python nonlinear solver type (TODO) <#petsc-python-snes>, setPythonContext, getPythonType, SNESPythonSetType <https://petsc.org/release/manualpages/SNES/SNESPythonSetType.html>


Source code at petsc4py/PETSc/SNES.pyx:2260 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2260>




Set the vector used to store the solution.

Collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:1909 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1909>



Set the tolerance parameters used for the trust region.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

getTRTolerances, setTRUpdateParameters, SNESNewtonTRSetTolerances <https://petsc.org/release/manualpages/SNES/SNESNewtonTRSetTolerances.html>


Source code at petsc4py/PETSc/SNES.pyx:324 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L324>


Set the update parameters used for the trust region.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

setTRTolerances, getTRUpdateParameters, SNESNewtonTRSetUpdateParameters <https://petsc.org/release/manualpages/SNES/SNESNewtonTRSetUpdateParameters.html>


Source code at petsc4py/PETSc/SNES.pyx:375 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L375>


Set the tolerance parameters used in the solver convergence tests.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SNES.pyx:1170 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1170>


Set the type of the solver.

Logically collective.

snes_type (Type <#petsc4py.PETSc.SNES.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of the solver.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SNES.pyx:180 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L180>



Ensures that matrices are available for Newton-like methods.

Collective.

This is only of use to implementers of custom SNES types.

See also:


Source code at petsc4py/PETSc/SNES.pyx:1691 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1691>



Set the callback to compute update at the beginning of each step.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SNES.pyx:887 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L887>


Tell the solver to use the Eisenstat-Walker trick.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:



Source code at petsc4py/PETSc/SNES.pyx:1965 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1965>


Set the boolean flag to use coloring finite-differencing for Jacobian assembly.

Logically collective.

See also:

getUseFD


Source code at petsc4py/PETSc/SNES.pyx:2135 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2135>



Set the boolean flag indicating to use a linear solver.

Logically collective.

See also:

getUseKSP


Source code at petsc4py/PETSc/SNES.pyx:2079 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2079>



Set the boolean flag indicating to use matrix-free finite-differencing.

Logically collective.

See also:

getUseMF


Source code at petsc4py/PETSc/SNES.pyx:2108 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2108>



Set the vector for the variable bounds.

Collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:2164 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2164>

  • xl (Vec <#petsc4py.PETSc.Vec>)
  • xu (Vec <#petsc4py.PETSc.Vec>)

None <https://docs.python.org/3/library/constants.html#None>


Solve the nonlinear equations.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

setSolution, getSolution, SNESSolve <https://petsc.org/release/manualpages/SNES/SNESSolve.html>


Source code at petsc4py/PETSc/SNES.pyx:1717 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1717>


View the solver.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> instance or None <https://docs.python.org/3/library/constants.html#None> for the default viewer.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SNES.pyx:127 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L127>


Attributes Documentation


Absolute residual tolerance.

Source code at petsc4py/PETSc/SNES.pyx:2515 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2515>


DM <#petsc4py.PETSc.DM>.

Source code at petsc4py/PETSc/SNES.pyx:2444 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2444>



Boolean indicating if the solver has converged.

Source code at petsc4py/PETSc/SNES.pyx:2587 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2587>


Boolean indicating if the solver has failed.

Source code at petsc4py/PETSc/SNES.pyx:2592 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2592>


Boolean indicating if the solver has not converged yet.

Source code at petsc4py/PETSc/SNES.pyx:2582 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2582>


Number of iterations.

Source code at petsc4py/PETSc/SNES.pyx:2551 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2551>



The linesearch object associated with this SNES.

Source code at petsc4py/PETSc/SNES.pyx:2644 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2644>


Maximum number of function evaluations.

Source code at petsc4py/PETSc/SNES.pyx:2541 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2541>


Maximum number of iterations.

Source code at petsc4py/PETSc/SNES.pyx:2531 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2531>



Nonlinear preconditioner.

Source code at petsc4py/PETSc/SNES.pyx:2454 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2454>



Relative residual tolerance.

Source code at petsc4py/PETSc/SNES.pyx:2507 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2507>


Solution update tolerance.

Source code at petsc4py/PETSc/SNES.pyx:2523 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2523>


Use the Eisenstat-Walker trick.

Source code at petsc4py/PETSc/SNES.pyx:2497 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2497>


Boolean indicating if the solver uses coloring finite-differencing.

Source code at petsc4py/PETSc/SNES.pyx:2607 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2607>


Boolean indicating if the solver uses a linear solver.

Source code at petsc4py/PETSc/SNES.pyx:2489 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2489>


Boolean indicating if the solver uses matrix-free finite-differencing.

Source code at petsc4py/PETSc/SNES.pyx:2599 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2599>


Right-hand side vector.

Source code at petsc4py/PETSc/SNES.pyx:2474 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2474>






petsc4py.PETSc.SNESLineSearch

Bases: Object <#petsc4py.PETSc.Object>

Linesearch object used by SNES solvers.

See also:


Enumerations

Type <#petsc4py.PETSc.SNESLineSearch.Type> SNES linesearch type.

petsc4py.PETSc.SNESLineSearch.Type

Bases: object <https://docs.python.org/3/library/functions.html#object>

SNES linesearch type.

See also:


Attributes Summary

BASIC Object BASIC of type str <https://docs.python.org/3/library/stdtypes.html#str>
BISECTION Object BISECTION of type str <https://docs.python.org/3/library/stdtypes.html#str>
BT Object BT of type str <https://docs.python.org/3/library/stdtypes.html#str>
CP Object CP of type str <https://docs.python.org/3/library/stdtypes.html#str>
NCGLINEAR Object NCGLINEAR of type str <https://docs.python.org/3/library/stdtypes.html#str>
NLEQERR Object NLEQERR of type str <https://docs.python.org/3/library/stdtypes.html#str>
NONE Object NONE of type str <https://docs.python.org/3/library/stdtypes.html#str>
SECANT Object SECANT of type str <https://docs.python.org/3/library/stdtypes.html#str>
SHELL Object SHELL of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation











Methods Summary

create([comm]) Create a new linesearch object.
destroy() Destroy the linesearch object.
getOrder() Return the order of the linesearch.
getTolerances() Return the tolerance parameters used in the linesearch.
getType() Return the type of the linesearch.
setFromOptions() Configure the linesearch from the options database.
setOrder(order) Set the order of the linesearch.
setTolerances([minstep, maxstep, rtol, ...]) Set the tolerance parameters used in the linesearch.
setType(ls_type) Set the type of the linesearch.
view([viewer]) View the linesearch object.

Methods Documentation

Create a new linesearch object.

Collective.

comm (Comm <#petsc4py.PETSc.Comm>, optional) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/SNES.pyx:2749 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2749>








Set the tolerance parameters used in the linesearch.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SNES.pyx:2858 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2858>


Set the type of the linesearch.

Logically collective.

See also:


Source code at petsc4py/PETSc/SNES.pyx:2815 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2815>



View the linesearch object.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> instance or None <https://docs.python.org/3/library/constants.html#None> for the default viewer.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/SNES.pyx:2782 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2782>




petsc4py.PETSc.Scatter

Bases: Object <#petsc4py.PETSc.Object>

Scatter object.

The object used to perform data movement between vectors. Scatter is described in the PETSc manual <https://petsc.org/release/manual/vec.html#sec-scatter>.

See also:

Vec <#petsc4py.PETSc.Vec>, SF <#petsc4py.PETSc.SF>, VecScatter <https://petsc.org/release/manualpages/PetscSF/VecScatter.html>


Enumerations

Mode <#petsc4py.PETSc.Scatter.Mode> Scatter mode.
Type <#petsc4py.PETSc.Scatter.Type> Scatter type.

petsc4py.PETSc.Scatter.Mode

Bases: object <https://docs.python.org/3/library/functions.html#object>

Scatter mode.

Most commonly used scatter modes are:

Scatter values in the forward direction.
Scatter values in the reverse direction.

See also:

Scatter.create <#petsc4py.PETSc.Scatter.create>, Scatter.begin <#petsc4py.PETSc.Scatter.begin>, Scatter.end <#petsc4py.PETSc.Scatter.end>, ScatterMode <https://petsc.org/release/manualpages/Vec/ScatterMode.html>


Attributes Summary

FORWARD Constant FORWARD of type int <https://docs.python.org/3/library/functions.html#int>
FORWARD_LOCAL Constant FORWARD_LOCAL of type int <https://docs.python.org/3/library/functions.html#int>
REVERSE Constant REVERSE of type int <https://docs.python.org/3/library/functions.html#int>
REVERSE_LOCAL Constant REVERSE_LOCAL of type int <https://docs.python.org/3/library/functions.html#int>
SCATTER_FORWARD Constant SCATTER_FORWARD of type int <https://docs.python.org/3/library/functions.html#int>
SCATTER_FORWARD_LOCAL Constant SCATTER_FORWARD_LOCAL of type int <https://docs.python.org/3/library/functions.html#int>
SCATTER_REVERSE Constant SCATTER_REVERSE of type int <https://docs.python.org/3/library/functions.html#int>
SCATTER_REVERSE_LOCAL Constant SCATTER_REVERSE_LOCAL of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation










petsc4py.PETSc.Scatter.Type

Bases: object <https://docs.python.org/3/library/functions.html#object>

Scatter type.

See also:


Attributes Summary

ALLGATHER Object ALLGATHER of type str <https://docs.python.org/3/library/stdtypes.html#str>
ALLGATHERV Object ALLGATHERV of type str <https://docs.python.org/3/library/stdtypes.html#str>
ALLTOALL Object ALLTOALL of type str <https://docs.python.org/3/library/stdtypes.html#str>
BASIC Object BASIC of type str <https://docs.python.org/3/library/stdtypes.html#str>
GATHER Object GATHER of type str <https://docs.python.org/3/library/stdtypes.html#str>
GATHERV Object GATHERV of type str <https://docs.python.org/3/library/stdtypes.html#str>
NEIGHBOR Object NEIGHBOR of type str <https://docs.python.org/3/library/stdtypes.html#str>
WINDOW Object WINDOW of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation










Methods Summary

begin(vec_from, vec_to[, addv, mode]) Begin a generalized scatter from one vector into another.
copy() Return a copy of the scatter.
create(vec_from, is_from, vec_to, is_to) Create a scatter object.
destroy() Destroy the scatter.
end(vec_from, vec_to[, addv, mode]) Complete a generalized scatter from one vector into another.
getType() Return the type of the scatter.
scatter(vec_from, vec_to[, addv, mode]) Perform a generalized scatter from one vector into another.
setFromOptions() Configure the scatter from the options database.
setType(scatter_type) Set the type of the scatter.
setUp() Set up the internal data structures for using the scatter.
toAll(vec) Create a scatter that communicates a vector to all sharing processes.
toZero(vec) Create a scatter that communicates a vector to rank zero.
view([viewer]) View the scatter.

Methods Documentation

Begin a generalized scatter from one vector into another.

Collective.

This call has to be concluded with a call to end. For additional details on the Parameters, see scatter.

See also:


Source code at petsc4py/PETSc/Scatter.pyx:262 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Scatter.pyx#L262>

  • vec_from (Vec <#petsc4py.PETSc.Vec>)
  • vec_to (Vec <#petsc4py.PETSc.Vec>)
  • addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>)
  • mode (ScatterModeSpec <#petsc4py.typing.ScatterModeSpec>)

None <https://docs.python.org/3/library/constants.html#None>


Return a copy of the scatter.

Source code at petsc4py/PETSc/Scatter.pyx:199 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Scatter.pyx#L199>

Scatter <#petsc4py.PETSc.Scatter>


Create a scatter object.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

Examples

The scatter object can be used to repeatedly perform data movement. It is the PETSc equivalent of NumPy-like indexing and slicing, with support for parallel communications:

>>> revmode = PETSc.Scatter.Mode.REVERSE
>>> v1 = PETSc.Vec().createWithArray([1, 2, 3])
>>> v2 = PETSc.Vec().createWithArray([0, 0, 0])
>>> sct = PETSc.Scatter().create(v1,None,v2,None)
>>> sct.scatter(v1,v2) # v2[:] = v1[:]
>>> sct.scatter(v2,v1,mode=revmode) # v1[:] = v2[:]

>>> revmode = PETSc.Scatter.Mode.REVERSE
>>> v1 = PETSc.Vec().createWithArray([1, 2, 3, 4])
>>> v2 = PETSc.Vec().createWithArray([0, 0])
>>> is1 = PETSc.IS().createStride(2, 3, -2)
>>> sct = PETSc.Scatter().create(v1,is1,v2,None)
>>> sct.scatter(v1,v2) # v2[:] = v1[3:0:-2]
>>> sct.scatter(v2,v1,mode=revmode) # v1[3:0:-2] = v2[:]

See also:

IS <#petsc4py.PETSc.IS>, VecScatterCreate <https://petsc.org/release/manualpages/Vec/VecScatterCreate.html>


Source code at petsc4py/PETSc/Scatter.pyx:90 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Scatter.pyx#L90>



Complete a generalized scatter from one vector into another.

Collective.

This call has to be preceded by a call to begin. For additional details on the Parameters, see scatter.

See also:


Source code at petsc4py/PETSc/Scatter.pyx:285 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Scatter.pyx#L285>

  • vec_from (Vec <#petsc4py.PETSc.Vec>)
  • vec_to (Vec <#petsc4py.PETSc.Vec>)
  • addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>)
  • mode (ScatterModeSpec <#petsc4py.typing.ScatterModeSpec>)

None <https://docs.python.org/3/library/constants.html#None>



Perform a generalized scatter from one vector into another.

Collective.

  • vec_from (Vec <#petsc4py.PETSc.Vec>) -- The source vector.
  • vec_to (Vec <#petsc4py.PETSc.Vec>) -- The destination vector.
  • addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
  • mode (ScatterModeSpec <#petsc4py.typing.ScatterModeSpec>) -- Scatter mode.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Scatter.pyx:308 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Scatter.pyx#L308>


Configure the scatter from the options database.

Collective.

See also:

Working with PETSc options <#petsc-options>, VecScatterSetFromOptions <https://petsc.org/release/manualpages/Vec/VecScatterSetFromOptions.html>


Source code at petsc4py/PETSc/Scatter.pyx:174 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Scatter.pyx#L174>



Set the type of the scatter.

Logically collective.

See also:


Source code at petsc4py/PETSc/Scatter.pyx:146 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Scatter.pyx#L146>



Set up the internal data structures for using the scatter.

Collective.

See also:


Source code at petsc4py/PETSc/Scatter.pyx:186 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Scatter.pyx#L186>



Create a scatter that communicates a vector to all sharing processes.

Collective.

vec (Vec <#petsc4py.PETSc.Vec>) -- The vector to scatter from.
tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Scatter <#petsc4py.PETSc.Scatter>, Vec <#petsc4py.PETSc.Vec>]

Notes

The created scatter will have the same communicator of vec. The method also returns an output vector of appropriate size to contain the result of the operation.

See also:


Source code at petsc4py/PETSc/Scatter.pyx:205 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Scatter.pyx#L205>


Create a scatter that communicates a vector to rank zero.

Collective.

vec (Vec <#petsc4py.PETSc.Vec>) -- The vector to scatter from.
tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Scatter <#petsc4py.PETSc.Scatter>, Vec <#petsc4py.PETSc.Vec>]

Notes

The created scatter will have the same communicator of vec. The method also returns an output vector of appropriate size to contain the result of the operation.

See also:


Source code at petsc4py/PETSc/Scatter.pyx:233 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Scatter.pyx#L233>


View the scatter.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> instance or None <https://docs.python.org/3/library/constants.html#None> for the default viewer.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Scatter.pyx:58 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Scatter.pyx#L58>




petsc4py.PETSc.ScatterMode

Bases: object <https://docs.python.org/3/library/functions.html#object>

Scatter mode.

Most commonly used scatter modes are:

Scatter values in the forward direction.
Scatter values in the reverse direction.

See also:

Scatter.create <#petsc4py.PETSc.Scatter.create>, Scatter.begin <#petsc4py.PETSc.Scatter.begin>, Scatter.end <#petsc4py.PETSc.Scatter.end>, ScatterMode <https://petsc.org/release/manualpages/Vec/ScatterMode.html>


Attributes Summary

FORWARD Constant FORWARD of type int <https://docs.python.org/3/library/functions.html#int>
FORWARD_LOCAL Constant FORWARD_LOCAL of type int <https://docs.python.org/3/library/functions.html#int>
REVERSE Constant REVERSE of type int <https://docs.python.org/3/library/functions.html#int>
REVERSE_LOCAL Constant REVERSE_LOCAL of type int <https://docs.python.org/3/library/functions.html#int>
SCATTER_FORWARD Constant SCATTER_FORWARD of type int <https://docs.python.org/3/library/functions.html#int>
SCATTER_FORWARD_LOCAL Constant SCATTER_FORWARD_LOCAL of type int <https://docs.python.org/3/library/functions.html#int>
SCATTER_REVERSE Constant SCATTER_REVERSE of type int <https://docs.python.org/3/library/functions.html#int>
SCATTER_REVERSE_LOCAL Constant SCATTER_REVERSE_LOCAL of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation










petsc4py.PETSc.Section

Bases: Object <#petsc4py.PETSc.Object>

Mapping from integers in a range to unstructured set of integers.

Methods Summary

addConstraintDof(point, numDof) Increment the number of constrained DOFs for a given point.
addDof(point, numDof) Add numDof degrees of freedom associated with a given point.
addFieldConstraintDof(point, field, numDof) Add numDof constrained DOFs for a given field on a point.
addFieldDof(point, field, numDof) Add numDof DOFs associated with a field on a given point.
clone() Return a copy of the section.
create([comm]) Allocate a section and set the map contents to the default.
createGlobalSection(sf) Create a section describing the global field layout.
destroy() Destroy a section.
getChart() Return the range in which points (indices) lie for this section.
getConstrainedStorageSize() Return the size capable of holding all unconstrained DOFs in a section.
getConstraintDof(point) Return the number of constrained DOFs associated with a given point.
getConstraintIndices(point) Return the point DOFs numbers which are constrained for a given point.
getDof(point) Return the number of degrees of freedom for a given point.
getFieldComponents(field) Return the number of field components for the given field.
getFieldConstraintDof(point, field) Return the number of constrained DOFs for a given field on a point.
getFieldConstraintIndices(point, field) Return the field DOFs numbers, in [0, DOFs), which are constrained.
getFieldDof(point, field) Return the number of DOFs associated with a field on a given point.
getFieldName(field) Return the name of a field in the section.
getFieldOffset(point, field) Return the offset for the field DOFs on the given point.
getMaxDof() Return the maximum number of DOFs for any point in the section.
getNumFields() Return the number of fields in a section.
getOffset(point) Return the offset for the DOFs associated with the given point.
getOffsetRange() Return the full range of offsets, [start, end), for a section.
getPermutation() Return the permutation that was set with setPermutation.
getStorageSize() Return the size capable of holding all the DOFs defined in a section.
reset() Free all section data.
setChart(pStart, pEnd) Set the range in which points (indices) lie for this section.
setConstraintDof(point, numDof) Set the number of constrained DOFs associated with a given point.
setConstraintIndices(point, indices) Set the point DOFs numbers, in [0, DOFs), which are constrained.
setDof(point, numDof) Set the number of degrees of freedom associated with a given point.
setFieldComponents(field, numComp) Set the number of field components for the given field.
setFieldConstraintDof(point, field, numDof) Set the number of constrained DOFs for a given field on a point.
setFieldConstraintIndices(point, field, indices) Set the field DOFs numbers, in [0, DOFs), which are constrained.
setFieldDof(point, field, numDof) Set the number of DOFs associated with a field on a given point.
setFieldName(field, fieldName) Set the name of a field in the section.
setFieldOffset(point, field, offset) Set the offset for the DOFs on the given field at a point.
setNumFields(numFields) Set the number of fields in a section.
setOffset(point, offset) Set the offset for the DOFs associated with the given point.
setPermutation(perm) Set the permutation for [0, pEnd - pStart).
setUp() Calculate offsets.
view([viewer]) View the section.

Methods Documentation

Increment the number of constrained DOFs for a given point.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

setConstraintDof, getConstraintDof, PetscSectionAddConstraintDof <https://petsc.org/release/manualpages/PetscSection/PetscSectionAddConstraintDof.html>


Source code at petsc4py/PETSc/Section.pyx:485 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L485>


Add numDof degrees of freedom associated with a given point.

Not collective.


See also:


Source code at petsc4py/PETSc/Section.pyx:354 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L354>


Add numDof constrained DOFs for a given field on a point.

Not collective.


See also:

setFieldConstraintDof, getFieldConstraintDof, PetscSectionAddFieldConstraintDof <https://petsc.org/release/manualpages/PetscSection/PetscSectionAddFieldConstraintDof.html>


Source code at petsc4py/PETSc/Section.pyx:557 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L557>


Add numDof DOFs associated with a field on a given point.

Not collective.


See also:



Source code at petsc4py/PETSc/Section.pyx:421 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L421>


Return a copy of the section.

Collective.

The copy is shallow, if possible.

See also:


Source code at petsc4py/PETSc/Section.pyx:80 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L80>

Section <#petsc4py.PETSc.Section>


Allocate a section and set the map contents to the default.

Collective.

Typical calling sequence: - create - setNumFields - setChart - setDof - setUp - getOffset - destroy

The Section object and methods are intended to be used in the PETSc Vec and Mat implementations. The indices returned by the Section are appropriate for the kind of Vec <#petsc4py.PETSc.Vec> it is associated with. For example, if the vector being indexed is a local vector, we call the section a local section. If the section indexes a global vector, we call it a global section. For parallel vectors, like global vectors, we use negative indices to indicate DOFs owned by other processes.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Section.pyx:42 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L42>


Create a section describing the global field layout.

Collective.

The section describes the global field layout using the local section and an SF <#petsc4py.PETSc.SF> describing the section point overlap.

If we have a set of local sections defining the layout of a set of local vectors, and also an SF <#petsc4py.PETSc.SF> to determine which section points are shared and the ownership, we can calculate a global section defining the parallel data layout, and the associated global vector.

This gives negative sizes and offsets to points not owned by this process.

includeConstraints and localOffsets parameters of the C API are always set to False <https://docs.python.org/3/library/constants.html#False>.

sf (SF <#petsc4py.PETSc.SF>) -- The SF <#petsc4py.PETSc.SF> describing the parallel layout of the section points (leaves are unowned local points).
Section <#petsc4py.PETSc.Section>

See also:


Source code at petsc4py/PETSc/Section.pyx:846 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L846>



Return the range in which points (indices) lie for this section.

Not collective.

The range is [pStart, pEnd), i.e., from the first point to one past the last point.

See also:


Source code at petsc4py/PETSc/Section.pyx:238 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L238>



Return the size capable of holding all unconstrained DOFs in a section.

Not collective.

See also:


Source code at petsc4py/PETSc/Section.pyx:720 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L720>



Return the number of constrained DOFs associated with a given point.

Not collective.


See also:


Source code at petsc4py/PETSc/Section.pyx:445 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L445>


Return the point DOFs numbers which are constrained for a given point.

Not collective.

The range is in [0, DOFs).

point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
ArrayInt <#petsc4py.typing.ArrayInt>

See also:



Source code at petsc4py/PETSc/Section.pyx:586 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L586>


Return the number of degrees of freedom for a given point.

Not collective.

In a global section, this value will be negative for points not owned by this process.


See also:


Source code at petsc4py/PETSc/Section.pyx:311 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L311>


Return the number of field components for the given field.

Not collective.


See also:


Source code at petsc4py/PETSc/Section.pyx:198 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L198>


Return the number of constrained DOFs for a given field on a point.

Not collective.


See also:



Source code at petsc4py/PETSc/Section.pyx:506 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L506>


Return the field DOFs numbers, in [0, DOFs), which are constrained.

Not collective.

The constrained DOFs are sorted in ascending order.


ArrayInt <#petsc4py.typing.ArrayInt>

See also:

setFieldConstraintIndices, PetscSectionGetFieldConstraintIndices <https://petsc.org/release/manualpages/PetscSection/PetscSectionGetFieldConstraintIndices.html>


Source code at petsc4py/PETSc/Section.pyx:634 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L634>




Return the offset for the field DOFs on the given point.

Not collective.

In a global section, this offset will be negative for points not owned by this process.


See also:


Source code at petsc4py/PETSc/Section.pyx:779 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L779>


Return the maximum number of DOFs for any point in the section.

Not collective.

See also:


Source code at petsc4py/PETSc/Section.pyx:692 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L692>



Return the number of fields in a section.

Not collective.

Returns 0 if no fields were defined.

See also:


Source code at petsc4py/PETSc/Section.pyx:122 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L122>



Return the offset for the DOFs associated with the given point.

Not collective.

In a global section, this offset will be negative for points not owned by this process.


See also:


Source code at petsc4py/PETSc/Section.pyx:734 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L734>



Return the permutation that was set with setPermutation.

Not collective.

See also:


Source code at petsc4py/PETSc/Section.pyx:279 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L279>

IS <#petsc4py.PETSc.IS>


Return the size capable of holding all the DOFs defined in a section.

Not collective.

See also:

getConstrainedStorageSize, PetscSectionGetStorageSize <https://petsc.org/release/manualpages/PetscSection/PetscSectionGetStorageSize.html>


Source code at petsc4py/PETSc/Section.pyx:706 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L706>




Set the range in which points (indices) lie for this section.

Not collective.

The range is [pStart, pEnd), i.e., from the first point to one past the last point.


See also:


Source code at petsc4py/PETSc/Section.pyx:255 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L255>


Set the number of constrained DOFs associated with a given point.

Not collective.


See also:

getConstraintDof, addConstraintDof, PetscSectionSetConstraintDof <https://petsc.org/release/manualpages/PetscSection/PetscSectionSetConstraintDof.html>


Source code at petsc4py/PETSc/Section.pyx:464 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L464>



Set the number of degrees of freedom associated with a given point.

Not collective.


See also:


Source code at petsc4py/PETSc/Section.pyx:333 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L333>


Set the number of field components for the given field.

Not collective.


See also:


Source code at petsc4py/PETSc/Section.pyx:217 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L217>


Set the number of constrained DOFs for a given field on a point.

Not collective.


See also:

getFieldConstraintDof, addFieldConstraintDof, PetscSectionSetFieldConstraintDof <https://petsc.org/release/manualpages/PetscSection/PetscSectionSetFieldConstraintDof.html>


Source code at petsc4py/PETSc/Section.pyx:528 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L528>



Set the number of DOFs associated with a field on a given point.

Not collective.


See also:



Source code at petsc4py/PETSc/Section.pyx:397 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L397>



Set the offset for the DOFs on the given field at a point.

Not collective.

The user usually does not call this function, but uses setUp.


See also:


Source code at petsc4py/PETSc/Section.pyx:805 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L805>



Set the offset for the DOFs associated with the given point.

Not collective.

The user usually does not call this function, but uses setUp.


See also:


Source code at petsc4py/PETSc/Section.pyx:756 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L756>


Set the permutation for [0, pEnd - pStart).

Not collective.

perm (IS <#petsc4py.PETSc.IS>) -- The permutation of points.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Section.pyx:294 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L294>


Calculate offsets.

Not collective.

Offsets are based on the number of degrees of freedom for each point.

See also:


Source code at petsc4py/PETSc/Section.pyx:96 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L96>



View the section.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the section.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Section.pyx:10 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L10>



petsc4py.PETSc.Space

Bases: Object <#petsc4py.PETSc.Object>

Function space object.

Enumerations

Type <#petsc4py.PETSc.Space.Type> The function space types.

petsc4py.PETSc.Space.Type

Bases: object <https://docs.python.org/3/library/functions.html#object>

The function space types.

Attributes Summary

POINT Object POINT of type str <https://docs.python.org/3/library/stdtypes.html#str>
POLYNOMIAL Object POLYNOMIAL of type str <https://docs.python.org/3/library/stdtypes.html#str>
PTRIMMED Object PTRIMMED of type str <https://docs.python.org/3/library/stdtypes.html#str>
SUBSPACE Object SUBSPACE of type str <https://docs.python.org/3/library/stdtypes.html#str>
SUM Object SUM of type str <https://docs.python.org/3/library/stdtypes.html#str>
TENSOR Object TENSOR of type str <https://docs.python.org/3/library/stdtypes.html#str>
WXY Object WXY of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation









Methods Summary

create([comm]) Create an empty Space object.
destroy() Destroy the Space object.
getDegree() Return the polynomial degrees that characterize this space.
getDimension() Return the number of basis vectors.
getNumComponents() Return the number of components for this space.
getNumVariables() Return the number of variables for this space.
getPTrimmedFormDegree() Return the form degree of the trimmed polynomials.
getPointPoints() Return the evaluation points for the space as the points of a quad.
getPolynomialTensor() Return whether a function space is a space of tensor polynomials.
getSumConcatenate() Return the concatenate flag for this space.
getSumNumSubspaces() Return the number of spaces in the sum.
getSumSubspace(s) Return a space in the sum.
getTensorNumSubspaces() Return the number of spaces in the tensor product.
getTensorSubspace(s) Return a space in the tensor product.
getType() Return the type of the space object.
setDegree(degree, maxDegree) Set the degree of approximation for this space.
setFromOptions() Set parameters in Space from the options database.
setNumComponents(nc) Set the number of components for this space.
setNumVariables(n) Set the number of variables for this space.
setPTrimmedFormDegree(formDegree) Set the form degree of the trimmed polynomials.
setPointPoints(quad) Set the evaluation points for the space to be based on a quad.
setPolynomialTensor(tensor) Set whether a function space is a space of tensor polynomials.
setSumConcatenate(concatenate) Set the concatenate flag for this space.
setSumNumSubspaces(numSumSpaces) Set the number of spaces in the sum.
setSumSubspace(s, subsp) Set a space in the sum.
setTensorNumSubspaces(numTensSpaces) Set the number of spaces in the tensor product.
setTensorSubspace(s, subsp) Set a space in the tensor product.
setType(space_type) Build a particular type of space.
setUp() Construct data structures for the Space.
view([viewer]) View a Space.

Methods Documentation

Create an empty Space object.

Collective.

The type can then be set with setType.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Space.pyx:36 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L36>



Return the polynomial degrees that characterize this space.

Not collective.


tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, int <https://docs.python.org/3/library/functions.html#int>]

See also:


Source code at petsc4py/PETSc/Space.pyx:117 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L117>



Return the number of components for this space.

Not collective.

See also:


Source code at petsc4py/PETSc/Space.pyx:195 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L195>



Return the number of variables for this space.

Not collective.

See also:


Source code at petsc4py/PETSc/Space.pyx:163 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L163>



Return the form degree of the trimmed polynomials.

Not collective.

See also:

setPTrimmedFormDegree, PetscSpacePTrimmedGetFormDegree <https://petsc.org/release/manualpages/SPACE/PetscSpacePTrimmedGetFormDegree.html>


Source code at petsc4py/PETSc/Space.pyx:546 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L546>



Return the evaluation points for the space as the points of a quad.

Logically collective.

See also:


Source code at petsc4py/PETSc/Space.pyx:513 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L513>

Quad <#petsc4py.PETSc.Quad>


Return whether a function space is a space of tensor polynomials.

Not collective.

Return True <https://docs.python.org/3/library/constants.html#True> if a function space is a space of tensor polynomials (the space is spanned by polynomials whose degree in each variable is bounded by the given order), as opposed to polynomials (the space is spanned by polynomials whose total degree—summing over all variables is bounded by the given order).

See also:

setPolynomialTensor, PetscSpacePolynomialGetTensor <https://petsc.org/release/manualpages/SPACE/PetscSpacePolynomialGetTensor.html>


Source code at petsc4py/PETSc/Space.pyx:448 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L448>



Return the concatenate flag for this space.

Not collective.

A concatenated sum space will have the number of components equal to the sum of the number of components of all subspaces. A non-concatenated, or direct sum space will have the same number of components as its subspaces.

See also:



Source code at petsc4py/PETSc/Space.pyx:261 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L261>



Return the number of spaces in the sum.

Not collective.

See also:



Source code at petsc4py/PETSc/Space.pyx:304 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L304>



Return a space in the sum.

Not collective.

s (int <https://docs.python.org/3/library/functions.html#int>) -- The space number.
Space <#petsc4py.PETSc.Space>

See also:


Source code at petsc4py/PETSc/Space.pyx:318 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L318>


Return the number of spaces in the tensor product.

Not collective.

See also:

setTensorNumSubspaces, PetscSpaceTensorGetNumSubspaces <https://petsc.org/release/manualpages/SPACE/PetscSpaceTensorGetNumSubspaces.html>


Source code at petsc4py/PETSc/Space.pyx:376 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L376>



Return a space in the tensor product.

Not collective.

s (int <https://docs.python.org/3/library/functions.html#int>) -- The space number.
Space <#petsc4py.PETSc.Space>

See also:



Source code at petsc4py/PETSc/Space.pyx:410 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L410>



Set the degree of approximation for this space.

Logically collective.

One of degree and maxDegree can be None <https://docs.python.org/3/library/constants.html#None>.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Space.pyx:138 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L138>


Set parameters in Space from the options database.

Collective.

See also:

Working with PETSc options <#petsc-options>, PetscSpaceSetFromOptions <https://petsc.org/release/manualpages/SPACE/PetscSpaceSetFromOptions.html>


Source code at petsc4py/PETSc/Space.pyx:91 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L91>



Set the number of components for this space.

Logically collective.


See also:


Source code at petsc4py/PETSc/Space.pyx:209 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L209>


Set the number of variables for this space.

Logically collective.


See also:


Source code at petsc4py/PETSc/Space.pyx:177 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L177>


Set the form degree of the trimmed polynomials.

Logically collective.


See also:

getPTrimmedFormDegree, PetscSpacePTrimmedSetFormDegree <https://petsc.org/release/manualpages/SPACE/PetscSpacePTrimmedSetFormDegree.html>


Source code at petsc4py/PETSc/Space.pyx:528 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L528>


Set the evaluation points for the space to be based on a quad.

Logically collective.

Sets the evaluation points for the space to coincide with the points of a quadrature rule.

quad (Quad <#petsc4py.PETSc.Quad>) -- The Quad <#petsc4py.PETSc.Quad> defining the points.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Space.pyx:493 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L493>


Set whether a function space is a space of tensor polynomials.

Logically collective.

Set to True <https://docs.python.org/3/library/constants.html#True> for a function space which is a space of tensor polynomials (the space is spanned by polynomials whose degree in each variable is bounded by the given order), as opposed to polynomials (the space is spanned by polynomials whose total degree—summing over all variables is bounded by the given order).


See also:

getPolynomialTensor, PetscSpacePolynomialSetTensor <https://petsc.org/release/manualpages/SPACE/PetscSpacePolynomialSetTensor.html>


Source code at petsc4py/PETSc/Space.pyx:468 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L468>


Set the concatenate flag for this space.

Logically collective.

A concatenated sum space will have the number of components equal to the sum of the number of components of all subspaces. A non-concatenated, or direct sum space will have the same number of components as its subspaces.


See also:



Source code at petsc4py/PETSc/Space.pyx:280 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L280>


Set the number of spaces in the sum.

Logically collective.


See also:



Source code at petsc4py/PETSc/Space.pyx:358 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L358>


Set a space in the sum.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Space.pyx:338 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L338>


Set the number of spaces in the tensor product.

Logically collective.


See also:

getTensorNumSubspaces, PetscSpaceTensorSetNumSubspaces <https://petsc.org/release/manualpages/SPACE/PetscSpaceTensorSetNumSubspaces.html>


Source code at petsc4py/PETSc/Space.pyx:430 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L430>


Set a space in the tensor product.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:



Source code at petsc4py/PETSc/Space.pyx:390 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L390>


Build a particular type of space.

Collective.

space_type (Type <#petsc4py.PETSc.Space.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The kind of space.
Self

See also:


Source code at petsc4py/PETSc/Space.pyx:241 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L241>



View a Space.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the Space.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Space.pyx:72 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L72>




petsc4py.PETSc.Sys

Bases: object <https://docs.python.org/3/library/functions.html#object>

System utilities.

Methods Summary

Print(*args[, sep, end, comm]) Print output from the first processor of a communicator.
getDefaultComm() Get the default MPI communicator used to create PETSc objects.
getVersion([devel, date, author]) Return PETSc version information.
getVersionInfo() Return PETSc version information.
hasExternalPackage(package) Return whether PETSc has support for external package.
infoAllow(flag[, filename, mode]) Enables or disables PETSc info messages.
isFinalized() Return whether PETSc has been finalized.
isInitialized() Return whether PETSc has been initialized.
popErrorHandler() Remove the current error handler.
popSignalHandler() Remove the current signal handler.
pushErrorHandler(errhandler) Set the current error handler.
registerCitation(citation) Register BibTeX citation.
setDefaultComm(comm) Set the default MPI communicator used to create PETSc objects.
sleep([seconds]) Sleep some number of seconds.
splitOwnership(size[, bsize, comm]) Given a global (or local) size determines a local (or global) size.
syncFlush([comm]) Flush output from previous syncPrint calls.
syncPrint(*args[, sep, end, flush, comm]) Print synchronized output from several processors of a communicator.

Methods Documentation

Print output from the first processor of a communicator.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Sys.pyx:155 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L155>


Get the default MPI communicator used to create PETSc objects.

Not collective.

See also:

setDefaultComm


Source code at petsc4py/PETSc/Sys.pyx:116 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L116>

Comm <#petsc4py.PETSc.Comm>






Return whether PETSc has been finalized.

Not collective.

See also:

isInitialized


Source code at petsc4py/PETSc/Sys.pyx:101 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L101>



Return whether PETSc has been initialized.

Not collective.

See also:

isFinalized


Source code at petsc4py/PETSc/Sys.pyx:88 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L88>







Set the default MPI communicator used to create PETSc objects.

Logically collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator. If set to None <https://docs.python.org/3/library/constants.html#None>, uses COMM_WORLD <#petsc4py.PETSc.COMM_WORLD>.
None <https://docs.python.org/3/library/constants.html#None>

See also:

getDefaultComm


Source code at petsc4py/PETSc/Sys.pyx:131 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L131>



Given a global (or local) size determines a local (or global) size.

Collective.


Notes

The size argument corresponds to the full size of the vector. That is, an array with 10 blocks and a block size of 3 will have a size of 30, not 10.

See also:


Source code at petsc4py/PETSc/Sys.pyx:261 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L261>


Flush output from previous syncPrint calls.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to getDefaultComm.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Sys.pyx:240 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L240>


Print synchronized output from several processors of a communicator.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Sys.pyx:197 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L197>



petsc4py.PETSc.TAO

Bases: Object <#petsc4py.PETSc.Object>

Optimization solver.

TAO is described in the PETSc manual <https://petsc.org/release/manual/tao.html>.

See also:


Enumerations

ALMMType <#petsc4py.PETSc.TAO.ALMMType> TAO Augmented Lagrangian Multiplier method (ALMM) Type.
BNCGType <#petsc4py.PETSc.TAO.BNCGType> TAO Bound Constrained Conjugate Gradient (BNCG) Update Type.
ConvergedReason <#petsc4py.PETSc.TAO.ConvergedReason> TAO solver termination reason.
Type <#petsc4py.PETSc.TAO.Type> TAO solver type.

petsc4py.PETSc.TAO.ALMMType


petsc4py.PETSc.TAO.BNCGType

Bases: object <https://docs.python.org/3/library/functions.html#object>

TAO Bound Constrained Conjugate Gradient (BNCG) Update Type.

Attributes Summary

DK Constant DK of type int <https://docs.python.org/3/library/functions.html#int>
DY Constant DY of type int <https://docs.python.org/3/library/functions.html#int>
FR Constant FR of type int <https://docs.python.org/3/library/functions.html#int>
GD Constant GD of type int <https://docs.python.org/3/library/functions.html#int>
HS Constant HS of type int <https://docs.python.org/3/library/functions.html#int>
HZ Constant HZ of type int <https://docs.python.org/3/library/functions.html#int>
KD Constant KD of type int <https://docs.python.org/3/library/functions.html#int>
PCGD Constant PCGD of type int <https://docs.python.org/3/library/functions.html#int>
PRP Constant PRP of type int <https://docs.python.org/3/library/functions.html#int>
PRP_PLUS Constant PRP_PLUS of type int <https://docs.python.org/3/library/functions.html#int>
SSML_BFGS Constant SSML_BFGS of type int <https://docs.python.org/3/library/functions.html#int>
SSML_BRDN Constant SSML_BRDN of type int <https://docs.python.org/3/library/functions.html#int>
SSML_DFP Constant SSML_DFP of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation















petsc4py.PETSc.TAO.ConvergedReason

Bases: object <https://docs.python.org/3/library/functions.html#object>

TAO solver termination reason.

See also:


Attributes Summary

CONTINUE_ITERATING Constant CONTINUE_ITERATING of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_GATOL Constant CONVERGED_GATOL of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_GRTOL Constant CONVERGED_GRTOL of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_GTTOL Constant CONVERGED_GTTOL of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_ITERATING Constant CONVERGED_ITERATING of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_MINF Constant CONVERGED_MINF of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_STEPTOL Constant CONVERGED_STEPTOL of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_USER Constant CONVERGED_USER of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_LS_FAILURE Constant DIVERGED_LS_FAILURE of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_MAXFCN Constant DIVERGED_MAXFCN of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_MAXITS Constant DIVERGED_MAXITS of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_NAN Constant DIVERGED_NAN of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_TR_REDUCTION Constant DIVERGED_TR_REDUCTION of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_USER Constant DIVERGED_USER of type int <https://docs.python.org/3/library/functions.html#int>
ITERATING Constant ITERATING of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation

















petsc4py.PETSc.TAO.Type

Bases: object <https://docs.python.org/3/library/functions.html#object>

TAO solver type.

See also:


Attributes Summary

ADMM Object ADMM of type str <https://docs.python.org/3/library/stdtypes.html#str>
ALMM Object ALMM of type str <https://docs.python.org/3/library/stdtypes.html#str>
ASFLS Object ASFLS of type str <https://docs.python.org/3/library/stdtypes.html#str>
ASILS Object ASILS of type str <https://docs.python.org/3/library/stdtypes.html#str>
BLMVM Object BLMVM of type str <https://docs.python.org/3/library/stdtypes.html#str>
BMRM Object BMRM of type str <https://docs.python.org/3/library/stdtypes.html#str>
BNCG Object BNCG of type str <https://docs.python.org/3/library/stdtypes.html#str>
BNLS Object BNLS of type str <https://docs.python.org/3/library/stdtypes.html#str>
BNTL Object BNTL of type str <https://docs.python.org/3/library/stdtypes.html#str>
BNTR Object BNTR of type str <https://docs.python.org/3/library/stdtypes.html#str>
BQNKLS Object BQNKLS of type str <https://docs.python.org/3/library/stdtypes.html#str>
BQNKTL Object BQNKTL of type str <https://docs.python.org/3/library/stdtypes.html#str>
BQNKTR Object BQNKTR of type str <https://docs.python.org/3/library/stdtypes.html#str>
BQNLS Object BQNLS of type str <https://docs.python.org/3/library/stdtypes.html#str>
BQPIP Object BQPIP of type str <https://docs.python.org/3/library/stdtypes.html#str>
BRGN Object BRGN of type str <https://docs.python.org/3/library/stdtypes.html#str>
CG Object CG of type str <https://docs.python.org/3/library/stdtypes.html#str>
GPCG Object GPCG of type str <https://docs.python.org/3/library/stdtypes.html#str>
IPM Object IPM of type str <https://docs.python.org/3/library/stdtypes.html#str>
LCL Object LCL of type str <https://docs.python.org/3/library/stdtypes.html#str>
LMVM Object LMVM of type str <https://docs.python.org/3/library/stdtypes.html#str>
NLS Object NLS of type str <https://docs.python.org/3/library/stdtypes.html#str>
NM Object NM of type str <https://docs.python.org/3/library/stdtypes.html#str>
NTL Object NTL of type str <https://docs.python.org/3/library/stdtypes.html#str>
NTR Object NTR of type str <https://docs.python.org/3/library/stdtypes.html#str>
OWLQN Object OWLQN of type str <https://docs.python.org/3/library/stdtypes.html#str>
PDIPM Object PDIPM of type str <https://docs.python.org/3/library/stdtypes.html#str>
POUNDERS Object POUNDERS of type str <https://docs.python.org/3/library/stdtypes.html#str>
PYTHON Object PYTHON of type str <https://docs.python.org/3/library/stdtypes.html#str>
SHELL Object SHELL of type str <https://docs.python.org/3/library/stdtypes.html#str>
SSFLS Object SSFLS of type str <https://docs.python.org/3/library/stdtypes.html#str>
SSILS Object SSILS of type str <https://docs.python.org/3/library/stdtypes.html#str>
TRON Object TRON of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation



































Methods Summary

appendOptionsPrefix(prefix) Append to the prefix used for searching for options in the database.
cancelMonitor() Cancel all the monitors of the solver.
checkConverged() Run convergence test and return converged reason.
computeConstraints(x, c) Compute the vector corresponding to the constraints.
computeDualVariables(xl, xu) Compute the dual vectors corresponding to variables' bounds.
computeGradient(x, g) Compute the gradient of the objective function.
computeHessian(x, H[, P]) Compute the Hessian of the objective function.
computeJacobian(x, J[, P]) Compute the Jacobian.
computeObjective(x) Compute the value of the objective function.
computeObjectiveGradient(x, g) Compute the gradient of the objective function and its value.
computeResidual(x, f) Compute the residual.
computeVariableBounds(xl, xu) Compute the vectors corresponding to variables' bounds.
create([comm]) Create a TAO solver.
createPython([context, comm]) Create an optimization solver of Python type.
destroy() Destroy the solver.
getALMMSubsolver() Return the subsolver inside the ALMM solver.
getALMMType() Return the type of the ALMM solver.
getAppCtx() Return the application context.
getBNCGType() Return the type of the BNCG solver.
getBRGNDampingVector() Return the damping vector.
getBRGNSubsolver() Return the subsolver inside the BRGN solver.
getConstraintTolerances() Return the constraints tolerance parameters used in the convergence tests.
getConvergedReason() Return the reason for the solver convergence.
getConvergenceTest() Return the callback used to test for solver convergence.
getEqualityConstraints() Return tuple holding vector and callback of equality constraints.
getGradient() Return the vector used to store the gradient and the evaluation callback.
getGradientNorm() Return the matrix used to compute inner products.
getHessian() Return the matrices used to store the Hessian and the evaluation callback.
getInequalityConstraints() Return tuple holding vector and callback of inequality constraints.
getIterationNumber() Return the current iteration number.
getJacobianEquality() Return matrix, precon matrix and callback of equality constraints Jacobian.
getJacobianInequality() Return matrix, precon matrix and callback of ineq.
getKSP() Return the linear solver used by the nonlinear solver.
getLMVMH0() Return the initial Hessian for the quasi-Newton approximation.
getLMVMH0KSP() Return the KSP <#petsc4py.PETSc.KSP> for the inverse of the initial Hessian approximation.
getLMVMMat() Get the LMVM matrix.
getLineSearch() Return the TAO Line Search object.
getMaximumFunctionEvaluations() Return the maximum number of objective evaluations within the solver.
getMaximumIterations() Return the maximum number of solver iterations.
getMonitor() Return the callback used to monitor solver convergence.
getObjective() Return the objective evaluation callback.
getObjectiveAndGradient() Return the vector used to store the gradient and the evaluation callback.
getObjectiveValue() Return the current value of the objective function.
getOptionsPrefix() Return the prefix used for searching for options in the database.
getPythonContext() Return the instance of the class implementing the required Python methods.
getPythonType() Return the fully qualified Python name of the class used by the solver.
getSolution() Return the vector holding the solution.
getSolutionNorm() Return the objective function value and the norms of gradient and constraints.
getSolutionStatus() Return the solution status.
getTolerances() Return the tolerance parameters used in the solver convergence tests.
getType() Return the type of the solver.
getUpdate() Return the callback to compute the update.
getVariableBounds() Return the lower and upper bounds vectors.
monitor([its, f, res, cnorm, step]) Monitor the solver.
setALMMSubsolver(subsolver) Set the subsolver inside the ALMM solver.
setALMMType(tao_almm_type) Set the ALMM type of the solver.
setAppCtx(appctx) Set the application context.
setBNCGType(cg_type) Set the type of the BNCG solver.
setBRGNDictionaryMatrix(D) Set the dictionary matrix.
setBRGNRegularizerHessian(hessian[, H, ...]) Set the callback to compute the regularizer Hessian.
setBRGNRegularizerObjectiveGradient(objgrad) Set the callback to compute the regularizer objective and gradient.
setBRGNRegularizerWeight(weight) Set the regularizer weight.
setBRGNSmoothL1Epsilon(epsilon) Set the smooth L1 epsilon.
setConstraintTolerances([catol, crtol]) Set the constraints tolerance parameters used in the solver convergence tests.
setConstraints(constraints[, C, args, kargs]) Set the callback to compute constraints.
setConvergedReason(reason) Set the termination flag.
setConvergenceTest(converged[, args, kargs]) Set the callback used to test for solver convergence.
setEqualityConstraints(equality_constraints, c) Set equality constraints callback.
setFromOptions() Configure the solver from the options database.
setGradient(gradient[, g, args, kargs]) Set the gradient evaluation callback.
setGradientNorm(mat) Set the matrix used to compute inner products.
setHessian(hessian[, H, P, args, kargs]) Set the callback to compute the Hessian matrix.
setInequalityConstraints(...[, args, kargs]) Set inequality constraints callback.
setInitialTrustRegionRadius(radius) Set the initial trust region radius.
setIterationNumber(its) Set the current iteration number.
setJacobian(jacobian[, J, P, args, kargs]) Set the callback to compute the Jacobian.
setJacobianDesign(jacobian_design[, J, ...]) Set Jacobian design callback.
setJacobianEquality(jacobian_equality[, J, ...]) Set Jacobian equality constraints callback.
setJacobianInequality(jacobian_inequality[, ...]) Set Jacobian inequality constraints callback.
setJacobianResidual(jacobian[, J, P, args, ...]) Set the callback to compute the least-squares residual Jacobian.
setJacobianState(jacobian_state[, J, P, I, ...]) Set Jacobian state callback.
setLMVMH0(mat) Set the initial Hessian for the quasi-Newton approximation.
setLMVMMat(M) Set the LMVM matrix.
setMaximumFunctionEvaluations(mit) Set the maximum number of objective evaluations within the solver.
setMaximumIterations(mit) Set the maximum number of solver iterations.
setMonitor(monitor[, args, kargs]) Set the callback used to monitor solver convergence.
setObjective(objective[, args, kargs]) Set the objective function evaluation callback.
setObjectiveGradient(objgrad[, g, args, kargs]) Set the objective function and gradient evaluation callback.
setOptionsPrefix(prefix) Set the prefix used for searching for options in the database.
setPythonContext(context) Set the instance of the class implementing the required Python methods.
setPythonType(py_type) Set the fully qualified Python name of the class to be used.
setResidual(residual, R[, args, kargs]) Set the residual evaluation callback for least-squares applications.
setSolution(x) Set the vector used to store the solution.
setStateDesignIS([state, design]) Set the index sets indicating state and design variables.
setTolerances([gatol, grtol, gttol]) Set the tolerance parameters used in the solver convergence tests.
setType(tao_type) Set the type of the solver.
setUp() Set up the internal data structures for using the solver.
setUpdate(update[, args, kargs]) Set the callback to compute update at each optimization step.
setVariableBounds(varbounds[, args, kargs]) Set the lower and upper bounds for the optimization problem.
solve([x]) Solve the optimization problem.
view([viewer]) View the solver.

Attributes Summary

appctx Application context.
cnorm Constraints norm.
converged Boolean indicating if the solver has converged.
ctol Broken.
diverged Boolean indicating if the solver has failed.
ftol Broken.
function Objective value.
gnorm Gradient norm.
gradient Gradient vector.
gtol Broken.
iterating Boolean indicating if the solver has not converged yet.
its Number of iterations.
ksp Linear solver.
objective Objective value.
reason Converged reason.
solution Solution vector.

Methods Documentation

Append to the prefix used for searching for options in the database.

Logically collective.

See also:

Working with PETSc options <#petsc-options>, setOptionsPrefix, TaoAppendOptionsPrefix <https://petsc.org/release/manualpages/Tao/TaoAppendOptionsPrefix.html>


Source code at petsc4py/PETSc/TAO.pyx:220 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L220>




Run convergence test and return converged reason.

Collective.

See also:

converged


Source code at petsc4py/PETSc/TAO.pyx:1700 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1700>

ConvergedReason <#petsc4py.PETSc.TAO.ConvergedReason>


Compute the vector corresponding to the constraints.

Collective.

  • x (Vec <#petsc4py.PETSc.Vec>) -- The parameter vector.
  • c (Vec <#petsc4py.PETSc.Vec>) -- The output constraints vector.

None <https://docs.python.org/3/library/constants.html#None>

See also:



Source code at petsc4py/PETSc/TAO.pyx:1040 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1040>


Compute the dual vectors corresponding to variables' bounds.

Collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:1004 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1004>

  • xl (Vec <#petsc4py.PETSc.Vec>)
  • xu (Vec <#petsc4py.PETSc.Vec>)

None <https://docs.python.org/3/library/constants.html#None>


Compute the gradient of the objective function.

Collective.

  • x (Vec <#petsc4py.PETSc.Vec>) -- The parameter vector.
  • g (Vec <#petsc4py.PETSc.Vec>) -- The output gradient vector.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TAO.pyx:963 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L963>


Compute the Hessian of the objective function.

Collective.

  • x (Vec <#petsc4py.PETSc.Vec>) -- The parameter vector.
  • H (Mat <#petsc4py.PETSc.Mat>) -- The output Hessian matrix.
  • P (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The output Hessian matrix used to construct the preconditioner.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TAO.pyx:1059 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1059>


Compute the Jacobian.

Collective.

  • x (Vec <#petsc4py.PETSc.Vec>) -- The parameter vector.
  • J (Mat <#petsc4py.PETSc.Mat>) -- The output Jacobian matrix.
  • P (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The output Jacobian matrix used to construct the preconditioner.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TAO.pyx:1082 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1082>


Compute the value of the objective function.

Collective.

x (Vec <#petsc4py.PETSc.Vec>) -- The parameter vector.
float <https://docs.python.org/3/library/functions.html#float>

See also:


Source code at petsc4py/PETSc/TAO.pyx:925 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L925>


Compute the gradient of the objective function and its value.

Collective.

  • x (Vec <#petsc4py.PETSc.Vec>) -- The parameter vector.
  • g (Vec <#petsc4py.PETSc.Vec>) -- The output gradient vector.

float <https://docs.python.org/3/library/functions.html#float>

See also:

setObjectiveGradient, setGradient, setObjective, TaoComputeObjectiveAndGradient <https://petsc.org/release/manualpages/Tao/TaoComputeObjectiveAndGradient.html>


Source code at petsc4py/PETSc/TAO.pyx:982 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L982>


Compute the residual.

Collective.

  • x (Vec <#petsc4py.PETSc.Vec>) -- The parameter vector.
  • f (Vec <#petsc4py.PETSc.Vec>) -- The output vector.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TAO.pyx:944 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L944>


Compute the vectors corresponding to variables' bounds.

Collective.

See also:



Source code at petsc4py/PETSc/TAO.pyx:1016 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1016>

  • xl (Vec <#petsc4py.PETSc.Vec>)
  • xu (Vec <#petsc4py.PETSc.Vec>)

None <https://docs.python.org/3/library/constants.html#None>


Create a TAO solver.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>, TaoCreate <https://petsc.org/release/manualpages/Tao/TaoCreate.html>


Source code at petsc4py/PETSc/TAO.pyx:152 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L152>


Create an optimization solver of Python type.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

PETSc Python optimization solver type (TODO) <#petsc-python-tao>, setType, setPythonContext, Type.PYTHON <#petsc4py.PETSc.TAO.Type.PYTHON>


Source code at petsc4py/PETSc/TAO.pyx:1891 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1891>



Return the subsolver inside the ALMM solver.

Not collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:1731 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1731>

TAO <#petsc4py.PETSc.TAO>


Return the type of the ALMM solver.

Not collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:1746 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1746>

ALMMType <#petsc4py.PETSc.TAO.ALMMType>



Return the type of the BNCG solver.

Not collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:1569 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1569>

BNCGType <#petsc4py.PETSc.TAO.BNCGType>


Return the damping vector.

Not collective.

Source code at petsc4py/PETSc/TAO.pyx:1876 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1876>

Vec <#petsc4py.PETSc.Vec>


Return the subsolver inside the BRGN solver.

Not collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:1793 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1793>

TAO <#petsc4py.PETSc.TAO>


Return the constraints tolerance parameters used in the convergence tests.

Not collective.


See also:

setConstraintTolerances, TaoGetConstraintTolerances <https://petsc.org/release/manualpages/Tao/TaoGetConstraintTolerances.html>


Source code at petsc4py/PETSc/TAO.pyx:1244 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1244>


Return the reason for the solver convergence.

Not collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:1626 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1626>

ConvergedReason <#petsc4py.PETSc.TAO.ConvergedReason>




Return the vector used to store the gradient and the evaluation callback.

Not collective.

See also:

setGradient, setHessian, TaoGetGradient <https://petsc.org/release/manualpages/Tao/TaoGetGradient.html>


Source code at petsc4py/PETSc/TAO.pyx:436 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L436>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, TAOGradientFunction <#petsc4py.typing.TAOGradientFunction>]


Return the matrix used to compute inner products.

Not collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:1484 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1484>

Mat <#petsc4py.PETSc.Mat>


Return the matrices used to store the Hessian and the evaluation callback.

Not collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:598 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L598>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>, TAOHessianFunction <#petsc4py.typing.TAOHessianFunction>]






Return the linear solver used by the nonlinear solver.

Not collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:1714 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1714>

KSP <#petsc4py.PETSc.KSP>


Return the initial Hessian for the quasi-Newton approximation.

Not collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:1511 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1511>

Mat <#petsc4py.PETSc.Mat>


Return the KSP <#petsc4py.PETSc.KSP> for the inverse of the initial Hessian approximation.

Not collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:1526 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1526>

KSP <#petsc4py.PETSc.KSP>


Get the LMVM matrix.

Not collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:709 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L709>

Mat <#petsc4py.PETSc.Mat>


Return the TAO Line Search object.

Not collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:1973 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1973>

TAOLineSearch <#petsc4py.PETSc.TAOLineSearch>


Return the maximum number of objective evaluations within the solver.

Not collective.

See also:

setMaximumFunctionEvaluations, TaoGetMaximumFunctionEvaluations <https://petsc.org/release/manualpages/Tao/TaoGetMaximumFunctionEvaluations.html>


Source code at petsc4py/PETSc/TAO.pyx:1204 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1204>



Return the maximum number of solver iterations.

Not collective.

See also:

setMaximumIterations, TaoGetMaximumIterations <https://petsc.org/release/manualpages/Tao/TaoGetMaximumIterations.html>


Source code at petsc4py/PETSc/TAO.pyx:1177 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1177>




Return the objective evaluation callback.

Not collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:423 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L423>

TAOObjectiveFunction <#petsc4py.typing.TAOObjectiveFunction>


Return the vector used to store the gradient and the evaluation callback.

Not collective.

See also:

setObjectiveGradient, TaoGetObjectiveAndGradient <https://petsc.org/release/manualpages/Tao/TaoGetObjectiveAndGradient.html>


Source code at petsc4py/PETSc/TAO.pyx:482 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L482>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, TAOObjectiveGradientFunction <#petsc4py.typing.TAOObjectiveGradientFunction>]


Return the current value of the objective function.

Not collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:1610 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1610>



Return the prefix used for searching for options in the database.

Not collective.

See also:

Working with PETSc options <#petsc-options>, setOptionsPrefix, TaoGetOptionsPrefix <https://petsc.org/release/manualpages/Tao/TaoGetOptionsPrefix.html>


Source code at petsc4py/PETSc/TAO.pyx:234 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L234>



Return the instance of the class implementing the required Python methods.

Not collective.

See also:

PETSc Python optimization solver type (TODO) <#petsc-python-tao>, setPythonContext


Source code at petsc4py/PETSc/TAO.pyx:1928 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1928>



Return the fully qualified Python name of the class used by the solver.

Not collective.

See also:

PETSc Python optimization solver type (TODO) <#petsc-python-tao>, setPythonContext, setPythonType, TaoPythonGetType <https://petsc.org/release/manualpages/Tao/TaoPythonGetType.html>


Source code at petsc4py/PETSc/TAO.pyx:1958 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1958>



Return the vector holding the solution.

Not collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:1457 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1457>

Vec <#petsc4py.PETSc.Vec>


Return the objective function value and the norms of gradient and constraints.

Not collective.


See also:


Source code at petsc4py/PETSc/TAO.pyx:1640 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1640>


Return the solution status.

Not collective.


tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, float <https://docs.python.org/3/library/functions.html#float>, float <https://docs.python.org/3/library/functions.html#float>, float <https://docs.python.org/3/library/functions.html#float>, float <https://docs.python.org/3/library/functions.html#float>, ConvergedReason <#petsc4py.PETSc.TAO.ConvergedReason>]

See also:


Source code at petsc4py/PETSc/TAO.pyx:1665 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1665>


Return the tolerance parameters used in the solver convergence tests.

Not collective.


See also:


Source code at petsc4py/PETSc/TAO.pyx:1140 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1140>




Return the lower and upper bounds vectors.

Not collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:1541 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1541>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>]


Monitor the solver.

Collective.

This function should be called without arguments, unless users want to modify the values internally stored by the solver.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TAO.pyx:1387 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1387>


Set the subsolver inside the ALMM solver.

Logically collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:1760 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1760>



Set the ALMM type of the solver.

Logically collective.

tao_almm_type (ALMMType <#petsc4py.PETSc.TAO.ALMMType>) -- The type of the solver.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TAO.pyx:1773 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1773>



Set the type of the BNCG solver.

Collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:1556 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1556>

cg_type (BNCGType <#petsc4py.PETSc.TAO.BNCGType>)
None <https://docs.python.org/3/library/constants.html#None>







Set the constraints tolerance parameters used in the solver convergence tests.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

getConstraintTolerances, TaoSetConstraintTolerances <https://petsc.org/release/manualpages/Tao/TaoSetConstraintTolerances.html>


Source code at petsc4py/PETSc/TAO.pyx:1218 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1218>


Set the callback to compute constraints.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TAO.pyx:534 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L534>


Set the termination flag.

Collective.

See also:



Source code at petsc4py/PETSc/TAO.pyx:1305 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1305>

reason (ConvergedReason <#petsc4py.PETSc.TAO.ConvergedReason>)
None <https://docs.python.org/3/library/constants.html#None>


Set the callback used to test for solver convergence.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:



Source code at petsc4py/PETSc/TAO.pyx:1265 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1265>



Configure the solver from the options database.

Collective.

See also:

Working with PETSc options <#petsc-options>, TaoSetFromOptions <https://petsc.org/release/manualpages/Tao/TaoSetFromOptions.html>


Source code at petsc4py/PETSc/TAO.pyx:248 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L248>



Set the gradient evaluation callback.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

setObjective, setObjectiveGradient, setHessian, TaoSetGradient <https://petsc.org/release/manualpages/Tao/TaoSetGradient.html>


Source code at petsc4py/PETSc/TAO.pyx:394 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L394>


Set the matrix used to compute inner products.

Collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:1472 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1472>



Set the callback to compute the Hessian matrix.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

getHessian, setObjective, setObjectiveGradient, setGradient, TaoSetHessian <https://petsc.org/release/manualpages/Tao/TaoSetHessian.html>


Source code at petsc4py/PETSc/TAO.pyx:563 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L563>





Set the callback to compute the Jacobian.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TAO.pyx:616 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L616>





Set the callback to compute the least-squares residual Jacobian.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TAO.pyx:361 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L361>



Set the initial Hessian for the quasi-Newton approximation.

Collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:1499 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1499>



Set the LMVM matrix.

Logically collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:724 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L724>






Set the objective function evaluation callback.

Logically collective.


See also:

setGradient, setObjectiveGradient, TaoSetObjective <https://petsc.org/release/manualpages/Tao/TaoSetObjective.html>


Source code at petsc4py/PETSc/TAO.pyx:309 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L309>


Set the objective function and gradient evaluation callback.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

setObjective, setGradient, setHessian, getObjectiveAndGradient, TaoSetObjectiveAndGradient <https://petsc.org/release/manualpages/Tao/TaoSetObjectiveAndGradient.html>


Source code at petsc4py/PETSc/TAO.pyx:452 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L452>


Set the prefix used for searching for options in the database.

Logically collective.

See also:

Working with PETSc options <#petsc-options>, TaoSetOptionsPrefix <https://petsc.org/release/manualpages/Tao/TaoSetOptionsPrefix.html>


Source code at petsc4py/PETSc/TAO.pyx:206 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L206>



Set the instance of the class implementing the required Python methods.

Not collective.

See also:

PETSc Python optimization solver type (TODO) <#petsc-python-tao>, getPythonContext


Source code at petsc4py/PETSc/TAO.pyx:1916 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1916>



Set the fully qualified Python name of the class to be used.

Collective.

See also:

PETSc Python optimization solver type (TODO) <#petsc-python-tao>, setPythonContext, getPythonType, TaoPythonSetType <https://petsc.org/release/manualpages/Tao/TaoPythonSetType.html>


Source code at petsc4py/PETSc/TAO.pyx:1943 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1943>



Set the residual evaluation callback for least-squares applications.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:



Source code at petsc4py/PETSc/TAO.pyx:334 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L334>


Set the vector used to store the solution.

Collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:297 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L297>




Set the tolerance parameters used in the solver convergence tests.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TAO.pyx:1107 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1107>


Set the type of the solver.

Logically collective.

tao_type (Type <#petsc4py.PETSc.TAO.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of the solver.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TAO.pyx:173 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L173>




Set the lower and upper bounds for the optimization problem.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TAO.pyx:498 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L498>


Solve the optimization problem.

Collective.

x (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- The starting vector or None <https://docs.python.org/3/library/constants.html#None> to use the vector stored internally.
None <https://docs.python.org/3/library/constants.html#None>

See also:

setSolution, getSolution, TaoSolve <https://petsc.org/release/manualpages/Tao/TaoSolve.html>


Source code at petsc4py/PETSc/TAO.pyx:1438 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1438>


View the solver.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> instance or None <https://docs.python.org/3/library/constants.html#None> for the default viewer.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TAO.pyx:120 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L120>


Attributes Documentation



Boolean indicating if the solver has converged.

Source code at petsc4py/PETSc/TAO.pyx:2100 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2100>



Boolean indicating if the solver has failed.

Source code at petsc4py/PETSc/TAO.pyx:2105 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2105>







Boolean indicating if the solver has not converged yet.

Source code at petsc4py/PETSc/TAO.pyx:2095 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2095>


Number of iterations.

Source code at petsc4py/PETSc/TAO.pyx:2053 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2053>








petsc4py.PETSc.TAOLineSearch

Bases: Object <#petsc4py.PETSc.Object>

TAO Line Search.

Enumerations

ConvergedReason <#petsc4py.PETSc.TAOLineSearch.ConvergedReason> TAO Line Search Termination Reasons.
Type <#petsc4py.PETSc.TAOLineSearch.Type> TAO Line Search Types.

petsc4py.PETSc.TAOLineSearch.ConvergedReason

Bases: object <https://docs.python.org/3/library/functions.html#object>

TAO Line Search Termination Reasons.

Attributes Summary

CONTINUE_SEARCH Constant CONTINUE_SEARCH of type int <https://docs.python.org/3/library/functions.html#int>
FAILED_ASCENT Constant FAILED_ASCENT of type int <https://docs.python.org/3/library/functions.html#int>
FAILED_BADPARAMETER Constant FAILED_BADPARAMETER of type int <https://docs.python.org/3/library/functions.html#int>
FAILED_INFORNAN Constant FAILED_INFORNAN of type int <https://docs.python.org/3/library/functions.html#int>
HALTED_LOWERBOUND Constant HALTED_LOWERBOUND of type int <https://docs.python.org/3/library/functions.html#int>
HALTED_MAXFCN Constant HALTED_MAXFCN of type int <https://docs.python.org/3/library/functions.html#int>
HALTED_OTHER Constant HALTED_OTHER of type int <https://docs.python.org/3/library/functions.html#int>
HALTED_RTOL Constant HALTED_RTOL of type int <https://docs.python.org/3/library/functions.html#int>
HALTED_UPPERBOUND Constant HALTED_UPPERBOUND of type int <https://docs.python.org/3/library/functions.html#int>
HALTED_USER Constant HALTED_USER of type int <https://docs.python.org/3/library/functions.html#int>
SUCCESS Constant SUCCESS of type int <https://docs.python.org/3/library/functions.html#int>
SUCCESS_USER Constant SUCCESS_USER of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation














petsc4py.PETSc.TAOLineSearch.Type

Bases: object <https://docs.python.org/3/library/functions.html#object>

TAO Line Search Types.

Attributes Summary

ARMIJO Object ARMIJO of type str <https://docs.python.org/3/library/stdtypes.html#str>
GPCG Object GPCG of type str <https://docs.python.org/3/library/stdtypes.html#str>
IPM Object IPM of type str <https://docs.python.org/3/library/stdtypes.html#str>
MORETHUENTE Object MORETHUENTE of type str <https://docs.python.org/3/library/stdtypes.html#str>
OWARMIJO Object OWARMIJO of type str <https://docs.python.org/3/library/stdtypes.html#str>
UNIT Object UNIT of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation








Methods Summary

apply(x, g, s) Performs a line-search in a given step direction.
create([comm]) Create a TAO linesearch.
destroy() Destroy the linesearch object.
getOptionsPrefix() Return the prefix used for searching for options in the database.
getType() Return the type of the linesearch.
setFromOptions() Configure the linesearch from the options database.
setGradient(gradient[, args, kargs]) Set the gradient evaluation callback.
setInitialStepLength(s) Sets the initial step length of a line search.
setObjective(objective[, args, kargs]) Set the objective function evaluation callback.
setObjectiveGradient(objgrad[, args, kargs]) Set the objective function and gradient evaluation callback.
setOptionsPrefix([prefix]) Set the prefix used for searching for options in the database.
setType(ls_type) Set the type of the linesearch.
setUp() Set up the internal data structures for using the linesearch.
useTAORoutine(tao) Use the objective and gradient evaluation routines from the given Tao object.
view([viewer]) View the linesearch object.

Methods Documentation


Create a TAO linesearch.

Collective.

comm -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>, TaoLineSearchCreate <https://petsc.org/release/manualpages/TaoLineSearch/TaoLineSearchCreate.html>


Source code at petsc4py/PETSc/TAO.pyx:2194 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2194>



Return the prefix used for searching for options in the database.

Not collective.

See also:

Working with PETSc options <#petsc-options>, setOptionsPrefix, TaoLineSearchGetOptionsPrefix <https://petsc.org/release/manualpages/TaoLineSearch/TaoLineSearchGetOptionsPrefix.html>


Source code at petsc4py/PETSc/TAO.pyx:2286 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2286>




Configure the linesearch from the options database.

Collective.

See also:

Working with PETSc options <#petsc-options>, TaoLineSearchSetFromOptions <https://petsc.org/release/manualpages/TaoLineSearch/TaoLineSearchSetFromOptions.html>


Source code at petsc4py/PETSc/TAO.pyx:2248 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2248>



Set the gradient evaluation callback.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

setObjective, setObjectiveGradient, setHessian <#petsc4py.PETSc.TAO.setHessian>, TaoLineSearchSetGradientRoutine <https://petsc.org/release/manualpages/TaoLineSearch/TaoLineSearchSetGradientRoutine.html>


Source code at petsc4py/PETSc/TAO.pyx:2325 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2325>



Set the objective function evaluation callback.

Logically collective.


See also:

setGradient, setObjectiveGradient, TaoLineSearchSetObjectiveRoutine <https://petsc.org/release/manualpages/TaoLineSearch/TaoLineSearchSetObjectiveRoutine.html>


Source code at petsc4py/PETSc/TAO.pyx:2300 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2300>


Set the objective function and gradient evaluation callback.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

setObjective, setGradient, setHessian <#petsc4py.PETSc.TAO.setHessian>, getObjectiveAndGradient <#petsc4py.PETSc.TAO.getObjectiveAndGradient>, TaoLineSearchSetObjectiveAndGradientRoutine <https://petsc.org/release/manualpages/TaoLineSearch/TaoLineSearchSetObjectiveAndGradientRoutine.html>


Source code at petsc4py/PETSc/TAO.pyx:2352 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2352>



Set the type of the linesearch.

Logically collective.

ls_type (Type <#petsc4py.PETSc.TAOLineSearch.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of the solver.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TAO.pyx:2215 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2215>



Use the objective and gradient evaluation routines from the given Tao object.

Logically collective.

See also:


Source code at petsc4py/PETSc/TAO.pyx:2379 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2379>



View the linesearch object.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> instance or None <https://docs.python.org/3/library/constants.html#None> for the default viewer.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TAO.pyx:2162 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2162>




petsc4py.PETSc.TS

Bases: Object <#petsc4py.PETSc.Object>

ODE integrator.

TS is described in the PETSc manual <https://petsc.org/release/manual/ts.html>.

See also:


Enumerations

ARKIMEXType <#petsc4py.PETSc.TS.ARKIMEXType> The ARKIMEX subtype.
ConvergedReason <#petsc4py.PETSc.TS.ConvergedReason> The reason the time step is converging.
DIRKType <#petsc4py.PETSc.TS.DIRKType> The DIRK subtype.
EquationType <#petsc4py.PETSc.TS.EquationType> Distinguishes among types of explicit and implicit equations.
ExactFinalTime <#petsc4py.PETSc.TS.ExactFinalTime> The method for ending time stepping.
ProblemType <#petsc4py.PETSc.TS.ProblemType> Distinguishes linear and nonlinear problems.
RKType <#petsc4py.PETSc.TS.RKType> The RK subtype.
Type <#petsc4py.PETSc.TS.Type> The time stepping method.

petsc4py.PETSc.TS.ARKIMEXType

Bases: object <https://docs.python.org/3/library/functions.html#object>

The ARKIMEX subtype.

Attributes Summary

ARKIMEX1BEE Object ARKIMEX1BEE of type str <https://docs.python.org/3/library/stdtypes.html#str>
ARKIMEX2C Object ARKIMEX2C of type str <https://docs.python.org/3/library/stdtypes.html#str>
ARKIMEX2D Object ARKIMEX2D of type str <https://docs.python.org/3/library/stdtypes.html#str>
ARKIMEX2E Object ARKIMEX2E of type str <https://docs.python.org/3/library/stdtypes.html#str>
ARKIMEX3 Object ARKIMEX3 of type str <https://docs.python.org/3/library/stdtypes.html#str>
ARKIMEX4 Object ARKIMEX4 of type str <https://docs.python.org/3/library/stdtypes.html#str>
ARKIMEX5 Object ARKIMEX5 of type str <https://docs.python.org/3/library/stdtypes.html#str>
ARKIMEXA2 Object ARKIMEXA2 of type str <https://docs.python.org/3/library/stdtypes.html#str>
ARKIMEXARS122 Object ARKIMEXARS122 of type str <https://docs.python.org/3/library/stdtypes.html#str>
ARKIMEXARS443 Object ARKIMEXARS443 of type str <https://docs.python.org/3/library/stdtypes.html#str>
ARKIMEXBPR3 Object ARKIMEXBPR3 of type str <https://docs.python.org/3/library/stdtypes.html#str>
ARKIMEXL2 Object ARKIMEXL2 of type str <https://docs.python.org/3/library/stdtypes.html#str>
ARKIMEXPRSSP2 Object ARKIMEXPRSSP2 of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation















petsc4py.PETSc.TS.ConvergedReason

Bases: object <https://docs.python.org/3/library/functions.html#object>

The reason the time step is converging.

Attributes Summary

CONVERGED_EVENT Constant CONVERGED_EVENT of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_ITERATING Constant CONVERGED_ITERATING of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_ITS Constant CONVERGED_ITS of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_TIME Constant CONVERGED_TIME of type int <https://docs.python.org/3/library/functions.html#int>
CONVERGED_USER Constant CONVERGED_USER of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_NONLINEAR_SOLVE Constant DIVERGED_NONLINEAR_SOLVE of type int <https://docs.python.org/3/library/functions.html#int>
DIVERGED_STEP_REJECTED Constant DIVERGED_STEP_REJECTED of type int <https://docs.python.org/3/library/functions.html#int>
ITERATING Constant ITERATING of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation










petsc4py.PETSc.TS.DIRKType

Bases: object <https://docs.python.org/3/library/functions.html#object>

The DIRK subtype.

Attributes Summary

DIRK657A Object DIRK657A of type str <https://docs.python.org/3/library/stdtypes.html#str>
DIRK658A Object DIRK658A of type str <https://docs.python.org/3/library/stdtypes.html#str>
DIRK7510SAL Object DIRK7510SAL of type str <https://docs.python.org/3/library/stdtypes.html#str>
DIRK759A Object DIRK759A of type str <https://docs.python.org/3/library/stdtypes.html#str>
DIRK8614A Object DIRK8614A of type str <https://docs.python.org/3/library/stdtypes.html#str>
DIRK8616SAL Object DIRK8616SAL of type str <https://docs.python.org/3/library/stdtypes.html#str>
DIRKES122SAL Object DIRKES122SAL of type str <https://docs.python.org/3/library/stdtypes.html#str>
DIRKES213SAL Object DIRKES213SAL of type str <https://docs.python.org/3/library/stdtypes.html#str>
DIRKES324SAL Object DIRKES324SAL of type str <https://docs.python.org/3/library/stdtypes.html#str>
DIRKES325SAL Object DIRKES325SAL of type str <https://docs.python.org/3/library/stdtypes.html#str>
DIRKES648SA Object DIRKES648SA of type str <https://docs.python.org/3/library/stdtypes.html#str>
DIRKES7510SA Object DIRKES7510SA of type str <https://docs.python.org/3/library/stdtypes.html#str>
DIRKES8516SAL Object DIRKES8516SAL of type str <https://docs.python.org/3/library/stdtypes.html#str>
DIRKS212 Object DIRKS212 of type str <https://docs.python.org/3/library/stdtypes.html#str>
DIRKS659A Object DIRKS659A of type str <https://docs.python.org/3/library/stdtypes.html#str>
DIRKS7511SAL Object DIRKS7511SAL of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation


















petsc4py.PETSc.TS.EquationType

Bases: object <https://docs.python.org/3/library/functions.html#object>

Distinguishes among types of explicit and implicit equations.

Attributes Summary

DAE_IMPLICIT_INDEX1 Constant DAE_IMPLICIT_INDEX1 of type int <https://docs.python.org/3/library/functions.html#int>
DAE_IMPLICIT_INDEX2 Constant DAE_IMPLICIT_INDEX2 of type int <https://docs.python.org/3/library/functions.html#int>
DAE_IMPLICIT_INDEX3 Constant DAE_IMPLICIT_INDEX3 of type int <https://docs.python.org/3/library/functions.html#int>
DAE_IMPLICIT_INDEXHI Constant DAE_IMPLICIT_INDEXHI of type int <https://docs.python.org/3/library/functions.html#int>
DAE_SEMI_EXPLICIT_INDEX1 Constant DAE_SEMI_EXPLICIT_INDEX1 of type int <https://docs.python.org/3/library/functions.html#int>
DAE_SEMI_EXPLICIT_INDEX2 Constant DAE_SEMI_EXPLICIT_INDEX2 of type int <https://docs.python.org/3/library/functions.html#int>
DAE_SEMI_EXPLICIT_INDEX3 Constant DAE_SEMI_EXPLICIT_INDEX3 of type int <https://docs.python.org/3/library/functions.html#int>
DAE_SEMI_EXPLICIT_INDEXHI Constant DAE_SEMI_EXPLICIT_INDEXHI of type int <https://docs.python.org/3/library/functions.html#int>
EXPLICIT Constant EXPLICIT of type int <https://docs.python.org/3/library/functions.html#int>
IMPLICIT Constant IMPLICIT of type int <https://docs.python.org/3/library/functions.html#int>
ODE_EXPLICIT Constant ODE_EXPLICIT of type int <https://docs.python.org/3/library/functions.html#int>
ODE_IMPLICIT Constant ODE_IMPLICIT of type int <https://docs.python.org/3/library/functions.html#int>
UNSPECIFIED Constant UNSPECIFIED of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation















petsc4py.PETSc.TS.ExactFinalTime


petsc4py.PETSc.TS.ProblemType


petsc4py.PETSc.TS.RKType

Bases: object <https://docs.python.org/3/library/functions.html#object>

The RK subtype.

Attributes Summary

RK1FE Object RK1FE of type str <https://docs.python.org/3/library/stdtypes.html#str>
RK2A Object RK2A of type str <https://docs.python.org/3/library/stdtypes.html#str>
RK2B Object RK2B of type str <https://docs.python.org/3/library/stdtypes.html#str>
RK3 Object RK3 of type str <https://docs.python.org/3/library/stdtypes.html#str>
RK3BS Object RK3BS of type str <https://docs.python.org/3/library/stdtypes.html#str>
RK4 Object RK4 of type str <https://docs.python.org/3/library/stdtypes.html#str>
RK5BS Object RK5BS of type str <https://docs.python.org/3/library/stdtypes.html#str>
RK5DP Object RK5DP of type str <https://docs.python.org/3/library/stdtypes.html#str>
RK5F Object RK5F of type str <https://docs.python.org/3/library/stdtypes.html#str>
RK6VR Object RK6VR of type str <https://docs.python.org/3/library/stdtypes.html#str>
RK7VR Object RK7VR of type str <https://docs.python.org/3/library/stdtypes.html#str>
RK8VR Object RK8VR of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation














petsc4py.PETSc.TS.Type

Bases: object <https://docs.python.org/3/library/functions.html#object>

The time stepping method.

Attributes Summary

ALPHA Object ALPHA of type str <https://docs.python.org/3/library/stdtypes.html#str>
ALPHA2 Object ALPHA2 of type str <https://docs.python.org/3/library/stdtypes.html#str>
ARKIMEX Object ARKIMEX of type str <https://docs.python.org/3/library/stdtypes.html#str>
BASICSYMPLECTIC Object BASICSYMPLECTIC of type str <https://docs.python.org/3/library/stdtypes.html#str>
BDF Object BDF of type str <https://docs.python.org/3/library/stdtypes.html#str>
BE Object BE of type str <https://docs.python.org/3/library/stdtypes.html#str>
BEULER Object BEULER of type str <https://docs.python.org/3/library/stdtypes.html#str>
CN Object CN of type str <https://docs.python.org/3/library/stdtypes.html#str>
CRANK_NICOLSON Object CRANK_NICOLSON of type str <https://docs.python.org/3/library/stdtypes.html#str>
DIRK Object DIRK of type str <https://docs.python.org/3/library/stdtypes.html#str>
DISCGRAD Object DISCGRAD of type str <https://docs.python.org/3/library/stdtypes.html#str>
EIMEX Object EIMEX of type str <https://docs.python.org/3/library/stdtypes.html#str>
EULER Object EULER of type str <https://docs.python.org/3/library/stdtypes.html#str>
FE Object FE of type str <https://docs.python.org/3/library/stdtypes.html#str>
GLEE Object GLEE of type str <https://docs.python.org/3/library/stdtypes.html#str>
GLLE Object GLLE of type str <https://docs.python.org/3/library/stdtypes.html#str>
MIMEX Object MIMEX of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPRK Object MPRK of type str <https://docs.python.org/3/library/stdtypes.html#str>
PSEUDO Object PSEUDO of type str <https://docs.python.org/3/library/stdtypes.html#str>
PYTHON Object PYTHON of type str <https://docs.python.org/3/library/stdtypes.html#str>
RADAU5 Object RADAU5 of type str <https://docs.python.org/3/library/stdtypes.html#str>
RK Object RK of type str <https://docs.python.org/3/library/stdtypes.html#str>
ROSW Object ROSW of type str <https://docs.python.org/3/library/stdtypes.html#str>
RUNGE_KUTTA Object RUNGE_KUTTA of type str <https://docs.python.org/3/library/stdtypes.html#str>
SSP Object SSP of type str <https://docs.python.org/3/library/stdtypes.html#str>
SUNDIALS Object SUNDIALS of type str <https://docs.python.org/3/library/stdtypes.html#str>
TH Object TH of type str <https://docs.python.org/3/library/stdtypes.html#str>
THETA Object THETA of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation






























Methods Summary

adjointReset() Reset a TS, removing any allocated vectors and matrices.
adjointSetSteps(adjoint_steps) Set the number of steps the adjoint solver should take backward in time.
adjointSetUp() Set up the internal data structures for the later use of an adjoint solver.
adjointSolve() Solve the discrete adjoint problem for an ODE/DAE.
adjointStep() Step one time step backward in the adjoint run.
appendOptionsPrefix(prefix) Append to the prefix used for all the TS options.
clone() Return a shallow clone of the TS object.
computeI2Function(t, x, xdot, xdotdot, f) Evaluate the DAE residual in implicit form.
computeI2Jacobian(t, x, xdot, xdotdot, v, a, J) Evaluate the Jacobian of the DAE.
computeIFunction(t, x, xdot, f[, imex]) Evaluate the DAE residual written in implicit form.
computeIJacobian(t, x, xdot, a, J[, P, imex]) Evaluate the Jacobian of the DAE.
computeIJacobianP(t, x, xdot, a, J[, imex]) Evaluate the Jacobian with respect to parameters.
computeRHSFunction(t, x, f) Evaluate the right-hand side function.
computeRHSFunctionLinear(t, x, f) Evaluate the right-hand side via the user-provided Jacobian.
computeRHSJacobian(t, x, J[, P]) Compute the Jacobian matrix that has been set with setRHSJacobian.
computeRHSJacobianConstant(t, x, J[, P]) Reuse a Jacobian that is time-independent.
computeRHSJacobianP(t, x, J) Run the user-defined JacobianP function.
create([comm]) Create an empty TS.
createPython([context, comm]) Create an integrator of Python type.
createQuadratureTS([forward]) Create a sub TS that evaluates integrals over time.
destroy() Destroy the TS that was created with create.
getARKIMEXType() Return the Type.ARKIMEX <#petsc4py.PETSc.TS.Type.ARKIMEX> scheme.
getAlphaParams() Return the algorithmic parameters for Type.ALPHA <#petsc4py.PETSc.TS.Type.ALPHA>.
getAppCtx() Return the application context.
getConvergedReason() Return the reason the TS step was stopped.
getCostGradients() Return the cost gradients.
getCostIntegral() Return a vector of values of the integral term in the cost functions.
getDIRKType() Return the Type.DIRK <#petsc4py.PETSc.TS.Type.DIRK> scheme.
getDM() Return the DM <#petsc4py.PETSc.DM> associated with the TS.
getEquationType() Get the type of the equation that TS is solving.
getEvaluationSolutions() Return the solutions and the times they were recorded at.
getEvaluationTimes() Return the evaluation points.
getI2Function() Return the vector and function which computes the residual.
getI2Jacobian() Return the matrices and function which computes the Jacobian.
getIFunction() Return the vector and function which computes the implicit residual.
getIJacobian() Return the matrices and function which computes the implicit Jacobian.
getKSP() Return the KSP <#petsc4py.PETSc.KSP> associated with the TS.
getKSPIterations() Return the total number of linear iterations used by the TS.
getMaxSteps() Return the maximum number of steps to use.
getMaxTime() Return the maximum (final) time.
getMonitor() Return the monitor.
getNumEvents() Return the number of events.
getOptionsPrefix() Return the prefix used for all the TS options.
getPostStep() Return the poststep function.
getPreStep() Return the prestep function.
getPrevTime() Return the starting time of the previously completed step.
getProblemType() Return the type of problem to be solved.
getPythonContext() Return the instance of the class implementing the required Python methods.
getPythonType() Return the fully qualified Python name of the class used by the solver.
getQuadratureTS() Return the sub TS that evaluates integrals over time.
getRHSFunction() Return the vector where the rhs is stored and the function used to compute it.
getRHSJacobian() Return the Jacobian and the function used to compute them.
getRKType() Return the Type.RK <#petsc4py.PETSc.TS.Type.RK> scheme.
getSNES() Return the SNES <#petsc4py.PETSc.SNES> associated with the TS.
getSNESFailures() Return the total number of failed SNES <#petsc4py.PETSc.SNES> solves in the TS.
getSNESIterations() Return the total number of nonlinear iterations used by the TS.
getSolution() Return the solution at the present timestep.
getSolution2() Return the solution and time derivative at the present timestep.
getSolveTime() Return the time after a call to solve.
getStepLimits() Return the minimum and maximum allowed time step sizes.
getStepNumber() Return the number of time steps completed.
getStepRejections() Return the total number of rejected steps.
getTheta() Return the abscissa of the stage in (0, 1] for Type.THETA <#petsc4py.PETSc.TS.Type.THETA>.
getThetaEndpoint() Return whether the endpoint variable of Type.THETA <#petsc4py.PETSc.TS.Type.THETA> is used.
getTime() Return the time of the most recently completed step.
getTimeSpanSolutions() Return the solutions at the times in the time span.
getTimeStep() Return the duration of the current timestep.
getTolerances() Return the tolerances for local truncation error.
getType() Return the TS type.
interpolate(t, u) Interpolate the solution to a given time.
load(viewer) Load a TS that has been stored in binary with view.
monitor(step, time[, u]) Monitor the solve.
monitorCancel() Clear all the monitors that have been set.
removeTrajectory() Remove the internal TS trajectory object.
reset() Reset the TS, removing any allocated vectors and matrices.
restartStep() Flag the solver to restart the next step.
rollBack() Roll back one time step.
setARKIMEXFastSlowSplit(flag) Use ARKIMEX for solving a fast-slow system.
setARKIMEXFullyImplicit(flag) Solve both parts of the equation implicitly.
setARKIMEXType(ts_type) Set the type of Type.ARKIMEX <#petsc4py.PETSc.TS.Type.ARKIMEX> scheme.
setAlphaParams([alpha_m, alpha_f, gamma]) Set the algorithmic parameters for Type.ALPHA <#petsc4py.PETSc.TS.Type.ALPHA>.
setAlphaRadius(radius) Set the spectral radius for Type.ALPHA <#petsc4py.PETSc.TS.Type.ALPHA>.
setAppCtx(appctx) Set the application context.
setConvergedReason(reason) Set the reason for handling the convergence of solve.
setCostGradients(vl[, vm]) Set the cost gradients.
setDIRKType(ts_type) Set the type of Type.DIRK <#petsc4py.PETSc.TS.Type.DIRK> scheme.
setDM(dm) Set the DM that may be used by some nonlinear solvers or preconditioners.
setEquationType(eqtype) Set the type of the equation that TS is solving.
setErrorIfStepFails([flag]) Immediately error is no step succeeds.
setEvaluationTimes(tspan) Sets evaluation points where solution will be computed and stored.
setEventHandler(direction, terminate, indicator) Set a function used for detecting events.
setEventTolerances([tol, vtol]) Set tolerances for event zero crossings when using event handler.
setExactFinalTime(option) Set method of computing the final time step.
setFromOptions() Set various TS parameters from user options.
setI2Function(function[, f, args, kargs]) Set the function to compute the 2nd order DAE.
setI2Jacobian(jacobian[, J, P, args, kargs]) Set the function to compute the Jacobian of the 2nd order DAE.
setIFunction(function[, f, args, kargs]) Set the function representing the DAE to be solved.
setIJacobian(jacobian[, J, P, args, kargs]) Set the function to compute the Jacobian.
setIJacobianP(jacobian[, J, args, kargs]) Set the function that computes the Jacobian.
setMaxSNESFailures(n) Set the maximum number of SNES solves failures allowed.
setMaxStepRejections(n) Set the maximum number of step rejections before a time step fails.
setMaxSteps(max_steps) Set the maximum number of steps to use.
setMaxTime(max_time) Set the maximum (final) time.
setMonitor(monitor[, args, kargs]) Set an additional monitor to the TS.
setOptionsPrefix(prefix) Set the prefix used for all the TS options.
setPostStep(poststep[, args, kargs]) Set a function to be called at the end of each time step.
setPreStep(prestep[, args, kargs]) Set a function to be called at the beginning of each time step.
setProblemType(ptype) Set the type of problem to be solved.
setPythonContext(context) Set the instance of the class implementing the required Python methods.
setPythonType(py_type) Set the fully qualified Python name of the class to be used.
setRHSFunction(function[, f, args, kargs]) Set the routine for evaluating the function G in U_t = G(t, u).
setRHSJacobian(jacobian[, J, P, args, kargs]) Set the function to compute the Jacobian of G in U_t = G(U, t).
setRHSJacobianP(rhsjacobianp[, A, args, kargs]) Set the function that computes the Jacobian with respect to the parameters.
setRHSSplitIFunction(splitname, function[, ...]) Set the split implicit functions.
setRHSSplitIJacobian(splitname, jacobian[, ...]) Set the Jacobian for the split implicit function.
setRHSSplitIS(splitname, iss) Set the index set for the specified split.
setRHSSplitRHSFunction(splitname, function) Set the split right-hand-side functions.
setRKType(ts_type) Set the type of the Runge-Kutta scheme.
setSaveTrajectory() Enable to save solutions as an internal TS trajectory.
setSolution(u) Set the initial solution vector.
setSolution2(u, v) Set the initial solution and its time derivative.
setStepLimits(hmin, hmax) Set the minimum and maximum allowed step sizes.
setStepNumber(step_number) Set the number of steps completed.
setTheta(theta) Set the abscissa of the stage in (0, 1] for Type.THETA <#petsc4py.PETSc.TS.Type.THETA>.
setThetaEndpoint([flag]) Set to use the endpoint variant of Type.THETA <#petsc4py.PETSc.TS.Type.THETA>.
setTime(t) Set the time.
setTimeSpan(tspan) Set the time span and time points to evaluate solution at.
setTimeStep(time_step) Set the duration of the timestep.
setTolerances([rtol, atol]) Set tolerances for local truncation error when using an adaptive controller.
setType(ts_type) Set the method to be used as the TS solver.
setUp() Set up the internal data structures for the TS.
solve([u]) Step the requested number of timesteps.
step() Take one step.
view([viewer]) Print the TS object.

Attributes Summary

appctx Application context.
atol The absolute tolerance.
converged Indicates the TS has converged.
diverged Indicates the TS has stopped.
dm The DM <#petsc4py.PETSc.DM>.
equation_type The equation type.
iterating Indicates the TS is still iterating.
ksp The KSP <#petsc4py.PETSc.KSP>.
max_steps The maximum number of steps.
max_time The maximum time.
problem_type The problem type.
reason The converged reason.
rtol The relative tolerance.
snes The SNES <#petsc4py.PETSc.SNES>.
step_number The current step number.
time The current time.
time_step The current time step size.
vec_sol The solution vector.

Methods Documentation


Set the number of steps the adjoint solver should take backward in time.

Logically collective.


See also:


Source code at petsc4py/PETSc/TS.pyx:2854 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2854>


Set up the internal data structures for the later use of an adjoint solver.

Collective.

See also:


Source code at petsc4py/PETSc/TS.pyx:2872 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2872>





Append to the prefix used for all the TS options.

Logically collective.


Notes

A hyphen must not be given at the beginning of the prefix name.

See also:

Working with PETSc options <#petsc-options>, TSAppendOptionsPrefix <https://petsc.org/release/manualpages/TS/TSAppendOptionsPrefix.html>


Source code at petsc4py/PETSc/TS.pyx:540 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L540>


Return a shallow clone of the TS object.

Collective.

See also:


Source code at petsc4py/PETSc/TS.pyx:244 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L244>

TS <#petsc4py.PETSc.TS>


Evaluate the DAE residual in implicit form.

Collective.

  • t (float <https://docs.python.org/3/library/functions.html#float>) -- The current time.
  • x (Vec <#petsc4py.PETSc.Vec>) -- The state vector.
  • xdot (Vec <#petsc4py.PETSc.Vec>) -- The time derivative of the state vector.
  • xdotdot (Vec <#petsc4py.PETSc.Vec>) -- The second time derivative of the state vector.
  • f (Vec <#petsc4py.PETSc.Vec>) -- The vector into which the residual is stored.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:1143 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1143>


Evaluate the Jacobian of the DAE.

Collective.

If F(t, U, V, A)=0 is the DAE, the required Jacobian is dF/dU + v dF/dV + a dF/dA.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:1170 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1170>


Evaluate the DAE residual written in implicit form.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:928 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L928>


Evaluate the Jacobian of the DAE.

Collective.

If F(t, U, Udot)=0 is the DAE, the required Jacobian is dF/dU + shift*dF/dUdot


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:958 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L958>


Evaluate the Jacobian with respect to parameters.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:998 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L998>


Evaluate the right-hand side function.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:675 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L675>


Evaluate the right-hand side via the user-provided Jacobian.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:697 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L697>


Compute the Jacobian matrix that has been set with setRHSJacobian.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:719 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L719>


Reuse a Jacobian that is time-independent.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:745 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L745>


Run the user-defined JacobianP function.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:2832 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2832>


Create an empty TS.

Collective.

The problem type can then be set with setProblemType and the type of solver can then be set with setType.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/TS.pyx:220 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L220>


Create an integrator of Python type.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

PETSc Python ode-integrator type (TODO) <#petsc-python-ts>, setType, setPythonContext, Type.PYTHON <#petsc4py.PETSc.TS.Type.PYTHON>


Source code at petsc4py/PETSc/TS.pyx:2922 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2922>


Create a sub TS that evaluates integrals over time.

Collective.

forward (bool <https://docs.python.org/3/library/functions.html#bool>) -- Enable to evaluate forward in time.
TS <#petsc4py.PETSc.TS>

See also:


Source code at petsc4py/PETSc/TS.pyx:2751 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2751>



Return the Type.ARKIMEX <#petsc4py.PETSc.TS.Type.ARKIMEX> scheme.

Not collective.

See also:


Source code at petsc4py/PETSc/TS.pyx:390 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L390>





Return the reason the TS step was stopped.

Not collective.

Can only be called once solve is complete.

See also:


Source code at petsc4py/PETSc/TS.pyx:2149 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2149>

ConvergedReason <#petsc4py.PETSc.TS.ConvergedReason>



Return a vector of values of the integral term in the cost functions.

Not collective.

See also:


Source code at petsc4py/PETSc/TS.pyx:2632 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2632>

Vec <#petsc4py.PETSc.Vec>


Return the Type.DIRK <#petsc4py.PETSc.TS.Type.DIRK> scheme.

Not collective.

See also:


Source code at petsc4py/PETSc/TS.pyx:427 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L427>



Return the DM <#petsc4py.PETSc.DM> associated with the TS.

Not collective.

Only valid if nonlinear solvers or preconditioners are used which use the DM <#petsc4py.PETSc.DM>.

See also:


Source code at petsc4py/PETSc/TS.pyx:1648 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1648>

DM <#petsc4py.PETSc.DM>


Get the type of the equation that TS is solving.

Not collective.

See also:


Source code at petsc4py/PETSc/TS.pyx:489 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L489>

EquationType <#petsc4py.PETSc.TS.EquationType>


Return the solutions and the times they were recorded at.

Not collective.

See also:

setEvaluationTimes


Source code at petsc4py/PETSc/TS.pyx:1539 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1539>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[ArrayReal <#petsc4py.typing.ArrayReal>, list <https://docs.python.org/3/library/stdtypes.html#list>[Vec <#petsc4py.PETSc.Vec>]]


Return the evaluation points.

Not collective.

See also:

setEvaluationTimes


Source code at petsc4py/PETSc/TS.pyx:1523 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1523>

ArrayReal <#petsc4py.typing.ArrayReal>


Return the vector and function which computes the residual.

Not collective.

See also:


Source code at petsc4py/PETSc/TS.pyx:1219 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1219>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, TSI2Function <#petsc4py.typing.TSI2Function>]


Return the matrices and function which computes the Jacobian.

Not collective.

See also:


Source code at petsc4py/PETSc/TS.pyx:1235 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1235>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>, TSI2Jacobian <#petsc4py.typing.TSI2Jacobian>]


Return the vector and function which computes the implicit residual.

Not collective.

See also:


Source code at petsc4py/PETSc/TS.pyx:1032 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1032>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, TSIFunction <#petsc4py.typing.TSIFunction>]


Return the matrices and function which computes the implicit Jacobian.

Not collective.

See also:


Source code at petsc4py/PETSc/TS.pyx:1048 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1048>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>, TSIJacobian <#petsc4py.typing.TSIJacobian>]


Return the KSP <#petsc4py.PETSc.KSP> associated with the TS.

Not collective.

See also:


Source code at petsc4py/PETSc/TS.pyx:1631 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1631>

KSP <#petsc4py.PETSc.KSP>


Return the total number of linear iterations used by the TS.

Not collective.

This counter is reset to zero for each successive call to solve.

See also:


Source code at petsc4py/PETSc/TS.pyx:1916 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1916>










Return the starting time of the previously completed step.

Not collective.

See also:


Source code at petsc4py/PETSc/TS.pyx:1723 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1723>



Return the type of problem to be solved.

Not collective.

See also:


Source code at petsc4py/PETSc/TS.pyx:458 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L458>

ProblemType <#petsc4py.PETSc.TS.ProblemType>


Return the instance of the class implementing the required Python methods.

Not collective.

See also:

PETSc Python ode-integrator type (TODO) <#petsc-python-ts>, setPythonContext


Source code at petsc4py/PETSc/TS.pyx:2959 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2959>



Return the fully qualified Python name of the class used by the solver.

Not collective.

See also:

PETSc Python ode-integrator type (TODO) <#petsc-python-ts>, setPythonContext, setPythonType, TSPythonGetType <https://petsc.org/release/manualpages/TS/TSPythonGetType.html>


Source code at petsc4py/PETSc/TS.pyx:2988 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2988>



Return the sub TS that evaluates integrals over time.

Not collective.


tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[bool <https://docs.python.org/3/library/functions.html#bool>, TS <#petsc4py.PETSc.TS>]

See also:


Source code at petsc4py/PETSc/TS.pyx:2772 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2772>


Return the vector where the rhs is stored and the function used to compute it.

Not collective.

See also:


Source code at petsc4py/PETSc/TS.pyx:771 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L771>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, TSRHSFunction <#petsc4py.typing.TSRHSFunction>]


Return the Jacobian and the function used to compute them.

Not collective.

See also:


Source code at petsc4py/PETSc/TS.pyx:787 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L787>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>, TSRHSJacobian <#petsc4py.typing.TSRHSJacobian>]



Return the SNES <#petsc4py.PETSc.SNES> associated with the TS.

Not collective.

See also:


Source code at petsc4py/PETSc/TS.pyx:1616 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1616>

SNES <#petsc4py.PETSc.SNES>


Return the total number of failed SNES <#petsc4py.PETSc.SNES> solves in the TS.

Not collective.

This counter is reset to zero for each successive call to solve.

See also:


Source code at petsc4py/PETSc/TS.pyx:1990 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1990>



Return the total number of nonlinear iterations used by the TS.

Not collective.

This counter is reset to zero for each successive call to solve.

See also:


Source code at petsc4py/PETSc/TS.pyx:1899 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1899>



Return the solution at the present timestep.

Not collective.

It is valid to call this routine inside the function that you are evaluating in order to move to the new timestep. This vector is not changed until the solution at the next timestep has been calculated.

See also:


Source code at petsc4py/PETSc/TS.pyx:1429 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1429>

Vec <#petsc4py.PETSc.Vec>


Return the solution and time derivative at the present timestep.

Not collective.

It is valid to call this routine inside the function that you are evaluating in order to move to the new timestep. These vectors are not changed until the solution at the next timestep has been calculated.

See also:


Source code at petsc4py/PETSc/TS.pyx:1467 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1467>

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>]


Return the time after a call to solve.

Not collective.

This time corresponds to the final time set with setMaxTime.

See also:


Source code at petsc4py/PETSc/TS.pyx:1737 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1737>





Return the total number of rejected steps.

Not collective.

This counter is reset to zero for each successive call to solve.

See also:


Source code at petsc4py/PETSc/TS.pyx:1955 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1955>



Return the abscissa of the stage in (0, 1] for Type.THETA <#petsc4py.PETSc.TS.Type.THETA>.

Not collective.

See also:


Source code at petsc4py/PETSc/TS.pyx:3026 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3026>



Return whether the endpoint variable of Type.THETA <#petsc4py.PETSc.TS.Type.THETA> is used.

Not collective.

See also:


Source code at petsc4py/PETSc/TS.pyx:3058 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3058>



Return the time of the most recently completed step.

Not collective.

When called during time step evaluation (e.g. during residual evaluation or via hooks set using setPreStep or setPostStep), the time returned is at the start of the step.

See also:


Source code at petsc4py/PETSc/TS.pyx:1705 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1705>



Return the solutions at the times in the time span. Deprecated.

Not collective.

See also:

setTimeSpan, setEvaluationTimes, getEvaluationSolutions


Source code at petsc4py/PETSc/TS.pyx:1596 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1596>






Interpolate the solution to a given time.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:2539 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2539>


Load a TS that has been stored in binary with view.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer>) -- The visualization context.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:190 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L190>


Monitor the solve.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:2228 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2228>




Reset the TS, removing any allocated vectors and matrices.

Collective.

See also:


Source code at petsc4py/PETSc/TS.pyx:2457 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2457>



Flag the solver to restart the next step.

Collective.

Multistep methods like TSBDF or Runge-Kutta methods with FSAL property require restarting the solver in the event of discontinuities. These discontinuities may be introduced as a consequence of explicitly modifications to the solution vector (which PETSc attempts to detect and handle) or problem coefficients (which PETSc is not able to detect). For the sake of correctness and maximum safety, users are expected to call TSRestart() whenever they introduce discontinuities in callback routines (e.g. prestep and poststep routines, or implicit/rhs function routines with discontinuous source terms).

See also:


Source code at petsc4py/PETSc/TS.pyx:2485 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2485>




Use ARKIMEX for solving a fast-slow system.

Logically collective.


See also:


Source code at petsc4py/PETSc/TS.pyx:345 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L345>



Set the type of Type.ARKIMEX <#petsc4py.PETSc.TS.Type.ARKIMEX> scheme.

Logically collective.

ts_type (ARKIMEXType <#petsc4py.PETSc.TS.ARKIMEXType> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of Type.ARKIMEX <#petsc4py.PETSc.TS.Type.ARKIMEX> scheme.
None <https://docs.python.org/3/library/constants.html#None>

Notes

-ts_arkimex_type sets scheme type from the commandline.

See also:


Source code at petsc4py/PETSc/TS.pyx:304 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L304>



Set the spectral radius for Type.ALPHA <#petsc4py.PETSc.TS.Type.ALPHA>.

Logically collective.


Notes

-ts_alpha_radius can be used to set this from the commandline.

See also:


Source code at petsc4py/PETSc/TS.pyx:3074 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3074>



Set the reason for handling the convergence of solve.

Logically collective.

Can only be called when solve is active and reason must contain common value.

reason (ConvergedReason <#petsc4py.PETSc.TS.ConvergedReason>) -- The reason for convergence.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:2128 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2128>


Set the cost gradients.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:2647 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2647>


Set the type of Type.DIRK <#petsc4py.PETSc.TS.Type.DIRK> scheme.

Logically collective.

ts_type (DIRKType <#petsc4py.PETSc.TS.DIRKType> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of Type.DIRK <#petsc4py.PETSc.TS.Type.DIRK> scheme.
None <https://docs.python.org/3/library/constants.html#None>

Notes

-ts_dirk_type sets scheme type from the commandline.

See also:


Source code at petsc4py/PETSc/TS.pyx:404 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L404>


Set the DM that may be used by some nonlinear solvers or preconditioners.

Logically collective.

dm (DM <#petsc4py.PETSc.DM>) -- The DM <#petsc4py.PETSc.DM> object.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:1668 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1668>


Set the type of the equation that TS is solving.

Logically collective.

eqtype (EquationType <#petsc4py.PETSc.TS.EquationType>) -- The type of equation.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:472 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L472>


Immediately error is no step succeeds.

Not collective.


Notes

-ts_error_if_step_fails to enable from the commandline.

See also:


Source code at petsc4py/PETSc/TS.pyx:2007 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2007>


Sets evaluation points where solution will be computed and stored.

Collective.

The solution will be computed and stored for each time requested. The times must be all increasing and correspond to the intermediate points for time integration. ExactFinalTime.MATCHSTEP <#petsc4py.PETSc.TS.ExactFinalTime.MATCHSTEP> must be used to make the last time step in each sub-interval match the intermediate points specified. The intermediate solutions are saved in a vector array that can be accessed with getEvaluationSolutions.

tspan (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[float <https://docs.python.org/3/library/functions.html#float>]) -- The sequence of time points. The first element and the last element are the initial time and the final time respectively.
None <https://docs.python.org/3/library/constants.html#None>

Notes

-ts_eval_times <t0, ..., tn> sets the time span from the commandline

See also:



Source code at petsc4py/PETSc/TS.pyx:1490 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1490>


Set a function used for detecting events.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:2257 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2257>


Set tolerances for event zero crossings when using event handler.

Logically collective.

setEventHandler must have already been called.


Notes

-ts_event_tol can be used to set values from the commandline.

See also:


Source code at petsc4py/PETSc/TS.pyx:2312 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2312>


Set method of computing the final time step.

Logically collective.

option (ExactFinalTime <#petsc4py.PETSc.TS.ExactFinalTime>) -- The exact final time option
None <https://docs.python.org/3/library/constants.html#None>

Notes

-ts_exact_final_time may be used to specify from the commandline.

See also:


Source code at petsc4py/PETSc/TS.pyx:2106 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2106>


Set various TS parameters from user options.

Collective.

See also:

Working with PETSc options <#petsc-options>, TSSetFromOptions <https://petsc.org/release/manualpages/TS/TSSetFromOptions.html>


Source code at petsc4py/PETSc/TS.pyx:563 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L563>



Set the function to compute the 2nd order DAE.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:1064 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1064>


Set the function to compute the Jacobian of the 2nd order DAE.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:1101 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1101>


Set the function representing the DAE to be solved.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:805 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L805>


Set the function to compute the Jacobian.

Logically collective.

Set the function to compute the matrix dF/dU + a*dF/dU_t where F(t, U, U_t) is the function provided with setIFunction.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:842 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L842>


Set the function that computes the Jacobian.

Logically collective.

Set the function that computes the Jacobian of F with respect to the parameters P where F(Udot, U, t) = G(U, P, t), as well as the location to store the matrix.


See also:


Source code at petsc4py/PETSc/TS.pyx:887 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L887>


Set the maximum number of SNES solves failures allowed.

Not collective.

n (int <https://docs.python.org/3/library/functions.html#int>) -- The maximum number of failed nonlinear solver, use -1 for unlimited.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:1972 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1972>


Set the maximum number of step rejections before a time step fails.

Not collective.

n (int <https://docs.python.org/3/library/functions.html#int>) -- The maximum number of rejected steps, use -1 for unlimited.
None <https://docs.python.org/3/library/constants.html#None>

Notes

-ts_max_reject can be used to set this from the commandline

See also:


Source code at petsc4py/PETSc/TS.pyx:1933 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1933>


Set the maximum number of steps to use.

Logically collective.

Defaults to 5000.


See also:


Source code at petsc4py/PETSc/TS.pyx:1865 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1865>


Set the maximum (final) time.

Logically collective.


Notes

-ts_max_time sets the max time from the commandline

See also:


Source code at petsc4py/PETSc/TS.pyx:1827 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1827>


Set an additional monitor to the TS.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:2167 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2167>


Set the prefix used for all the TS options.

Logically collective.


Notes

A hyphen must not be given at the beginning of the prefix name.

See also:

Working with PETSc options <#petsc-options>, TSSetOptionsPrefix <https://petsc.org/release/manualpages/TS/TSSetOptionsPrefix.html>


Source code at petsc4py/PETSc/TS.pyx:503 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L503>


Set a function to be called at the end of each time step.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:2409 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2409>


Set a function to be called at the beginning of each time step.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:2364 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2364>


Set the type of problem to be solved.

Logically collective.

ptype (ProblemType <#petsc4py.PETSc.TS.ProblemType>) -- The type of problem of the forms.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:441 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L441>


Set the instance of the class implementing the required Python methods.

Not collective.

See also:

PETSc Python ode-integrator type (TODO) <#petsc-python-ts>, getPythonContext


Source code at petsc4py/PETSc/TS.pyx:2947 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2947>



Set the fully qualified Python name of the class to be used.

Collective.

See also:

PETSc Python ode-integrator type (TODO) <#petsc-python-ts>, setPythonContext, getPythonType, TSPythonSetType <https://petsc.org/release/manualpages/TS/TSPythonSetType.html>


Source code at petsc4py/PETSc/TS.pyx:2974 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2974>



Set the routine for evaluating the function G in U_t = G(t, u).

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:596 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L596>


Set the function to compute the Jacobian of G in U_t = G(U, t).

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:633 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L633>


Set the function that computes the Jacobian with respect to the parameters.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:2795 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2795>


Set the split implicit functions.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:1317 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1317>


Set the Jacobian for the split implicit function.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:1361 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1361>


Set the index set for the specified split.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:1252 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1252>


Set the split right-hand-side functions.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:1273 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1273>


Set the type of the Runge-Kutta scheme.

Logically collective.

ts_type (RKType <#petsc4py.PETSc.TS.RKType> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of scheme.
None <https://docs.python.org/3/library/constants.html#None>

Notes

-ts_rk_type sets scheme type from the commandline.

See also:


Source code at petsc4py/PETSc/TS.pyx:281 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L281>


Enable to save solutions as an internal TS trajectory.

Collective.

This routine should be called after all TS options have been set.

Notes

-ts_save_trajectory can be used to save a trajectory to a file.

See also:


Source code at petsc4py/PETSc/TS.pyx:2601 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2601>



Set the initial solution vector.

Logically collective.

u (Vec <#petsc4py.PETSc.Vec>) -- The solution vector.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:1412 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1412>


Set the initial solution and its time derivative.

Logically collective.

  • u (Vec <#petsc4py.PETSc.Vec>) -- The solution vector.
  • v (Vec <#petsc4py.PETSc.Vec>) -- The time derivative vector.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:1448 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1448>



Set the number of steps completed.

Logically collective.

For most uses of the TS solvers the user need not explicitly call setStepNumber, as the step counter is appropriately updated in solve/step/rollBack. Power users may call this routine to reinitialize timestepping by setting the step counter to zero (and time to the initial time) to solve a similar problem with different initial conditions or parameters. It may also be used to continue timestepping from a previously interrupted run in such a way that TS monitors will be called with a initial nonzero step counter.


See also:


Source code at petsc4py/PETSc/TS.pyx:1786 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1786>


Set the abscissa of the stage in (0, 1] for Type.THETA <#petsc4py.PETSc.TS.Type.THETA>.

Logically collective.


Notes

-ts_theta_theta can be used to set a value from the commandline.

See also:


Source code at petsc4py/PETSc/TS.pyx:3004 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3004>


Set to use the endpoint variant of Type.THETA <#petsc4py.PETSc.TS.Type.THETA>.

Logically collective.

flag -- Enable to use the endpoint variant.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/TS.pyx:3040 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3040>



Set the time span and time points to evaluate solution at.

Collective.

The solution will be computed and stored for each time requested in the span. The times must be all increasing and correspond to the intermediate points for time integration. ExactFinalTime.MATCHSTEP <#petsc4py.PETSc.TS.ExactFinalTime.MATCHSTEP> must be used to make the last time step in each sub-interval match the intermediate points specified. The intermediate solutions are saved in a vector array that can be accessed with getEvaluationSolutions.

tspan (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[float <https://docs.python.org/3/library/functions.html#float>]) -- The sequence of time points. The first element and the last element are the initial time and the final time respectively.
None <https://docs.python.org/3/library/constants.html#None>

Notes

-ts_time_span <t0, ..., tf> sets the time span from the commandline

See also:


Source code at petsc4py/PETSc/TS.pyx:1561 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1561>



Set tolerances for local truncation error when using an adaptive controller.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

Notes

-ts_rtol and -ts_atol may be used to set values from the commandline.

See also:


Source code at petsc4py/PETSc/TS.pyx:2029 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2029>


Set the method to be used as the TS solver.

Collective.


Notes

-ts_type sets the method from the commandline

See also:


Source code at petsc4py/PETSc/TS.pyx:258 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L258>




Take one step.

Collective.

The preferred interface for the TS solvers is solve. If you need to execute code at the beginning or ending of each step, use setPreStep and setPostStep respectively.

See also:


Source code at petsc4py/PETSc/TS.pyx:2469 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2469>



Print the TS object.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- The visualization context.
None <https://docs.python.org/3/library/constants.html#None>

Notes

-ts_view calls TSView at the end of TSStep

See also:


Source code at petsc4py/PETSc/TS.pyx:167 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L167>


Attributes Documentation


The absolute tolerance.

Source code at petsc4py/PETSc/TS.pyx:3248 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3248>


Indicates the TS has converged.

Source code at petsc4py/PETSc/TS.pyx:3269 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3269>


Indicates the TS has stopped.

Source code at petsc4py/PETSc/TS.pyx:3274 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3274>


The DM <#petsc4py.PETSc.DM>.

Source code at petsc4py/PETSc/TS.pyx:3155 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3155>



Indicates the TS is still iterating.

Source code at petsc4py/PETSc/TS.pyx:3264 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3264>


The KSP <#petsc4py.PETSc.KSP>.

Source code at petsc4py/PETSc/TS.pyx:3186 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3186>


The maximum number of steps.

Source code at petsc4py/PETSc/TS.pyx:3230 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3230>





The relative tolerance.

Source code at petsc4py/PETSc/TS.pyx:3240 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3240>


The SNES <#petsc4py.PETSc.SNES>.

Source code at petsc4py/PETSc/TS.pyx:3181 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3181>




The current time step size.

Source code at petsc4py/PETSc/TS.pyx:3206 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3206>





petsc4py.PETSc.Vec

Bases: Object <#petsc4py.PETSc.Object>

A vector object.

See also:


Enumerations

Option <#petsc4py.PETSc.Vec.Option> Vector assembly option.
Type <#petsc4py.PETSc.Vec.Type> The vector type.

petsc4py.PETSc.Vec.Option

Bases: object <https://docs.python.org/3/library/functions.html#object>

Vector assembly option.

Attributes Summary

IGNORE_NEGATIVE_INDICES Constant IGNORE_NEGATIVE_INDICES of type int <https://docs.python.org/3/library/functions.html#int>
IGNORE_OFF_PROC_ENTRIES Constant IGNORE_OFF_PROC_ENTRIES of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation




petsc4py.PETSc.Vec.Type

Bases: object <https://docs.python.org/3/library/functions.html#object>

The vector type.

Attributes Summary

CUDA Object CUDA of type str <https://docs.python.org/3/library/stdtypes.html#str>
HIP Object HIP of type str <https://docs.python.org/3/library/stdtypes.html#str>
KOKKOS Object KOKKOS of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPI Object MPI of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPICUDA Object MPICUDA of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPIHIP Object MPIHIP of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPIKOKKOS Object MPIKOKKOS of type str <https://docs.python.org/3/library/stdtypes.html#str>
MPIVIENNACL Object MPIVIENNACL of type str <https://docs.python.org/3/library/stdtypes.html#str>
NEST Object NEST of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQ Object SEQ of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQCUDA Object SEQCUDA of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQHIP Object SEQHIP of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQKOKKOS Object SEQKOKKOS of type str <https://docs.python.org/3/library/stdtypes.html#str>
SEQVIENNACL Object SEQVIENNACL of type str <https://docs.python.org/3/library/stdtypes.html#str>
SHARED Object SHARED of type str <https://docs.python.org/3/library/stdtypes.html#str>
STANDARD Object STANDARD of type str <https://docs.python.org/3/library/stdtypes.html#str>
VIENNACL Object VIENNACL of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation



















Methods Summary

abs() Replace each entry (xₙ) in the vector by abs|xₙ|.
appendOptionsPrefix(prefix) Append to the prefix used for searching for options in the database.
assemble() Assemble the vector.
assemblyBegin() Begin an assembling stage of the vector.
assemblyEnd() Finish the assembling stage initiated with assemblyBegin.
attachDLPackInfo([vec, dltensor]) Attach tensor information from another vector or DLPack tensor.
axpby(alpha, beta, x) Compute and store y = ɑ·x + β·y.
axpy(alpha, x) Compute and store y = ɑ·x + y.
aypx(alpha, x) Compute and store y = x + ɑ·y.
bindToCPU(flg) Bind vector operations execution on the CPU.
boundToCPU() Return whether the vector has been bound to the CPU.
chop(tol) Set all vector entries less than some absolute tolerance to zero.
clearDLPackInfo() Clear tensor information.
concatenate(vecs) Concatenate vectors into a single vector.
conjugate() Conjugate the vector.
copy([result]) Return a copy of the vector.
create([comm]) Create a vector object.
createCUDAWithArrays([cpuarray, cudahandle, ...]) Create a Type.CUDA <#petsc4py.PETSc.Vec.Type.CUDA> vector with optional arrays.
createGhost(ghosts, size[, bsize, comm]) Create a parallel vector with ghost padding on each processor.
createGhostWithArray(ghosts, array[, size, ...]) Create a parallel vector with ghost padding and provided arrays.
createHIPWithArrays([cpuarray, hiphandle, ...]) Create a Type.HIP <#petsc4py.PETSc.Vec.Type.HIP> vector with optional arrays.
createLocalVector() Create a local vector.
createMPI(size[, bsize, comm]) Create a parallel Type.MPI <#petsc4py.PETSc.Vec.Type.MPI> vector.
createNest(vecs[, isets, comm]) Create a Type.NEST <#petsc4py.PETSc.Vec.Type.NEST> vector containing multiple nested subvectors.
createSeq(size[, bsize, comm]) Create a sequential Type.SEQ <#petsc4py.PETSc.Vec.Type.SEQ> vector.
createShared(size[, bsize, comm]) Create a Type.SHARED <#petsc4py.PETSc.Vec.Type.SHARED> vector that uses shared memory.
createViennaCLWithArrays([cpuarray, ...]) Create a Type.VIENNACL <#petsc4py.PETSc.Vec.Type.VIENNACL> vector with optional arrays.
createWithArray(array[, size, bsize, comm]) Create a vector using a provided array.
createWithDLPack(dltensor[, size, bsize, comm]) Create a vector wrapping a DLPack object, sharing the same memory.
destroy() Destroy the vector.
dot(vec) Return the dot product with vec.
dotBegin(vec) Begin computing the dot product.
dotEnd(vec) Finish computing the dot product initiated with dotBegin.
dotNorm2(vec) Return the dot product with vec and its squared norm.
duplicate([array]) Create a new vector with the same type, optionally with data.
equal(vec) Return whether the vector is equal to another.
exp() Replace each entry (xₙ) in the vector by exp(xₙ).
getArray([readonly]) Return local portion of the vector as an ndarray <https://numpy.org/doc/stable/glossary.html#term-ndarray>.
getBlockSize() Return the block size of the vector.
getBuffer([readonly]) Return a buffered view of the local portion of the vector.
getCLContextHandle() Return the OpenCL context associated with the vector.
getCLMemHandle([mode]) Return the OpenCL buffer associated with the vector.
getCLQueueHandle() Return the OpenCL command queue associated with the vector.
getCUDAHandle([mode]) Return a pointer to the device buffer.
getDM() Return the DM <#petsc4py.PETSc.DM> associated to the vector.
getGhostIS() Return ghosting indices of a ghost vector.
getHIPHandle([mode]) Return a pointer to the device buffer.
getLGMap() Return the local-to-global mapping.
getLocalSize() Return the local size of the vector.
getLocalVector(lvec[, readonly]) Maps the local portion of the vector into a local vector.
getNestSubVecs() Return all the vectors contained in the nested vector.
getOffloadMask() Return the offloading status of the vector.
getOptionsPrefix() Return the prefix used for searching for options in the database.
getOwnershipRange() Return the locally owned range of indices (start, end).
getOwnershipRanges() Return the range of indices owned by each process.
getSize() Return the global size of the vector.
getSizes() Return the vector sizes.
getSubVector(iset[, subvec]) Return a subvector from given indices.
getType() Return the type of the vector.
getValue(index) Return a single value from the vector.
getValues(indices[, values]) Return values from certain locations in the vector.
getValuesStagStencil(indices[, values]) Not implemented.
ghostUpdate([addv, mode]) Update ghosted vector entries.
ghostUpdateBegin([addv, mode]) Begin updating ghosted vector entries.
ghostUpdateEnd([addv, mode]) Finish updating ghosted vector entries initiated with ghostUpdateBegin.
isaxpy(idx, alpha, x) Add a scaled reduced-space vector to a subset of the vector.
isset(idx, alpha) Set specific elements of the vector to the same value.
load(viewer) Load a vector.
localForm() Return a context manager for viewing ghost vectors in local form.
log() Replace each entry in the vector by its natural logarithm.
mDot(vecs[, out]) Compute Xᴴ·y with X an array of vectors.
mDotBegin(vecs, out) Starts a split phase multiple dot product computation.
mDotEnd(vecs, out) Ends a split phase multiple dot product computation.
max() Return the vector entry with maximum real part and its location.
maxPointwiseDivide(vec) Return the maximum of the component-wise absolute value division.
maxpy(alphas, vecs) Compute and store y = Σₙ(ɑₙ·Xₙ) + y with X an array of vectors.
mean() Return the arithmetic mean of all the entries of the vector.
min() Return the vector entry with minimum real part and its location.
mtDot(vecs[, out]) Compute Xᵀ·y with X an array of vectors.
mtDotBegin(vecs, out) Starts a split phase transpose multiple dot product computation.
mtDotEnd(vecs, out) Ends a split phase transpose multiple dot product computation.
norm([norm_type]) Compute the vector norm.
normBegin([norm_type]) Begin computing the vector norm.
normEnd([norm_type]) Finish computations initiated with normBegin.
normalize() Normalize the vector by its 2-norm.
permute(order[, invert]) Permute the vector in-place with a provided ordering.
placeArray(array) Set the local portion of the vector to a provided array.
pointwiseDivide(x, y) Compute and store the component-wise division of two vectors.
pointwiseMax(x, y) Compute and store the component-wise maximum of two vectors.
pointwiseMaxAbs(x, y) Compute and store the component-wise maximum absolute values.
pointwiseMin(x, y) Compute and store the component-wise minimum of two vectors.
pointwiseMult(x, y) Compute and store the component-wise multiplication of two vectors.
reciprocal() Replace each entry in the vector by its reciprocal.
resetArray([force]) Reset the vector to use its default array.
restoreCLMemHandle() Restore a pointer to the OpenCL buffer obtained with getCLMemHandle.
restoreCUDAHandle(handle[, mode]) Restore a pointer to the device buffer obtained with getCUDAHandle.
restoreHIPHandle(handle[, mode]) Restore a pointer to the device buffer obtained with getHIPHandle.
restoreLocalVector(lvec[, readonly]) Unmap a local access obtained with getLocalVector.
restoreSubVector(iset, subvec) Restore a subvector extracted using getSubVector.
scale(alpha) Scale all entries of the vector.
set(alpha) Set all components of the vector to the same value.
setArray(array) Set values for the local portion of the vector.
setBlockSize(bsize) Set the block size of the vector.
setDM(dm) Associate a DM <#petsc4py.PETSc.DM> to the vector.
setFromOptions() Configure the vector from the options database.
setLGMap(lgmap) Set the local-to-global mapping.
setMPIGhost(ghosts) Set the ghost points for a ghosted vector.
setNestSubVecs(sx[, idxm]) Set the component vectors at specified indices in the nested vector.
setOption(option, flag) Set option.
setOptionsPrefix(prefix) Set the prefix used for searching for options in the database.
setRandom([random]) Set all components of the vector to random numbers.
setSizes(size[, bsize]) Set the local and global sizes of the vector.
setType(vec_type) Set the vector type.
setUp() Set up the internal data structures for using the vector.
setValue(index, value[, addv]) Insert or add a single value in the vector.
setValueLocal(index, value[, addv]) Insert or add a single value in the vector using a local numbering.
setValues(indices, values[, addv]) Insert or add multiple values in the vector.
setValuesBlocked(indices, values[, addv]) Insert or add blocks of values in the vector.
setValuesBlockedLocal(indices, values[, addv]) Insert or add blocks of values in the vector with a local numbering.
setValuesLocal(indices, values[, addv]) Insert or add multiple values in the vector with a local numbering.
setValuesStagStencil(indices, values[, addv]) Not implemented.
shift(alpha) Shift all entries in the vector.
sqrtabs() Replace each entry (xₙ) in the vector by √|xₙ|.
strideGather(field, vec[, addv]) Insert component values into a single-component vector.
strideMax(field) Return the maximum of entries in a subvector.
strideMin(field) Return the minimum of entries in a subvector.
strideNorm(field[, norm_type]) Return the norm of entries in a subvector.
strideScale(field, alpha) Scale a component of the vector.
strideScatter(field, vec[, addv]) Scatter entries into a component of another vector.
strideSum(field) Sum subvector entries.
sum() Return the sum of all the entries of the vector.
swap(vec) Swap the content of two vectors.
tDot(vec) Return the indefinite dot product with vec.
tDotBegin(vec) Begin computing the indefinite dot product.
tDotEnd(vec) Finish computing the indefinite dot product initiated with tDotBegin.
toDLPack([mode]) Return a DLPack PyCapsule <https://docs.python.org/3/c-api/capsule.html#c.PyCapsule> wrapping the vector data.
view([viewer]) Display the vector.
waxpy(alpha, x, y) Compute and store w = ɑ·x + y.
zeroEntries() Set all entries in the vector to zero.

Attributes Summary

array Alias for array_w.
array_r Read-only ndarray <https://numpy.org/doc/stable/glossary.html#term-ndarray> containing the local portion of the vector.
array_w Writeable ndarray <https://numpy.org/doc/stable/glossary.html#term-ndarray> containing the local portion of the vector.
block_size The block size.
buffer Alias for buffer_w.
buffer_r Read-only buffered view of the local portion of the vector.
buffer_w Writeable buffered view of the local portion of the vector.
local_size The local vector size.
owner_range The locally owned range of indices in the form [low, high).
owner_ranges The range of indices owned by each process.
size The global vector size.
sizes The local and global vector sizes.

Methods Documentation

Replace each entry (xₙ) in the vector by abs|xₙ|.

Logically collective.

See also:


Source code at petsc4py/PETSc/Vec.pyx:2307 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2307>



Append to the prefix used for searching for options in the database.

Logically collective.

See also:

Working with PETSc options <#petsc-options>, setOptionsPrefix, VecAppendOptionsPrefix <https://petsc.org/release/manualpages/Vec/VecAppendOptionsPrefix.html>


Source code at petsc4py/PETSc/Vec.pyx:1028 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1028>



Assemble the vector.

Collective.

See also:

assemblyBegin, assemblyEnd


Source code at petsc4py/PETSc/Vec.pyx:3061 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3061>




Finish the assembling stage initiated with assemblyBegin.

Collective.

See also:


Source code at petsc4py/PETSc/Vec.pyx:3049 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3049>



Attach tensor information from another vector or DLPack tensor.

Logically collective.

This tensor information is required when converting a Vec to a DLPack object.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

Notes

This operation does not copy any data from vec or dltensor.

See also:

clearDLPackInfo, createWithDLPack


Source code at petsc4py/PETSc/Vec.pyx:643 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L643>


Compute and store y = ɑ·x + β·y.

Logically collective.

  • alpha (Scalar <#petsc4py.typing.Scalar>) -- First scale factor.
  • beta (Scalar <#petsc4py.typing.Scalar>) -- Second scale factor.
  • x (Vec <#petsc4py.PETSc.Vec>) -- Input vector, must not be the current vector.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:2538 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2538>


Compute and store y = ɑ·x + y.

Logically collective.

  • alpha (Scalar <#petsc4py.typing.Scalar>) -- Scale factor.
  • x (Vec <#petsc4py.PETSc.Vec>) -- Input vector.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:2474 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2474>


Compute and store y = x + ɑ·y.

Logically collective.

  • alpha (Scalar <#petsc4py.typing.Scalar>) -- Scale factor.
  • x (Vec <#petsc4py.PETSc.Vec>) -- Input vector, must not be the current vector.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:2518 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2518>



Return whether the vector has been bound to the CPU.

Not collective.

See also:


Source code at petsc4py/PETSc/Vec.pyx:1409 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1409>



Set all vector entries less than some absolute tolerance to zero.

Collective.

tol (float <https://docs.python.org/3/library/functions.html#float>) -- The absolute tolerance below which entries are set to zero.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:1732 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1732>


Clear tensor information.

Logically collective.

See also:

attachDLPackInfo, createWithDLPack


Source code at petsc4py/PETSc/Vec.pyx:705 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L705>



Concatenate vectors into a single vector.

Collective.

vecs (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Vec <#petsc4py.PETSc.Vec>]) -- The vectors to be concatenated.

tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, list <https://docs.python.org/3/library/stdtypes.html#list>[IS <#petsc4py.PETSc.IS>]]

See also:


Source code at petsc4py/PETSc/Vec.pyx:3552 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3552>



Return a copy of the vector.

Logically collective.

This operation copies vector entries to the new vector.

result (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- Target vector for the copy. If None <https://docs.python.org/3/library/constants.html#None> then a new vector is created internally.
Vec <#petsc4py.PETSc.Vec>

See also:


Source code at petsc4py/PETSc/Vec.pyx:1707 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1707>


Create a vector object.

Collective.

After creation the vector type can then be set with setType.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Vec.pyx:176 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L176>


Create a Type.CUDA <#petsc4py.PETSc.Vec.Type.CUDA> vector with optional arrays.

Collective.


Self

See also:


Source code at petsc4py/PETSc/Vec.pyx:370 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L370>


Create a parallel vector with ghost padding on each processor.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Vec.pyx:819 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L819>


Create a parallel vector with ghost padding and provided arrays.

Collective.


Self

See also:


Source code at petsc4py/PETSc/Vec.pyx:861 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L861>


Create a Type.HIP <#petsc4py.PETSc.Vec.Type.HIP> vector with optional arrays.

Collective.


Self

See also:


Source code at petsc4py/PETSc/Vec.pyx:428 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L428>


Create a local vector.

Not collective.

The local vector.
Vec

See also:


Source code at petsc4py/PETSc/Vec.pyx:1204 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1204>


Create a parallel Type.MPI <#petsc4py.PETSc.Vec.Type.MPI> vector.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Vec.pyx:283 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L283>


Create a Type.NEST <#petsc4py.PETSc.Vec.Type.NEST> vector containing multiple nested subvectors.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Vec.pyx:952 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L952>


Create a sequential Type.SEQ <#petsc4py.PETSc.Vec.Type.SEQ> vector.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Vec.pyx:247 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L247>


Create a Type.SHARED <#petsc4py.PETSc.Vec.Type.SHARED> vector that uses shared memory.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:


Source code at petsc4py/PETSc/Vec.pyx:918 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L918>


Create a Type.VIENNACL <#petsc4py.PETSc.Vec.Type.VIENNACL> vector with optional arrays.

Collective.


Self

See also:


Source code at petsc4py/PETSc/Vec.pyx:486 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L486>


Create a vector using a provided array.

Collective.

This method will create either a Type.SEQ <#petsc4py.PETSc.Vec.Type.SEQ> or Type.MPI <#petsc4py.PETSc.Vec.Type.MPI> depending on the size of the communicator.


Self

See also:


Source code at petsc4py/PETSc/Vec.pyx:319 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L319>


Create a vector wrapping a DLPack object, sharing the same memory.

Collective.

This operation does not modify the storage of the original tensor and should be used with contiguous tensors only. If the tensor is stored in row-major order (e.g. PyTorch tensors), the resulting vector will look like an unrolled tensor using row-major order.

The resulting vector type will be one of Type.SEQ <#petsc4py.PETSc.Vec.Type.SEQ>, Type.MPI <#petsc4py.PETSc.Vec.Type.MPI>, Type.SEQCUDA <#petsc4py.PETSc.Vec.Type.SEQCUDA>, Type.MPICUDA <#petsc4py.PETSc.Vec.Type.MPICUDA>, Type.SEQHIP <#petsc4py.PETSc.Vec.Type.SEQHIP> or Type.MPIHIP <#petsc4py.PETSc.Vec.Type.MPIHIP> depending on the type of dltensor and the number of processes in the communicator.


Self

Source code at petsc4py/PETSc/Vec.pyx:545 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L545>



Return the dot product with vec.

Collective.

For complex numbers this computes yᴴ·x with self as x, vec as y and where yᴴ denotes the conjugate transpose of y.

Use tDot for the indefinite form yᵀ·x where yᵀ denotes the transpose of y.

vec (Vec <#petsc4py.PETSc.Vec>) -- Vector to compute the dot product with.
Scalar <#petsc4py.typing.Scalar>

See also:


Source code at petsc4py/PETSc/Vec.pyx:1787 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1787>


Begin computing the dot product.

Collective.

This should be paired with a call to dotEnd.

vec (Vec <#petsc4py.PETSc.Vec>) -- Vector to compute the dot product with.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:1812 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1812>


Finish computing the dot product initiated with dotBegin.

Collective.

See also:


Source code at petsc4py/PETSc/Vec.pyx:1832 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1832>

vec (Vec <#petsc4py.PETSc.Vec>)
Scalar <#petsc4py.typing.Scalar>


Return the dot product with vec and its squared norm.

Collective.

See also:


Source code at petsc4py/PETSc/Vec.pyx:2151 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2151>

vec (Vec <#petsc4py.PETSc.Vec>)
tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Scalar <#petsc4py.typing.Scalar>, float <https://docs.python.org/3/library/functions.html#float>]


Create a new vector with the same type, optionally with data.

Collective.

array (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>] | None <https://docs.python.org/3/library/constants.html#None>) -- Optional values to store in the new vector.
Vec <#petsc4py.PETSc.Vec>

See also:


Source code at petsc4py/PETSc/Vec.pyx:1682 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1682>


Return whether the vector is equal to another.

Collective.

vec (Vec <#petsc4py.PETSc.Vec>) -- Vector to compare with.
bool <https://docs.python.org/3/library/functions.html#bool>

See also:


Source code at petsc4py/PETSc/Vec.pyx:1768 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1768>


Replace each entry (xₙ) in the vector by exp(xₙ).

Logically collective.

See also:


Source code at petsc4py/PETSc/Vec.pyx:2271 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2271>



Return local portion of the vector as an ndarray <https://numpy.org/doc/stable/glossary.html#term-ndarray>.

Logically collective.

readonly (bool <https://docs.python.org/3/library/functions.html#bool>) -- Request read-only access.
ArrayScalar <#petsc4py.typing.ArrayScalar>

See also:

setArray, getBuffer


Source code at petsc4py/PETSc/Vec.pyx:1313 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1313>



Return a buffered view of the local portion of the vector.

Logically collective.

readonly (bool <https://docs.python.org/3/library/functions.html#bool>) -- Request read-only access.
Buffer object <https://docs.python.org/3/c-api/buffer.html> wrapping the local portion of the vector data. This can be used either as a context manager providing access as a numpy array or can be passed to array constructors accepting buffered objects such as numpy.asarray <https://numpy.org/doc/stable/reference/generated/numpy.asarray.html#numpy.asarray>.
typing.Any <https://docs.python.org/3/library/typing.html#typing.Any>

Examples

Accessing the data with a context manager:

>>> vec = PETSc.Vec().createWithArray([1, 2, 3])
>>> with vec.getBuffer() as arr:
...     arr
array([1., 2., 3.])

Converting the buffer to an ndarray <https://numpy.org/doc/stable/glossary.html#term-ndarray>:

>>> buf = PETSc.Vec().createWithArray([1, 2, 3]).getBuffer()
>>> np.asarray(buf)
array([1., 2., 3.])

See also:

getArray


Source code at petsc4py/PETSc/Vec.pyx:1270 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1270>


Return the OpenCL context associated with the vector.

Not collective.

Pointer to underlying CL context. This can be used with pyopencl through pyopencl.Context.from_int_ptr.
int <https://docs.python.org/3/library/functions.html#int>

See also:


Source code at petsc4py/PETSc/Vec.pyx:1593 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1593>


Return the OpenCL buffer associated with the vector.

Not collective.

Pointer to the device buffer. This can be used with pyopencl through pyopencl.Context.from_int_ptr.
int <https://docs.python.org/3/library/functions.html#int>
mode (AccessModeSpec <#petsc4py.typing.AccessModeSpec>)

Notes

This method may incur a host-to-device copy if the device data is out of date and mode is "r" or "rw".

See also:


Source code at petsc4py/PETSc/Vec.pyx:1633 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1633>


Return the OpenCL command queue associated with the vector.

Not collective.

Pointer to underlying CL command queue. This can be used with pyopencl through pyopencl.Context.from_int_ptr.
int <https://docs.python.org/3/library/functions.html#int>

See also:



Source code at petsc4py/PETSc/Vec.pyx:1613 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1613>


Return a pointer to the device buffer.

Not collective.

The returned pointer should be released using restoreCUDAHandle with the same access mode.

CUDA device pointer.
typing.Any <https://docs.python.org/3/library/typing.html#typing.Any>
mode (AccessModeSpec <#petsc4py.typing.AccessModeSpec>)

Notes

This method may incur a host-to-device copy if the device data is out of date and mode is "r" or "rw".

See also:


Source code at petsc4py/PETSc/Vec.pyx:1423 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1423>


Return the DM <#petsc4py.PETSc.DM> associated to the vector.

Not collective.

See also:


Source code at petsc4py/PETSc/Vec.pyx:3533 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3533>

DM <#petsc4py.PETSc.DM>


Return ghosting indices of a ghost vector.

Collective.

Indices of ghosts.
IS <#petsc4py.PETSc.IS>

See also:


Source code at petsc4py/PETSc/Vec.pyx:3399 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3399>


Return a pointer to the device buffer.

Not collective.

The returned pointer should be released using restoreHIPHandle with the same access mode.

HIP device pointer.
typing.Any <https://docs.python.org/3/library/typing.html#typing.Any>
mode (AccessModeSpec <#petsc4py.typing.AccessModeSpec>)

Notes

This method may incur a host-to-device copy if the device data is out of date and mode is "r" or "rw".

See also:


Source code at petsc4py/PETSc/Vec.pyx:1495 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1495>


Return the local-to-global mapping.

Not collective.

See also:


Source code at petsc4py/PETSc/Vec.pyx:2913 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2913>

LGMap <#petsc4py.PETSc.LGMap>



Maps the local portion of the vector into a local vector.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:1223 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1223>


Return all the vectors contained in the nested vector.

Not collective.

See also:


Source code at petsc4py/PETSc/Vec.pyx:3465 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3465>



Return the offloading status of the vector.

Not collective.

Common return values include:

  • 1: PETSC_OFFLOAD_CPU - CPU has valid entries
  • 2: PETSC_OFFLOAD_GPU - GPU has valid entries
  • 3: PETSC_OFFLOAD_BOTH - CPU and GPU are in sync


See also:


Source code at petsc4py/PETSc/Vec.pyx:1567 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1567>


Return the prefix used for searching for options in the database.

Not collective.

See also:

Working with PETSc options <#petsc-options>, setOptionsPrefix, VecGetOptionsPrefix <https://petsc.org/release/manualpages/Vec/VecGetOptionsPrefix.html>


Source code at petsc4py/PETSc/Vec.pyx:1014 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1014>




Return the range of indices owned by each process.

Not collective.

The returned array is the result of exclusive scan of the local sizes.

See also:


Source code at petsc4py/PETSc/Vec.pyx:1184 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1184>

ArrayInt <#petsc4py.typing.ArrayInt>


Return the global size of the vector.

Not collective.

See also:



Source code at petsc4py/PETSc/Vec.pyx:1093 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1093>



Return the vector sizes.

Not collective.

See also:


Source code at petsc4py/PETSc/Vec.pyx:1121 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1121>

LayoutSizeSpec <#petsc4py.typing.LayoutSizeSpec>


Return a subvector from given indices.

Collective.

Once finished with the subvector it should be returned with restoreSubVector.


Vec <#petsc4py.PETSc.Vec>

See also:


Source code at petsc4py/PETSc/Vec.pyx:3420 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3420>



Return a single value from the vector.

Not collective.

Only values locally stored may be accessed.

index (int <https://docs.python.org/3/library/functions.html#int>) -- Location of the value to read.
Scalar <#petsc4py.typing.Scalar>

See also:


Source code at petsc4py/PETSc/Vec.pyx:2734 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2734>


Return values from certain locations in the vector.

Not collective.

Only values locally stored may be accessed.


ArrayScalar <#petsc4py.typing.ArrayScalar>

See also:


Source code at petsc4py/PETSc/Vec.pyx:2756 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2756>



Update ghosted vector entries.

Neighborwise collective.

  • addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
  • mode (ScatterModeSpec <#petsc4py.typing.ScatterModeSpec>) -- Scatter mode.

None <https://docs.python.org/3/library/constants.html#None>

Examples

To accumulate ghost region values onto owning processes:

>>> vec.ghostUpdate(InsertMode.ADD_VALUES, ScatterMode.REVERSE)

Update ghost regions:

>>> vec.ghostUpdate(InsertMode.INSERT_VALUES, ScatterMode.FORWARD)

See also:

ghostUpdateBegin, ghostUpdateEnd


Source code at petsc4py/PETSc/Vec.pyx:3345 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3345>


Begin updating ghosted vector entries.

Neighborwise collective.

See also:

ghostUpdateEnd, ghostUpdate, createGhost, VecGhostUpdateBegin <https://petsc.org/release/manualpages/Vec/VecGhostUpdateBegin.html>


Source code at petsc4py/PETSc/Vec.pyx:3311 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3311>

  • addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>)
  • mode (ScatterModeSpec <#petsc4py.typing.ScatterModeSpec>)

None <https://docs.python.org/3/library/constants.html#None>


Finish updating ghosted vector entries initiated with ghostUpdateBegin.

Neighborwise collective.

See also:

ghostUpdateBegin, ghostUpdate, createGhost, VecGhostUpdateEnd <https://petsc.org/release/manualpages/Vec/VecGhostUpdateEnd.html>


Source code at petsc4py/PETSc/Vec.pyx:3328 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3328>

  • addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>)
  • mode (ScatterModeSpec <#petsc4py.typing.ScatterModeSpec>)

None <https://docs.python.org/3/library/constants.html#None>


Add a scaled reduced-space vector to a subset of the vector.

Logically collective.

This is equivalent to y[idx[i]] += alpha*x[i].

  • idx (IS <#petsc4py.PETSc.IS>) -- Index set for the reduced space. Negative indices are skipped.
  • alpha (Scalar <#petsc4py.typing.Scalar>) -- Scale factor.
  • x (Vec <#petsc4py.PETSc.Vec>) -- Reduced-space vector.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:2494 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2494>


Set specific elements of the vector to the same value.

Not collective.

  • idx (IS <#petsc4py.PETSc.IS>) -- Index set specifying the vector entries to set.
  • alpha (Scalar <#petsc4py.typing.Scalar>) -- Value to set the selected entries to.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:2397 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2397>



Return a context manager for viewing ghost vectors in local form.

Logically collective.

Context manager yielding the vector in local (ghosted) form.
typing.Any <https://docs.python.org/3/library/typing.html#typing.Any>

Notes

This operation does not perform a copy. To obtain up-to-date ghost values ghostUpdateBegin and ghostUpdateEnd must be called first.

Non-ghost values can be found at values[0:nlocal] and ghost values at values[nlocal:nlocal+nghost].

Examples

>>> with vec.localForm() as lf:
...     # compute with lf

See also:

createGhost, ghostUpdateBegin, ghostUpdateEnd, VecGhostGetLocalForm <https://petsc.org/release/manualpages/Vec/VecGhostGetLocalForm.html>, VecGhostRestoreLocalForm <https://petsc.org/release/manualpages/Vec/VecGhostRestoreLocalForm.html>


Source code at petsc4py/PETSc/Vec.pyx:3278 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3278>


Replace each entry in the vector by its natural logarithm.

Logically collective.

See also:


Source code at petsc4py/PETSc/Vec.pyx:2283 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2283>



Compute Xᴴ·y with X an array of vectors.

Collective.


ArrayScalar <#petsc4py.typing.ArrayScalar>

See also:

dot, tDot, mDotBegin, mDotEnd, VecMDot <https://petsc.org/release/manualpages/Vec/VecMDot.html>


Source code at petsc4py/PETSc/Vec.pyx:1902 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1902>


Starts a split phase multiple dot product computation.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:1935 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1935>


Ends a split phase multiple dot product computation.

Collective.


ArrayScalar <#petsc4py.typing.ArrayScalar>

See also:


Source code at petsc4py/PETSc/Vec.pyx:1965 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1965>


Return the vector entry with maximum real part and its location.

Collective.


tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, float <https://docs.python.org/3/library/functions.html#float>]

See also:


Source code at petsc4py/PETSc/Vec.pyx:2217 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2217>


Return the maximum of the component-wise absolute value division.

Logically collective.

Equivalent to result = max_i abs(x[i] / y[i]).

  • x -- Numerator vector.
  • y -- Denominator vector.
  • vec (Vec <#petsc4py.PETSc.Vec>)

float <https://docs.python.org/3/library/functions.html#float>

See also:

pointwiseMin, pointwiseMax, pointwiseMaxAbs, VecMaxPointwiseDivide <https://petsc.org/release/manualpages/Vec/VecMaxPointwiseDivide.html>


Source code at petsc4py/PETSc/Vec.pyx:2710 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2710>


Compute and store y = Σₙ(ɑₙ·Xₙ) + y with X an array of vectors.

Logically collective.

Equivalent to y[:] = alphas[i]*vecs[i, :] + y[:].


None <https://docs.python.org/3/library/constants.html#None>

See also:

axpy, aypx, axpby, waxpy, VecMAXPY <https://petsc.org/release/manualpages/Vec/VecMAXPY.html>


Source code at petsc4py/PETSc/Vec.pyx:2583 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2583>


Return the arithmetic mean of all the entries of the vector.

Collective.

See also:


Source code at petsc4py/PETSc/Vec.pyx:2180 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2180>

Scalar <#petsc4py.typing.Scalar>


Return the vector entry with minimum real part and its location.

Collective.


tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, float <https://docs.python.org/3/library/functions.html#float>]

See also:


Source code at petsc4py/PETSc/Vec.pyx:2194 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2194>


Compute Xᵀ·y with X an array of vectors.

Collective.


ArrayScalar <#petsc4py.typing.ArrayScalar>

See also:

tDot, mDot, mtDotBegin, mtDotEnd, VecMTDot <https://petsc.org/release/manualpages/Vec/VecMTDot.html>


Source code at petsc4py/PETSc/Vec.pyx:1996 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1996>


Starts a split phase transpose multiple dot product computation.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:2029 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2029>


Ends a split phase transpose multiple dot product computation.

Collective.


ArrayScalar <#petsc4py.typing.ArrayScalar>

See also:


Source code at petsc4py/PETSc/Vec.pyx:2059 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2059>


Compute the vector norm.

Collective.

A 2-tuple is returned if NormType.NORM_1_AND_2 <#petsc4py.PETSc.NormType.NORM_1_AND_2> is specified.

See also:


Source code at petsc4py/PETSc/Vec.pyx:2090 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2090>



Begin computing the vector norm.

Collective.

This should be paired with a call to normEnd.

See also:


Source code at petsc4py/PETSc/Vec.pyx:2112 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2112>

norm_type (NormTypeSpec <#petsc4py.typing.NormTypeSpec>)
None <https://docs.python.org/3/library/constants.html#None>



Normalize the vector by its 2-norm.

Collective.

The vector norm before normalization.
float <https://docs.python.org/3/library/functions.html#float>

See also:


Source code at petsc4py/PETSc/Vec.pyx:2240 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2240>


Permute the vector in-place with a provided ordering.

Collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:2351 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2351>


Set the local portion of the vector to a provided array.

Not collective.

See also:



Source code at petsc4py/PETSc/Vec.pyx:1345 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1345>



Compute and store the component-wise division of two vectors.

Logically collective.

Equivalent to w[i] = x[i] / y[i].

  • x (Vec <#petsc4py.PETSc.Vec>) -- Numerator vector.
  • y (Vec <#petsc4py.PETSc.Vec>) -- Denominator vector.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:2632 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2632>


Compute and store the component-wise maximum of two vectors.

Logically collective.

Equivalent to w[i] = max(x[i], y[i]).

  • x (Vec <#petsc4py.PETSc.Vec>) -- Input vectors to find the component-wise maxima.
  • y (Vec <#petsc4py.PETSc.Vec>) -- Input vectors to find the component-wise maxima.

None <https://docs.python.org/3/library/constants.html#None>

See also:

pointwiseMin, pointwiseMaxAbs, VecPointwiseMax <https://petsc.org/release/manualpages/Vec/VecPointwiseMax.html>


Source code at petsc4py/PETSc/Vec.pyx:2672 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2672>


Compute and store the component-wise maximum absolute values.

Logically collective.

Equivalent to w[i] = max(abs(x[i]), abs(y[i])).

  • x (Vec <#petsc4py.PETSc.Vec>) -- Input vectors to find the component-wise maxima.
  • y (Vec <#petsc4py.PETSc.Vec>) -- Input vectors to find the component-wise maxima.

None <https://docs.python.org/3/library/constants.html#None>

See also:

pointwiseMin, pointwiseMax, VecPointwiseMaxAbs <https://petsc.org/release/manualpages/Vec/VecPointwiseMaxAbs.html>


Source code at petsc4py/PETSc/Vec.pyx:2691 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2691>


Compute and store the component-wise minimum of two vectors.

Logically collective.

Equivalent to w[i] = min(x[i], y[i]).

  • x (Vec <#petsc4py.PETSc.Vec>) -- Input vectors to find the component-wise minima.
  • y (Vec <#petsc4py.PETSc.Vec>) -- Input vectors to find the component-wise minima.

None <https://docs.python.org/3/library/constants.html#None>

See also:

pointwiseMax, pointwiseMaxAbs, VecPointwiseMin <https://petsc.org/release/manualpages/Vec/VecPointwiseMin.html>


Source code at petsc4py/PETSc/Vec.pyx:2653 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2653>


Compute and store the component-wise multiplication of two vectors.

Logically collective.

Equivalent to w[i] = x[i] * y[i].

  • x (Vec <#petsc4py.PETSc.Vec>) -- Input vectors to multiply component-wise.
  • y (Vec <#petsc4py.PETSc.Vec>) -- Input vectors to multiply component-wise.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:2613 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2613>


Replace each entry in the vector by its reciprocal.

Logically collective.

See also:


Source code at petsc4py/PETSc/Vec.pyx:2259 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2259>



Reset the vector to use its default array.

Not collective.

force (bool <https://docs.python.org/3/library/functions.html#bool>) -- Force the calling of VecResetArray <https://petsc.org/release/manualpages/Vec/VecResetArray.html> even if no user array has been placed with placeArray.
The array previously provided by the user with placeArray. Can be None <https://docs.python.org/3/library/constants.html#None> if force is True <https://docs.python.org/3/library/constants.html#True> and no array was placed before.
ArrayScalar <#petsc4py.typing.ArrayScalar>

See also:


Source code at petsc4py/PETSc/Vec.pyx:1366 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1366>


Restore a pointer to the OpenCL buffer obtained with getCLMemHandle.

Not collective.

See also:


Source code at petsc4py/PETSc/Vec.pyx:1670 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1670>



Restore a pointer to the device buffer obtained with getCUDAHandle.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:1462 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1462>


Restore a pointer to the device buffer obtained with getHIPHandle.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:1534 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1534>


Unmap a local access obtained with getLocalVector.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:1246 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1246>


Restore a subvector extracted using getSubVector.

Collective.

  • iset (IS <#petsc4py.PETSc.IS>) -- Index set describing the indices represented by the subvector.
  • subvec (Vec <#petsc4py.PETSc.Vec>) -- Subvector to be restored.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:3446 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3446>


Scale all entries of the vector.

Collective.

This method sets each entry (xₙ) in the vector to ɑ·xₙ.

alpha (Scalar <#petsc4py.typing.Scalar>) -- The scaling factor.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:2417 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2417>


Set all components of the vector to the same value.

Collective.

See also:


Source code at petsc4py/PETSc/Vec.pyx:2384 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2384>

alpha (Scalar <#petsc4py.typing.Scalar>)
None <https://docs.python.org/3/library/constants.html#None>


Set values for the local portion of the vector.

Logically collective.

See also:

placeArray


Source code at petsc4py/PETSc/Vec.pyx:1333 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1333>




Associate a DM <#petsc4py.PETSc.DM> to the vector.

Not collective.

See also:


Source code at petsc4py/PETSc/Vec.pyx:3521 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3521>



Configure the vector from the options database.

Collective.

See also:

Working with PETSc options <#petsc-options>, VecSetFromOptions <https://petsc.org/release/manualpages/Vec/VecSetFromOptions.html>


Source code at petsc4py/PETSc/Vec.pyx:1042 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1042>



Set the local-to-global mapping.

Logically collective.

This allows users to insert vector entries using a local numbering with setValuesLocal.

See also:

setValues, setValuesLocal, getLGMap, VecSetLocalToGlobalMapping <https://petsc.org/release/manualpages/Vec/VecSetLocalToGlobalMapping.html>


Source code at petsc4py/PETSc/Vec.pyx:2898 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2898>




Set the component vectors at specified indices in the nested vector.

Not collective.


See also:


Source code at petsc4py/PETSc/Vec.pyx:3487 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3487>



Set the prefix used for searching for options in the database.

Logically collective.

See also:

Working with PETSc options <#petsc-options>, getOptionsPrefix, VecSetOptionsPrefix <https://petsc.org/release/manualpages/Vec/VecSetOptionsPrefix.html>


Source code at petsc4py/PETSc/Vec.pyx:1000 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1000>



Set all components of the vector to random numbers.

Collective.

random (Random <#petsc4py.PETSc.Random> | None <https://docs.python.org/3/library/constants.html#None>) -- Random number generator. If None <https://docs.python.org/3/library/constants.html#None> then one will be created internally.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:2331 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2331>


Set the local and global sizes of the vector.

Collective.


See also:


Source code at petsc4py/PETSc/Vec.pyx:218 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L218>


Set the vector type.

Collective.


See also:


Source code at petsc4py/PETSc/Vec.pyx:199 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L199>


Set up the internal data structures for using the vector.

Collective.

See also:


Source code at petsc4py/PETSc/Vec.pyx:1054 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1054>



Insert or add a single value in the vector.

Not collective.

  • index (int <https://docs.python.org/3/library/functions.html#int>) -- Location to write to. Negative indices are ignored.
  • value (Scalar <#petsc4py.typing.Scalar>) -- Value to insert at index.
  • addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.

None <https://docs.python.org/3/library/constants.html#None>

Notes

The values may be cached so assemblyBegin and assemblyEnd must be called after all calls of this method are completed.

Multiple calls to setValue cannot be made with different values for addv without intermediate calls to assemblyBegin and assemblyEnd.

See also:


Source code at petsc4py/PETSc/Vec.pyx:2785 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2785>


Insert or add a single value in the vector using a local numbering.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

Notes

The values may be cached so assemblyBegin and assemblyEnd must be called after all calls of this method are completed.

Multiple calls to setValueLocal cannot be made with different values for addv without intermediate calls to assemblyBegin and assemblyEnd.

See also:


Source code at petsc4py/PETSc/Vec.pyx:2928 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2928>


Insert or add multiple values in the vector.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

Notes

The values may be cached so assemblyBegin and assemblyEnd must be called after all calls of this method are completed.

Multiple calls to setValues cannot be made with different values for addv without intermediate calls to assemblyBegin and assemblyEnd.

See also:


Source code at petsc4py/PETSc/Vec.pyx:2822 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2822>


Insert or add blocks of values in the vector.

Not collective.

Equivalent to x[bs*indices[i]+j] = y[bs*i+j] for 0 <= i < len(indices), 0 <= j < bs and bs block_size.


None <https://docs.python.org/3/library/constants.html#None>

Notes

The values may be cached so assemblyBegin and assemblyEnd must be called after all calls of this method are completed.

Multiple calls to setValuesBlocked cannot be made with different values for addv without intermediate calls to assemblyBegin and assemblyEnd.

See also:


Source code at petsc4py/PETSc/Vec.pyx:2856 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2856>


Insert or add blocks of values in the vector with a local numbering.

Not collective.

Equivalent to x[bs*indices[i]+j] = y[bs*i+j] for 0 <= i < len(indices), 0 <= j < bs and bs block_size.


None <https://docs.python.org/3/library/constants.html#None>

Notes

The values may be cached so assemblyBegin and assemblyEnd must be called after all calls of this method are completed.

Multiple calls to setValuesBlockedLocal cannot be made with different values for addv without intermediate calls to assemblyBegin and assemblyEnd.

See also:

setValuesBlocked, setValuesLocal, VecSetValuesBlockedLocal <https://petsc.org/release/manualpages/Vec/VecSetValuesBlockedLocal.html>


Source code at petsc4py/PETSc/Vec.pyx:2999 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2999>


Insert or add multiple values in the vector with a local numbering.

Not collective.


None <https://docs.python.org/3/library/constants.html#None>

Notes

The values may be cached so assemblyBegin and assemblyEnd must be called after all calls of this method are completed.

Multiple calls to setValuesLocal cannot be made with different values for addv without intermediate calls to assemblyBegin and assemblyEnd.

See also:


Source code at petsc4py/PETSc/Vec.pyx:2965 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2965>



Shift all entries in the vector.

Collective.

This method sets each entry (xₙ) in the vector to xₙ + ɑ.

alpha (Scalar <#petsc4py.typing.Scalar>) -- The shift to apply to the vector values.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:2437 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2437>


Replace each entry (xₙ) in the vector by √|xₙ|.

Logically collective.

See also:


Source code at petsc4py/PETSc/Vec.pyx:2295 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2295>



Insert component values into a single-component vector.

Collective.

The current vector is expected to be multi-component (block_size greater than 1) and the target vector is expected to be single-component.

  • field (int <https://docs.python.org/3/library/functions.html#int>) -- Component index. Must be between 0 and vec.block_size.
  • vec (Vec <#petsc4py.PETSc.Vec>) -- Single-component vector to be inserted into.
  • addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:3245 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3245>


Return the maximum of entries in a subvector.

Collective.

Equivalent to max(x[field], x[field+bs], x[field+2*bs], ...) where bs is block_size.


See also:

strideScale, strideSum, strideMin, VecStrideMax <https://petsc.org/release/manualpages/Vec/VecStrideMax.html>


Source code at petsc4py/PETSc/Vec.pyx:3151 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3151>


Return the minimum of entries in a subvector.

Collective.

Equivalent to min(x[field], x[field+bs], x[field+2*bs], ...) where bs is block_size.


See also:

strideScale, strideSum, strideMax, VecStrideMin <https://petsc.org/release/manualpages/Vec/VecStrideMin.html>


Source code at petsc4py/PETSc/Vec.pyx:3120 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3120>


Return the norm of entries in a subvector.

Collective.

Equivalent to norm(x[field], x[field+bs], x[field+2*bs], ...) where bs is block_size.


See also:

norm, strideScale, strideSum, VecStrideNorm <https://petsc.org/release/manualpages/Vec/VecStrideNorm.html>


Source code at petsc4py/PETSc/Vec.pyx:3182 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3182>


Scale a component of the vector.

Logically collective.


None <https://docs.python.org/3/library/constants.html#None>

See also:

strideSum, strideMin, strideMax, VecStrideScale <https://petsc.org/release/manualpages/Vec/VecStrideScale.html>


Source code at petsc4py/PETSc/Vec.pyx:3076 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3076>


Scatter entries into a component of another vector.

Collective.

The current vector is expected to be single-component (block_size of 1) and the target vector is expected to be multi-component.

  • field (int <https://docs.python.org/3/library/functions.html#int>) -- Component index. Must be between 0 and vec.block_size.
  • vec (Vec <#petsc4py.PETSc.Vec>) -- Multi-component vector to be scattered into.
  • addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.

None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:3214 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3214>


Sum subvector entries.

Collective.

Equivalent to sum(x[field], x[field+bs], x[field+2*bs], ...) where bs is block_size.

field (int <https://docs.python.org/3/library/functions.html#int>) -- Component index. Must be between 0 and vec.block_size.
Scalar <#petsc4py.typing.Scalar>

See also:

strideScale, strideMin, strideMax, VecStrideSum <https://petsc.org/release/manualpages/Vec/VecStrideSum.html>


Source code at petsc4py/PETSc/Vec.pyx:3097 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3097>


Return the sum of all the entries of the vector.

Collective.

See also:


Source code at petsc4py/PETSc/Vec.pyx:2166 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2166>

Scalar <#petsc4py.typing.Scalar>


Swap the content of two vectors.

Logically collective.

vec (Vec <#petsc4py.PETSc.Vec>) -- The vector to swap data with.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:2457 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2457>


Return the indefinite dot product with vec.

Collective.

This computes yᵀ·x with self as x, vec as y and where yᵀ denotes the transpose of y.

vec (Vec <#petsc4py.PETSc.Vec>) -- Vector to compute the indefinite dot product with.
Scalar <#petsc4py.typing.Scalar>

See also:



Source code at petsc4py/PETSc/Vec.pyx:1846 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1846>


Begin computing the indefinite dot product.

Collective.

This should be paired with a call to tDotEnd.

vec (Vec <#petsc4py.PETSc.Vec>) -- Vector to compute the indefinite dot product with.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:1868 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1868>


Finish computing the indefinite dot product initiated with tDotBegin.

Collective.

See also:


Source code at petsc4py/PETSc/Vec.pyx:1888 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1888>

vec (Vec <#petsc4py.PETSc.Vec>)
Scalar <#petsc4py.typing.Scalar>


Return a DLPack PyCapsule <https://docs.python.org/3/c-api/capsule.html#c.PyCapsule> wrapping the vector data.

Collective.

mode (AccessModeSpec <#petsc4py.typing.AccessModeSpec>) -- Access mode for the vector.
Capsule of a DLPack tensor wrapping a Vec.
PyCapsule <https://docs.python.org/3/c-api/capsule.html#c.PyCapsule>

Notes

It is important that the access mode is respected by the consumer as this is not enforced internally.

See also:

createWithDLPack


Source code at petsc4py/PETSc/Vec.pyx:726 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L726>


Display the vector.

Collective.

viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> instance or None <https://docs.python.org/3/library/constants.html#None> for the default viewer.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Vec.pyx:144 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L144>


Compute and store w = ɑ·x + y.

Logically collective.

  • alpha (Scalar <#petsc4py.typing.Scalar>) -- Scale factor.
  • x (Vec <#petsc4py.PETSc.Vec>) -- First input vector.
  • y (Vec <#petsc4py.PETSc.Vec>) -- Second input vector.

None <https://docs.python.org/3/library/constants.html#None>

See also:

axpy, aypx, axpby, maxpy, VecWAXPY <https://petsc.org/release/manualpages/Vec/VecWAXPY.html>


Source code at petsc4py/PETSc/Vec.pyx:2561 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2561>



Attributes Documentation


Read-only ndarray <https://numpy.org/doc/stable/glossary.html#term-ndarray> containing the local portion of the vector.

Source code at petsc4py/PETSc/Vec.pyx:3648 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3648>


Writeable ndarray <https://numpy.org/doc/stable/glossary.html#term-ndarray> containing the local portion of the vector.

Source code at petsc4py/PETSc/Vec.pyx:3639 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3639>




Read-only buffered view of the local portion of the vector.

Source code at petsc4py/PETSc/Vec.pyx:3634 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3634>


Writeable buffered view of the local portion of the vector.

Source code at petsc4py/PETSc/Vec.pyx:3629 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3629>



The locally owned range of indices in the form [low, high).

Source code at petsc4py/PETSc/Vec.pyx:3619 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3619>


The range of indices owned by each process.

Source code at petsc4py/PETSc/Vec.pyx:3624 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3624>


The global vector size.

Source code at petsc4py/PETSc/Vec.pyx:3604 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3604>


The local and global vector sizes.

Source code at petsc4py/PETSc/Vec.pyx:3596 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3596>




petsc4py.PETSc.Viewer

Bases: Object <#petsc4py.PETSc.Object>

Viewer object.

Viewer is described in the PETSc manual <https://petsc.org/release/manual/other.html#sec-viewers>.

Viewers can be called as functions where the argument specified is the PETSc object to be viewed. See the example below.

Examples

>>> from petsc4py import PETSc
>>> u = PETSc.Vec().createWithArray([1,2])
>>> v = PETSc.Viewer()
>>> v(u)
Vec Object: 1 MPI process

type: seq 1. 2.

See also:


Enumerations

DrawSize <#petsc4py.PETSc.Viewer.DrawSize> Window size.
FileMode <#petsc4py.PETSc.Viewer.FileMode> Viewer file mode.
Format <#petsc4py.PETSc.Viewer.Format> Viewer format.
Type <#petsc4py.PETSc.Viewer.Type> Viewer type.

petsc4py.PETSc.Viewer.DrawSize

Bases: object <https://docs.python.org/3/library/functions.html#object>

Window size.

Attributes Summary

FULL Constant FULL of type int <https://docs.python.org/3/library/functions.html#int>
FULL_SIZE Constant FULL_SIZE of type int <https://docs.python.org/3/library/functions.html#int>
HALF Constant HALF of type int <https://docs.python.org/3/library/functions.html#int>
HALF_SIZE Constant HALF_SIZE of type int <https://docs.python.org/3/library/functions.html#int>
QUARTER Constant QUARTER of type int <https://docs.python.org/3/library/functions.html#int>
QUARTER_SIZE Constant QUARTER_SIZE of type int <https://docs.python.org/3/library/functions.html#int>
THIRD Constant THIRD of type int <https://docs.python.org/3/library/functions.html#int>
THIRD_SIZE Constant THIRD_SIZE of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation










petsc4py.PETSc.Viewer.FileMode

Bases: object <https://docs.python.org/3/library/functions.html#object>

Viewer file mode.

Attributes Summary

A Constant A of type int <https://docs.python.org/3/library/functions.html#int>
APPEND Constant APPEND of type int <https://docs.python.org/3/library/functions.html#int>
APPEND_UPDATE Constant APPEND_UPDATE of type int <https://docs.python.org/3/library/functions.html#int>
AU Constant AU of type int <https://docs.python.org/3/library/functions.html#int>
R Constant R of type int <https://docs.python.org/3/library/functions.html#int>
READ Constant READ of type int <https://docs.python.org/3/library/functions.html#int>
U Constant U of type int <https://docs.python.org/3/library/functions.html#int>
UA Constant UA of type int <https://docs.python.org/3/library/functions.html#int>
UPDATE Constant UPDATE of type int <https://docs.python.org/3/library/functions.html#int>
W Constant W of type int <https://docs.python.org/3/library/functions.html#int>
WRITE Constant WRITE of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation













petsc4py.PETSc.Viewer.Format

Bases: object <https://docs.python.org/3/library/functions.html#object>

Viewer format.

Attributes Summary

ASCII_COMMON Constant ASCII_COMMON of type int <https://docs.python.org/3/library/functions.html#int>
ASCII_CSV Constant ASCII_CSV of type int <https://docs.python.org/3/library/functions.html#int>
ASCII_DENSE Constant ASCII_DENSE of type int <https://docs.python.org/3/library/functions.html#int>
ASCII_FACTOR_INFO Constant ASCII_FACTOR_INFO of type int <https://docs.python.org/3/library/functions.html#int>
ASCII_GLVIS Constant ASCII_GLVIS of type int <https://docs.python.org/3/library/functions.html#int>
ASCII_IMPL Constant ASCII_IMPL of type int <https://docs.python.org/3/library/functions.html#int>
ASCII_INDEX Constant ASCII_INDEX of type int <https://docs.python.org/3/library/functions.html#int>
ASCII_INFO Constant ASCII_INFO of type int <https://docs.python.org/3/library/functions.html#int>
ASCII_INFO_DETAIL Constant ASCII_INFO_DETAIL of type int <https://docs.python.org/3/library/functions.html#int>
ASCII_LATEX Constant ASCII_LATEX of type int <https://docs.python.org/3/library/functions.html#int>
ASCII_MATHEMATICA Constant ASCII_MATHEMATICA of type int <https://docs.python.org/3/library/functions.html#int>
ASCII_MATLAB Constant ASCII_MATLAB of type int <https://docs.python.org/3/library/functions.html#int>
ASCII_MATRIXMARKET Constant ASCII_MATRIXMARKET of type int <https://docs.python.org/3/library/functions.html#int>
ASCII_PCICE Constant ASCII_PCICE of type int <https://docs.python.org/3/library/functions.html#int>
ASCII_PYTHON Constant ASCII_PYTHON of type int <https://docs.python.org/3/library/functions.html#int>
ASCII_SYMMODU Constant ASCII_SYMMODU of type int <https://docs.python.org/3/library/functions.html#int>
ASCII_XML Constant ASCII_XML of type int <https://docs.python.org/3/library/functions.html#int>
BINARY_MATLAB Constant BINARY_MATLAB of type int <https://docs.python.org/3/library/functions.html#int>
DEFAULT Constant DEFAULT of type int <https://docs.python.org/3/library/functions.html#int>
DRAW_BASIC Constant DRAW_BASIC of type int <https://docs.python.org/3/library/functions.html#int>
DRAW_CONTOUR Constant DRAW_CONTOUR of type int <https://docs.python.org/3/library/functions.html#int>
DRAW_LG Constant DRAW_LG of type int <https://docs.python.org/3/library/functions.html#int>
DRAW_LG_XRANGE Constant DRAW_LG_XRANGE of type int <https://docs.python.org/3/library/functions.html#int>
DRAW_PORTS Constant DRAW_PORTS of type int <https://docs.python.org/3/library/functions.html#int>
FAILED Constant FAILED of type int <https://docs.python.org/3/library/functions.html#int>
HDF5_MAT Constant HDF5_MAT of type int <https://docs.python.org/3/library/functions.html#int>
HDF5_PETSC Constant HDF5_PETSC of type int <https://docs.python.org/3/library/functions.html#int>
HDF5_VIZ Constant HDF5_VIZ of type int <https://docs.python.org/3/library/functions.html#int>
HDF5_XDMF Constant HDF5_XDMF of type int <https://docs.python.org/3/library/functions.html#int>
LOAD_BALANCE Constant LOAD_BALANCE of type int <https://docs.python.org/3/library/functions.html#int>
NATIVE Constant NATIVE of type int <https://docs.python.org/3/library/functions.html#int>
NOFORMAT Constant NOFORMAT of type int <https://docs.python.org/3/library/functions.html#int>
VTK_VTR Constant VTK_VTR of type int <https://docs.python.org/3/library/functions.html#int>
VTK_VTS Constant VTK_VTS of type int <https://docs.python.org/3/library/functions.html#int>
VTK_VTU Constant VTK_VTU of type int <https://docs.python.org/3/library/functions.html#int>

Attributes Documentation





































petsc4py.PETSc.Viewer.Type

Bases: object <https://docs.python.org/3/library/functions.html#object>

Viewer type.

Attributes Summary

ADIOS Object ADIOS of type str <https://docs.python.org/3/library/stdtypes.html#str>
ASCII Object ASCII of type str <https://docs.python.org/3/library/stdtypes.html#str>
BINARY Object BINARY of type str <https://docs.python.org/3/library/stdtypes.html#str>
DRAW Object DRAW of type str <https://docs.python.org/3/library/stdtypes.html#str>
EXODUSII Object EXODUSII of type str <https://docs.python.org/3/library/stdtypes.html#str>
GLVIS Object GLVIS of type str <https://docs.python.org/3/library/stdtypes.html#str>
HDF5 Object HDF5 of type str <https://docs.python.org/3/library/stdtypes.html#str>
MATHEMATICA Object MATHEMATICA of type str <https://docs.python.org/3/library/stdtypes.html#str>
MATLAB Object MATLAB of type str <https://docs.python.org/3/library/stdtypes.html#str>
PYTHON Object PYTHON of type str <https://docs.python.org/3/library/stdtypes.html#str>
PYVISTA Object PYVISTA of type str <https://docs.python.org/3/library/stdtypes.html#str>
SAWS Object SAWS of type str <https://docs.python.org/3/library/stdtypes.html#str>
SOCKET Object SOCKET of type str <https://docs.python.org/3/library/stdtypes.html#str>
STRING Object STRING of type str <https://docs.python.org/3/library/stdtypes.html#str>
VTK Object VTK of type str <https://docs.python.org/3/library/stdtypes.html#str>
VU Object VU of type str <https://docs.python.org/3/library/stdtypes.html#str>

Attributes Documentation


















Methods Summary

ASCII(name[, comm]) Return an ASCII viewer associated with the communicator.
BINARY([comm]) Return the default Type.BINARY <#petsc4py.PETSc.Viewer.Type.BINARY> viewer associated with the communicator.
DRAW([comm]) Return the default Type.DRAW <#petsc4py.PETSc.Viewer.Type.DRAW> viewer associated with the communicator.
STDERR([comm]) Return the standard error viewer associated with the communicator.
STDOUT([comm]) Return the standard output viewer associated with the communicator.
addASCIITab(tabs) Increment the ASCII tab level.
clearDraw() Reset graphics.
create([comm]) Create a viewer.
createASCII(name[, mode, comm]) Create a viewer of type Type.ASCII <#petsc4py.PETSc.Viewer.Type.ASCII>.
createBinary(name[, mode, comm]) Create a viewer of type Type.BINARY <#petsc4py.PETSc.Viewer.Type.BINARY>.
createDraw([display, title, position, size, ...]) Create a Type.DRAW <#petsc4py.PETSc.Viewer.Type.DRAW> viewer.
createHDF5(name[, mode, comm]) Create a viewer of type Type.HDF5 <#petsc4py.PETSc.Viewer.Type.HDF5>.
createMPIIO(name[, mode, comm]) Create a viewer of type Type.BINARY <#petsc4py.PETSc.Viewer.Type.BINARY> supporting MPI-IO.
createPython([context, comm]) Create a Type.PYTHON <#petsc4py.PETSc.Viewer.Type.PYTHON> viewer.
createVTK(name[, mode, comm]) Create a viewer of type Type.VTK <#petsc4py.PETSc.Viewer.Type.VTK>.
destroy() Destroy the viewer.
flush() Flush the viewer.
getASCIITab() Return the ASCII tab level.
getFileMode() Return the file mode.
getFileName() Return file name.
getFormat() Return the format of the viewer.
getPythonContext() Return the instance of the class implementing the required Python methods.
getPythonType() Return the fully qualified Python name of the class used by the viewer.
getSubViewer([comm]) Return a viewer defined on a subcommunicator.
getType() Return the type of the viewer.
popASCIISynchronized() Disallow ASCII synchronized calls.
popASCIITab() Pop an additional tab level pushed via pushASCIITab.
popFormat() Pop format from the viewer.
printfASCII(msg) Print a message.
printfASCIISynchronized(msg) Print a synchronized message.
pushASCIISynchronized() Allow ASCII synchronized calls.
pushASCIITab() Push an additional tab level.
pushFormat(format) Push format to the viewer.
restoreSubViewer(sub) Restore a viewer defined on a subcommunicator.
setASCIITab(tabs) Set ASCII tab level.
setDrawInfo([display, title, position, size]) Set window information for a Type.DRAW <#petsc4py.PETSc.Viewer.Type.DRAW> viewer.
setFileMode(mode) Set file mode.
setFileName(name) Set file name.
setFromOptions() Configure the object from the options database.
setPythonContext(context) Set the instance of the class implementing the required Python methods.
setPythonType(py_type) Set the fully qualified Python name of the class to be used.
setType(vwr_type) Set the type of the viewer.
setUp() Set up the internal data structures for using the viewer.
subtractASCIITab(tabs) Decrement the ASCII tab level.
useASCIITabs(flag) Enable/disable the use of ASCII tabs.
view([obj]) View the viewer.
viewObjectPython(obj) View a generic Object <#petsc4py.PETSc.Object>.

Methods Documentation

Return an ASCII viewer associated with the communicator.

Collective.


Viewer <#petsc4py.PETSc.Viewer>

Source code at petsc4py/PETSc/Viewer.pyx:604 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L604>


Return the default Type.BINARY <#petsc4py.PETSc.Viewer.Type.BINARY> viewer associated with the communicator.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Viewer <#petsc4py.PETSc.Viewer>

Source code at petsc4py/PETSc/Viewer.pyx:625 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L625>


Return the default Type.DRAW <#petsc4py.PETSc.Viewer.Type.DRAW> viewer associated with the communicator.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Viewer <#petsc4py.PETSc.Viewer>

Source code at petsc4py/PETSc/Viewer.pyx:643 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L643>


Return the standard error viewer associated with the communicator.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Viewer <#petsc4py.PETSc.Viewer>

Source code at petsc4py/PETSc/Viewer.pyx:586 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L586>


Return the standard output viewer associated with the communicator.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Viewer <#petsc4py.PETSc.Viewer>

Source code at petsc4py/PETSc/Viewer.pyx:568 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L568>




Create a viewer.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>, PetscViewerCreate <https://petsc.org/release/manualpages/Viewer/PetscViewerCreate.html>


Source code at petsc4py/PETSc/Viewer.pyx:179 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L179>


Create a viewer of type Type.ASCII <#petsc4py.PETSc.Viewer.Type.ASCII>.

Collective.


Self

See also:

create, setType, setFileMode, setFileName, Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>, setASCIITab, addASCIITab, subtractASCIITab, getASCIITab


Source code at petsc4py/PETSc/Viewer.pyx:200 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L200>


Create a viewer of type Type.BINARY <#petsc4py.PETSc.Viewer.Type.BINARY>.

Collective.


Self

See also:

create, setType, setFileMode, setFileName, Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>


Source code at petsc4py/PETSc/Viewer.pyx:238 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L238>


Create a Type.DRAW <#petsc4py.PETSc.Viewer.Type.DRAW> viewer.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>, PetscViewerDrawOpen <https://petsc.org/release/manualpages/Viewer/PetscViewerDrawOpen.html>


Source code at petsc4py/PETSc/Viewer.pyx:380 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L380>


Create a viewer of type Type.HDF5 <#petsc4py.PETSc.Viewer.Type.HDF5>.

Collective.


Self

See also:

create, setType, setFileMode, setFileName, Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>


Source code at petsc4py/PETSc/Viewer.pyx:344 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L344>


Create a viewer of type Type.BINARY <#petsc4py.PETSc.Viewer.Type.BINARY> supporting MPI-IO.

Collective.


Self

See also:

create, setType, setFileMode, setFileName, Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>


Source code at petsc4py/PETSc/Viewer.pyx:271 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L271>


Create a Type.PYTHON <#petsc4py.PETSc.Viewer.Type.PYTHON> viewer.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

PETSc Python viewer <#petsc-python-viewer>, setType, setPythonContext, Type.PYTHON <#petsc4py.PETSc.Viewer.Type.PYTHON>


Source code at petsc4py/PETSc/Viewer.pyx:933 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L933>


Create a viewer of type Type.VTK <#petsc4py.PETSc.Viewer.Type.VTK>.

Collective.


Self

See also:

create, setType, setFileMode, setFileName, Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>


Source code at petsc4py/PETSc/Viewer.pyx:308 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L308>





Return the file mode.

Not collective.

See also:


Source code at petsc4py/PETSc/Viewer.pyx:833 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L833>

FileMode <#petsc4py.PETSc.Viewer.FileMode>



Return the format of the viewer.

Not collective.

See also:



Source code at petsc4py/PETSc/Viewer.pyx:488 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L488>

Format <#petsc4py.PETSc.Viewer.Format>


Return the instance of the class implementing the required Python methods.

Not collective.

See also:

PETSc Python viewer <#petsc-python-viewer>, setPythonContext


Source code at petsc4py/PETSc/Viewer.pyx:973 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L973>



Return the fully qualified Python name of the class used by the viewer.

Not collective.

See also:

PETSc Python viewer <#petsc-python-viewer>, setPythonContext, setPythonType, PetscViewerPythonGetType <https://petsc.org/release/manualpages/Viewer/PetscViewerPythonGetType.html>


Source code at petsc4py/PETSc/Viewer.pyx:1003 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L1003>



Return a viewer defined on a subcommunicator.

Collective.

comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- The subcommunicator. If None <https://docs.python.org/3/library/constants.html#None>, uses COMM_SELF <#petsc4py.PETSc.COMM_SELF>.
Viewer <#petsc4py.PETSc.Viewer>

Notes

Users must call restoreSubViewer when done.

See also:


Source code at petsc4py/PETSc/Viewer.pyx:526 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L526>



Disallow ASCII synchronized calls.

Collective.

See also:

printfASCIISynchronized, pushASCIISynchronized, PetscViewerASCIIPopSynchronized <https://petsc.org/release/manualpages/Viewer/PetscViewerASCIIPopSynchronized.html>


Source code at petsc4py/PETSc/Viewer.pyx:729 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L729>



Pop an additional tab level pushed via pushASCIITab.

Collective.

See also:


Source code at petsc4py/PETSc/Viewer.pyx:754 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L754>






Allow ASCII synchronized calls.

Collective.

See also:

printfASCIISynchronized, popASCIISynchronized, PetscViewerASCIIPushSynchronized <https://petsc.org/release/manualpages/Viewer/PetscViewerASCIIPushSynchronized.html>


Source code at petsc4py/PETSc/Viewer.pyx:716 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L716>




Push format to the viewer.

Collective.

See also:


Source code at petsc4py/PETSc/Viewer.pyx:502 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L502>

format (Format <#petsc4py.PETSc.Viewer.Format>)
None <https://docs.python.org/3/library/constants.html#None>


Restore a viewer defined on a subcommunicator.

Collective.

sub (Viewer <#petsc4py.PETSc.Viewer>) -- The subviewer obtained from getSubViewer.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Viewer.pyx:550 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L550>



Set window information for a Type.DRAW <#petsc4py.PETSc.Viewer.Type.DRAW> viewer.

Collective.


Source code at petsc4py/PETSc/Viewer.pyx:877 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L877>




Configure the object from the options database.

Collective.

See also:

Working with PETSc options <#petsc-options>, PetscViewerSetFromOptions <https://petsc.org/release/manualpages/Viewer/PetscViewerSetFromOptions.html>


Source code at petsc4py/PETSc/Viewer.pyx:463 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L463>



Set the instance of the class implementing the required Python methods.

Logically collective.

See also:

PETSc Python viewer <#petsc-python-viewer>, getPythonContext, setPythonType


Source code at petsc4py/PETSc/Viewer.pyx:961 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L961>



Set the fully qualified Python name of the class to be used.

Collective.

See also:

PETSc Python viewer <#petsc-python-viewer>, setPythonContext, getPythonType, PetscViewerPythonSetType <https://petsc.org/release/manualpages/Viewer/PetscViewerPythonSetType.html>


Source code at petsc4py/PETSc/Viewer.pyx:988 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L988>



Set the type of the viewer.

Logically collective.

vwr_type (Type <#petsc4py.PETSc.Viewer.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of the viewer.
None <https://docs.python.org/3/library/constants.html#None>

See also:


Source code at petsc4py/PETSc/Viewer.pyx:430 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L430>





View the viewer.

Collective.

obj (Viewer <#petsc4py.PETSc.Viewer> | Object <#petsc4py.PETSc.Object> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer instance or None <https://docs.python.org/3/library/constants.html#None> for the default viewer. If none of the above applies, it assumes obj is an instance of Object <#petsc4py.PETSc.Object> and it calls the generic view for obj.
None <https://docs.python.org/3/library/constants.html#None>

Notes

See also:


Source code at petsc4py/PETSc/Viewer.pyx:138 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L138>


View a generic Object <#petsc4py.PETSc.Object>.

Collective.

See also:

PETSc Python viewer <#petsc-python-viewer>, setPythonContext, setPythonType, PetscViewerPythonViewObject <https://petsc.org/release/manualpages/Viewer/PetscViewerPythonViewObject.html>


Source code at petsc4py/PETSc/Viewer.pyx:1018 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L1018>





petsc4py.PETSc.ViewerHDF5

Bases: Viewer <#petsc4py.PETSc.Viewer>

Viewer object for HDF5 file formats.

Viewer is described in the PETSc manual <https://petsc.org/release/manual/other.html#sec-viewers>.

See also:

Viewer <#petsc4py.PETSc.Viewer>


Methods Summary

create(name[, mode, comm]) Create a viewer of type Type.HDF5 <#petsc4py.PETSc.Viewer.Type.HDF5>.
getGroup() Return the current group.
getTimestep() Return the current time step.
incrementTimestep() Increment the time step.
popGroup() Pop the current group from the stack.
popTimestepping() Deactivate the timestepping mode.
pushGroup(group) Set the current group.
pushTimestepping() Activate the timestepping mode.
setTimestep(timestep) Set the current time step.

Methods Documentation

Create a viewer of type Type.HDF5 <#petsc4py.PETSc.Viewer.Type.HDF5>.

Collective.


Self <https://docs.python.org/3/library/typing.html#typing.Self>

See also:

Viewer.createHDF5 <#petsc4py.PETSc.Viewer.createHDF5>


Source code at petsc4py/PETSc/Viewer.pyx:1044 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L1044>



Return the current time step.

Not collective.

See also:

pushTimestepping, setTimestep, incrementTimestep, PetscViewerHDF5GetTimestep <https://petsc.org/release/manualpages/Viewer/PetscViewerHDF5GetTimestep.html>


Source code at petsc4py/PETSc/Viewer.pyx:1104 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L1104>



Increment the time step.

Logically collective.

See also:

pushTimestepping, setTimestep, getTimestep, PetscViewerHDF5IncrementTimestep <https://petsc.org/release/manualpages/Viewer/PetscViewerHDF5IncrementTimestep.html>


Source code at petsc4py/PETSc/Viewer.pyx:1132 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L1132>



Pop the current group from the stack.

Logically collective.

See also:



Source code at petsc4py/PETSc/Viewer.pyx:1159 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L1159>



Deactivate the timestepping mode.

Logically collective.

See also:


Source code at petsc4py/PETSc/Viewer.pyx:1092 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L1092>





Set the current time step.

Logically collective.

See also:

pushTimestepping, getTimestep, incrementTimestep, PetscViewerHDF5SetTimestep <https://petsc.org/release/manualpages/Viewer/PetscViewerHDF5SetTimestep.html>


Source code at petsc4py/PETSc/Viewer.pyx:1119 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L1119>




Exceptions

Error <#petsc4py.PETSc.Error> PETSc Error.

petsc4py.PETSc.Error


Functions

garbage_cleanup <#petsc4py.PETSc.garbage_cleanup>([comm]) Clean up unused PETSc objects.
garbage_view <#petsc4py.PETSc.garbage_view>([comm]) Print summary of the garbage PETSc objects.

petsc4py.PETSc.garbage_cleanup

Clean up unused PETSc objects.

Collective.

Notes

If the communicator comm if not provided or it is None <https://docs.python.org/3/library/constants.html#None>, then COMM_WORLD <#petsc4py.PETSc.COMM_WORLD> is used.

Source code at petsc4py/PETSc/cyclicgc.pxi:59 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/cyclicgc.pxi#L59>



petsc4py.PETSc.garbage_view

Print summary of the garbage PETSc objects.

Collective.

Notes

Print out garbage summary on each rank of the communicator comm. If no communicator is provided then COMM_WORLD <#petsc4py.PETSc.COMM_WORLD> is used.

Source code at petsc4py/PETSc/cyclicgc.pxi:83 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/cyclicgc.pxi#L83>



Attributes

DECIDE <#petsc4py.PETSc.DECIDE> Constant DECIDE of type int <https://docs.python.org/3/library/functions.html#int>
DEFAULT <#petsc4py.PETSc.DEFAULT> Constant DEFAULT of type int <https://docs.python.org/3/library/functions.html#int>
DETERMINE <#petsc4py.PETSc.DETERMINE> Constant DETERMINE of type int <https://docs.python.org/3/library/functions.html#int>
CURRENT <#petsc4py.PETSc.CURRENT> Constant CURRENT of type int <https://docs.python.org/3/library/functions.html#int>
UNLIMITED <#petsc4py.PETSc.UNLIMITED> Constant UNLIMITED of type int <https://docs.python.org/3/library/functions.html#int>
INFINITY <#petsc4py.PETSc.INFINITY> Object INFINITY of type float <https://docs.python.org/3/library/functions.html#float>
NINFINITY <#petsc4py.PETSc.NINFINITY> Object NINFINITY of type float <https://docs.python.org/3/library/functions.html#float>
PINFINITY <#petsc4py.PETSc.PINFINITY> Object PINFINITY of type float <https://docs.python.org/3/library/functions.html#float>
COMM_NULL <#petsc4py.PETSc.COMM_NULL> Object COMM_NULL of type Comm <#petsc4py.PETSc.Comm>
COMM_SELF <#petsc4py.PETSc.COMM_SELF> Object COMM_SELF of type Comm <#petsc4py.PETSc.Comm>
COMM_WORLD <#petsc4py.PETSc.COMM_WORLD> Object COMM_WORLD of type Comm <#petsc4py.PETSc.Comm>

petsc4py.PETSc.DECIDE


petsc4py.PETSc.DEFAULT


petsc4py.PETSc.DETERMINE


petsc4py.PETSc.CURRENT


petsc4py.PETSc.UNLIMITED


petsc4py.PETSc.INFINITY


petsc4py.PETSc.NINFINITY


petsc4py.PETSc.PINFINITY


petsc4py.PETSc.COMM_NULL

Object COMM_NULL of type Comm <#petsc4py.PETSc.Comm>

petsc4py.PETSc.COMM_SELF

Object COMM_SELF of type Comm <#petsc4py.PETSc.Comm>

petsc4py.PETSc.COMM_WORLD

Object COMM_WORLD of type Comm <#petsc4py.PETSc.Comm>

PETSC PYTHON TYPES

Here we discuss details about Python-aware PETSc types that can be used within the library.

In particular, we discuss matrices, preconditioners, Krylov solvers, nonlinear solvers, ODE integrators and viewers.

The low-level, Cython implementation exposing the Python methods is in src/petsc4py/PETSc/libpetsc4py.pyx <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/libpetsc4py.pyx>.

The scripts used here can be found at demo/python_types <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/demo/python_types>.

PETSc Python matrix type

PETSc provides a convenient way to compute the action of linear operators coded in Python through the petsc4py.PETSc.Mat.Type.PYTHON <#petsc4py.PETSc.Mat.Type.PYTHON> type.

In addition to the matrix action, the implementation can expose additional methods for use within the library. A template class for the supported methods is given below.

from petsc4py.typing import Scalar
from petsc4py.PETSc import Mat
from petsc4py.PETSc import Vec
from petsc4py.PETSc import IS
from petsc4py.PETSc import InsertMode
from petsc4py.PETSc import NormType
from petsc4py.PETSc import Viewer
# A template class with the Python methods supported by MATPYTHON
class MatPythonProtocol:

def mult(self, A: Mat, x: Vec, y: Vec) -> None:
"""Matrix vector multiplication: y = A @ x."""
...
def multAdd(self, A: Mat, x: Vec, y: Vec, z: Vec) -> None:
"""Matrix vector multiplication: z = A @ x + y."""
...
def multTranspose(self, A: Mat, x: Vec, y: Vec) -> None:
"""Transposed matrix vector multiplication: y = A^T @ x."""
...
def multTransposeAdd(self, A: Mat, x: Vec, y: Vec, z: Vec) -> None:
"""Transposed matrix vector multiplication: z = A^T @ x + y."""
...
def multHermitian(self, A: Mat, x: Vec, y: Vec) -> None:
"""Hermitian matrix vector multiplication: y = A^H @ x."""
...
def multHermitianAdd(self, A: Mat, x: Vec, y: Vec, z: Vec) -> None:
"""Hermitian matrix vector multiplication: z = A^H @ x + y."""
...
def view(self, A: Mat, viewer: Viewer) -> None:
"""View the matrix."""
...
def setFromOptions(self, A: Mat) -> None:
"""Process command line for customization."""
...
def multDiagonalBlock(self, A: Mat, x: Vec, y: Vec) -> None:
"""Perform the on-process matrix vector multiplication."""
...
def createVecs(self, A: Mat) -> tuple[Vec, Vec]:
"""Return tuple of vectors (x,y) suitable for A @ x = y."""
...
def scale(self, A: Mat, s: Scalar) -> None:
"""Scale the matrix by a scalar."""
...
def shift(self, A: Mat, s: Scalar) -> None:
"""Shift the matrix by a scalar."""
...
def createSubMatrix(self, A: Mat, r: IS, c: IS, out: Mat) -> Mat:
"""Return the submatrix corresponding to r rows and c columns.
Matrix out must be reused if not None.
"""
...
def zeroRowsColumns(self, A: Mat, r: IS, diag: Scalar, x: Vec, b: Vec) -> None:
"""Zero rows and columns of the matrix corresponding to the index set r.
Insert diag on the diagonal and modify vectors x and b accordingly if not None.
"""
...
def getDiagonal(self, A: Mat, d: Vec) -> None:
"""Compute the diagonal of the matrix: d = diag(A)."""
...
def setDiagonal(self, A: Mat, d: Vec, im: InsertMode) -> None:
"""Set the diagonal of the matrix."""
...
def missingDiagonal(self, A: Mat, d: Vec, im: InsertMode) -> tuple[bool, int]:
"""Return a flag indicating if the matrix is missing a diagonal entry and the location."""
...
def diagonalScale(self, A: Mat, L: Vec, R: Vec) -> None:
"""Perform left and right diagonal scaling if vectors are not None.
A = diag(L)@A@diag(R).
"""
...
def getDiagonalBlock(self, A: Mat) -> Mat:
"""Return the on-process matrix."""
...
def setUp(self, A: Mat) -> None:
"""Perform the required setup."""
...
def duplicate(self, A: Mat, op: Mat.DuplicateOption) -> Mat:
"""Duplicate the matrix."""
...
def copy(self, A: Mat, B: Mat, op: Mat.Structure) -> None:
"""Copy the matrix: B = A."""
...
def productSetFromOptions(
self, A: Mat, prodtype: str, X: Mat, Y: Mat, Z: Mat
) -> bool:
"""The boolean flag indicating if the matrix supports prodtype."""
...
def productSymbolic(
self, A: Mat, product: Mat, producttype: str, X: Mat, Y: Mat, Z: Mat
) -> None:
"""Perform the symbolic stage of the requested matrix product."""
...
def productNumeric(
self, A: Mat, product: Mat, producttype: str, X: Mat, Y: Mat, Z: Mat
) -> None:
"""Perform the numeric stage of the requested matrix product."""
...
def zeroEntries(self, A: Mat) -> None:
"""Set the matrix to zero."""
...
def norm(self, A: Mat, normtype: NormType) -> float:
"""Compute the norm of the matrix."""
...
def solve(self, A: Mat, y: Vec, x: Vec) -> None:
"""Solve the equation: x = inv(A) y."""
...
def solveAdd(self, A: Mat, y: Vec, z: Vec, x: Vec) -> None:
"""Solve the equation: x = inv(A) y + z."""
...
def solveTranspose(self, A: Mat, y: Vec, x: Vec) -> None:
"""Solve the equation: x = inv(A)^T y."""
...
def solveTransposeAdd(self, A: Mat, y: Vec, z: Vec, x: Vec) -> None:
"""Solve the equation: x = inv(A)^T y + z."""
...
def SOR(
self,
A: Mat,
b: Vec,
omega: float,
sortype: Mat.SORType,
shift: float,
its: int,
lits: int,
x: Vec,
) -> None:
"""Perform SOR iterations."""
...
def conjugate(self, A: Mat) -> None:
"""Perform the conjugation of the matrix: A = conj(A)."""
...
def imagPart(self, A: Mat) -> None:
"""Set real part to zero. A = imag(A)."""
...
def realPart(self, A: Mat) -> None:
"""Set imaginary part to zero. A = real(A)."""
...


In the example below, we create an operator that applies the Laplacian operator on a two-dimensional grid, and use it to solve the associated linear system. The default preconditioner in the script is petsc4py.PETSc.PC.Type.JACOBI <#petsc4py.PETSc.PC.Type.JACOBI> which needs to access the diagonal of the matrix.

# ------------------------------------------------------------------------
#
#  Poisson problem. This problem is modeled by the partial
#  differential equation
#
#          -Laplacian(u) = 1,  0 < x,y < 1,
#
#  with boundary conditions
#
#           u = 0  for  x = 0, x = 1, y = 0, y = 1
#
#  A finite difference approximation with the usual 5-point stencil
#  is used to discretize the boundary value problem to obtain a
#  nonlinear system of equations. The problem is solved in a 2D
#  rectangular domain, using distributed arrays (DAs) to partition
#  the parallel grid.
#
# ------------------------------------------------------------------------
# We first import petsc4py and sys to initialize PETSc
import sys
import petsc4py
petsc4py.init(sys.argv)
# Import the PETSc module
from petsc4py import PETSc
# Here we define a class representing the discretized operator
# This allows us to apply the operator "matrix-free"
class Poisson2D:

def __init__(self, da):
self.da = da
self.localX = da.createLocalVec()
# This is the method that PETSc will look for when applying
# the operator. `X` is the PETSc input vector, `Y` the output vector,
# while `mat` is the PETSc matrix holding the PETSc datastructures.
def mult(self, mat, X, Y):
# Grid sizes
mx, my = self.da.getSizes()
hx, hy = (1.0 / m for m in [mx, my])
# Bounds for the local part of the grid this process owns
(xs, xe), (ys, ye) = self.da.getRanges()
# Map global vector to local vectors
self.da.globalToLocal(X, self.localX)
# We can access the vector data as NumPy arrays
x = self.da.getVecArray(self.localX)
y = self.da.getVecArray(Y)
# Loop on the local grid and compute the local action of the operator
for j in range(ys, ye):
for i in range(xs, xe):
u = x[i, j] # center
u_e = u_w = u_n = u_s = 0
if i > 0:
u_w = x[i - 1, j] # west
if i < mx - 1:
u_e = x[i + 1, j] # east
if j > 0:
u_s = x[i, j - 1] # south
if j < ny - 1:
u_n = x[i, j + 1] # north
u_xx = (-u_e + 2 * u - u_w) * hy / hx
u_yy = (-u_n + 2 * u - u_s) * hx / hy
y[i, j] = u_xx + u_yy
# This is the method that PETSc will look for when the diagonal of the matrix is needed.
def getDiagonal(self, mat, D):
mx, my = self.da.getSizes()
hx, hy = (1.0 / m for m in [mx, my])
(xs, xe), (ys, ye) = self.da.getRanges()
d = self.da.getVecArray(D)
# Loop on the local grid and compute the diagonal
for j in range(ys, ye):
for i in range(xs, xe):
d[i, j] = 2 * hy / hx + 2 * hx / hy
# The class can contain other methods that PETSc won't use
def formRHS(self, B):
b = self.da.getVecArray(B)
mx, my = self.da.getSizes()
hx, hy = (1.0 / m for m in [mx, my])
(xs, xe), (ys, ye) = self.da.getRanges()
for j in range(ys, ye):
for i in range(xs, xe):
b[i, j] = 1 * hx * hy # Access the option database and read options from the command line OptDB = PETSc.Options() nx, ny = OptDB.getIntArray(
'grid', (16, 16) ) # Read `-grid <int,int>`, defaults to 16,16 # Create the distributed memory implementation for structured grid da = PETSc.DMDA().create([nx, ny], stencil_width=1) # Create vectors to hold the solution and the right-hand side x = da.createGlobalVec() b = da.createGlobalVec() # Instantiate an object of our Poisson2D class pde = Poisson2D(da) # Create a PETSc matrix of type Python using `pde` as context A = PETSc.Mat().create(comm=da.comm) A.setSizes([x.getSizes(), b.getSizes()]) A.setType(PETSc.Mat.Type.PYTHON) A.setPythonContext(pde) A.setUp() # Create a Conjugate Gradient Krylov solver ksp = PETSc.KSP().create() ksp.setType(PETSc.KSP.Type.CG) # Use diagonal preconditioning ksp.getPC().setType(PETSc.PC.Type.JACOBI) # Allow command-line customization ksp.setFromOptions() # Assemble right-hand side and solve the linear system pde.formRHS(b) ksp.setOperators(A) ksp.solve(b, x) # Here we programmatically visualize the solution if OptDB.getBool('plot', True):
# Modify the option database: keep the X window open for 1 second
OptDB['draw_pause'] = 1
# Obtain a viewer of type DRAW
draw = PETSc.Viewer.DRAW(x.comm)
# View the vector in the X window
draw(x) # We can also visualize the solution by command line options # For example, we can dump a VTK file with: # # $ python poisson2d.py -plot 0 -view_solution vtk:sol.vts: # # or obtain the same visualization as programmatically done above as: # # $ python poisson2d.py -plot 0 -view_solution draw -draw_pause 1 # x.viewFromOptions('-view_solution')


PETSc Python preconditioner type

The protocol for the petsc4py.PETSc.PC.Type.PYTHON <#petsc4py.PETSc.PC.Type.PYTHON> preconditioner is:

from petsc4py.PETSc import KSP
from petsc4py.PETSc import PC
from petsc4py.PETSc import Mat
from petsc4py.PETSc import Vec
from petsc4py.PETSc import Viewer
# A template class with the Python methods supported by PCPYTHON
class PCPythonProtocol:

def apply(self, pc: PC, b: Vec, x: Vec) -> None:
"""Apply the preconditioner on vector b, return in x."""
...
def applySymmetricLeft(self, pc: PC, b: Vec, x: Vec) -> None:
"""Apply the symmetric left part of the preconditioner on vector b, return in x."""
...
def applySymmetricRight(self, pc: PC, b: Vec, x: Vec) -> None:
"""Apply the symmetric right part of the preconditioner on vector b, return in x."""
...
def applyTranspose(self, pc: PC, b: Vec, x: Vec) -> None:
"""Apply the transposed preconditioner on vector b, return in x."""
...
def applyMat(self, pc: PC, B: Mat, X: Mat) -> None:
"""Apply the preconditioner on a block of right-hand sides B, return in X."""
...
def preSolve(self, pc: PC, ksp: KSP, b: Vec, x: Vec) -> None:
"""Callback called at the beginning of a Krylov method.
This method is allowed to modify the right-hand side b and the initial guess x.
"""
...
def postSolve(self, pc: PC, ksp: KSP, b: Vec, x: Vec) -> None:
"""Callback called at the end of a Krylov method.
This method is allowed to modify the right-hand side b and the solution x.
"""
def view(self, pc: PC, viewer: Viewer) -> None:
"""View the preconditioner."""
...
def setFromOptions(self, pc: PC) -> None:
"""Process command line for customization."""
...
def setUp(self, pc: PC) -> None:
"""Perform the required setup."""
...
def reset(self, pc: PC) -> None:
"""Reset the preconditioner."""
...


In the example below, we create a Jacobi preconditioner, which needs to access the diagonal of the matrix. The action of the preconditioner consists of the pointwise multiplication of the inverse diagonal with the input vector.

# The user-defined Python class implementing the Jacobi method.
class myJacobi:

# Setup the internal data. In this case, we access the matrix diagonal.
def setUp(self, pc):
_, P = pc.getOperators()
self.D = P.getDiagonal()
# Apply the preconditioner
def apply(self, pc, x, y):
y.pointwiseDivide(x, self.D)


We can run the script used to test our matrix class and use command line arguments to specify that our preconditioner should be used:

$ python mat.py -pc_type python -pc_python_type pc.myJacobi -ksp_view
KSP Object: 1 MPI process

type: cg
maximum iterations=10000, initial guess is zero
tolerances: relative=1e-05, absolute=1e-50, divergence=10000.
left preconditioning
using PRECONDITIONED norm type for convergence test PC Object: 1 MPI process
type: python
Python: pc.myJacobi
linear system matrix = precond matrix:
Mat Object: 1 MPI process
type: python
rows=256, cols=256
Python: __main__.Poisson2D


PETSc Python linear solver type

The protocol for the petsc4py.PETSc.KSP.Type.PYTHON <#petsc4py.PETSc.KSP.Type.PYTHON> Krylov solver is:

from petsc4py.PETSc import KSP
from petsc4py.PETSc import Vec
from petsc4py.PETSc import Viewer
# A template class with the Python methods supported by KSPPYTHON
class KSPPythonProtocol:

def solve(self, ksp: KSP, b: Vec, x: Vec) -> None:
"""Solve the linear system with right-hand side b. Return solution in x."""
...
def solveTranspose(self, ksp: KSP, b: Vec, x: Vec) -> None:
"""Solve the transposed linear system with right-hand side b. Return solution in x."""
...
def view(self, ksp: KSP, viewer: Viewer) -> None:
"""View the Krylov solver."""
...
def setFromOptions(self, ksp: KSP) -> None:
"""Process command line for customization."""
...
def setUp(self, ksp: KSP) -> None:
"""Perform the required setup."""
...
def buildSolution(self, ksp: KSP, x: Vec) -> None:
"""Compute the solution vector."""
...
def buildResidual(self, ksp: KSP, t: Vec, r: Vec) -> None:
"""Compute the residual vector, return it in r. t is a scratch working vector."""
...
def reset(self, ksp: KSP) -> None:
"""Reset the Krylov solver."""
...


PETSc Python nonlinear solver type (TODO)

PETSc Python ode-integrator type (TODO)

PETSc Python optimization solver type (TODO)

PETSc Python viewer

The protocol for the petsc4py.PETSc.Viewer.Type.PYTHON <#petsc4py.PETSc.Viewer.Type.PYTHON> viewer is:

from petsc4py.PETSc import Object
from petsc4py.PETSc import Viewer
# A template class with the Python methods supported by PETSCVIEWERPYTHON
class PetscViewerPythonProtocol:

def viewObject(self, viewer: Viewer, obj: Object) -> None:
"""View a generic object."""
...
def setUp(self, viewer: Viewer) -> None:
"""Setup the viewer."""
...
def setFromOptions(self, viewer: Viewer) -> None:
"""Process command line for customization."""
...
def flush(self, viewer: Viewer) -> None:
"""Flush the viewer."""
...
def view(self, viewer: Viewer, outviewer: Viewer) -> None:
"""View the viewer."""
...


WORKING WITH PETSC OPTIONS

A very powerful feature of PETSc is that objects can be configured via command-line options. In this way, one can choose the method to be used or set different parameters without changing the source code. See the PETSc manual <https://petsc.org/release/manual/getting_started.html#the-options-database> for additional information.

In order to use command-line options in a petsc4py program, it is important to initialize the module as follows:

# We first import petsc4py and sys to initialize PETSc
import sys, petsc4py
petsc4py.init(sys.argv)
# Import the PETSc module
from petsc4py import PETSc


Then one can provide command-line options when running a script:

$ python foo.py -ksp_type gmres -ksp_gmres_restart 100 -ksp_view


When the above initialization method is not possible, PETSc options can be also specified via environment variables or configuration files, e.g.:

$ PETSC_OPTIONS='-ksp_type gmres -ksp_gmres_restart 100 -ksp_view' python foo.py


Command-line options can be read via an instance of the Options class. For instance:

OptDB = PETSc.Options()
n     = OptDB.getInt('n', 16)
eta   = OptDB.getReal('eta', 0.014)
alpha = OptDB.getScalar('alpha', -12.3)


In this way, if the script is run with

$ python foo.py -n 50 -alpha 8.8


the options, n and alpha will get the values 50 and 8.8, respectively, while eta will be assigned the value specified as default, 0.014.

The options database is accessible also as a Python dictionary, so that one can for instance override, insert or delete an option:

OptDB['draw_pause'] = 1
del OptDB['draw_pause']


PETSC4PY DEMOS

Poisson in 2D

Solve a constant coefficient Poisson problem on a regular grid. The source code for this demo can be downloaded here <../../_static/poisson2d.py>


- u_{xx} - u_{yy} = 1 \quad\textsf{in}\quad [0,1]^2\\
u = 0 \quad\textsf{on the boundary.}

This is a naïve, parallel implementation, using n interior grid points per dimension and a lexicographic ordering of the nodes.

This code is kept as simple as possible. However, simplicity comes at a price. Here we use a naive decomposition that does not lead to an optimal communication complexity for the matrix-vector product. An optimal complexity decomposition of a structured grid could be achieved using PETSc.DMDA <#petsc4py.PETSc.DMDA>.

This demo is structured as a script to be executed using:

$ python poisson2d.py


potentially with additional options passed at the end of the command.

At the start of your script, call petsc4py.init <#petsc4py.init> passing sys.argv <https://docs.python.org/3/library/sys.html#sys.argv> so that command-line arguments to the script are passed through to PETSc.

import sys
import petsc4py
petsc4py.init(sys.argv)


The full PETSc4py API is to be found in the petsc4py.PETSc <#module-petsc4py.PETSc> module.

from petsc4py import PETSc


PETSc is extensively programmable using the PETSc.Options <#petsc4py.PETSc.Options> database. For more information see working with PETSc Options <#petsc-options>.

OptDB = PETSc.Options()


Grid size and spacing using a default value of 5. The user can specify a different number of points in each direction by passing the -n option to the script.

n = OptDB.getInt('n', 5)
h = 1.0 / (n + 1)


Matrices are instances of the PETSc.Mat <#petsc4py.PETSc.Mat> class.

A = PETSc.Mat()


Create the underlying PETSc C Mat object. You can omit the comm argument if your objects live on PETSc.COMM_WORLD <#petsc4py.PETSc.COMM_WORLD> but it is a dangerous choice to rely on default values for such important arguments.

A.create(comm=PETSc.COMM_WORLD)


Specify global matrix shape with a tuple.

A.setSizes((n * n, n * n))


The call above implicitly assumes that we leave the parallel decomposition of the matrix rows to PETSc by using PETSc.DECIDE <#petsc4py.PETSc.DECIDE> for local sizes. It is equivalent to:

A.setSizes(((PETSc.DECIDE, n * n), (PETSc.DECIDE, n * n)))


Here we use a sparse matrix of AIJ type Various matrix formats <#petsc4py.PETSc.Mat.Type> can be selected:

A.setType(PETSc.Mat.Type.AIJ)


Finally we allow the user to set any options they want to on the matrix from the command line:

A.setFromOptions()


Insertion into some matrix types is vastly more efficient if we preallocate space rather than allow this to happen dynamically. Here we hint the number of nonzeros to be expected on each row.

A.setPreallocationNNZ(5)


We can now write out our finite difference matrix assembly using conventional Python syntax. Mat.getOwnershipRange <#petsc4py.PETSc.Mat.getOwnershipRange> is used to retrieve the range of rows local to this processor.

def index_to_grid(r):

"""Convert a row number into a grid point."""
return (r // n, r % n) rstart, rend = A.getOwnershipRange() for row in range(rstart, rend):
i, j = index_to_grid(row)
A[row, row] = 4.0 / h**2
if i > 0:
column = row - n
A[row, column] = -1.0 / h**2
if i < n - 1:
column = row + n
A[row, column] = -1.0 / h**2
if j > 0:
column = row - 1
A[row, column] = -1.0 / h**2
if j < n - 1:
column = row + 1
A[row, column] = -1.0 / h**2


At this stage, any exchange of information required in the matrix assembly process has not occurred. We achieve this by calling Mat.assemblyBegin <#petsc4py.PETSc.Mat.assemblyBegin> and then Mat.assemblyEnd <#petsc4py.PETSc.Mat.assemblyEnd>.

A.assemblyBegin()
A.assemblyEnd()


We set up an additional option so that the user can print the matrix by passing -view_mat to the script.

A.viewFromOptions('-view_mat')


PETSc represents all linear solvers as preconditioned Krylov subspace methods of type PETSc.KSP <#petsc4py.PETSc.KSP>. Here we create a KSP object for a conjugate gradient solver preconditioned with an algebraic multigrid method.

ksp = PETSc.KSP()
ksp.create(comm=A.getComm())
ksp.setType(PETSc.KSP.Type.CG)
ksp.getPC().setType(PETSc.PC.Type.GAMG)


We set the matrix in our linear solver and allow the user to program the solver with options.

ksp.setOperators(A)
ksp.setFromOptions()


Since the matrix knows its size and parallel distribution, we can retrieve appropriately-scaled vectors using Mat.createVecs <#petsc4py.PETSc.Mat.createVecs>. PETSc vectors are objects of type PETSc.Vec <#petsc4py.PETSc.Vec>. Here we set the right-hand side of our system to a vector of ones, and then solve.

x, b = A.createVecs()
b.set(1.0)
ksp.solve(b, x)


Finally, allow the user to print the solution by passing -view_sol to the script.

x.viewFromOptions('-view_sol')


Things to try

  • Show the solution with -view_sol.
  • Show the matrix with -view_mat.
  • Change the resolution with -n.
  • Use a direct solver by passing -ksp_type preonly -pc_type lu.
  • Run in parallel on two processors using:

mpiexec -n 2 python poisson2d.py



DOCUMENTATION STANDARDS FOR PETSC4PY

Subject to exceptions given below, new contributions to petsc4py must include type annotations <https://docs.python.org/3/library/typing.html#module-typing> for function parameters and results, and docstrings on every class, function and method.

The documentation should be consistent with the corresponding C API documentation, including copying text where this is appropriate. More in-depth documentation from the C API (such as extended discussions of algorithmic or performance factors) should not be copied.

Docstring standards

Docstrings are to be written in numpydoc:format format.

The first line of a class, function or method docstring must be a short description of the method in imperative mood ("Return the norm of the matrix.") "Return" is to be preferred over "Get" in this sentence. A blank line must follow this description. Use one-liner descriptions for properties.

If the corresponding C API documentation of a method lists a function as being collective, then this information must be repeated on the next line of the docstring. Valid strings are: "Not collective.", "Logically collective.", "Collective.", "Neighborwise collective.", or "Collective the first time it is called".

The initial description section can contain more information if this is useful. In particular, if there is a PETSc manual chapter about a class, then this should be referred to from here.

Use double backticks around literals (like strings and numbers), e.g., ``2``, ``"foo"``.

Reference PETSc functions simply using backticks, e.g., KSP <https://petsc.org/release/manualpages/KSP/KSP.html> refers to the PETSc C documentation for KSP. Do not use URLs in docstrings. Always use Intersphinx references.

The following sections describe the use of numpydoc sections. Other sections allowed by numpydoc may be included if they are useful.

Parameters

This is required for methods unless there are no parameters, or it will be completely obvious to even a novice user what the parameters do.

If a class has a non-trivial constructor, the arguments of the constructor and their types must be explicitly documented within this section.

For methods, types should only be specified in this section if for some reason the types provided by typing prove to be inadequate. If no type is being specified, do not include a colon (:) to the right of the parameter name.

Use Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm> when specifying the default communicator.

Returns

This should only be specified if the return value is not obvious from the initial description and typing.

If a "Returns" section is required, the type of the returned items must be specified, even if this duplicates typing information.

See Also

If any of the following apply, then this section is required. The order of entries is as follows. Other links are permitted in this section if they add information useful to users.

Every setFromOptions must include the link petsc_options.

Any closely related part of the petsc4py API not already linked in the docstring should appear (e.g. setters and getters should cross-refer).

If there is a corresponding C API documentation page, this must be linked from the "See also" section, e.g. petsc.MatSetValues.

End docstring with an empty line - "closing three quotation marks must be on a line by itself, preferably preceded by a blank line"

Type hint standards

If returning self, use -> Self in function signature.

Type hints are not required when the static type signature includes a PETSc type (e.g. Vec x). These will be automatically generated. This will also work for = None. When using type hints, use spacing around the equals in any = None.

Communicators in type signatures must use Python typing instead of c-typing (i.e. comm: Comm not Comm comm). This is because communicators can come from mpi4py and not just the petsc4py.PETSc.Comm class.

For petsc4py native types that are strings, the type is argument: KSP.Type | str (not e.g.: KSPType argument). If the type is strictly an enum the | str can be omitted. Full signature example:

def setType(self, ksp_type: KSP.Type | str) -> None:


If a NumPy array is returned, use ArrayBool/ArrayInt/ArrayReal/ArrayScalar as the return type.

Author

Lisandro Dalcin

November 22, 2025 3.24