- trixie 3.22.4-1
- testing 3.22.4-2
- unstable 3.24.1-2
- experimental 3.24.1-1exp1
| PETSC4PY(3) | Project name not set | PETSC4PY(3) |
NAME¶
petsc4py - PETSc for Python
- Author
- Lisandro Dalcin
- Contact
- <dalcinl@gmail.com>
- Web Site
- <https://gitlab.com/petsc/petsc>
- Date
- 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.
- Vec
- 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.
- Mat
- 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.
- PC
- A collection of sequential and parallel preconditioners, including (sequential) ILU(k), LU, and (both sequential and parallel) block Jacobi, overlapping additive Schwarz methods.
- KSP
- 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.
- SNES
- 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.
- TS
- 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:
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:
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¶
- 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.init(args=None, arch=None, comm=None)
- Initialize PETSc.
- args (str <https://docs.python.org/3/library/stdtypes.html#str> | list <https://docs.python.org/3/library/stdtypes.html#list>[str <https://docs.python.org/3/library/stdtypes.html#str>] | None <https://docs.python.org/3/library/constants.html#None>) -- Command-line arguments, usually the sys.argv <https://docs.python.org/3/library/sys.html#sys.argv> list
- arch (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- Specific configuration to use
- comm (Intracomm <https://mpi4py.readthedocs.io/en/stable/reference/mpi4py.MPI.Intracomm.html#mpi4py.MPI.Intracomm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI commmunicator
Notes
This function should be called only once, typically at the very beginning of the bootstrap script of an application.
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.ArrayBool
- Array of bool
<https://docs.python.org/3/library/functions.html#bool>.
alias of ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>[tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...], dtype <https://numpy.org/doc/stable/reference/generated/numpy.dtype.html#numpy.dtype>[bool <https://docs.python.org/3/library/functions.html#bool>]]
petsc4py.typing.ArrayInt¶
- petsc4py.typing.ArrayInt
- Array of int
<https://docs.python.org/3/library/functions.html#int>.
alias of ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>[tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...], dtype <https://numpy.org/doc/stable/reference/generated/numpy.dtype.html#numpy.dtype>[int <https://docs.python.org/3/library/functions.html#int>]]
petsc4py.typing.ArrayReal¶
- petsc4py.typing.ArrayReal
- Array of float
<https://docs.python.org/3/library/functions.html#float>.
alias of ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>[tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...], dtype <https://numpy.org/doc/stable/reference/generated/numpy.dtype.html#numpy.dtype>[float <https://docs.python.org/3/library/functions.html#float>]]
petsc4py.typing.ArrayComplex¶
- petsc4py.typing.ArrayComplex
- Array of complex
<https://docs.python.org/3/library/functions.html#complex>.
alias of ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>[tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...], dtype <https://numpy.org/doc/stable/reference/generated/numpy.dtype.html#numpy.dtype>[complex <https://docs.python.org/3/library/functions.html#complex>]]
petsc4py.typing.ArrayScalar¶
- petsc4py.typing.ArrayScalar
- Array of Scalar <#petsc4py.typing.Scalar> numbers.
alias of ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>[tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...], dtype <https://numpy.org/doc/stable/reference/generated/numpy.dtype.html#numpy.dtype>[float <https://docs.python.org/3/library/functions.html#float> | complex <https://docs.python.org/3/library/functions.html#complex>]]
petsc4py.typing.DimsSpec¶
- 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¶
- petsc4py.typing.AccessModeSpec
- Access mode specification.
- 'rw' Read-Write mode.
- 'r' Read-only mode.
- 'w' Write-only mode.
- None <https://docs.python.org/3/library/constants.html#None> as 'rw'.
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.
- InsertMode.ADD_VALUES <#petsc4py.PETSc.InsertMode.ADD_VALUES> Add new value to existing one.
- InsertMode.INSERT_VALUES <#petsc4py.PETSc.InsertMode.INSERT_VALUES> Replace existing entry with new value.
- None <https://docs.python.org/3/library/constants.html#None> as InsertMode.INSERT_VALUES <#petsc4py.PETSc.InsertMode.INSERT_VALUES>.
- False <https://docs.python.org/3/library/constants.html#False> as InsertMode.INSERT_VALUES <#petsc4py.PETSc.InsertMode.INSERT_VALUES>.
- True <https://docs.python.org/3/library/constants.html#True> as InsertMode.ADD_VALUES <#petsc4py.PETSc.InsertMode.ADD_VALUES>.
See also:
petsc4py.typing.ScatterModeSpec¶
- petsc4py.typing.ScatterModeSpec = petsc4py.PETSc.ScatterMode | bool | str | None
- Scatter mode specification.
- ScatterMode.FORWARD <#petsc4py.PETSc.ScatterMode.FORWARD> Forward mode.
- ScatterMode.REVERSE <#petsc4py.PETSc.ScatterMode.REVERSE> Reverse mode.
- None <https://docs.python.org/3/library/constants.html#None> as ScatterMode.FORWARD <#petsc4py.PETSc.ScatterMode.FORWARD>.
- False <https://docs.python.org/3/library/constants.html#False> as ScatterMode.FORWARD <#petsc4py.PETSc.ScatterMode.FORWARD>.
- True <https://docs.python.org/3/library/constants.html#True> as ScatterMode.REVERSE <#petsc4py.PETSc.ScatterMode.REVERSE>.
- 'forward' as ScatterMode.FORWARD <#petsc4py.PETSc.ScatterMode.FORWARD>.
- 'reverse' as ScatterMode.REVERSE <#petsc4py.PETSc.ScatterMode.REVERSE>.
See also:
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:
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:
petsc4py.typing.PetscOptionsHandlerFunction¶
- 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.
- Mat.AssemblyType.FINAL <#petsc4py.PETSc.Mat.AssemblyType.FINAL>
- Mat.AssemblyType.FLUSH <#petsc4py.PETSc.Mat.AssemblyType.FLUSH>
- None <https://docs.python.org/3/library/constants.html#None> as Mat.AssemblyType.FINAL <#petsc4py.PETSc.Mat.AssemblyType.FINAL>
- False <https://docs.python.org/3/library/constants.html#False> as Mat.AssemblyType.FINAL <#petsc4py.PETSc.Mat.AssemblyType.FINAL>
- True <https://docs.python.org/3/library/constants.html#True> as Mat.AssemblyType.FLUSH <#petsc4py.PETSc.Mat.AssemblyType.FLUSH>
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:
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.CSRIndicesSpec
- CSR indices format specification.
A 2-tuple carrying the (row_start, col_indices) information.
alias of tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>], Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]]
petsc4py.typing.CSRSpec¶
- petsc4py.typing.CSRSpec
- CSR format specification.
A 3-tuple carrying the (row_start, col_indices, values) information.
alias of tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>], Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>], Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[float <https://docs.python.org/3/library/functions.html#float> | complex <https://docs.python.org/3/library/functions.html#complex>]]
petsc4py.typing.NNZSpec¶
- petsc4py.typing.NNZSpec
- Nonzero pattern specification.
A single int <https://docs.python.org/3/library/functions.html#int> corresponds to fixed number of non-zeros per row. A Sequence <https://docs.python.org/3/glossary.html#term-sequence> of int <https://docs.python.org/3/library/functions.html#int> indicates different non-zeros per row. If a 2-tuple <https://docs.python.org/3/library/stdtypes.html#tuple> is used, the elements of the tuple corresponds to the on-process and off-process parts of the matrix.
See also:
alias of int <https://docs.python.org/3/library/functions.html#int> | 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>[Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>], Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]]
petsc4py.typing.MatNullFunction¶
- 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¶
- 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¶
- 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¶
- 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¶
- 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¶
- 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.KSPMonitorFunction
- PETSc.KSP <#petsc4py.PETSc.KSP> monitor 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>], None <https://docs.python.org/3/library/constants.html#None>]
petsc4py.typing.KSPPreSolveFunction¶
- 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¶
- 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.SNESMonitorFunction
- SNES <#petsc4py.PETSc.SNES> monitor callback.
alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[SNES <#petsc4py.PETSc.SNES>, int <https://docs.python.org/3/library/functions.html#int>, float <https://docs.python.org/3/library/functions.html#float>], None <https://docs.python.org/3/library/constants.html#None>]
petsc4py.typing.SNESObjFunction¶
- 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¶
- 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¶
- 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¶
- 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.SNESUpdateFunction
- SNES <#petsc4py.PETSc.SNES> step update callback.
alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[SNES <#petsc4py.PETSc.SNES>, int <https://docs.python.org/3/library/functions.html#int>], None <https://docs.python.org/3/library/constants.html#None>]
petsc4py.typing.SNESLSPreFunction¶
- 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¶
- 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.SNESConvergedFunction
- SNES <#petsc4py.PETSc.SNES> convergence test callback.
alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[SNES <#petsc4py.PETSc.SNES>, int <https://docs.python.org/3/library/functions.html#int>, tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[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.SNES.ConvergedReason>]
petsc4py.typing.TSRHSFunction¶
- 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¶
- 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¶
- 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¶
- 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¶
- 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¶
- 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¶
- 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¶
- 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¶
- 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.TSMonitorFunction
- TS <#petsc4py.PETSc.TS> monitor callback.
alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TS <#petsc4py.PETSc.TS>, int <https://docs.python.org/3/library/functions.html#int>, float <https://docs.python.org/3/library/functions.html#float>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>]
petsc4py.typing.TSPreStepFunction¶
- 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¶
- 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.TSIndicatorFunction
- TS <#petsc4py.PETSc.TS> event indicator 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>, ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>[tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...], dtype <https://numpy.org/doc/stable/reference/generated/numpy.dtype.html#numpy.dtype>[float <https://docs.python.org/3/library/functions.html#float>]]], None <https://docs.python.org/3/library/constants.html#None>]
petsc4py.typing.TSPostEventFunction¶
- petsc4py.typing.TSPostEventFunction
- TS <#petsc4py.PETSc.TS> post-event callback.
alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TS <#petsc4py.PETSc.TS>, ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>[tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...], dtype <https://numpy.org/doc/stable/reference/generated/numpy.dtype.html#numpy.dtype>[int <https://docs.python.org/3/library/functions.html#int>]], float <https://docs.python.org/3/library/functions.html#float>, Vec <#petsc4py.PETSc.Vec>, bool <https://docs.python.org/3/library/functions.html#bool>], None <https://docs.python.org/3/library/constants.html#None>]
petsc4py.typing.TAOObjectiveFunction¶
- 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¶
- 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¶
- 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¶
- 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.TAOUpdateFunction
- TAO <#petsc4py.PETSc.TAO> update callback.
alias of Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[TAO <#petsc4py.PETSc.TAO>, int <https://docs.python.org/3/library/functions.html#int>], None <https://docs.python.org/3/library/constants.html#None>]
petsc4py.typing.TAOMonitorFunction¶
- 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¶
- 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¶
- 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¶
- 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¶
- 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¶
- 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¶
- 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¶
- 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¶
- 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¶
- 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¶
- 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:
- DECIDE <#petsc4py.PETSc.DECIDE>
- 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.
- DEFAULT <#petsc4py.PETSc.DEFAULT>
- Use a default value chosen by PETSc.
- DETERMINE <#petsc4py.PETSc.DETERMINE>
- 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.
- CURRENT <#petsc4py.PETSc.CURRENT>
- Do not change the current value that is set.
- UNLIMITED <#petsc4py.PETSc.UNLIMITED>
- For a parameter that is a bound, such as the maximum number of iterations, do not bound the value.
More constants:
- INFINITY <#petsc4py.PETSc.INFINITY>
- Very large real value.
- NINFINITY <#petsc4py.PETSc.NINFINITY>
- Very large negative real value.
- PINFINITY <#petsc4py.PETSc.PINFINITY>
- 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¶
- class 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¶
- class petsc4py.PETSc.AO.Type
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The application ordering types.
Attributes Summary
ADVANCED Object ADVANCED 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> MAPPING Object MAPPING of type str <https://docs.python.org/3/library/stdtypes.html#str> MEMORYSCALABLE Object MEMORYSCALABLE of type str <https://docs.python.org/3/library/stdtypes.html#str> Attributes Documentation
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
- app2petsc(indices)
- 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.
- Parameters
- indices (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | IS <#petsc4py.PETSc.IS>) -- The indices; to be replaced with their mapped values.
- Return type
- Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | IS <#petsc4py.PETSc.IS>
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>
- createBasic(app, petsc=None, comm=None)
- 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.
- app (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | IS <#petsc4py.PETSc.IS>) -- The application ordering.
- petsc (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | IS <#petsc4py.PETSc.IS> | None <https://docs.python.org/3/library/constants.html#None>) -- Another ordering (may be None <https://docs.python.org/3/library/constants.html#None> to indicate the natural ordering, that is 0, 1, 2, 3, ...).
- 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>.
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>
- createMapping(app, petsc=None, comm=None)
- 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.
- app (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | IS <#petsc4py.PETSc.IS>) -- The application ordering.
- petsc (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | IS <#petsc4py.PETSc.IS> | None <https://docs.python.org/3/library/constants.html#None>) -- Another ordering. May be None <https://docs.python.org/3/library/constants.html#None> to indicate the identity ordering.
- 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>.
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>
- createMemoryScalable(app, petsc=None, comm=None)
- 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.
- app (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | IS <#petsc4py.PETSc.IS>) -- The application ordering.
- petsc (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | IS <#petsc4py.PETSc.IS> | None <https://docs.python.org/3/library/constants.html#None>) -- Another ordering (may be None <https://docs.python.org/3/library/constants.html#None> to indicate the natural ordering, that is 0, 1, 2, 3, ...).
- 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>.
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>
- destroy()
- Destroy the application ordering.
Collective.
See also:
Source code at petsc4py/PETSc/AO.pyx:40 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/AO.pyx#L40>
- getType()
- Return the application ordering type.
Not collective.
See also:
Source code at petsc4py/PETSc/AO.pyx:200 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/AO.pyx#L200>
- petsc2app(indices)
- 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.
- Parameters
- indices (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | IS <#petsc4py.PETSc.IS>) -- The indices; to be replaced with their mapped values.
- Return type
- Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | IS <#petsc4py.PETSc.IS>
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>
- view(viewer=None)
- Display the application ordering.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the ordering.
- Return type
- 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¶
- class 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(dm, fields, coords)
- Create the cell DM.
Collective.
- dm (DM <#petsc4py.PETSc.DM>) -- The underlying DM on which to place particles
- fields (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[str <https://docs.python.org/3/library/stdtypes.html#str>]) -- The swarm fields represented on the DM
- coords (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[str <https://docs.python.org/3/library/stdtypes.html#str>]) -- The swarm fields to use as coordinates in the DM
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>
- destroy()
- Destroy the cell DM.
Collective.
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:1108 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L1108>
- getBlockSize(sw)
- Return the block size for this cell DM.
Not collective.
- Parameters
- sw (DM <#petsc4py.PETSc.DM>) -- The DMSwarm <#petsc4py.PETSc.DMSwarm> object
- Return type
- 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>
- getCellID()
- Return the cellid field for this cell DM.
Not collective.
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:1181 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L1181>
- getCoordinateFields()
- Return the swarm fields used as coordinates on this cell DM.
Not collective.
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:1232 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L1232>
- getDM()
- 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>
- Return type
- DM <#petsc4py.PETSc.DM>
- getFields()
- Return the swarm fields defined on this cell DM.
Not collective.
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:1214 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L1214>
- view(viewer=None)
- View the cell DM.
Collective.
- Parameters
- 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.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
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¶
- class petsc4py.PETSc.Comm
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Communicator object.
Predefined instances:
- COMM_NULL <#petsc4py.PETSc.COMM_NULL>
- The null (or invalid) communicator.
- COMM_SELF <#petsc4py.PETSc.COMM_SELF>
- The self communicator.
- COMM_WORLD <#petsc4py.PETSc.COMM_WORLD>
- The world communicator.
See also:
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
- barrier()
- Barrier synchronization.
Collective.
Source code at petsc4py/PETSc/Comm.pyx:123 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Comm.pyx#L123>
- destroy()
- Destroy the communicator.
Collective.
See also:
Source code at petsc4py/PETSc/Comm.pyx:61 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Comm.pyx#L61>
- duplicate()
- Duplicate the communicator.
Collective.
See also:
Source code at petsc4py/PETSc/Comm.pyx:79 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Comm.pyx#L79>
- getRank()
- 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>
- getSize()
- 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>
- tompi4py()
- Convert communicator to mpi4py
<https://mpi4py.readthedocs.io/en/stable/mpi4py.html#module-mpi4py>.
Not collective.
See also:
Source code at petsc4py/PETSc/Comm.pyx:155 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Comm.pyx#L155>
Attributes Documentation
- fortran
- Fortran handle.
Source code at petsc4py/PETSc/Comm.pyx:147 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Comm.pyx#L147>
- rank
- Communicator rank.
Source code at petsc4py/PETSc/Comm.pyx:140 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Comm.pyx#L140>
- size
- Communicator size.
Source code at petsc4py/PETSc/Comm.pyx:135 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Comm.pyx#L135>
petsc4py.PETSc.DM¶
- class 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¶
- class petsc4py.PETSc.DM.BoundaryType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
DM <#petsc4py.PETSc.DM> Boundary types.
Attributes Summary
GHOSTED Constant GHOSTED of type int <https://docs.python.org/3/library/functions.html#int> MIRROR Constant MIRROR 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> PERIODIC Constant PERIODIC of type int <https://docs.python.org/3/library/functions.html#int> TWIST Constant TWIST of type int <https://docs.python.org/3/library/functions.html#int> Attributes Documentation
petsc4py.PETSc.DM.PolytopeType¶
- class petsc4py.PETSc.DM.PolytopeType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The DM <#petsc4py.PETSc.DM> cell types.
Attributes Summary
Attributes Documentation
petsc4py.PETSc.DM.ReorderDefaultFlag¶
- class petsc4py.PETSc.DM.ReorderDefaultFlag
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The DM <#petsc4py.PETSc.DM> reordering default flags.
Attributes Summary
FALSE Constant FALSE of type int <https://docs.python.org/3/library/functions.html#int> NOTSET Constant NOTSET of type int <https://docs.python.org/3/library/functions.html#int> TRUE Constant TRUE of type int <https://docs.python.org/3/library/functions.html#int> Attributes Documentation
petsc4py.PETSc.DM.Type¶
- class petsc4py.PETSc.DM.Type
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
DM <#petsc4py.PETSc.DM> types.
Attributes Summary
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
- adaptLabel(label)
- Adapt a DM based on a DMLabel
<#petsc4py.PETSc.DMLabel>.
Collective.
- Parameters
- label (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The name of the DMLabel <#petsc4py.PETSc.DMLabel>.
- Return type
- 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>
- adaptMetric(metric, bdLabel=None, rgLabel=None)
- Return a mesh adapted to the specified metric field.
Collective.
- metric (Vec <#petsc4py.PETSc.Vec>) -- The metric to which the mesh is adapted, defined vertex-wise.
- bdLabel (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- Label for boundary tags.
- rgLabel (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- Label for cell tag.
- Return type
- 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>
- addCoarsenHook(coarsenhook, restricthook, args=None, kargs=None)
- Add a callback to be executed when restricting to a coarser grid.
Logically collective.
- coarsenhook (DMCoarsenHookFunction <#petsc4py.typing.DMCoarsenHookFunction>) -- The coarsen hook function.
- restricthook (DMRestrictHookFunction <#petsc4py.typing.DMRestrictHookFunction>) -- The restrict hook function.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the hooks.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the hooks.
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>
- addField(field, label=None)
- Add a field to a DM object.
Logically collective.
- field (Object <#petsc4py.PETSc.Object>) -- The discretization object.
- label (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 indicating the support of the field, or None <https://docs.python.org/3/library/constants.html#None> for the entire mesh.
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>
- appendOptionsPrefix(prefix)
- Append to the prefix used for searching for options in the database.
Logically collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:298 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L298>
- clearDS()
- Remove all discrete systems from the DM.
Logically collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:691 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L691>
- clearFields()
- Remove all fields from the DM.
Logically collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:634 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L634>
- clearLabelStratum(name, value)
- Remove all points from a stratum.
Not collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The label name.
- value (int <https://docs.python.org/3/library/functions.html#int>) -- The stratum value.
See also:
Source code at petsc4py/PETSc/DM.pyx:2192 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L2192>
- clearLabelValue(name, point, value)
- Remove a point from a DMLabel <#petsc4py.PETSc.DMLabel> with
given value.
Not collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The label name.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The mesh point.
- value (int <https://docs.python.org/3/library/functions.html#int>) -- The label value for the point.
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>
- clone()
- 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>
- Return type
- DM <#petsc4py.PETSc.DM>
- coarsen(comm=None)
- Return a coarsened DM object.
Collective.
- Parameters
- 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>.
- Return type
- 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>
- coarsenHierarchy(nlevels)
- Coarsen this DM and return the coarsened DM hierarchy.
Collective.
- Parameters
- nlevels (int <https://docs.python.org/3/library/functions.html#int>) -- The number of levels of coarsening.
- Return type
- list <https://docs.python.org/3/library/stdtypes.html#list>
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>
- convert(dm_type)
- Return a DM converted to another DM.
Collective.
- Parameters
- 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.
- Return type
- DM <#petsc4py.PETSc.DM>
See also:
Source code at petsc4py/PETSc/DM.pyx:1540 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1540>
- copyDS(dm, minDegree=None, maxDegree=None)
- Copy the discrete systems for this DM into another DM.
Collective.
- dm (DM <#petsc4py.PETSc.DM>) -- The DM that the discrete fields are copied into.
- minDegree -- The minimum polynommial degree for the discretization, or None <https://docs.python.org/3/library/constants.html#None> for no limit
- maxDegree -- The maximum polynommial degree for the discretization, or None <https://docs.python.org/3/library/constants.html#None> for no limit
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>
- copyDisc(dm)
- Copy fields and discrete systems of a DM into another DM.
Collective.
- Parameters
- dm (DM <#petsc4py.PETSc.DM>) -- The DM that the fields and discrete systems are copied into.
- Return type
- 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>
- copyFields(dm, minDegree=None, maxDegree=None)
- Copy the discretizations of this DM into another DM.
Collective.
- dm (DM <#petsc4py.PETSc.DM>) -- The DM that the fields are copied into.
- minDegree -- The minimum polynommial degree for the discretization, or None <https://docs.python.org/3/library/constants.html#None> for no limit
- maxDegree -- The maximum polynommial degree for the discretization, or None <https://docs.python.org/3/library/constants.html#None> for no limit
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>
- create(comm=None)
- Return an empty DM.
Collective.
- Parameters
- 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>.
- Return type
- 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>
- createDS()
- Create discrete systems.
Collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:679 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L679>
- createFieldDecomposition()
- Return field splitting information.
Collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:2290 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L2290>
- createGlobalVec()
- 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>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- createInjection(dm)
- Return the injection matrix into a finer DM.
Collective.
- Parameters
- dm (DM <#petsc4py.PETSc.DM>) -- The second, finer DM object.
- Return type
- 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>
- createInterpolation(dm)
- Return the interpolation matrix to a finer DM.
Collective.
- Parameters
- dm (DM <#petsc4py.PETSc.DM>) -- The second, finer DM.
- Return type
- 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>
- createLabel(name)
- Create a label of the given name if it does not already exist.
Not collective.
- Parameters
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The label name.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DM.pyx:1990 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1990>
- createLocalVec()
- 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>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- createMassMatrix(dmf)
- Return the mass matrix between this DM and the given DM.
Collective.
- Parameters
- dmf (DM <#petsc4py.PETSc.DM>) -- The second DM.
- Return type
- 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>
- createMat()
- 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>
- Return type
- Mat <#petsc4py.PETSc.Mat>
- createRestriction(dm)
- Return the restriction matrix between this DM and the given
DM.
Collective.
- Parameters
- dm (DM <#petsc4py.PETSc.DM>) -- The second, finer DM object.
- Return type
- 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>
- createSectionSF(localsec, globalsec)
- 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.
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>
- createSubDM(fields)
- 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.
- Parameters
- fields (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>])
- Return type
- 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>
- destroy()
- Destroy the object.
Collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:121 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L121>
- getAppCtx()
- Return the application context.
Source code at petsc4py/PETSc/DM.pyx:343 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L343>
- getAuxiliaryVec(label=None, value=0, part=0)
- Return an auxiliary vector for region.
Not collective.
- label (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The name of the DMLabel <#petsc4py.PETSc.DMLabel>.
- value (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Indicate the region.
- part (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- The equation part, or 0 is unused.
- Return type
- Vec <#petsc4py.PETSc.Vec>
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>
- getBasicAdjacency()
- Return the flags for determining variable influence.
Not collective.
- useCone (bool <https://docs.python.org/3/library/functions.html#bool>) -- Whether adjacency uses cone information.
- useClosure (bool <https://docs.python.org/3/library/functions.html#bool>) -- Whether adjacency is computed using full closure information.
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>
- getBlockSize()
- Return the inherent block size associated with a DM.
Not collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:770 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L770>
- getBoundingBox()
- Return the dimension of embedding space for coordinates values.
Not collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:1311 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1311>
- getCellCoordinateDM()
- 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>
- Return type
- DM <#petsc4py.PETSc.DM>
- getCellCoordinateSection()
- 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>
- Return type
- Section <#petsc4py.PETSc.Section>
- getCellCoordinates()
- 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>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- getCellCoordinatesLocal()
- 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>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- getCoarseDM()
- 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>
- Return type
- DM <#petsc4py.PETSc.DM>
- getCoarsenLevel()
- Return the number of coarsenings.
Not collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:1697 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1697>
- getCoordinateDM()
- 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>
- Return type
- DM <#petsc4py.PETSc.DM>
- getCoordinateDim()
- 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>
- getCoordinateSection()
- 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>
- Return type
- Section <#petsc4py.PETSc.Section>
- getCoordinates()
- 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>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- getCoordinatesLocal()
- 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>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- getCoordinatesLocalized()
- Check if the coordinates have been localized for cells.
Not collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:1297 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1297>
- getDS()
- 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>
- Return type
- DS <#petsc4py.PETSc.DS>
- getDimension()
- Return the topological dimension of the DM.
Not collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:206 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L206>
- getField(index)
- Return the discretization object for a given DM field.
Not collective.
- Parameters
- index (int <https://docs.python.org/3/library/functions.html#int>) -- The field number.
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Object <#petsc4py.PETSc.Object>, None <https://docs.python.org/3/library/constants.html#None>]
See also:
Source code at petsc4py/PETSc/DM.pyx:586 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L586>
- getFieldAdjacency(field)
- Return the flags for determining variable influence.
Not collective.
- Parameters
- field (int <https://docs.python.org/3/library/functions.html#int>) -- The field number.
- Returns
- useCone (bool <https://docs.python.org/3/library/functions.html#bool>) -- Whether adjacency uses cone information.
- useClosure (bool <https://docs.python.org/3/library/functions.html#bool>) -- Whether adjacency is computed using full closure information.
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>
- getGlobalSection()
- 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>
- Return type
- Section <#petsc4py.PETSc.Section>
- getGlobalVec(name=None)
- Return a global vector.
Collective.
- Parameters
- 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.
- Return type
- 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>
- getLGMap()
- 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>
- Return type
- LGMap <#petsc4py.PETSc.LGMap>
- getLabel(name)
- 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>
- Parameters
- name (str <https://docs.python.org/3/library/stdtypes.html#str>)
- Return type
- DMLabel <#petsc4py.PETSc.DMLabel>
- getLabelIdIS(name)
- Return an IS <#petsc4py.PETSc.IS> of all values that the
DMLabel <#petsc4py.PETSc.DMLabel> takes.
Not collective.
- Parameters
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The label name.
- Return type
- 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>
- getLabelName(index)
- Return the name of nth label.
Not collective.
- Parameters
- index (int <https://docs.python.org/3/library/functions.html#int>) -- The label number.
- Return type
- str <https://docs.python.org/3/library/stdtypes.html#str>
See also:
Source code at petsc4py/PETSc/DM.pyx:1949 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1949>
- getLabelOutput(name)
- Return the output flag for a given label.
Not collective.
- Parameters
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The label name.
- Return type
- bool <https://docs.python.org/3/library/functions.html#bool>
See also:
Source code at petsc4py/PETSc/DM.pyx:2236 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L2236>
- getLabelSize(name)
- Return the number of values that the DMLabel
<#petsc4py.PETSc.DMLabel> takes.
Not collective.
- Parameters
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The label name.
- Return type
- int <https://docs.python.org/3/library/functions.html#int>
See also:
Source code at petsc4py/PETSc/DM.pyx:2102 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L2102>
- getLabelValue(name, point)
- Return the value in DMLabel <#petsc4py.PETSc.DMLabel> for the
given point.
Not collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The label name.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The mesh point
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>
- getLocalBoundingBox()
- Return the bounding box for the piece of the DM.
Not collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:1328 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1328>
- getLocalSection()
- 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>
- Return type
- Section <#petsc4py.PETSc.Section>
- getLocalVec(name=None)
- Return a local vector.
Not collective.
- Parameters
- 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.
- Return type
- 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>
- getNumFields()
- Return the number of fields in the DM.
Not collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:546 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L546>
- getNumLabels()
- Return the number of labels defined by on the DM.
Not collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:1935 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1935>
- getOptionsPrefix()
- Return the prefix used for searching for options in the database.
Not collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:284 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L284>
- getPeriodicity()
- 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
- Return type
- 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>
- getPointSF()
- 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>
- Return type
- SF <#petsc4py.PETSc.SF>
- getRefineLevel()
- Return the refinement level.
Not collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:1665 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1665>
- getSectionSF()
- 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>
- Return type
- SF <#petsc4py.PETSc.SF>
- getStratumIS(name, value)
- Return the points in a label stratum.
Not collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The label name.
- value (int <https://docs.python.org/3/library/functions.html#int>) -- The stratum value.
- Return type
- 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>
- getStratumSize(name, value)
- Return the number of points in a label stratum.
Not collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The label name.
- value (int <https://docs.python.org/3/library/functions.html#int>) -- The stratum value.
See also:
Source code at petsc4py/PETSc/DM.pyx:2144 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L2144>
- getType()
- Return the DM type name.
Not collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:192 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L192>
- globalToLocal(vg, vl, addv=None)
- Update local vectors from global vector.
Neighborwise collective.
- vg (Vec <#petsc4py.PETSc.Vec>) -- The global vector.
- vl (Vec <#petsc4py.PETSc.Vec>) -- The local vector.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Insertion mode.
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>
- hasLabel(name)
- Determine whether the DM has a label.
Not collective.
- Parameters
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The label name.
- Return type
- bool <https://docs.python.org/3/library/functions.html#bool>
See also:
Source code at petsc4py/PETSc/DM.pyx:1969 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1969>
- load(viewer)
- Return a DM stored in binary.
Collective.
- Parameters
- 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>.
- Return type
- 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:
Source code at petsc4py/PETSc/DM.pyx:95 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L95>
- localToGlobal(vl, vg, addv=None)
- Update global vectors from local vector.
Neighborwise collective.
- vl (Vec <#petsc4py.PETSc.Vec>) -- The local vector.
- vg (Vec <#petsc4py.PETSc.Vec>) -- The global vector.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Insertion mode.
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>
- localToLocal(vl, vlg, addv=None)
- Map the values from a local vector to another local vector.
Neighborwise collective.
- vl (Vec <#petsc4py.PETSc.Vec>) -- The local vector.
- vlg (Vec <#petsc4py.PETSc.Vec>) -- The global vector.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Insertion mode.
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>
- localizeCoordinates()
- 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>
- refine(comm=None)
- Return a refined DM object.
Collective.
- Parameters
- 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>.
- Return type
- 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>
- refineHierarchy(nlevels)
- Refine this DM and return the refined DM hierarchy.
Collective.
- Parameters
- nlevels (int <https://docs.python.org/3/library/functions.html#int>) -- The number of levels of refinement.
- Return type
- list <https://docs.python.org/3/library/stdtypes.html#list>
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>
- removeLabel(name)
- Remove and destroy the label by name.
Not collective.
- Parameters
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The label name.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DM.pyx:2009 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L2009>
- restoreGlobalVec(vg, name=None)
- Restore a global vector obtained with getGlobalVec.
Logically collective.
- vg (Vec <#petsc4py.PETSc.Vec>) -- The global vector.
- name (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The name used to retrieve the persistent vector, if any.
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>
- restoreLocalVec(vl, name=None)
- Restore a local vector obtained with getLocalVec.
Not collective.
- vl (Vec <#petsc4py.PETSc.Vec>) -- The local vector.
- name (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The name used to retrieve the persistent vector, if any.
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>
- setAppCtx(appctx)
- Set the application context.
Source code at petsc4py/PETSc/DM.pyx:339 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L339>
- setAuxiliaryVec(aux, label, value=0, part=0)
- 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.
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>
- setBasicAdjacency(useCone, useClosure)
- Set the flags for determining variable influence.
Not collective.
- useCone (bool <https://docs.python.org/3/library/functions.html#bool>) -- Whether adjacency uses cone information.
- useClosure (bool <https://docs.python.org/3/library/functions.html#bool>) -- Whether adjacency is computed using full closure information.
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>
- setCellCoordinateDM(dm)
- Set the cell coordinate DM.
Collective.
- Parameters
- dm (DM <#petsc4py.PETSc.DM>) -- The cell coordinate DM.
- Return type
- 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>
- setCellCoordinateSection(dim, sec)
- Set the cell coordinate layout over the DM.
Collective.
- dim (int <https://docs.python.org/3/library/functions.html#int>) -- The embedding dimension, or DETERMINE <#petsc4py.PETSc.DETERMINE>.
- sec (Section <#petsc4py.PETSc.Section>) -- The cell coordinate Section <#petsc4py.PETSc.Section>.
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>
- setCellCoordinates(c)
- Set a global vector with the cellwise coordinates.
Collective.
- Parameters
- c (Vec <#petsc4py.PETSc.Vec>) -- The global cell coordinate vector.
- Return type
- 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>
- setCellCoordinatesLocal(c)
- Set a local vector with the cellwise coordinates.
Not collective.
- Parameters
- c (Vec <#petsc4py.PETSc.Vec>) -- The local cell coordinate vector.
- Return type
- 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>
- setCoarseDM(dm)
- Set the coarse DM.
Collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:1035 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1035>
- Parameters
- dm (DM <#petsc4py.PETSc.DM>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setCoordinateDim(dim)
- Set the dimension of embedding space for coordinates values.
Not collective.
- Parameters
- dim (int <https://docs.python.org/3/library/functions.html#int>) -- The embedding dimension.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setCoordinateDisc(disc, localized, project)
- Project coordinates to a different space.
Collective.
- disc (FE <#petsc4py.PETSc.FE>) -- The new coordinates discretization.
- localized (bool <https://docs.python.org/3/library/functions.html#bool>) -- Set a localized (DG) coordinate space
- project (bool <https://docs.python.org/3/library/functions.html#bool>) -- Project coordinates to new discretization
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>
- setCoordinates(c)
- Set a global vector that holds the coordinates.
Collective.
- Parameters
- c (Vec <#petsc4py.PETSc.Vec>) -- Coordinate Vector.
- Return type
- 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>
- setCoordinatesLocal(c)
- Set a local vector with the ghost point holding the coordinates.
Not collective.
- Parameters
- c (Vec <#petsc4py.PETSc.Vec>) -- Coordinate Vector.
- Return type
- 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>
- setDimension(dim)
- Set the topological dimension of the DM.
Collective.
- Parameters
- dim (int <https://docs.python.org/3/library/functions.html#int>) -- Topological dimension.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DM.pyx:220 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L220>
- setField(index, field, label=None)
- Set the discretization object for a given DM field.
Logically collective.
- index (int <https://docs.python.org/3/library/functions.html#int>) -- The field number.
- field (Object <#petsc4py.PETSc.Object>) -- The discretization object.
- label (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 indicating the support of the field, or None <https://docs.python.org/3/library/constants.html#None> for the entire mesh.
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>
- setFieldAdjacency(field, useCone, useClosure)
- Set the flags for determining variable influence.
Not collective.
- field (int <https://docs.python.org/3/library/functions.html#int>) -- The field number.
- useCone (bool <https://docs.python.org/3/library/functions.html#bool>) -- Whether adjacency uses cone information.
- useClosure (bool <https://docs.python.org/3/library/functions.html#bool>) -- Whether adjacency is computed using full closure information.
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>
- setFromOptions()
- Configure the object from the options database.
Collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:312 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L312>
- setGlobalSection(sec)
- 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>
- Parameters
- sec (Section <#petsc4py.PETSc.Section>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setKSPComputeOperators(operators, args=None, kargs=None)
- Matrix associated with the linear system.
Collective.
- operator -- Callback function to compute the operators.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
See also:
Source code at petsc4py/PETSc/DM.pyx:2262 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L2262>
- setLabelOutput(name, output)
- Set if a given label should be saved to a view.
Not collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The label name.
- output (bool <https://docs.python.org/3/library/functions.html#bool>) -- If True <https://docs.python.org/3/library/constants.html#True>, the label is saved to the viewer.
See also:
Source code at petsc4py/PETSc/DM.pyx:2214 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L2214>
- setLabelValue(name, point, value)
- Set a point to a DMLabel <#petsc4py.PETSc.DMLabel> with a
given value.
Not collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The label name.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The mesh point.
- value (int <https://docs.python.org/3/library/functions.html#int>) -- The label value for the point.
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>
- setLocalSection(sec)
- 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>
- Parameters
- sec (Section <#petsc4py.PETSc.Section>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setMatType(mat_type)
- Set matrix type to be used by DM.createMat.
Logically collective.
- Parameters
- mat_type (Type <#petsc4py.PETSc.Mat.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The matrix type.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
Notes
The option -dm_mat_type is used to set the matrix type.
See also:
Source code at petsc4py/PETSc/DM.pyx:1425 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1425>
- setNumFields(numFields)
- Set the number of fields in the DM.
Logically collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:533 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L533>
- setOptionsPrefix(prefix)
- Set the prefix used for searching for options in the database.
Logically collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:270 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L270>
- setPeriodicity(maxCell, Lstart, L)
- Set the description of mesh periodicity.
Logically collective.
- maxCell (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[float <https://docs.python.org/3/library/functions.html#float>]) -- The longest allowable cell dimension in each direction.
- Lstart (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[float <https://docs.python.org/3/library/functions.html#float>]) -- The start of each coordinate direction, usually [0, 0, 0]
- L (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[float <https://docs.python.org/3/library/functions.html#float>]) -- The periodic length of each coordinate direction, or -1 for non-periodic
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>
- setPointSF(sf)
- 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>
- Parameters
- sf (SF <#petsc4py.PETSc.SF>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setRefineLevel(level)
- Set the number of refinements.
Not collective.
- nlevels -- The number of refinement.
- level (int <https://docs.python.org/3/library/functions.html#int>)
See also:
Source code at petsc4py/PETSc/DM.pyx:1679 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L1679>
- setSNESFunction(function, args=None, kargs=None)
- Set SNES <#petsc4py.PETSc.SNES> residual evaluation function.
Not collective.
- function (SNESFunction <#petsc4py.typing.SNESFunction>) -- The callback.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
See also:
Source code at petsc4py/PETSc/DM.pyx:2337 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L2337>
- setSNESJacobian(jacobian, args=None, kargs=None)
- Set the SNES <#petsc4py.PETSc.SNES> Jacobian evaluation
function.
Not collective.
- jacobian (SNESJacobianFunction <#petsc4py.typing.SNESJacobianFunction>) -- The Jacobian callback.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
See also:
Source code at petsc4py/PETSc/DM.pyx:2369 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L2369>
- setSectionSF(sf)
- 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>
- Parameters
- sf (SF <#petsc4py.PETSc.SF>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setType(dm_type)
- Build a DM.
Collective.
- Parameters
- dm_type (Type <#petsc4py.PETSc.DM.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of DM.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
Notes
DM types are available in DM.Type <#petsc4py.PETSc.DM.Type> class.
See also:
Source code at petsc4py/PETSc/DM.pyx:169 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L169>
- setUp()
- Return the data structure.
Collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:324 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L324>
- setVecType(vec_type)
- Set the type of vector.
Logically collective.
See also:
Source code at petsc4py/PETSc/DM.pyx:784 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L784>
- Parameters
- vec_type (Type <#petsc4py.PETSc.Vec.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- view(viewer=None)
- View the DM.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- The DM viewer.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DM.pyx:76 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L76>
Attributes Documentation
- appctx
- Application context.
Source code at petsc4py/PETSc/DM.pyx:2453 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L2453>
- ds
- Discrete space.
Source code at petsc4py/PETSc/DM.pyx:2463 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DM.pyx#L2463>
petsc4py.PETSc.DMComposite¶
- class 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
- addDM(dm, *args)
- Add a DM vector to the composite.
Collective.
- dm (DM <#petsc4py.PETSc.DM>) -- The DM object.
- *args (DM <#petsc4py.PETSc.DM>) -- Additional DM objects.
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(comm=None)
- Create a composite object.
Collective.
- Parameters
- 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>.
- Return type
- 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(gvec, imode, lvecs)
- Gather split local vectors into a coupled global vector.
Collective.
- gvec (Vec <#petsc4py.PETSc.Vec>) -- The global vector.
- imode (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- The insertion mode.
- lvecs (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Vec <#petsc4py.PETSc.Vec>]) -- The individual sequential vectors.
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>
- getAccess(gvec, locs=None)
- 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).
- gvec (Vec <#petsc4py.PETSc.Vec>) -- The global vector.
- locs (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | None <https://docs.python.org/3/library/constants.html#None>) -- Indices of vectors wanted, or None <https://docs.python.org/3/library/constants.html#None> to get all vectors.
Source code at petsc4py/PETSc/DMComposite.pyx:219 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMComposite.pyx#L219>
- getEntries()
- 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 type
- list <https://docs.python.org/3/library/stdtypes.html#list>[DM <#petsc4py.PETSc.DM>]
- getGlobalISs()
- 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 type
- list <https://docs.python.org/3/library/stdtypes.html#list>[IS <#petsc4py.PETSc.IS>]
- getLGMaps()
- 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 type
- list <https://docs.python.org/3/library/stdtypes.html#list>[LGMap <#petsc4py.PETSc.LGMap>]
- getLocalISs()
- 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>
- Return type
- list <https://docs.python.org/3/library/stdtypes.html#list>[IS <#petsc4py.PETSc.IS>]
- getNumber()
- Get number of sub-DMs contained in the composite.
Not collective.
See also:
Source code at petsc4py/PETSc/DMComposite.pyx:51 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMComposite.pyx#L51>
- scatter(gvec, lvecs)
- Scatter coupled global vector into split local vectors.
Collective.
- gvec (Vec <#petsc4py.PETSc.Vec>) -- The global vector.
- lvecs (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Vec <#petsc4py.PETSc.Vec>]) -- Array of local vectors.
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¶
- class 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¶
- class petsc4py.PETSc.DMDA.ElementType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Element types.
Attributes Summary
P1 Constant P1 of type int <https://docs.python.org/3/library/functions.html#int> Q1 Constant Q1 of type int <https://docs.python.org/3/library/functions.html#int> Attributes Documentation
petsc4py.PETSc.DMDA.InterpolationType¶
- class petsc4py.PETSc.DMDA.InterpolationType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Interpolation types.
Attributes Summary
Q0 Constant Q0 of type int <https://docs.python.org/3/library/functions.html#int> Q1 Constant Q1 of type int <https://docs.python.org/3/library/functions.html#int> Attributes Documentation
petsc4py.PETSc.DMDA.StencilType¶
- class petsc4py.PETSc.DMDA.StencilType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Stencil types.
Attributes Summary
BOX Constant BOX of type int <https://docs.python.org/3/library/functions.html#int> STAR Constant STAR of type int <https://docs.python.org/3/library/functions.html#int> Attributes Documentation
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(dim=None, dof=None, sizes=None, proc_sizes=None, boundary_type=None, stencil_type=None, stencil_width=None, setup=True, ownership_ranges=None, comm=None)
- 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)
- dim (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- The number of dimensions.
- dof (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- The number of degrees of freedom.
- sizes (DimsSpec <#petsc4py.typing.DimsSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- The number of elements in each dimension.
- proc_sizes (DimsSpec <#petsc4py.typing.DimsSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- The number of processes in x, y, z dimensions.
- boundary_type (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[DM.BoundaryType <#petsc4py.PETSc.DM.BoundaryType> | int <https://docs.python.org/3/library/functions.html#int> | str <https://docs.python.org/3/library/stdtypes.html#str> | bool <https://docs.python.org/3/library/functions.html#bool>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- The boundary types.
- stencil_type (StencilType <#petsc4py.PETSc.DMDA.StencilType> | None <https://docs.python.org/3/library/constants.html#None>) -- The ghost/halo stencil type.
- stencil_width (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- The width of the ghost/halo region.
- setup (bool <https://docs.python.org/3/library/functions.html#bool>) -- Whether to call the setup routine after creating the object.
- ownership_ranges (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Sequence[int <https://docs.python.org/3/library/functions.html#int>], ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Local x, y, z element counts, of length equal to proc_sizes, summing to sizes.
- 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>.
- Return type
- 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>
- createNaturalVec()
- 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>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- duplicate(dof=None, boundary_type=None, stencil_type=None, stencil_width=None)
- 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.
- dof (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- The number of degrees of freedom.
- boundary_type (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[DM.BoundaryType <#petsc4py.PETSc.DM.BoundaryType> | int <https://docs.python.org/3/library/functions.html#int> | str <https://docs.python.org/3/library/stdtypes.html#str> | bool <https://docs.python.org/3/library/functions.html#bool>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Boundary types.
- stencil_type (StencilType <#petsc4py.PETSc.DMDA.StencilType> | None <https://docs.python.org/3/library/constants.html#None>) -- The ghost/halo stencil type.
- stencil_width (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- The width of the ghost/halo region.
- Return type
- 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>
- getAO()
- 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>
- Return type
- AO <#petsc4py.PETSc.AO>
- getBoundaryType()
- Return the type of ghost nodes at boundary in each dimension.
Not collective.
See also:
Source code at petsc4py/PETSc/DMDA.pyx:407 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L407>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[BoundaryType <#petsc4py.PETSc.DM.BoundaryType>, ...]
- getCoordinateName(index)
- Return the name of a coordinate dimension.
Not collective.
- Parameters
- index (int <https://docs.python.org/3/library/functions.html#int>) -- The coordinate number for the DMDA (0, 1, ..., dim-1).
- Return type
- 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>
- getCorners()
- 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:
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 type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, ...], tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, ...]]
- getDim()
- Return the topological dimension.
Not collective.
See also:
Source code at petsc4py/PETSc/DMDA.pyx:234 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L234>
- getDof()
- 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>
- getElementType()
- 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>
- Return type
- ElementType <#petsc4py.PETSc.DMDA.ElementType>
- getElements(elem_type=None)
- 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.
- Parameters
- elem_type (ElementType <#petsc4py.PETSc.DMDA.ElementType> | None <https://docs.python.org/3/library/constants.html#None>) -- The element type.
- Return 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>
- getFieldName(field)
- Return the name of an individual field component.
Not collective.
- Parameters
- 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.
- Return type
- 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>
- getGhostCorners()
- 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:
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 type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, ...], tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, ...]]
- getGhostRanges()
- Return the ranges of the local region in each dimension, including ghost
nodes.
Not collective.
See also:
Source code at petsc4py/PETSc/DMDA.pyx:577 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L577>
- getInterpolationType()
- Return the type of interpolation.
Not collective.
See also:
Source code at petsc4py/PETSc/DMDA.pyx:1020 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L1020>
- Return type
- InterpolationType <#petsc4py.PETSc.DMDA.InterpolationType>
- getOwnershipRanges()
- 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:
Source code at petsc4py/PETSc/DMDA.pyx:597 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L597>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[ArrayInt <#petsc4py.typing.ArrayInt>, ...]
- getProcSizes()
- Return the number of processes in each dimension.
Not collective.
See also:
Source code at petsc4py/PETSc/DMDA.pyx:361 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L361>
- getRanges()
- Return the ranges of the owned local region in each dimension.
Not collective.
Excluding ghost nodes.
See also:
Source code at petsc4py/PETSc/DMDA.pyx:555 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L555>
- getRefinementFactor()
- 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>
- getScatter()
- 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>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Scatter <#petsc4py.PETSc.Scatter>, Scatter <#petsc4py.PETSc.Scatter>]
- getSizes()
- Return the number of grid points in each dimension.
Not collective.
See also:
Source code at petsc4py/PETSc/DMDA.pyx:311 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L311>
- getStencil()
- Return the stencil type and width.
Not collective.
See also:
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 type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[StencilType <#petsc4py.PETSc.DMDA.StencilType>, int <https://docs.python.org/3/library/functions.html#int>]
- getStencilType()
- 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>
- Return type
- StencilType <#petsc4py.PETSc.DMDA.StencilType>
- getStencilWidth()
- Return the stencil width.
Not collective.
See also:
Source code at petsc4py/PETSc/DMDA.pyx:486 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L486>
- getVecArray(vec, readonly=False)
- Get access to the vector as laid out on a N-d grid.
Logically collective.
- vec (Vec <#petsc4py.PETSc.Vec>) -- The vector to which access is being requested.
- readonly (bool <https://docs.python.org/3/library/functions.html#bool>) -- Request read-only access.
See also:
Source code at petsc4py/PETSc/DMDA.pyx:723 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L723>
- globalToNatural(vg, vn, addv=None)
- 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.
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>
- naturalToGlobal(vn, vg, addv=None)
- 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.
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>
- setBoundaryType(boundary_type)
- Set the type of ghost nodes on domain boundaries.
Not collective.
- Parameters
- boundary_type (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[BoundaryType <#petsc4py.PETSc.DM.BoundaryType> | int <https://docs.python.org/3/library/functions.html#int> | str <https://docs.python.org/3/library/stdtypes.html#str> | bool <https://docs.python.org/3/library/functions.html#bool>, ...]) -- The boundary type in (x), (x, y), or (x, y, z) dimensions.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setCoordinateName(index, name)
- Set the name of the coordinate dimension.
Logically collective.
- index (int <https://docs.python.org/3/library/functions.html#int>) -- The coordinate number for the DMDA (0, 1, ..., dim-1).
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The name of the coordinate.
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>
- setDim(dim)
- Set the topological dimension.
Collective.
- Parameters
- dim (int <https://docs.python.org/3/library/functions.html#int>) -- Topological dimension.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMDA.pyx:217 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L217>
- setDof(dof)
- Set the number of degrees of freedom per vertex.
Not collective.
- Parameters
- dof (int <https://docs.python.org/3/library/functions.html#int>) -- The number of degrees of freedom.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setElementType(elem_type)
- 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>
- Parameters
- elem_type (ElementType <#petsc4py.PETSc.DMDA.ElementType> | str <https://docs.python.org/3/library/stdtypes.html#str>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setFieldName(field, name)
- Set the name of individual field components.
Logically 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.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The name of the field (component).
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>
- setInterpolationType(interp_type)
- 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>.
- Parameters
- interp_type (InterpolationType <#petsc4py.PETSc.DMDA.InterpolationType>) -- The interpolation type.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMDA.pyx:999 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L999>
- setProcSizes(proc_sizes)
- Set the number of processes in each dimension.
Logically collective.
- Parameters
- proc_sizes (DimsSpec <#petsc4py.typing.DimsSpec>) -- The number of processes in (x,), (x, y), or (x, y, z) dimensions.
- Return type
- 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>
- setRefinementFactor(refine_x=2, refine_y=2, refine_z=2)
- Set the ratios for the DMDA grid refinement.
Logically collective.
- refine_x (int <https://docs.python.org/3/library/functions.html#int>) -- Ratio of fine grid to coarse in x dimension.
- refine_y (int <https://docs.python.org/3/library/functions.html#int>) -- Ratio of fine grid to coarse in y dimension.
- refine_z (int <https://docs.python.org/3/library/functions.html#int>) -- Ratio of fine grid to coarse in z dimension.
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>
- setSizes(sizes)
- Set the number of grid points in each dimension.
Logically collective.
- Parameters
- sizes (DimsSpec <#petsc4py.typing.DimsSpec>) -- The global (x,), (x, y), or (x, y, z) size.
- Return type
- 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>
- setStencil(stencil_type, stencil_width)
- Set the stencil type and width.
Not collective.
- stencil_type (StencilType <#petsc4py.PETSc.DMDA.StencilType>) -- The stencil type.
- stencil_width (int <https://docs.python.org/3/library/functions.html#int>) -- The stencil width.
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>
- setStencilType(stencil_type)
- Set the stencil type.
Logically collective.
- stype -- The stencil type.
- stencil_type (StencilType <#petsc4py.PETSc.DMDA.StencilType>)
See also:
Source code at petsc4py/PETSc/DMDA.pyx:430 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L430>
- setStencilWidth(stencil_width)
- Set the stencil width.
Logically collective.
- Parameters
- stencil_width (int <https://docs.python.org/3/library/functions.html#int>) -- The stencil width.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMDA.pyx:468 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L468>
- setUniformCoordinates(xmin=0, xmax=1, ymin=0, ymax=1, zmin=0, zmax=1)
- Set the DMDA coordinates to be a uniform grid.
Collective.
- xmin (float <https://docs.python.org/3/library/functions.html#float>) -- The minimum in the x dimension.
- xmax (float <https://docs.python.org/3/library/functions.html#float>) -- The maximum in the x dimension.
- ymin (float <https://docs.python.org/3/library/functions.html#float>) -- The minimum in the y dimension (value ignored for 1 dimensional problems).
- ymax (float <https://docs.python.org/3/library/functions.html#float>) -- The maximum in the y dimension (value ignored for 1 dimensional problems).
- zmin (float <https://docs.python.org/3/library/functions.html#float>) -- The minimum in the z dimension (value ignored for 1 or 2 dimensional problems).
- zmax (float <https://docs.python.org/3/library/functions.html#float>) -- The maximum in the z dimension (value ignored for 1 or 2 dimensional problems).
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_type
- 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>
- corners
- 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>
- dim
- 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>
- dof
- 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>
- ghost_corners
- 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>
- ghost_ranges
- 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>
- proc_sizes
- 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
- 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>
- sizes
- 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
- 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>
- stencil_type
- Stencil type.
Source code at petsc4py/PETSc/DMDA.pyx:1133 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMDA.pyx#L1133>
- stencil_width
- 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¶
- class 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(comm=None)
- Create a DMInterpolation context.
Collective.
- Parameters
- 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>.
- Return type
- 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>
- destroy()
- Destroy the DMInterpolation context.
Collective.
See also:
Source code at petsc4py/PETSc/DMUtils.pyx:35 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMUtils.pyx#L35>
- evaluate(dm, x, v=None)
- 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.
- Return type
- 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>
- getCoordinates()
- 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>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- getDim()
- 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>
- getDof()
- 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>
- getVector()
- 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>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- restoreVector(vec)
- Restore a Vec which can hold all the interpolated field values.
Collective.
- Parameters
- vec (Vec <#petsc4py.PETSc.Vec>) -- A vector capable of holding the interpolated field values.
- Return type
- 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>
- setDim(dim)
- Set the spatial dimension for the interpolation context.
Not collective.
- Parameters
- dim (int <https://docs.python.org/3/library/functions.html#int>) -- The spatial dimension.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setDof(dof)
- Set the number of fields interpolated at a point.
Not collective.
- Parameters
- dof (int <https://docs.python.org/3/library/functions.html#int>) -- The number of fields.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setUp(dm, redundantPoints=False, ignoreOutsideDomain=False)
- Compute spatial indices for point location during interpolation.
Collective.
- dm (DM <#petsc4py.PETSc.DM>) -- The DM for the function space used for interpolation.
- redundantPoints (bool <https://docs.python.org/3/library/functions.html#bool>) -- If True <https://docs.python.org/3/library/constants.html#True>, all processes are passing in the same array of points. Otherwise, points need to be communicated among processes.
- ignoreOutsideDomain (bool <https://docs.python.org/3/library/functions.html#bool>) -- Ignore points outside of the domain if True <https://docs.python.org/3/library/constants.html#True>; otherwise, return an error.
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¶
- class 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
- addStrata(strata)
- Add new stratum values in a DMLabel.
Not collective.
- Parameters
- strata (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- The stratum values.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMLabel.pyx:238 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L238>
- addStrataIS(iset)
- Add new stratum values in a DMLabel.
Not collective.
- Parameters
- iset (IS <#petsc4py.PETSc.IS>) -- Index set with stratum values.
- Return type
- 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>
- addStratum(value)
- Add a new stratum value in a DMLabel.
Not collective.
- Parameters
- value (int <https://docs.python.org/3/library/functions.html#int>) -- The stratum value.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMLabel.pyx:220 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L220>
- clearStratum(stratum)
- Remove a stratum.
Not collective.
- Parameters
- stratum (int <https://docs.python.org/3/library/functions.html#int>) -- The stratum value.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMLabel.pyx:406 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L406>
- clearValue(point, value)
- Clear the value a label assigns to a point.
Not collective.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- value (int <https://docs.python.org/3/library/functions.html#int>) -- The point value.
See also:
Source code at petsc4py/PETSc/DMLabel.pyx:199 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L199>
- computeIndex()
- 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>
- convertToSection()
- 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>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Section <#petsc4py.PETSc.Section>, IS <#petsc4py.PETSc.IS>]
- create(name, comm=None)
- Create a DMLabel object, which is a multimap.
Collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The label name.
- 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>.
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>
- createIndex(pStart, pEnd)
- Create an index structure for membership determination.
Not collective.
- pStart (int <https://docs.python.org/3/library/functions.html#int>) -- The smallest point.
- pEnd (int <https://docs.python.org/3/library/functions.html#int>) -- The largest point + 1.
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>
- destroy()
- Destroy the label.
Collective.
See also:
Source code at petsc4py/PETSc/DMLabel.pyx:8 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L8>
- destroyIndex()
- Destroy the index structure.
Not collective.
See also:
Source code at petsc4py/PETSc/DMLabel.pyx:458 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L458>
- distribute(sf)
- Create a new label pushed forward over the SF
<#petsc4py.PETSc.SF>.
Collective.
- Parameters
- sf (SF <#petsc4py.PETSc.SF>) -- The map from old to new distribution.
- Return type
- 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()
- 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>
- Return type
- DMLabel <#petsc4py.PETSc.DMLabel>
- filter(start, end)
- Remove all points outside of [start, end).
Not collective.
- start (int <https://docs.python.org/3/library/functions.html#int>) -- The first point kept.
- end (int <https://docs.python.org/3/library/functions.html#int>) -- One more than the last point kept.
See also:
Source code at petsc4py/PETSc/DMLabel.pyx:528 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L528>
- gather(sf)
- Gather all label values from leaves into roots.
Collective.
This is the inverse operation to distribute.
- Parameters
- sf (SF <#petsc4py.PETSc.SF>) -- The SF <#petsc4py.PETSc.SF> communication map.
- Return type
- 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>
- getBounds()
- 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>
- getDefaultValue()
- 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>
- getNonEmptyStratumValuesIS()
- 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>
- Return type
- IS <#petsc4py.PETSc.IS>
- getNumValues()
- Return the number of values that the DMLabel takes.
Not collective.
See also:
Source code at petsc4py/PETSc/DMLabel.pyx:275 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L275>
- getStratumIS(stratum)
- Return an IS <#petsc4py.PETSc.IS> with the stratum points.
Not collective.
- Parameters
- stratum (int <https://docs.python.org/3/library/functions.html#int>) -- The stratum value.
- Return type
- 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>
- getStratumSize(stratum)
- Return the size of a stratum.
Not collective.
- Parameters
- stratum (int <https://docs.python.org/3/library/functions.html#int>) -- The stratum value.
- Return type
- int <https://docs.python.org/3/library/functions.html#int>
See also:
Source code at petsc4py/PETSc/DMLabel.pyx:346 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L346>
- getValue(point)
- 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.
- Parameters
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- Return type
- int <https://docs.python.org/3/library/functions.html#int>
See also:
Source code at petsc4py/PETSc/DMLabel.pyx:137 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L137>
- getValueIS()
- 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>
- Return type
- IS <#petsc4py.PETSc.IS>
- hasPoint(point)
- Determine whether the label contains a point.
Not collective.
The user must call createIndex before this function.
- Parameters
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- Return type
- bool <https://docs.python.org/3/library/functions.html#bool>
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>
- hasStratum(value)
- Determine whether points exist with the given value.
Not collective.
- Parameters
- value (int <https://docs.python.org/3/library/functions.html#int>) -- The stratum value.
- Return type
- bool <https://docs.python.org/3/library/functions.html#bool>
See also:
Source code at petsc4py/PETSc/DMLabel.pyx:326 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L326>
- hasValue(value)
- Determine whether a label assigns the value to any point.
Not collective.
- Parameters
- value (int <https://docs.python.org/3/library/functions.html#int>) -- The value.
- Return type
- bool <https://docs.python.org/3/library/functions.html#bool>
See also:
Source code at petsc4py/PETSc/DMLabel.pyx:470 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L470>
- insertIS(iset, value)
- Set all points in the IS <#petsc4py.PETSc.IS> to a value.
Not collective.
- iset (IS <#petsc4py.PETSc.IS>) -- The point IS.
- value (int <https://docs.python.org/3/library/functions.html#int>) -- The point value.
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>
- permute(permutation)
- Create a new label with permuted points.
Not collective.
- Parameters
- permutation (IS <#petsc4py.PETSc.IS>) -- The point permutation.
- Return type
- 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>
- reset()
- Destroy internal data structures in the DMLabel.
Not collective.
See also:
Source code at petsc4py/PETSc/DMLabel.pyx:79 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L79>
- setDefaultValue(value)
- 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.
- Parameters
- value (int <https://docs.python.org/3/library/functions.html#int>) -- The default value.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setStratumIS(stratum, iset)
- Set the stratum points using an IS <#petsc4py.PETSc.IS>.
Not collective.
- stratum (int <https://docs.python.org/3/library/functions.html#int>) -- The stratum value.
- iset (IS <#petsc4py.PETSc.IS>) -- The stratum points.
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>
- setValue(point, value)
- 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.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- value (int <https://docs.python.org/3/library/functions.html#int>) -- The point value.
See also:
Source code at petsc4py/PETSc/DMLabel.pyx:112 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L112>
- stratumHasPoint(value, point)
- Return whether the stratum contains a point.
Not collective.
- value (int <https://docs.python.org/3/library/functions.html#int>) -- The stratum value.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
See also:
Source code at petsc4py/PETSc/DMLabel.pyx:303 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMLabel.pyx#L303>
- view(viewer=None)
- View the label.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the graph.
- Return type
- 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¶
- class 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
- computeCellGeometryFVM(cell)
- Compute the volume for a given cell.
Not collective.
- Parameters
- cell (int <https://docs.python.org/3/library/functions.html#int>) -- The cell.
- Returns
- volume (float <https://docs.python.org/3/library/functions.html#float>) -- The cell volume.
- centroid (ArrayReal <#petsc4py.typing.ArrayReal>) -- The cell centroid.
- normal (ArrayReal <#petsc4py.typing.ArrayReal>) -- The cell normal, if appropriate.
- Return type
- 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:
Source code at petsc4py/PETSc/DMPlex.pyx:2241 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2241>
- computeGradientClementInterpolant(locX, locC)
- 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.
- Return type
- Vec <#petsc4py.PETSc.Vec>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:3175 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3175>
- constructGhostCells(labelName=None)
- Construct ghost cells which connect to every boundary face.
Collective.
- Parameters
- 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".
- Returns
- numGhostCells -- The number of ghost cells added to the DMPlex.
- Return type
- int <https://docs.python.org/3/library/functions.html#int>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2273 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2273>
- coordinatesLoad(viewer, sfxc)
- 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.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:3348 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3348>
- coordinatesView(viewer)
- Save DMPlex coordinates into a file.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer>) -- The Viewer <#petsc4py.PETSc.Viewer> for saving.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
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(comm=None)
- Create a DMPlex object, which encapsulates an unstructured mesh.
Collective.
- Parameters
- 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>.
- Return type
- Self <https://docs.python.org/3/library/typing.html#typing.Self>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:14 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L14>
- createBoxMesh(faces, lower=(0, 0, 0), upper=(1, 1, 1), simplex=True, periodic=False, interpolate=True, localizationHeight=0, sparseLocalize=True, comm=None)
- Create a mesh on the tensor product of intervals.
Collective.
- faces (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Number of faces per dimension, or None <https://docs.python.org/3/library/constants.html#None> for the default.
- lower (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[float <https://docs.python.org/3/library/functions.html#float>] | None <https://docs.python.org/3/library/constants.html#None>) -- The lower left corner.
- upper (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[float <https://docs.python.org/3/library/functions.html#float>] | None <https://docs.python.org/3/library/constants.html#None>) -- The upper right corner.
- simplex (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- True <https://docs.python.org/3/library/constants.html#True> for simplices, False <https://docs.python.org/3/library/constants.html#False> for tensor cells.
- periodic (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence> | str <https://docs.python.org/3/library/stdtypes.html#str> | int <https://docs.python.org/3/library/functions.html#int> | bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- The boundary type for the X, Y, Z direction, or None <https://docs.python.org/3/library/constants.html#None> for DM.BoundaryType.NONE <#petsc4py.PETSc.DM.BoundaryType.NONE>.
- interpolate (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Flag to create intermediate mesh entities (edges, faces).
- localizationHeight (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Flag to localize edges and faces in addition to cells; only significant for periodic meshes.
- sparseLocalize (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Flag to localize coordinates only for cells near the periodic boundary; only significant for periodic meshes.
- 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>.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:90 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L90>
- createBoxSurfaceMesh(faces, lower=(0, 0, 0), upper=(1, 1, 1), interpolate=True, comm=None)
- Create a mesh on the surface of a box mesh using tensor cells.
Collective.
- faces (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Number of faces per dimension, or None <https://docs.python.org/3/library/constants.html#None> for the default.
- lower (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[float <https://docs.python.org/3/library/functions.html#float>] | None <https://docs.python.org/3/library/constants.html#None>) -- The lower left corner.
- upper (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[float <https://docs.python.org/3/library/functions.html#float>] | None <https://docs.python.org/3/library/constants.html#None>) -- The upper right corner.
- interpolate (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Flag to create intermediate mesh pieces (edges, faces).
- 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>.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:149 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L149>
- createCGNS(cgid, interpolate=True, comm=None)
- Create a DMPlex mesh from a CGNS file.
Collective.
- cgid (int <https://docs.python.org/3/library/functions.html#int>) -- The CG id associated with a file and obtained using cg_open.
- interpolate (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Create faces and edges in the mesh.
- 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>.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:226 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L226>
- createCGNSFromFile(filename, interpolate=True, comm=None)
- "Create a DMPlex mesh from a CGNS file.
Collective.
- filename (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The name of the CGNS file.
- interpolate (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Create faces and edges in the mesh.
- 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>.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:254 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L254>
- createClosureIndex(sec)
- Calculate an index for sec for the closure operation.
Not collective.
- Parameters
- 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.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2055 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2055>
- createCoarsePointIS()
- Create an IS <#petsc4py.PETSc.IS> covering the coarse
DMPlex chart with the fine points as data.
Collective.
- Returns
- fpointIS -- The IS <#petsc4py.PETSc.IS> of all the fine points which exist in the original coarse mesh.
- Return type
- IS <#petsc4py.PETSc.IS>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1841 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1841>
- createCohesiveSubmesh(hasLagrange, value)
- Extract the hypersurface defined by one face of the cohesive cells.
Collective.
- hasLagrange (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag indicating whether the mesh has Lagrange dofs in the cohesive cells.
- value (int <https://docs.python.org/3/library/functions.html#int>) -- A label value.
- Return type
- DMPlex <#petsc4py.PETSc.DMPlex>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:401 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L401>
- createCoordinateSpace(degree, localized, project)
- Create a finite element space for the coordinates.
Collective.
- degree (int <https://docs.python.org/3/library/functions.html#int>) -- The degree of the finite element.
- localized (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag to create a localized (DG) coordinate space.
- project (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag to project current coordinates into the space.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:377 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L377>
- createExodus(exoid, interpolate=True, comm=None)
- Create a DMPlex mesh from an ExodusII file ID.
Collective.
- exoid (int <https://docs.python.org/3/library/functions.html#int>) -- The ExodusII id associated with a file obtained using ex_open.
- interpolate (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Create faces and edges in the mesh,
- 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>.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:312 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L312>
- createExodusFromFile(filename, interpolate=True, comm=None)
- Create a DMPlex mesh from an ExodusII file.
Collective.
- filename (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The name of the ExodusII file.
- interpolate (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Create faces and edges in the mesh.
- 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>.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:283 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L283>
- createFromCellList(dim, cells, coords, interpolate=True, comm=None)
- Create a DMPlex from a list of vertices for each cell on process 0.
Collective.
- dim (int <https://docs.python.org/3/library/functions.html#int>) -- The topological dimension of the mesh.
- cells (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- An array of number of cells times number of vertices on each cell.
- coords (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[float <https://docs.python.org/3/library/functions.html#float>]) -- An array of number of vertices times spatial dimension for coordinates.
- interpolate (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Flag to interpolate the mesh.
- 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>.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:35 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L35>
- createFromFile(filename, plexname='unnamed', interpolate=True, comm=None)
- Create DMPlex from a file.
Collective.
- filename (str <https://docs.python.org/3/library/stdtypes.html#str>) -- A file name.
- plexname (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The name of the resulting DMPlex, also used for intra-datafile lookup by some formats.
- interpolate (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Flag to create intermediate mesh pieces (edges, faces).
- 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>.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:192 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L192>
- createGmsh(viewer, interpolate=True, comm=None)
- Create a DMPlex mesh from a Gmsh file viewer.
Collective.
- viewer (Viewer <#petsc4py.PETSc.Viewer>) -- The Viewer <#petsc4py.PETSc.Viewer> associated with a Gmsh file.
- interpolate (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Create faces and edges in the mesh.
- 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>.
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:
Source code at petsc4py/PETSc/DMPlex.pyx:339 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L339>
- createPointNumbering()
- Create a global numbering for all points.
Collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:939 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L939>
- Return type
- IS <#petsc4py.PETSc.IS>
- createSection(numComp, numDof, bcField=None, bcComps=None, bcPoints=None, perm=None)
- Create a Section <#petsc4py.PETSc.Section> based upon the DOF
layout specification provided.
Not collective.
- numComp (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- An array of size numFields holding the number of components per field.
- numDof (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- An array of size numFields*(dim+1) holding the number of DOFs per field on a mesh piece of dimension dim.
- bcField (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | None <https://docs.python.org/3/library/constants.html#None>) -- An array of size numBC giving the field number for each boundary condition, where numBC is the number of boundary conditions.
- bcComps (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[IS <#petsc4py.PETSc.IS>] | None <https://docs.python.org/3/library/constants.html#None>) -- An array of size numBC giving an IS <#petsc4py.PETSc.IS> holding the field components to which each boundary condition applies.
- bcPoints (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[IS <#petsc4py.PETSc.IS>] | None <https://docs.python.org/3/library/constants.html#None>) -- An array of size numBC giving an IS <#petsc4py.PETSc.IS> holding the DMPlex points to which each boundary condition applies.
- perm (IS <#petsc4py.PETSc.IS> | None <https://docs.python.org/3/library/constants.html#None>) -- Permutation of the chart.
- Return type
- Section <#petsc4py.PETSc.Section>
See also:
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(overlap=0)
- Distribute the mesh and any associated sections.
Collective.
- Parameters
- 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.
- Returns
- sf -- The SF <#petsc4py.PETSc.SF> used for point distribution, or None <https://docs.python.org/3/library/constants.html#None> if not distributed.
- Return type
- SF <#petsc4py.PETSc.SF> or None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1585 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1585>
- distributeField(sf, sec, vec, newsec=None, newvec=None)
- 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.
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Section <#petsc4py.PETSc.Section>, Vec <#petsc4py.PETSc.Vec>]
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1782 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1782>
- distributeGetDefault()
- Return a flag indicating whether the DM <#petsc4py.PETSc.DM>
should be distributed by default.
Not collective.
- Returns
- dist -- Flag indicating whether the DMPlex should be distributed by default.
- Return type
- bool <https://docs.python.org/3/library/functions.html#bool>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1671 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1671>
- distributeOverlap(overlap=0)
- Add partition overlap to a distributed non-overlapping DMPlex.
Collective.
- Parameters
- 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).
- Returns
- sf -- The SF <#petsc4py.PETSc.SF> used for point distribution.
- Return type
- SF <#petsc4py.PETSc.SF>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1613 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1613>
- distributeSetDefault(flag)
- Set flag indicating whether the DMPlex should be distributed by
default.
Logically collective.
- Parameters
- flag (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag indicating whether the DMPlex should be distributed by default.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1691 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1691>
- distributionGetName()
- Retrieve the name of the specific parallel distribution.
Not collective.
- Returns
- name -- The name of the specific parallel distribution.
- Return type
- str <https://docs.python.org/3/library/stdtypes.html#str>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1732 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1732>
- distributionSetName(name)
- Set the name of the specific parallel distribution.
Logically collective.
- Parameters
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The name of the specific parallel distribution.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
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(boundary, name=None, interpolate=True)
- Generate a mesh.
Not collective.
- boundary (DMPlex <#petsc4py.PETSc.DMPlex>) -- The DMPlex boundary object.
- name (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The mesh generation package name.
- interpolate (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Flag to create intermediate mesh elements.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1308 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1308>
- getAdjacency(p)
- Return all points adjacent to the given point.
Not collective.
- Parameters
- p (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- Return type
- ArrayInt <#petsc4py.typing.ArrayInt>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1491 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1491>
- getAdjacencyUseAnchors()
- Query whether adjacency in the mesh uses the point-to-point constraints.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1476 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1476>
- getCellNumbering()
- Return a global cell numbering for all cells on this process.
Collective the first time it is called.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:909 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L909>
- Return type
- IS <#petsc4py.PETSc.IS>
- getCellType(p)
- Return the polytope type of a given cell.
Not collective.
- Parameters
- p (int <https://docs.python.org/3/library/functions.html#int>) -- The cell.
- Return type
- PolytopeType <#petsc4py.PETSc.DM.PolytopeType>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:709 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L709>
- getCellTypeLabel()
- Return the DMLabel <#petsc4py.PETSc.DMLabel> recording the
polytope type of each cell.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:730 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L730>
- Return type
- DMLabel <#petsc4py.PETSc.DMLabel>
- getChart()
- Return the interval for all mesh points [pStart, pEnd).
Not collective.
- pStart (int <https://docs.python.org/3/library/functions.html#int>) -- The first mesh point.
- pEnd (int <https://docs.python.org/3/library/functions.html#int>) -- The upper bound for mesh points.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:424 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L424>
- getCone(p)
- Return the points on the in-edges for this point in the DAG.
Not collective.
- Parameters
- p (int <https://docs.python.org/3/library/functions.html#int>) -- The point, which must lie in the chart set with DMPlex.setChart.
- Return type
- ArrayInt <#petsc4py.typing.ArrayInt>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:515 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L515>
- getConeOrientation(p)
- Return the orientations on the in-edges for this point in the DAG.
Not collective.
- Parameters
- p (int <https://docs.python.org/3/library/functions.html#int>) -- The point, which must lie in the chart set with DMPlex.setChart.
- Return type
- ArrayInt <#petsc4py.typing.ArrayInt>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:630 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L630>
- getConeSize(p)
- Return the number of in-edges for this point in the DAG.
Not collective.
- Parameters
- p (int <https://docs.python.org/3/library/functions.html#int>) -- The point, which must lie in the chart set with DMPlex.setChart.
- Return type
- int <https://docs.python.org/3/library/functions.html#int>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:466 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L466>
- getDepth()
- Return the depth of the DAG representing this mesh.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:953 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L953>
- getDepthStratum(svalue)
- Return the bounds [start, end) for all points at a certain
depth.
Not collective.
- Parameters
- svalue (int <https://docs.python.org/3/library/functions.html#int>) -- The requested depth.
- Returns
- pStart (int <https://docs.python.org/3/library/functions.html#int>) -- The first stratum point.
- pEnd (int <https://docs.python.org/3/library/functions.html#int>) -- The upper bound for stratum points.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:968 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L968>
- getFullJoin(points)
- Return an array for the join of the set of points.
Not collective.
- Parameters
- 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.
- Return type
- ArrayInt <#petsc4py.typing.ArrayInt>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1116 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1116>
- getHeightStratum(svalue)
- Return the bounds [start, end) for all points at a certain
height.
Not collective.
- Parameters
- svalue (int <https://docs.python.org/3/library/functions.html#int>) -- The requested height.
- Returns
- pStart (int <https://docs.python.org/3/library/functions.html#int>) -- The first stratum point.
- pEnd (int <https://docs.python.org/3/library/functions.html#int>) -- The upper bound for stratum points.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:995 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L995>
- getJoin(points)
- Return an array for the join of the set of points.
Not collective.
- Parameters
- 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.
- Return type
- ArrayInt <#petsc4py.typing.ArrayInt>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1090 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1090>
- getMaxSizes()
- Return the maximum number of in-edges and out-edges of the DAG.
Not collective.
- maxConeSize (int <https://docs.python.org/3/library/functions.html#int>) -- The maximum number of in-edges.
- maxSupportSize (int <https://docs.python.org/3/library/functions.html#int>) -- The maximum number of out-edges.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:850 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L850>
- getMeet(points)
- Return an array for the meet of the set of points.
Not collective.
- Parameters
- 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.
- Return type
- ArrayInt <#petsc4py.typing.ArrayInt>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1064 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1064>
- getMinRadius()
- Return the minimum distance from any cell centroid to a face.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1827 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1827>
- getOrdering(otype)
- Calculate a reordering of the mesh.
Collective.
- Parameters
- otype (OrderingType <#petsc4py.PETSc.Mat.OrderingType>) -- Type of reordering, see Mat.OrderingType <#petsc4py.PETSc.Mat.OrderingType>.
- Returns
- perm -- The point permutation.
- Return type
- IS <#petsc4py.PETSc.IS>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2154 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2154>
- getPartitioner()
- Return the mesh partitioner.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1534 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1534>
- Return type
- Partitioner <#petsc4py.PETSc.Partitioner>
- getPointDepth(point)
- Return the depth of a given point.
Not collective.
- Parameters
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- Return type
- int <https://docs.python.org/3/library/functions.html#int>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1022 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1022>
- getPointGlobal(point)
- Return location of point data in global Vec
<#petsc4py.PETSc.Vec>.
Not collective.
- Parameters
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The topological point.
- Returns
- start (int <https://docs.python.org/3/library/functions.html#int>) -- Start of point data; returns -(globalStart+1) if point is not owned.
- end (int <https://docs.python.org/3/library/functions.html#int>) -- End of point data; returns -(globalEnd+1) if point is not owned.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1996 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1996>
- getPointGlobalField(point, field)
- Return location of point field data in global Vec
<#petsc4py.PETSc.Vec>.
Not collective.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The topological point.
- field (int <https://docs.python.org/3/library/functions.html#int>) -- The field number.
- start (int <https://docs.python.org/3/library/functions.html#int>) -- Start of point data; returns -(globalStart+1) if point is not owned.
- end (int <https://docs.python.org/3/library/functions.html#int>) -- End of point data; returns -(globalEnd+1) if point is not owned.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2024 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2024>
- getPointHeight(point)
- Return the height of a given point.
Not collective.
- Parameters
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- Return type
- int <https://docs.python.org/3/library/functions.html#int>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1043 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1043>
- getPointLocal(point)
- Return location of point data in local Vec
<#petsc4py.PETSc.Vec>.
Not collective.
- Parameters
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The topological point.
- Returns
- start (int <https://docs.python.org/3/library/functions.html#int>) -- Start of point data.
- end (int <https://docs.python.org/3/library/functions.html#int>) -- End of point data.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1937 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1937>
- getPointLocalField(point, field)
- Return location of point field data in local Vec
<#petsc4py.PETSc.Vec>.
Not collective.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The topological point.
- field (int <https://docs.python.org/3/library/functions.html#int>) -- The field number.
- start (int <https://docs.python.org/3/library/functions.html#int>) -- Start of point data.
- end (int <https://docs.python.org/3/library/functions.html#int>) -- End of point data.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1965 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1965>
- getRefinementLimit()
- Retrieve the maximum cell volume for refinement.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2138 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2138>
- getRefinementUniform()
- Retrieve the flag for uniform refinement.
Not collective.
- Returns
- refinementUniform -- The flag for uniform refinement.
- Return type
- bool <https://docs.python.org/3/library/functions.html#bool>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2097 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2097>
- getSubpointIS()
- Return an IS <#petsc4py.PETSc.IS> covering the entire subdm
chart.
Not collective.
- Returns
- iset -- The IS <#petsc4py.PETSc.IS> containing subdm's parent's points.
- Return type
- IS <#petsc4py.PETSc.IS>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2302 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2302>
- getSubpointMap()
- Return a DMLabel <#petsc4py.PETSc.DMLabel> with point
dimension as values.
Not collective.
- Returns
- label -- The DMLabel <#petsc4py.PETSc.DMLabel> whose values are subdm's point dimensions.
- Return type
- DMLabel <#petsc4py.PETSc.DMLabel>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2322 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2322>
- getSupport(p)
- Return the points on the out-edges for this point in the DAG.
Not collective.
- Parameters
- p (int <https://docs.python.org/3/library/functions.html#int>) -- The point, which must lie in the chart set with DMPlex.setChart.
- Return type
- ArrayInt <#petsc4py.typing.ArrayInt>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:795 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L795>
- getSupportSize(p)
- Return the number of out-edges for this point in the DAG.
Not collective.
- Parameters
- p (int <https://docs.python.org/3/library/functions.html#int>) -- The point, which must lie in the chart set with DMPlex.setChart.
- Return type
- int <https://docs.python.org/3/library/functions.html#int>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:746 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L746>
- getTransitiveClosure(p, useCone=True)
- Return the points and orientations on the transitive closure of this
point.
Not collective.
- p (int <https://docs.python.org/3/library/functions.html#int>) -- The mesh point.
- useCone (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- True <https://docs.python.org/3/library/constants.html#True> for the closure, otherwise return the star.
- points (ArrayInt <#petsc4py.typing.ArrayInt>) -- The points.
- orientations (ArrayInt <#petsc4py.typing.ArrayInt>) -- The orientations.
- Return type
- 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/DMPlex.pyx:1142 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1142>
- getVecClosure(sec, vec, point)
- Return an array of the values on the closure of a point.
Not collective.
- sec (Section <#petsc4py.PETSc.Section>) -- The Section <#petsc4py.PETSc.Section> describing the layout in vec or None <https://docs.python.org/3/library/constants.html#None> to use the default section.
- vec (Vec <#petsc4py.PETSc.Vec>) -- The local vector.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point in the DMPlex.
- Return type
- ArrayScalar <#petsc4py.typing.ArrayScalar>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1209 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1209>
- getVertexNumbering()
- Return a global vertex numbering for all vertices on this process.
Collective the first time it is called.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:924 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L924>
- Return type
- IS <#petsc4py.PETSc.IS>
- globalVectorLoad(viewer, sectiondm, sf, vec)
- 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.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:3425 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3425>
- globalVectorView(viewer, sectiondm, vec)
- 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.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:3272 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3272>
- insertCone(p, conePos, conePoint)
- DMPlexInsertCone - Insert a point into the in-edges for the point p 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.
- conePos (int <https://docs.python.org/3/library/functions.html#int>) -- The local index in the cone where the point should be put.
- conePoint (int <https://docs.python.org/3/library/functions.html#int>) -- The mesh point to insert.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:580 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L580>
- insertConeOrientation(p, conePos, coneOrientation)
- Insert a point orientation for the in-edge for the point p 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
- conePos (int <https://docs.python.org/3/library/functions.html#int>) -- The local index in the cone where the point should be put.
- coneOrientation (int <https://docs.python.org/3/library/functions.html#int>) -- The point orientation to insert.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:605 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L605>
- interpolate()
- Convert to a mesh with all intermediate faces, edges, etc.
Collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1752 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1752>
- isDistributed()
- Return the flag indicating if the mesh is distributed.
Collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1642 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1642>
- isSimplex()
- Return the flag indicating if the first cell is a simplex.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1656 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1656>
- labelCohesiveComplete(label, bdlabel, bdvalue, flip, split, subdm)
- 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.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1420 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1420>
- labelComplete(label)
- Add the transitive closure to the surface.
Not collective.
- Parameters
- label (DMLabel <#petsc4py.PETSc.DMLabel>) -- A DMLabel <#petsc4py.PETSc.DMLabel> marking the surface points.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1403 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1403>
- labelsLoad(viewer, sfxc)
- 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.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:3368 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3368>
- labelsView(viewer)
- Save DMPlex labels into a file.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer>) -- The Viewer <#petsc4py.PETSc.Viewer> for saving.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:3233 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3233>
- localVectorLoad(viewer, sectiondm, sf, vec)
- 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.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:3450 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3450>
- localVectorView(viewer, sectiondm, vec)
- 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.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:3296 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3296>
- markBoundaryFaces(label, value=None)
- Mark all faces on the boundary.
Not collective.
- value (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- The marker value, or DETERMINE <#petsc4py.PETSc.DETERMINE> or None <https://docs.python.org/3/library/constants.html#None> to use some value in the closure (or 1 if none are found).
- label (str <https://docs.python.org/3/library/stdtypes.html#str>)
- Return type
- DMLabel <#petsc4py.PETSc.DMLabel>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1376 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1376>
- metricAverage2(metric1, metric2, metricAvg)
- 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.
- Return type
- 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>
- metricAverage3(metric1, metric2, metric3, metricAvg)
- 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.
- Return type
- 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>
- metricCreate(field=0)
- Create a Riemannian metric field.
Collective.
- Parameters
- 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.
- Return type
- Vec <#petsc4py.PETSc.Vec>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2914 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2914>
- metricCreateIsotropic(indicator, field=0)
- Construct an isotropic metric from an error indicator.
Collective.
- indicator (Vec <#petsc4py.PETSc.Vec>) -- The error indicator.
- 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.
- Return type
- Vec <#petsc4py.PETSc.Vec>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2959 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2959>
- metricCreateUniform(alpha, field=0)
- Construct a uniform isotropic metric.
Collective.
- alpha (float <https://docs.python.org/3/library/functions.html#float>) -- Scaling parameter for the diagonal.
- 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.
- Return type
- Vec <#petsc4py.PETSc.Vec>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2935 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2935>
- metricDeterminantCreate(field=0)
- Create the determinant field for a Riemannian metric.
Collective.
- Parameters
- 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.
- Returns
- determinant (Vec <#petsc4py.PETSc.Vec>) -- The determinant field.
- dmDet (DM <#petsc4py.PETSc.DM>) -- The corresponding DM
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, DM <#petsc4py.PETSc.DM>]
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2982 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2982>
- metricEnforceSPD(metric, ometric, determinant, restrictSizes=False, restrictAnisotropy=False)
- Enforce symmetric positive-definiteness of a metric.
Collective.
- metric (Vec <#petsc4py.PETSc.Vec>) -- The metric.
- ometric (Vec <#petsc4py.PETSc.Vec>) -- The output metric.
- determinant (Vec <#petsc4py.PETSc.Vec>) -- The output determinant.
- restrictSizes (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Flag indicating whether maximum/minimum magnitudes should be enforced.
- restrictAnisotropy (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Flag indicating whether maximum anisotropy should be enforced.
- ometric (Vec <#petsc4py.PETSc.Vec>) -- The output metric.
- determinant (Vec <#petsc4py.PETSc.Vec>) -- The output determinant.
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>]
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:3011 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3011>
- metricGetGradationFactor()
- Return the metric gradation factor.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2865 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2865>
- metricGetHausdorffNumber()
- Return the metric Hausdorff number.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2899 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2899>
- metricGetMaximumAnisotropy()
- Return the maximum tolerated metric anisotropy.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2763 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2763>
- metricGetMaximumMagnitude()
- Return the maximum tolerated metric magnitude.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2729 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2729>
- metricGetMinimumMagnitude()
- Return the minimum tolerated metric magnitude.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2695 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2695>
- metricGetNormalizationOrder()
- Return the order p for L-p normalization.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2831 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2831>
- metricGetNumIterations()
- Return the number of parallel adaptation iterations.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2661 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2661>
- metricGetTargetComplexity()
- Return the target metric complexity.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2797 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2797>
- metricGetVerbosity()
- Return the verbosity of the mesh adaptation package.
Not collective.
- Returns
- verbosity -- The verbosity, where -1 is silent and 10 is maximum.
- Return type
- int <https://docs.python.org/3/library/functions.html#int>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2622 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2622>
- metricIntersection2(metric1, metric2, metricInt)
- 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.
- Return type
- Vec <#petsc4py.PETSc.Vec>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:3129 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3129>
- metricIntersection3(metric1, metric2, metric3, metricInt)
- 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.
- Return type
- Vec <#petsc4py.PETSc.Vec>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:3151 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3151>
- metricIsIsotropic()
- Return the flag indicating whether the metric is isotropic or not.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2410 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2410>
- metricIsUniform()
- Return the flag indicating whether the metric is uniform or not.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2376 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2376>
- metricNoInsertion()
- Return the flag indicating whether node insertion and deletion are turned
off.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2479 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2479>
- metricNoMovement()
- Return the flag indicating whether node movement is turned off.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2551 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2551>
- metricNoSurf()
- Return the flag indicating whether surface modification is turned off.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2587 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2587>
- metricNoSwapping()
- Return the flag indicating whether facet swapping is turned off.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2515 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2515>
- metricNormalize(metric, ometric, determinant, restrictSizes=True, restrictAnisotropy=True)
- Apply L-p normalization to a metric.
Collective.
- metric (Vec <#petsc4py.PETSc.Vec>) -- The metric.
- ometric (Vec <#petsc4py.PETSc.Vec>) -- The output metric.
- determinant (Vec <#petsc4py.PETSc.Vec>) -- The output determinant.
- restrictSizes (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Flag indicating whether maximum/minimum magnitudes should be enforced.
- restrictAnisotropy (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Flag indicating whether maximum anisotropy should be enforced.
- ometric (Vec <#petsc4py.PETSc.Vec>) -- The output normalized metric.
- determinant (Vec <#petsc4py.PETSc.Vec>) -- The output determinant.
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>]
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:3047 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3047>
- metricRestrictAnisotropyFirst()
- Return true if anisotropy is restricted before normalization.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2444 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2444>
- metricSetFromOptions()
- Configure the object from the options database.
Collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2344 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2344>
- metricSetGradationFactor(beta)
- Set the metric gradation factor.
Logically collective.
- Parameters
- beta (float <https://docs.python.org/3/library/functions.html#float>) -- The metric gradation factor.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2846 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2846>
- metricSetHausdorffNumber(hausd)
- Set the metric Hausdorff number.
Logically collective.
- Parameters
- hausd (float <https://docs.python.org/3/library/functions.html#float>) -- The metric Hausdorff number.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2880 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2880>
- metricSetIsotropic(isotropic)
- Record whether the metric is isotropic or not.
Logically collective.
- Parameters
- isotropic (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag indicating whether the metric is isotropic or not.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2391 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2391>
- metricSetMaximumAnisotropy(a_max)
- Set the maximum tolerated metric anisotropy.
Logically collective.
- Parameters
- a_max (float <https://docs.python.org/3/library/functions.html#float>) -- The maximum tolerated metric anisotropy.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2744 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2744>
- metricSetMaximumMagnitude(h_max)
- Set the maximum tolerated metric magnitude.
Logically collective.
- Parameters
- h_max (float <https://docs.python.org/3/library/functions.html#float>) -- The maximum tolerated metric magnitude.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2710 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2710>
- metricSetMinimumMagnitude(h_min)
- Set the minimum tolerated metric magnitude.
Logically collective.
- Parameters
- h_min (float <https://docs.python.org/3/library/functions.html#float>) -- The minimum tolerated metric magnitude.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2676 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2676>
- metricSetNoInsertion(noInsert)
- Set the flag indicating whether node insertion should be turned off.
Logically collective.
- Parameters
- noInsert (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag indicating whether node insertion and deletion should be turned off.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2459 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2459>
- metricSetNoMovement(noMove)
- Set the flag indicating whether node movement should be turned off.
Logically collective.
- Parameters
- noMove (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag indicating whether node movement should be turned off.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2531 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2531>
- metricSetNoSurf(noSurf)
- Set the flag indicating whether surface modification should be turned off.
Logically collective.
- Parameters
- noSurf (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag indicating whether surface modification should be turned off.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2567 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2567>
- metricSetNoSwapping(noSwap)
- Set the flag indicating whether facet swapping should be turned off.
Logically collective.
- Parameters
- noSwap (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag indicating whether facet swapping should be turned off.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2495 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2495>
- metricSetNormalizationOrder(p)
- Set the order p for L-p normalization.
Logically collective.
- Parameters
- p (float <https://docs.python.org/3/library/functions.html#float>) -- The normalization order.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2812 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2812>
- metricSetNumIterations(numIter)
- Set the number of parallel adaptation iterations.
Logically collective.
- Parameters
- numIter (int <https://docs.python.org/3/library/functions.html#int>) -- The number of parallel adaptation iterations.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2642 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2642>
- metricSetRestrictAnisotropyFirst(restrictAnisotropyFirst)
- Record whether anisotropy is be restricted before normalization or after.
Logically collective.
- Parameters
- restrictAnisotropyFirst (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag indicating if anisotropy is restricted before normalization or after.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2425 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2425>
- metricSetTargetComplexity(targetComplexity)
- Set the target metric complexity.
Logically collective.
- Parameters
- targetComplexity (float <https://docs.python.org/3/library/functions.html#float>) -- The target metric complexity.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2778 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2778>
- metricSetUniform(uniform)
- Record whether the metric is uniform or not.
Logically collective.
- Parameters
- uniform (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag indicating whether the metric is uniform or not.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2357 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2357>
- metricSetVerbosity(verbosity)
- Set the verbosity of the mesh adaptation package.
Logically collective.
- Parameters
- verbosity (int <https://docs.python.org/3/library/functions.html#int>) -- The verbosity, where -1 is silent and 10 is maximum.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2603 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2603>
- orient()
- Give a consistent orientation to the input mesh.
Collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:897 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L897>
- permute(perm)
- Reorder the mesh according to the input permutation.
Collective.
- Parameters
- perm (IS <#petsc4py.PETSc.IS>) -- The point permutation, perm[old point number] = new point number.
- Returns
- pdm -- The permuted DMPlex.
- Return type
- DMPlex
See also:
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.
- entityDepth (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Depth of the entity to balance (e.g., 0 -> balance vertices).
- useInitialGuess (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Whether to use the current distribution as initial guess.
- parallel (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Whether to use ParMETIS and do the partition in parallel or gather the graph onto a single process.
- Returns
- success -- Whether the graph partitioning was successful or not. Unsuccessful simply means no change to the partitioning.
- Return type
- bool <https://docs.python.org/3/library/functions.html#bool>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1551 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1551>
- reorderGetDefault()
- 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>
- Return type
- ReorderDefaultFlag <#petsc4py.PETSc.DM.ReorderDefaultFlag>
- reorderSetDefault(flag)
- Set flag indicating whether the DM should be reordered by default.
Logically collective.
- reorder -- Flag for reordering.
- flag (ReorderDefaultFlag <#petsc4py.PETSc.DM.ReorderDefaultFlag>)
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2220 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2220>
- sectionLoad(viewer, sectiondm, sfxc)
- 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).
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[SF <#petsc4py.PETSc.SF>, SF <#petsc4py.PETSc.SF>]
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:3388 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3388>
- sectionView(viewer, sectiondm)
- 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.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:3251 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3251>
- setAdjacencyUseAnchors(useAnchors=True)
- Define adjacency in the mesh using the point-to-point constraints.
Logically collective.
- Parameters
- 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.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1455 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1455>
- setCellType(p, ctype)
- Set the polytope type of a given cell.
Not collective.
- p (int <https://docs.python.org/3/library/functions.html#int>) -- The cell.
- ctype (PolytopeType <#petsc4py.PETSc.DM.PolytopeType>) -- The polytope type of the cell.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:687 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L687>
- setChart(pStart, pEnd)
- Set the interval for all mesh points [pStart, pEnd).
Not collective.
- pStart (int <https://docs.python.org/3/library/functions.html#int>) -- The first mesh point.
- pEnd (int <https://docs.python.org/3/library/functions.html#int>) -- The upper bound for mesh points.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:445 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L445>
- setCone(p, cone, orientation=None)
- Set 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.
- cone (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- An array of points which are on the in-edges for point p.
- orientation (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | None <https://docs.python.org/3/library/constants.html#None>) -- An array of orientations, defaults to None <https://docs.python.org/3/library/constants.html#None>.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:541 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L541>
- setConeOrientation(p, orientation)
- Set 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.
- orientation (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- An array of orientations.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:656 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L656>
- setConeSize(p, size)
- Set 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.
- size (int <https://docs.python.org/3/library/functions.html#int>) -- The cone size for point p.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:490 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L490>
- setMatClosure(sec, gsec, mat, point, values, addv=None)
- Set an array of the values on the closure of point.
Not collective.
- sec (Section <#petsc4py.PETSc.Section>) -- The section describing the layout in mat, or None <https://docs.python.org/3/library/constants.html#None> to use the default section.
- gsec (Section <#petsc4py.PETSc.Section>) -- The section describing the layout in mat, or None <https://docs.python.org/3/library/constants.html#None> to use the default global section.
- mat (Mat <#petsc4py.PETSc.Mat>) -- The matrix.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point in the DMPlex.
- values (Sequence[Scalar <#petsc4py.typing.Scalar>]) -- The array of values.
- mode -- The insertion mode.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec> | None <https://docs.python.org/3/library/constants.html#None>)
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1271 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1271>
- setPartitioner(part)
- Set the mesh partitioner.
Logically collective.
- Parameters
- part (Partitioner <#petsc4py.PETSc.Partitioner>) -- The partitioner.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1516 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1516>
- setRefinementLimit(refinementLimit)
- Set the maximum cell volume for refinement.
Logically collective.
- Parameters
- refinementLimit (float <https://docs.python.org/3/library/functions.html#float>) -- The maximum cell volume in the refined mesh.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2118 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2118>
- setRefinementUniform(refinementUniform=True)
- Set the flag for uniform refinement.
Logically collective.
- Parameters
- refinementUniform (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- The flag for uniform refinement.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:2077 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L2077>
- setSupport(p, supp)
- Set 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.
- supp (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- An array of points which are on the out-edges for point p.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:821 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L821>
- setSupportSize(p, size)
- Set 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.
- size (int <https://docs.python.org/3/library/functions.html#int>) -- The support size for point p.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:770 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L770>
- setTetGenOptions(opts)
- Set the options used for the Tetgen mesh generator.
Not collective.
- Parameters
- opts (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The command line options.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1356 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1356>
- setTriangleOptions(opts)
- Set the options used for the Triangle mesh generator.
Not collective.
- Parameters
- opts (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The command line options.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1336 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1336>
- setVecClosure(sec, vec, point, values, addv=None)
- Set an array of the values on the closure of point.
Not collective.
- sec (Section <#petsc4py.PETSc.Section>) -- The section describing the layout in vec, or None <https://docs.python.org/3/library/constants.html#None> to use the default section.
- vec (Vec <#petsc4py.PETSc.Vec>) -- The local vector.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point in the DMPlex.
- values (Sequence[Scalar <#petsc4py.typing.Scalar>]) -- The array of values.
- mode -- The insertion mode.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec> | None <https://docs.python.org/3/library/constants.html#None>)
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1239 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1239>
- stratify()
- Calculate the strata of DAG.
Collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:885 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L885>
- symmetrize()
- Create support (out-edge) information from cone (in-edge) information.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:872 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L872>
- topologyLoad(viewer)
- Load a topology into this DMPlex object.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer>) -- The Viewer <#petsc4py.PETSc.Viewer> for the saved topology
- Returns
- 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.
- Return type
- SF <#petsc4py.PETSc.SF>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:3322 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3322>
- topologyView(viewer)
- Save a DMPlex topology into a file.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer>) -- The Viewer <#petsc4py.PETSc.Viewer> for saving.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:3197 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3197>
- uninterpolate()
- Convert to a mesh with only cells and vertices.
Collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:1767 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L1767>
- vecGetClosure(sec, vec, p)
- Return an array of values on the closure of p.
Not collective.
- sec (Section <#petsc4py.PETSc.Section>) -- The section describing the layout in vec.
- vec (Vec <#petsc4py.PETSc.Vec>) -- The local vector.
- p (int <https://docs.python.org/3/library/functions.html#int>) -- The point in the DMPlex.
- Return type
- ArrayScalar <#petsc4py.typing.ArrayScalar>
See also:
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¶
- class 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(dm)
- 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>
- Parameters
- dm (DM <#petsc4py.PETSc.DM>)
- Return type
- DM <#petsc4py.PETSc.DM>
- create(comm=None)
- Create a mesh transformation.
Collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:3510 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3510>
- Parameters
- comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>)
- Return type
- Self <https://docs.python.org/3/library/typing.html#typing.Self>
- destroy()
- Destroy a mesh transformation.
Collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:3527 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3527>
- getType()
- Return the transformation type name.
Not collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:3540 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3540>
- setDM(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>
- Parameters
- dm (DM <#petsc4py.PETSc.DM>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setFromOptions()
- Configure the transformation from the options database.
Collective.
See also:
Source code at petsc4py/PETSc/DMPlex.pyx:3587 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3587>
- setType(tr_type)
- 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>
- Parameters
- tr_type (DMPlexTransformType <#petsc4py.PETSc.DMPlexTransformType> | str <https://docs.python.org/3/library/stdtypes.html#str>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setUp()
- Setup a mesh transformation.
Collective.
Source code at petsc4py/PETSc/DMPlex.pyx:3554 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMPlex.pyx#L3554>
- view(viewer=None)
- View the mesh transformation.
Collective.
- Parameters
- 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.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
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¶
- class petsc4py.PETSc.DMPlexTransformType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Transformation types.
Attributes Summary
Attributes Documentation
petsc4py.PETSc.DMShell¶
- class 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
- create(comm=None)
- Creates a shell DM object.
Collective.
- Parameters
- 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>.
- Return type
- 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>
- setCoarsen(coarsen, args=None, kargs=None)
- Set the routine used to coarsen the DMShell.
Logically collective.
- coarsen (Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[DM <#petsc4py.PETSc.DM>, Comm <#petsc4py.PETSc.Comm>], DM <#petsc4py.PETSc.DM>] | None <https://docs.python.org/3/library/constants.html#None>) -- The routine which coarsens the DM.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for coarsen.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for coarsen.
See also:
Source code at petsc4py/PETSc/DMShell.pyx:368 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L368>
- setCreateDomainDecomposition(decomp, args=None, kargs=None)
- Set the routine used to create a domain decomposition.
Logically collective.
- decomp (Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[DM <#petsc4py.PETSc.DM>], tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[list <https://docs.python.org/3/library/stdtypes.html#list>[str <https://docs.python.org/3/library/stdtypes.html#str>] | None <https://docs.python.org/3/library/constants.html#None>, list <https://docs.python.org/3/library/stdtypes.html#list>[IS <#petsc4py.PETSc.IS>] | None <https://docs.python.org/3/library/constants.html#None>, list <https://docs.python.org/3/library/stdtypes.html#list>[IS <#petsc4py.PETSc.IS>] | None <https://docs.python.org/3/library/constants.html#None>, list <https://docs.python.org/3/library/stdtypes.html#list>[DM <#petsc4py.PETSc.DM>] | None <https://docs.python.org/3/library/constants.html#None>]] | None <https://docs.python.org/3/library/constants.html#None>) -- The routine to create the decomposition.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for decomp.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for decomp.
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>
- setCreateDomainDecompositionScatters(scatter, args=None, kargs=None)
- Set the routine used to create the scatter contexts for domain
decomposition.
Logically collective.
- scatter (Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[DM <#petsc4py.PETSc.DM>, list <https://docs.python.org/3/library/stdtypes.html#list>[DM <#petsc4py.PETSc.DM>]], tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[list <https://docs.python.org/3/library/stdtypes.html#list>[Scatter <#petsc4py.PETSc.Scatter>], list <https://docs.python.org/3/library/stdtypes.html#list>[Scatter <#petsc4py.PETSc.Scatter>], list <https://docs.python.org/3/library/stdtypes.html#list>[Scatter <#petsc4py.PETSc.Scatter>]]] | None <https://docs.python.org/3/library/constants.html#None>) -- The routine to create the scatters.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for scatter.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for scatter.
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>
- setCreateFieldDecomposition(decomp, args=None, kargs=None)
- Set the routine used to create a field decomposition.
Logically collective.
- decomp (Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[DM <#petsc4py.PETSc.DM>], tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[list <https://docs.python.org/3/library/stdtypes.html#list>[str <https://docs.python.org/3/library/stdtypes.html#str>] | None <https://docs.python.org/3/library/constants.html#None>, list <https://docs.python.org/3/library/stdtypes.html#list>[IS <#petsc4py.PETSc.IS>] | None <https://docs.python.org/3/library/constants.html#None>, list <https://docs.python.org/3/library/stdtypes.html#list>[DM <#petsc4py.PETSc.DM>] | None <https://docs.python.org/3/library/constants.html#None>]] | None <https://docs.python.org/3/library/constants.html#None>) -- The routine to create the decomposition.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for decomp.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for decomp.
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>
- setCreateGlobalVector(create_gvec, args=None, kargs=None)
- Set the routine to create a global vector.
Logically collective.
- create_gvec (Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[DM <#petsc4py.PETSc.DM>], Vec <#petsc4py.PETSc.Vec>] | None <https://docs.python.org/3/library/constants.html#None>) -- The creation routine.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for create_gvec.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for create_gvec.
See also:
Source code at petsc4py/PETSc/DMShell.pyx:76 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L76>
- setCreateInjection(create_injection, args=None, kargs=None)
- Set the routine used to create the injection operator.
Logically collective.
- create_injection (Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[DM <#petsc4py.PETSc.DM>, DM <#petsc4py.PETSc.DM>], Mat <#petsc4py.PETSc.Mat>] | None <https://docs.python.org/3/library/constants.html#None>) -- The routine to create the injection.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for create_injection.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for create_injection.
See also:
Source code at petsc4py/PETSc/DMShell.pyx:464 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L464>
- setCreateInterpolation(create_interpolation, args=None, kargs=None)
- Set the routine used to create the interpolation operator.
Logically collective.
- create_interpolation (Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[DM <#petsc4py.PETSc.DM>, DM <#petsc4py.PETSc.DM>], tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Mat <#petsc4py.PETSc.Mat>, Vec <#petsc4py.PETSc.Vec>]] | None <https://docs.python.org/3/library/constants.html#None>) -- The routine to create the interpolation.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for create_interpolation.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for create_interpolation.
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>
- setCreateLocalVector(create_lvec, args=None, kargs=None)
- Set the routine to create a local vector.
Logically collective.
- create_lvec (Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[DM <#petsc4py.PETSc.DM>], Vec <#petsc4py.PETSc.Vec>] | None <https://docs.python.org/3/library/constants.html#None>) -- The creation routine.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for create_lvec.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for create_lvec.
See also:
Source code at petsc4py/PETSc/DMShell.pyx:108 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L108>
- setCreateMatrix(create_matrix, args=None, kargs=None)
- Set the routine to create a matrix.
Logically collective.
- create_matrix (Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[DM <#petsc4py.PETSc.DM>], Mat <#petsc4py.PETSc.Mat>] | None <https://docs.python.org/3/library/constants.html#None>) -- The function to create a matrix.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for create_matrix.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for create_matrix.
See also:
Source code at petsc4py/PETSc/DMShell.pyx:336 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L336>
- setCreateRestriction(create_restriction, args=None, kargs=None)
- Set the routine used to create the restriction operator.
Logically collective.
- create_restriction (Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[DM <#petsc4py.PETSc.DM>, DM <#petsc4py.PETSc.DM>], Mat <#petsc4py.PETSc.Mat>] | None <https://docs.python.org/3/library/constants.html#None>) -- The routine to create the restriction
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for create_restriction.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for create_restriction.
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>
- setCreateSubDM(create_subdm, args=None, kargs=None)
- Set the routine used to create a sub DM from the DMShell.
Logically collective.
- subdm -- The routine to create the decomposition.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for subdm.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for subdm.
- create_subdm (Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[DM <#petsc4py.PETSc.DM>, 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>]] | None <https://docs.python.org/3/library/constants.html#None>)
See also:
Source code at petsc4py/PETSc/DMShell.pyx:624 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L624>
- setGlobalToLocal(begin, end, begin_args=None, begin_kargs=None, end_args=None, end_kargs=None)
- Set the routines used to perform a global to local scatter.
Logically collective.
- dm -- The DMShell.
- begin (Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[DM <#petsc4py.PETSc.DM>, Vec <#petsc4py.PETSc.Vec>, InsertMode <#petsc4py.PETSc.InsertMode>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>] | None <https://docs.python.org/3/library/constants.html#None>) -- The routine which begins the global to local scatter.
- end (Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[DM <#petsc4py.PETSc.DM>, Vec <#petsc4py.PETSc.Vec>, InsertMode <#petsc4py.PETSc.InsertMode>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>] | None <https://docs.python.org/3/library/constants.html#None>) -- The routine which ends the global to local scatter.
- begin_args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for begin.
- begin_kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for begin.
- end_args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for end.
- end_kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for end.
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>
- setGlobalToLocalVecScatter(gtol)
- Set a Scatter <#petsc4py.PETSc.Scatter> context for global to
local communication.
Logically collective.
- Parameters
- gtol (Scatter <#petsc4py.PETSc.Scatter>) -- The global to local Scatter <#petsc4py.PETSc.Scatter> context.
- Return type
- 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>
- setGlobalVector(gv)
- Set a template global vector.
Logically collective.
- Parameters
- gv (Vec <#petsc4py.PETSc.Vec>) -- Template vector.
- Return type
- 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>
- setLocalToGlobal(begin, end, begin_args=None, begin_kargs=None, end_args=None, end_kargs=None)
- Set the routines used to perform a local to global scatter.
Logically collective.
- begin (Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[DM <#petsc4py.PETSc.DM>, Vec <#petsc4py.PETSc.Vec>, InsertMode <#petsc4py.PETSc.InsertMode>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>] | None <https://docs.python.org/3/library/constants.html#None>) -- The routine which begins the local to global scatter.
- end (Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[DM <#petsc4py.PETSc.DM>, Vec <#petsc4py.PETSc.Vec>, InsertMode <#petsc4py.PETSc.InsertMode>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>] | None <https://docs.python.org/3/library/constants.html#None>) -- The routine which ends the local to global scatter.
- begin_args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for begin.
- begin_kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for begin.
- end_args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for end.
- end_kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for end.
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>
- setLocalToGlobalVecScatter(ltog)
- Set a Scatter <#petsc4py.PETSc.Scatter> context for local to
global communication.
Logically collective.
- Parameters
- ltog (Scatter <#petsc4py.PETSc.Scatter>) -- The local to global Scatter <#petsc4py.PETSc.Scatter> context.
- Return type
- 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>
- setLocalToLocal(begin, end, begin_args=None, begin_kargs=None, end_args=None, end_kargs=None)
- Set the routines used to perform a local to local scatter.
Logically collective.
- begin (Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[DM <#petsc4py.PETSc.DM>, Vec <#petsc4py.PETSc.Vec>, InsertMode <#petsc4py.PETSc.InsertMode>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>] | None <https://docs.python.org/3/library/constants.html#None>) -- The routine which begins the local to local scatter.
- end (Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[DM <#petsc4py.PETSc.DM>, Vec <#petsc4py.PETSc.Vec>, InsertMode <#petsc4py.PETSc.InsertMode>, Vec <#petsc4py.PETSc.Vec>], None <https://docs.python.org/3/library/constants.html#None>] | None <https://docs.python.org/3/library/constants.html#None>) -- The routine which ends the local to local scatter.
- begin_args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for begin.
- begin_kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for begin.
- end_args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for end.
- end_kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for end.
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>
- setLocalToLocalVecScatter(ltol)
- Set a Scatter context for local to local communication.
Logically collective.
- Parameters
- ltol (Scatter <#petsc4py.PETSc.Scatter>) -- The local to local Scatter context.
- Return type
- 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>
- setLocalVector(lv)
- Set a template local vector.
Logically collective.
- Parameters
- lv (Vec <#petsc4py.PETSc.Vec>) -- Template vector.
- Return type
- 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>
- setMatrix(mat)
- Set a template matrix.
Collective.
- Parameters
- mat (Mat <#petsc4py.PETSc.Mat>) -- The template matrix.
- Return type
- 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>
- setRefine(refine, args=None, kargs=None)
- Set the routine used to refine the DMShell.
Logically collective.
- refine (Callable <https://docs.python.org/3/library/typing.html#typing.Callable>[[DM <#petsc4py.PETSc.DM>, Comm <#petsc4py.PETSc.Comm>], DM <#petsc4py.PETSc.DM>] | None <https://docs.python.org/3/library/constants.html#None>) -- The routine which refines the DM.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for refine.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for refine.
See also:
Source code at petsc4py/PETSc/DMShell.pyx:400 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMShell.pyx#L400>
petsc4py.PETSc.DMStag¶
- class 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¶
- class petsc4py.PETSc.DMStag.StencilLocation
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Stencil location types.
Attributes Summary
Attributes Documentation
petsc4py.PETSc.DMStag.StencilType¶
- class petsc4py.PETSc.DMStag.StencilType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Stencil types.
Attributes Summary
BOX Constant BOX 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> STAR Constant STAR of type int <https://docs.python.org/3/library/functions.html#int> Attributes Documentation
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
- VecSplitToDMDA(vec, loc, c)
- 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.
- vec (Vec <#petsc4py.PETSc.Vec>) -- The Vec object.
- loc (StencilLocation <#petsc4py.PETSc.DMStag.StencilLocation>) -- Which subgrid to extract.
- c (int <https://docs.python.org/3/library/functions.html#int>) -- Which component to extract.
- Return type
- 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(dim, dofs=None, sizes=None, boundary_types=None, stencil_type=None, stencil_width=None, proc_sizes=None, ownership_ranges=None, comm=None, setUp=False)
- 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.
- dim (int <https://docs.python.org/3/library/functions.html#int>) -- The number of dimensions.
- dofs (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- The number of degrees of freedom per vertex, element (1D); vertex, face, element (2D); or vertex, edge, face, element (3D).
- sizes (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- The number of elements in each dimension.
- boundary_types (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[DM.BoundaryType <#petsc4py.PETSc.DM.BoundaryType> | int <https://docs.python.org/3/library/functions.html#int> | str <https://docs.python.org/3/library/stdtypes.html#str> | bool <https://docs.python.org/3/library/functions.html#bool>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- The boundary types.
- stencil_type (StencilType <#petsc4py.PETSc.DMStag.StencilType> | None <https://docs.python.org/3/library/constants.html#None>) -- The ghost/halo stencil type.
- stencil_width (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- The width of the ghost/halo region.
- proc_sizes (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- The number of processes in x, y, z dimensions.
- ownership_ranges (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Sequence[int <https://docs.python.org/3/library/functions.html#int>], ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Local x, y, z element counts, of length equal to proc_sizes, summing to sizes.
- 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>.
- setUp (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Whether to call the setup routine after creating the object.
- Return type
- 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>
- createCompatibleDMStag(dofs)
- Create a compatible DMStag with different DOFs/stratum.
Collective.
- Parameters
- 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.
- Return type
- 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>
- get1dCoordinatecArrays()
- Not implemented.
Source code at petsc4py/PETSc/DMStag.pyx:832 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L832>
- getBoundaryTypes()
- Return boundary types in each dimension.
Not collective.
See also:
Source code at petsc4py/PETSc/DMStag.pyx:478 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L478>
- getCorners()
- 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 type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, ...], tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, ...], tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, ...]]
- getDim()
- Return the number of dimensions.
Not collective.
Source code at petsc4py/PETSc/DMStag.pyx:310 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L310>
- getDof()
- Get number of DOFs associated with each stratum of the grid.
Not collective.
See also:
Source code at petsc4py/PETSc/DMStag.pyx:348 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L348>
- getEntriesPerElement()
- 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>
- getGhostCorners()
- Return starting element index and width of local region.
Not collective.
See also:
Source code at petsc4py/PETSc/DMStag.pyx:385 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L385>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, ...], tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, ...]]
- getGlobalSizes()
- Return global element counts in each dimension.
Not collective.
See also:
Source code at petsc4py/PETSc/DMStag.pyx:417 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L417>
- getIsFirstRank()
- Return whether this process is first in each dimension in the process
grid.
Not collective.
See also:
Source code at petsc4py/PETSc/DMStag.pyx:496 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L496>
- getIsLastRank()
- Return whether this process is last in each dimension in the process grid.
Not collective.
See also:
Source code at petsc4py/PETSc/DMStag.pyx:512 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L512>
- getLocalSizes()
- 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>
- getLocationDof(loc)
- Return number of DOFs associated with a given point on the grid.
Not collective.
- Parameters
- loc (StencilLocation <#petsc4py.PETSc.DMStag.StencilLocation>) -- The grid point.
- Return type
- 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>
- getLocationSlot(loc, c)
- Return index to use in accessing raw local arrays.
Not collective.
- loc (StencilLocation <#petsc4py.PETSc.DMStag.StencilLocation>) -- Location relative to an element.
- c (int <https://docs.python.org/3/library/functions.html#int>) -- Component.
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>
- getOwnershipRanges()
- Return elements per process in each dimension.
Not collective.
See also:
Source code at petsc4py/PETSc/DMStag.pyx:461 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L461>
- getProcSizes()
- Return number of processes in each dimension.
Not collective.
See also:
Source code at petsc4py/PETSc/DMStag.pyx:432 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L432>
- getProductCoordinateLocationSlot(loc)
- Return slot for use with local product coordinate arrays.
Not collective.
- Parameters
- loc (StencilLocation <#petsc4py.PETSc.DMStag.StencilLocation>) -- The grid location.
- Return type
- 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>
- getStencilType()
- 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>
- getStencilWidth()
- Return elementwise stencil width.
Not collective.
See also:
Source code at petsc4py/PETSc/DMStag.pyx:334 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L334>
- getVecArray(vec)
- Not implemented.
Source code at petsc4py/PETSc/DMStag.pyx:828 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L828>
- Parameters
- vec (Vec <#petsc4py.PETSc.Vec>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- migrateVec(vec, dmTo, vecTo)
- 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.
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>
- setBoundaryTypes(boundary_types)
- Set the boundary types.
Logically collective.
- Parameters
- boundary_types (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[BoundaryType <#petsc4py.PETSc.DM.BoundaryType> | int <https://docs.python.org/3/library/functions.html#int> | str <https://docs.python.org/3/library/stdtypes.html#str> | bool <https://docs.python.org/3/library/functions.html#bool>, ...]) -- Boundary types for one/two/three dimensions.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMStag.pyx:201 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L201>
- setCoordinateDMType(dmtype)
- Set the type to store coordinates.
Logically collective.
- Parameters
- dmtype (Type <#petsc4py.PETSc.DM.Type>) -- The type to store coordinates.
- Return type
- 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>
- setDof(dofs)
- Set DOFs/stratum.
Logically collective.
- Parameters
- 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).
- Return type
- 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>
- setGlobalSizes(sizes)
- Set global element counts in each dimension.
Logically collective.
- Parameters
- sizes (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, ...]) -- Global elementwise size in the one/two/three dimensions.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setOwnershipRanges(ranges)
- Set elements per process in each dimension.
Logically collective.
- Parameters
- ranges (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>], ...]) -- Element counts for each process in one/two/three dimensions.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMStag.pyx:286 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L286>
- setProcSizes(sizes)
- Set the number of processes in each dimension in the global process grid.
Logically collective.
- Parameters
- sizes (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[int <https://docs.python.org/3/library/functions.html#int>, ...]) -- Number of processes in one/two/three dimensions.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setStencilType(stenciltype)
- Set elementwise ghost/halo stencil type.
Logically collective.
- Parameters
- stenciltype (StencilType <#petsc4py.PETSc.DMStag.StencilType> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The elementwise ghost stencil type.
- Return 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>
- setStencilWidth(swidth)
- Set elementwise stencil width.
Logically collective.
The width value is not used when StencilType.NONE <#petsc4py.PETSc.DMStag.StencilType.NONE> is specified.
- Parameters
- swidth (int <https://docs.python.org/3/library/functions.html#int>) -- Stencil/halo/ghost width in elements.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setUniformCoordinates(xmin=0, xmax=1, ymin=0, ymax=1, zmin=0, zmax=1)
- 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.
- xmin (float <https://docs.python.org/3/library/functions.html#float>) -- The minimum global coordinate value in the x dimension.
- xmax (float <https://docs.python.org/3/library/functions.html#float>) -- The maximum global coordinate value in the x dimension.
- ymin (float <https://docs.python.org/3/library/functions.html#float>) -- The minimum global coordinate value in the y dimension.
- ymax (float <https://docs.python.org/3/library/functions.html#float>) -- The maximum global coordinate value in the y dimension.
- zmin (float <https://docs.python.org/3/library/functions.html#float>) -- The minimum global coordinate value in the z dimension.
- zmax (float <https://docs.python.org/3/library/functions.html#float>) -- The maximum global coordinate value in the z dimension.
See also:
Source code at petsc4py/PETSc/DMStag.pyx:610 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L610>
- setUniformCoordinatesExplicit(xmin=0, xmax=1, ymin=0, ymax=1, zmin=0, zmax=1)
- Set coordinates to be a uniform grid, storing all values.
Collective.
- xmin (float <https://docs.python.org/3/library/functions.html#float>) -- The minimum global coordinate value in the x dimension.
- xmax (float <https://docs.python.org/3/library/functions.html#float>) -- The maximum global coordinate value in the x dimension.
- ymin (float <https://docs.python.org/3/library/functions.html#float>) -- The minimum global coordinate value in the y dimension.
- ymax (float <https://docs.python.org/3/library/functions.html#float>) -- The maximum global coordinate value in the y dimension.
- zmin (float <https://docs.python.org/3/library/functions.html#float>) -- The minimum global coordinate value in the z dimension.
- zmax (float <https://docs.python.org/3/library/functions.html#float>) -- The maximum global coordinate value in the z dimension.
See also:
Source code at petsc4py/PETSc/DMStag.pyx:530 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L530>
- setUniformCoordinatesProduct(xmin=0, xmax=1, ymin=0, ymax=1, zmin=0, zmax=1)
- 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).
- xmin (float <https://docs.python.org/3/library/functions.html#float>) -- The minimum global coordinate value in the x dimension.
- xmax (float <https://docs.python.org/3/library/functions.html#float>) -- The maximum global coordinate value in the x dimension.
- ymin (float <https://docs.python.org/3/library/functions.html#float>) -- The minimum global coordinate value in the y dimension.
- ymax (float <https://docs.python.org/3/library/functions.html#float>) -- The maximum global coordinate value in the y dimension.
- zmin (float <https://docs.python.org/3/library/functions.html#float>) -- The minimum global coordinate value in the z dimension.
- zmax (float <https://docs.python.org/3/library/functions.html#float>) -- The maximum global coordinate value in the z dimension.
See also:
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
- 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>
- corners
- 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>
- dim
- The dimension.
Source code at petsc4py/PETSc/DMStag.pyx:836 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L836>
- dofs
- 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>
- entries_per_element
- 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>
- ghost_corners
- 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_sizes
- 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_sizes
- 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>
- proc_sizes
- 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>
- stencil_type
- Stencil type.
Source code at petsc4py/PETSc/DMStag.pyx:871 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMStag.pyx#L871>
- stencil_width
- 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¶
- class 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¶
- class 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¶
- class 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¶
- class 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¶
- class petsc4py.PETSc.DMSwarm.Type
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Swarm types.
Attributes Summary
BASIC Constant BASIC of type int <https://docs.python.org/3/library/functions.html#int> PIC Constant PIC of type int <https://docs.python.org/3/library/functions.html#int> Attributes Documentation
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
- addCellDM(celldm)
- Add a cell DM to the DMSwarm.
Logically collective.
- cellDM (CellDM <#petsc4py.PETSc.CellDM>) -- The cell DM object
- celldm (CellDM <#petsc4py.PETSc.CellDM>)
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>
- addNPoints(npoints)
- Add space for a number of new points in the DMSwarm.
Not collective.
- Parameters
- npoints (int <https://docs.python.org/3/library/functions.html#int>) -- The number of new points to add.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- addPoint()
- Add space for one new point in the DMSwarm.
Not collective.
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:431 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L431>
- collectViewCreate()
- 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>
- collectViewDestroy()
- 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>
- computeMoments(coord, weight)
- Return the moments defined in the active cell DM.
Collective.
Notes
We integrate the given weight field over the given coordinate
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:1046 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L1046>
- coord (str <https://docs.python.org/3/library/stdtypes.html#str>)
- weight (str <https://docs.python.org/3/library/stdtypes.html#str>)
- copyPoint(pi, pj)
- Copy point pi to point pj in the DMSwarm.
Not collective.
- pi (int <https://docs.python.org/3/library/functions.html#int>) -- The index of the point to copy (source).
- pj (int <https://docs.python.org/3/library/functions.html#int>) -- The point index where the copy should be located (destination).
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(comm=None)
- 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.
- Parameters
- 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>.
- Return type
- 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>
- createGlobalVectorFromField(fieldname)
- 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.
- Parameters
- fieldname (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The textual name given to a registered field.
- Return type
- Vec <#petsc4py.PETSc.Vec>
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:65 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L65>
- createGlobalVectorFromFields(fieldnames)
- 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.
- Parameters
- 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.
- Return type
- Vec <#petsc4py.PETSc.Vec>
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:109 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L109>
- createLocalVectorFromField(fieldname)
- 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.
- Parameters
- fieldname (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The textual name given to a registered field.
- Return type
- Vec <#petsc4py.PETSc.Vec>
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:165 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L165>
- createLocalVectorFromFields(fieldnames)
- 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.
- Parameters
- 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.
- Return type
- Vec <#petsc4py.PETSc.Vec>
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:209 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L209>
- destroyGlobalVectorFromField(fieldname)
- Destroy the global Vec <#petsc4py.PETSc.Vec> object
associated with a given field.
Collective.
- Parameters
- fieldname (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The textual name given to a registered field.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:89 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L89>
- destroyGlobalVectorFromFields(fieldnames)
- Destroy the global Vec <#petsc4py.PETSc.Vec> object
associated with a given set of fields.
Collective.
- Parameters
- 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.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:139 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L139>
- destroyLocalVectorFromField(fieldname)
- Destroy the local Vec <#petsc4py.PETSc.Vec> object associated
with a given field.
Collective.
- Parameters
- fieldname (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The textual name given to a registered field.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:189 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L189>
- destroyLocalVectorFromFields(fieldnames)
- Destroy the local Vec <#petsc4py.PETSc.Vec> object associated
with a given set of fields.
Collective.
- Parameters
- 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.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:239 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L239>
- finalizeFieldRegister()
- Finalize the registration of fields to a DMSwarm.
Collective.
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:279 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L279>
- getCellDM()
- 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>
- Return type
- DM <#petsc4py.PETSc.DM>
- getCellDMActive()
- 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>
- Return type
- CellDM <#petsc4py.PETSc.CellDM>
- getCellDMByName(name)
- 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>
- Parameters
- name (str <https://docs.python.org/3/library/stdtypes.html#str>)
- Return type
- CellDM <#petsc4py.PETSc.CellDM>
- getCellDMNames()
- Return the names of all cell DMs in the DMSwarm.
Not collective.
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:1028 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L1028>
- getField(fieldname)
- 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.
- Parameters
- fieldname (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The textual name to identify this field.
- Returns
- 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).
- Return type
- 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>
- getLocalSize()
- Return the local length of fields registered.
Not collective.
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:512 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L512>
- getSize()
- Return the total length of fields registered.
Collective.
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:526 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L526>
- initializeFieldRegister()
- Initiate the registration of fields to a DMSwarm.
Collective.
After all fields have been registered, you must call finalizeFieldRegister.
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:265 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L265>
- insertPointUsingCellDM(layoutType, fill_param)
- 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>)
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>
- migrate(remove_sent_points=False)
- Relocate points defined in the DMSwarm to other MPI ranks.
Collective.
- Parameters
- 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.
- Return type
- 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>
- projectFields(dm, fieldnames, vecs, mode=None)
- Project a set of DMSwarm fields onto the cell DM
<#petsc4py.PETSc.DM>.
Collective.
- dm (DM <#petsc4py.PETSc.DM>) -- The continuum DM <#petsc4py.PETSc.DM>.
- fieldnames (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[str <https://docs.python.org/3/library/stdtypes.html#str>]) -- The textual names of the swarm fields to project.
- vecs (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Vec <#petsc4py.PETSc.Vec>])
- mode (ScatterModeSpec <#petsc4py.typing.ScatterModeSpec>)
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>
- registerField(fieldname, blocksize, dtype=ScalarType)
- Register a field to a DMSwarm with a native PETSc data type.
Collective.
- fieldname (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The textual name to identify this field.
- blocksize (int <https://docs.python.org/3/library/functions.html#int>) -- The number of each data type.
- dtype (type <https://docs.python.org/3/library/functions.html#type> | dtype <https://numpy.org/doc/stable/reference/generated/numpy.dtype.html#numpy.dtype>) -- A valid PETSc data type.
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:313 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L313>
- removePoint()
- Remove the last point from the DMSwarm.
Not collective.
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:461 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L461>
- removePointAtIndex(index)
- Remove a specific point from the DMSwarm.
Not collective.
- Parameters
- index (int <https://docs.python.org/3/library/functions.html#int>) -- Index of point to remove
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:473 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L473>
- restoreField(fieldname)
- Restore accesses associated with a registered field.
Not collective.
- Parameters
- fieldname (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The textual name to identify this field.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setCellDM(dm)
- Attach a DM <#petsc4py.PETSc.DM> to a DMSwarm.
Collective.
- Parameters
- dm (DM <#petsc4py.PETSc.DM>) -- The DM <#petsc4py.PETSc.DM> to attach to the DMSwarm.
- Return type
- 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>
- setCellDMActive(name)
- Activate a cell DM in the DMSwarm.
Logically collective.
- Parameters
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The name of the cell DM to activate
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:973 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L973>
- setLocalSizes(nlocal, buffer)
- Set the length of all registered fields on the DMSwarm.
Not collective.
- nlocal (int <https://docs.python.org/3/library/functions.html#int>) -- The length of each registered field.
- buffer (int <https://docs.python.org/3/library/functions.html#int>) -- The length of the buffer used for efficient dynamic resizing.
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>
- setPointCoordinates(coordinates, redundant=False, mode=None)
- Set point coordinates in a DMSwarm from a user-defined list.
Collective.
- coordinates (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[float <https://docs.python.org/3/library/functions.html#float>]) -- The coordinate values.
- redundant (bool <https://docs.python.org/3/library/functions.html#bool>) -- If set to True <https://docs.python.org/3/library/constants.html#True>, it is assumed that coordinates are only valid on rank 0 and should be broadcast to other ranks.
- mode (InsertMode <#petsc4py.PETSc.InsertMode> | None <https://docs.python.org/3/library/constants.html#None>) -- Indicates whether to append points to the swarm (InsertMode.ADD <#petsc4py.PETSc.InsertMode.ADD>), or override existing points (InsertMode.INSERT <#petsc4py.PETSc.InsertMode.INSERT>).
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>
- setPointCoordinatesCellwise(coordinates)
- Insert point coordinates within each cell.
Not collective.
Point coordinates are defined over the reference cell.
- Parameters
- 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.
- Return type
- 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>
- setPointsUniformCoordinates(min, max, npoints, mode=None)
- Set point coordinates in a DMSwarm on a regular (ijk) grid.
Collective.
- min (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[float <https://docs.python.org/3/library/functions.html#float>]) -- Minimum coordinate values in the x, y, z directions (array of length dim).
- max (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[float <https://docs.python.org/3/library/functions.html#float>]) -- Maximum coordinate values in the x, y, z directions (array of length dim).
- npoints (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Number of points in each spatial direction (array of length dim).
- mode (InsertMode <#petsc4py.PETSc.InsertMode> | None <https://docs.python.org/3/library/constants.html#None>) -- Indicates whether to append points to the swarm (InsertMode.ADD <#petsc4py.PETSc.InsertMode.ADD>), or override existing points (InsertMode.INSERT <#petsc4py.PETSc.InsertMode.INSERT>).
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>
- setType(dmswarm_type)
- Set particular flavor of DMSwarm.
Collective.
- Parameters
- dmswarm_type (Type <#petsc4py.PETSc.DMSwarm.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The DMSwarm type.
- Return 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>
- sortGetAccess()
- 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>
- sortGetIsValid()
- 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>
- sortGetNumberOfPointsPerCell(e)
- Return the number of points in a cell.
Not collective.
- Parameters
- e (int <https://docs.python.org/3/library/functions.html#int>) -- The index of the cell.
- Return type
- int <https://docs.python.org/3/library/functions.html#int>
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:866 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L866>
- sortGetPointsPerCell(e)
- Create an array of point indices for all points in a cell.
Not collective.
- Parameters
- e (int <https://docs.python.org/3/library/functions.html#int>) -- The index of the cell.
- Return type
- list <https://docs.python.org/3/library/stdtypes.html#list>[int <https://docs.python.org/3/library/functions.html#int>]
See also:
Source code at petsc4py/PETSc/DMSwarm.pyx:842 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DMSwarm.pyx#L842>
- sortGetSizes()
- Return the sizes associated with a DMSwarm point sorting context.
Not collective.
- ncells (int <https://docs.python.org/3/library/functions.html#int>) -- Number of cells within the sort context.
- npoints (int <https://docs.python.org/3/library/functions.html#int>) -- Number of points used to create the sort context.
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>
- sortRestoreAccess()
- 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>
- vectorDefineField(fieldname)
- 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.
- Parameters
- fieldname (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The textual names given to a registered field.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- viewFieldsXDMF(filename, fieldnames)
- Write a selection of 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).
- fieldnames (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[str <https://docs.python.org/3/library/stdtypes.html#str>]) -- Array containing the textual names of fields to write.
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>
- viewXDMF(filename)
- Write this DMSwarm fields to an XDMF3 file.
Collective.
- Parameters
- filename (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The file name of the XDMF file (must have the extension .xmf).
- Return type
- 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¶
- class 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¶
- class petsc4py.PETSc.DS.Type
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The Discrete System types.
Attributes Summary
BASIC Object BASIC of type str <https://docs.python.org/3/library/stdtypes.html#str> Attributes Documentation
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(comm=None)
- Create an empty DS.
Collective.
The type can then be set with setType.
- Parameters
- 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>.
- Return type
- 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>
- destroy()
- Destroy the discrete system.
Collective.
See also:
Source code at petsc4py/PETSc/DS.pyx:40 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DS.pyx#L40>
- getComponents()
- 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>
- Return type
- ArrayInt <#petsc4py.typing.ArrayInt>
- getCoordinateDimension()
- 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>
- getDimensions()
- 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>
- Return type
- ArrayInt <#petsc4py.typing.ArrayInt>
- getFieldIndex(disc)
- Return the index of the given field.
Not collective.
- Parameters
- disc (Object <#petsc4py.PETSc.Object>) -- The discretization object.
- Return type
- 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>
- getNumFields()
- Return the number of fields in the DS.
Not collective.
See also:
Source code at petsc4py/PETSc/DS.pyx:170 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DS.pyx#L170>
- getSpatialDimension()
- 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>
- getTotalComponents()
- Return the total number of components in this system.
Not collective.
See also:
Source code at petsc4py/PETSc/DS.pyx:217 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DS.pyx#L217>
- getTotalDimensions()
- 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>
- getType()
- Return the type of the discrete system.
Not collective.
See also:
Source code at petsc4py/PETSc/DS.pyx:95 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DS.pyx#L95>
- setDiscretisation(f, disc)
- Set the discretization object for the given field.
Not collective.
- f (int <https://docs.python.org/3/library/functions.html#int>) -- The field number.
- disc (Object <#petsc4py.PETSc.Object>) -- The discretization object.
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>
- setFromOptions()
- Set parameters in a DS from the options database.
Collective.
See also:
Source code at petsc4py/PETSc/DS.pyx:109 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DS.pyx#L109>
- setType(ds_type)
- Build a particular type of a discrete system.
Collective.
- Parameters
- ds_type (Type <#petsc4py.PETSc.DS.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of the discrete system.
- Return type
- 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>
- setUp()
- Construct data structures for the discrete system.
Collective.
See also:
Source code at petsc4py/PETSc/DS.pyx:121 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DS.pyx#L121>
- view(viewer=None)
- View a discrete system.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the system.
- Return type
- 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¶
- class 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:
Enumerations
| Type <#petsc4py.PETSc.Device.Type> | The type of device. |
petsc4py.PETSc.Device.Type¶
- class petsc4py.PETSc.Device.Type
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The type of device.
See also:
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
- configure()
- Configure and setup a device object.
Not collective.
See also:
Source code at petsc4py/PETSc/Device.pyx:132 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L132>
- classmethod create(dtype=None, device_id=DECIDE)
- Create a device object.
Not collective.
- dtype (Type <#petsc4py.PETSc.Device.Type> | None <https://docs.python.org/3/library/constants.html#None>) -- The type of device to create (or None <https://docs.python.org/3/library/constants.html#None> for the default).
- device_id (int <https://docs.python.org/3/library/functions.html#int>) -- The numeric id of the device to create.
- Return type
- 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>
- destroy()
- Destroy a device object.
Not collective.
See also:
Source code at petsc4py/PETSc/Device.pyx:120 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L120>
- getDeviceId()
- Return the device id.
Not collective.
See also:
Source code at petsc4py/PETSc/Device.pyx:180 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L180>
- getDeviceType()
- Return the type of the device.
Not collective.
See also:
Source code at petsc4py/PETSc/Device.pyx:165 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L165>
- static setDefaultType(device_type)
- 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>
- Parameters
- device_type (Type <#petsc4py.PETSc.Device.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- view(viewer=None)
- View a device object.
Collective.
- Parameters
- 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.
- Return type
- 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
- device_id
- The device id.
Source code at petsc4py/PETSc/Device.pyx:215 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L215>
- type
- The device type.
Source code at petsc4py/PETSc/Device.pyx:210 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L210>
petsc4py.PETSc.DeviceContext¶
- class petsc4py.PETSc.DeviceContext
- Bases: Object <#petsc4py.PETSc.Object>
DeviceContext object.
Represents an abstract handle to a device context.
See also:
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¶
- class petsc4py.PETSc.DeviceContext.DeviceJoinMode
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The type of join to perform.
See also:
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¶
- class petsc4py.PETSc.DeviceContext.StreamType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The type of stream.
See also:
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()
- Create an empty DeviceContext.
Not collective.
See also:
Source code at petsc4py/PETSc/Device.pyx:240 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L240>
- destroy()
- Destroy a device context.
Not collective.
See also:
Source code at petsc4py/PETSc/Device.pyx:255 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L255>
- duplicate()
- 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>
- Return type
- DeviceContext <#petsc4py.PETSc.DeviceContext>
- fork(n, stream_type=None)
- Create multiple device contexts which are all logically dependent on this
one.
Not collective.
- n (int <https://docs.python.org/3/library/functions.html#int>) -- The number of device contexts to create.
- stream_type (StreamType <#petsc4py.PETSc.DeviceContext.StreamType> | str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The type of stream of the forked device context.
- Return type
- 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>
- static getCurrent()
- Return the current device context.
Not collective.
See also:
Source code at petsc4py/PETSc/Device.pyx:519 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L519>
- Return type
- DeviceContext <#petsc4py.PETSc.DeviceContext>
- getDevice()
- Get the Device <#petsc4py.PETSc.Device> which this instance
is attached to.
Not collective.
See also:
Source code at petsc4py/PETSc/Device.pyx:302 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L302>
- Return type
- Device <#petsc4py.PETSc.Device>
- getStreamType()
- Return the StreamType
<#petsc4py.PETSc.DeviceContext.StreamType>.
Not collective.
See also:
Source code at petsc4py/PETSc/Device.pyx:268 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L268>
- idle()
- 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(join_mode, py_sub_ctxs)
- Join a set of device contexts on this one.
Not collective.
- join_mode (DeviceJoinMode <#petsc4py.PETSc.DeviceContext.DeviceJoinMode> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of join to perform.
- py_sub_ctxs (list <https://docs.python.org/3/library/stdtypes.html#list>[DeviceContext <#petsc4py.PETSc.DeviceContext>]) -- The list of device contexts to join.
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>
- static setCurrent(dctx)
- Set the current device context.
Not collective.
- Parameters
- 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).
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Device.pyx:535 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L535>
- setDevice(device)
- Set the Device <#petsc4py.PETSc.Device> which this
DeviceContext is attached to.
Collective.
- Parameters
- device (Device <#petsc4py.PETSc.Device>) -- The Device <#petsc4py.PETSc.Device> to which this instance is attached to.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Device.pyx:317 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L317>
- setFromOptions(comm=None)
- Configure the DeviceContext from the options database.
Collective.
- Parameters
- 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>.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Device.pyx:500 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L500>
- setStreamType(stream_type)
- Set the StreamType
<#petsc4py.PETSc.DeviceContext.StreamType>.
Not collective.
- Parameters
- stream_type (StreamType <#petsc4py.PETSc.DeviceContext.StreamType> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of stream to set
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Device.pyx:283 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L283>
- setUp()
- 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()
- 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>
- waitFor(other)
- Make this instance wait for other.
Not collective.
- Parameters
- other (DeviceContext <#petsc4py.PETSc.DeviceContext> | None <https://docs.python.org/3/library/constants.html#None>) -- The other DeviceContext to wait for
- Return type
- 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
- current
- 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>
- device
- 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>
- stream_type
- The stream type.
Source code at petsc4py/PETSc/Device.pyx:558 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Device.pyx#L558>
petsc4py.PETSc.DualSpace¶
- class 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¶
- class petsc4py.PETSc.DualSpace.Type
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The dual space types.
Attributes Summary
BDM Object BDM of type str <https://docs.python.org/3/library/stdtypes.html#str> LAGRANGE Object LAGRANGE of type str <https://docs.python.org/3/library/stdtypes.html#str> REFINED Object REFINED 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 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(comm=None)
- Create an empty DualSpace object.
Collective.
The type can then be set with setType.
- Parameters
- 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>.
- Return type
- 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>
- destroy()
- Destroy the DualSpace object.
Collective.
See also:
Source code at petsc4py/PETSc/Space.pyx:636 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L636>
- duplicate()
- 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>
- Return type
- DualSpace <#petsc4py.PETSc.DualSpace>
- getDM()
- 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>
- Return type
- DM <#petsc4py.PETSc.DM>
- getDimension()
- 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>
- getFunctional(i)
- Return the i-th basis functional in the dual space.
Not collective.
- Parameters
- i (int <https://docs.python.org/3/library/functions.html#int>) -- The basis number.
- Return type
- 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>
- getInteriorDimension()
- 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>
- getLagrangeContinuity()
- Return whether the element is continuous.
Not collective.
See also:
Source code at petsc4py/PETSc/Space.pyx:864 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L864>
- getLagrangeTensor()
- 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>
- getLagrangeTrimmed()
- 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>
- getNumComponents()
- 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>
- getNumDof()
- 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>
- Return type
- ArrayInt <#petsc4py.typing.ArrayInt>
- getOrder()
- Return the order of the dual space.
Not collective.
See also:
Source code at petsc4py/PETSc/Space.pyx:778 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L778>
- getType()
- Return the type of the dual space object.
Not collective.
See also:
Source code at petsc4py/PETSc/Space.pyx:744 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L744>
- setDM(dm)
- Set the DM <#petsc4py.PETSc.DM> representing the reference
cell.
Not collective.
- Parameters
- dm (DM <#petsc4py.PETSc.DM>) -- The reference cell.
- Return type
- 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>
- setLagrangeContinuity(continuous)
- Indicate whether the element is continuous.
Not collective.
- Parameters
- continuous (bool <https://docs.python.org/3/library/functions.html#bool>) -- The flag for element continuity.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Space.pyx:878 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L878>
- setLagrangeTensor(tensor)
- Set the tensor nature of the dual space.
Not collective.
- Parameters
- tensor (bool <https://docs.python.org/3/library/functions.html#bool>) -- Whether the dual space has tensor layout (vs. simplicial).
- Return type
- 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>
- setLagrangeTrimmed(trimmed)
- Set the trimmed nature of the dual space.
Not collective.
- Parameters
- 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).
- Return type
- 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>
- setNumComponents(nc)
- Set the number of components for this space.
Logically collective.
- Parameters
- nc (int <https://docs.python.org/3/library/functions.html#int>) -- The number of components
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setOrder(order)
- Set the order of the dual space.
Not collective.
- Parameters
- order (int <https://docs.python.org/3/library/functions.html#int>) -- The order.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Space.pyx:792 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L792>
- setSimpleDimension(dim)
- Set the number of functionals in the dual space basis.
Logically collective.
- Parameters
- dim (int <https://docs.python.org/3/library/functions.html#int>) -- The basis dimension.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Space.pyx:962 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L962>
- setSimpleFunctional(func, functional)
- Set the given basis element for this dual space.
Not collective.
- func (int <https://docs.python.org/3/library/functions.html#int>) -- The basis index.
- functional (Quad <#petsc4py.PETSc.Quad>) -- The basis functional.
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>
- setType(dualspace_type)
- Build a particular type of dual space.
Collective.
- Parameters
- dualspace_type (Type <#petsc4py.PETSc.DualSpace.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The kind of space.
- Return type
- 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>
- setUp()
- Construct a basis for a DualSpace.
Collective.
See also:
Source code at petsc4py/PETSc/Space.pyx:582 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L582>
- view(viewer=None)
- View a DualSpace.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the DualSpace.
- Return type
- 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¶
- class 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¶
- class petsc4py.PETSc.FE.Type
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The finite element types.
Attributes Summary
BASIC Object BASIC 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> OPENCL Object OPENCL of type str <https://docs.python.org/3/library/stdtypes.html#str> Attributes Documentation
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(comm=None)
- Create an empty FE object.
Collective.
The type can then be set with setType.
- Parameters
- 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>.
- Return type
- 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>
- createDefault(dim, nc, isSimplex, qorder=DETERMINE, prefix=None, comm=None)
- Create a FE for basic FEM computation.
Collective.
- dim (int <https://docs.python.org/3/library/functions.html#int>) -- The spatial dimension.
- nc (int <https://docs.python.org/3/library/functions.html#int>) -- The number of components.
- isSimplex (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag for simplex reference cell, otherwise it's a tensor product.
- qorder (int <https://docs.python.org/3/library/functions.html#int>) -- The quadrature order or DETERMINE <#petsc4py.PETSc.DETERMINE> to use Space <#petsc4py.PETSc.Space> polynomial degree.
- prefix (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The options prefix, or 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>.
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>
- createLagrange(dim, nc, isSimplex, k, qorder=DETERMINE, comm=None)
- Create a FE for the basic Lagrange space of degree k.
Collective.
- dim (int <https://docs.python.org/3/library/functions.html#int>) -- The spatial dimension.
- nc (int <https://docs.python.org/3/library/functions.html#int>) -- The number of components.
- isSimplex (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag for simplex reference cell, otherwise it's a tensor product.
- k (int <https://docs.python.org/3/library/functions.html#int>) -- The degree of the space.
- qorder (int <https://docs.python.org/3/library/functions.html#int>) -- The quadrature order or DETERMINE <#petsc4py.PETSc.DETERMINE> to use Space <#petsc4py.PETSc.Space> polynomial degree.
- 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>.
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>
- destroy()
- Destroy the FE object.
Collective.
See also:
Source code at petsc4py/PETSc/FE.pyx:40 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L40>
- getBasisSpace()
- 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>
- Return type
- Space <#petsc4py.PETSc.Space>
- getDimension()
- 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>
- getDualSpace()
- Return the DualSpace <#petsc4py.PETSc.DualSpace> used to
define the inner product for the FE.
Not collective.
See also:
Source code at petsc4py/PETSc/FE.pyx:443 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L443>
- Return type
- DualSpace <#petsc4py.PETSc.DualSpace>
- getFaceQuadrature()
- 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>
- Return type
- Quad <#petsc4py.PETSc.Quad>
- getNumComponents()
- 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>
- getNumDof()
- 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>
- getQuadrature()
- 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>
- Return type
- Quad <#petsc4py.PETSc.Quad>
- getSpatialDimension()
- Return the spatial dimension of the element.
Not collective.
See also:
Source code at petsc4py/PETSc/FE.pyx:195 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L195>
- getTileSizes()
- Return the tile sizes for evaluation.
Not collective.
- blockSize (int <https://docs.python.org/3/library/functions.html#int>) -- The number of elements in a block.
- numBlocks (int <https://docs.python.org/3/library/functions.html#int>) -- The number of blocks in a batch.
- batchSize (int <https://docs.python.org/3/library/functions.html#int>) -- The number of elements in a batch.
- numBatches (int <https://docs.python.org/3/library/functions.html#int>) -- The number of batches in a chunk.
- Return type
- 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>, 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/FE.pyx:260 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L260>
- setBasisSpace(sp)
- Set the Space <#petsc4py.PETSc.Space> used for the
approximation of the solution.
Not collective.
- Parameters
- sp (Space <#petsc4py.PETSc.Space>) -- The Space <#petsc4py.PETSc.Space> object.
- Return type
- 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>
- setDualSpace(dspace)
- Set the DualSpace <#petsc4py.PETSc.DualSpace> used to define
the inner product.
Not collective.
- Parameters
- dspace (DualSpace <#petsc4py.PETSc.DualSpace>) -- The DualSpace <#petsc4py.PETSc.DualSpace> object.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/FE.pyx:458 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L458>
- setFaceQuadrature(quad)
- Set the Quad <#petsc4py.PETSc.Quad> used to calculate inner
products on faces.
Not collective.
- Parameters
- quad (Quad <#petsc4py.PETSc.Quad>) -- The Quad <#petsc4py.PETSc.Quad> object.
- Return type
- 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>
- setFromOptions()
- Set parameters in a FE from the options database.
Collective.
See also:
Source code at petsc4py/PETSc/FE.pyx:419 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/FE.pyx#L419>
- setNumComponents(comp)
- Set the number of field components in the element.
Not collective.
- Parameters
- comp (int <https://docs.python.org/3/library/functions.html#int>) -- The number of field components.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setQuadrature(quad)
- Set the Quad <#petsc4py.PETSc.Quad> used to calculate inner
products.
Not collective.
- Parameters
- quad (Quad <#petsc4py.PETSc.Quad>) -- The Quad <#petsc4py.PETSc.Quad> object.
- Return type
- 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>
- setTileSizes(blockSize, numBlocks, batchSize, numBatches)
- Set the tile sizes for evaluation.
Not collective.
- blockSize (int <https://docs.python.org/3/library/functions.html#int>) -- The number of elements in a block.
- numBlocks (int <https://docs.python.org/3/library/functions.html#int>) -- The number of blocks in a batch.
- batchSize (int <https://docs.python.org/3/library/functions.html#int>) -- The number of elements in a batch.
- numBatches (int <https://docs.python.org/3/library/functions.html#int>) -- The number of batches in a chunk.
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>
- setType(fe_type)
- Build a particular FE.
Collective.
- Parameters
- fe_type (Type <#petsc4py.PETSc.FE.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The kind of FEM space.
- Return type
- 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>
- setUp()
- 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(viewer=None)
- View a FE object.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the graph.
- Return type
- 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¶
- class 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¶
- class petsc4py.PETSc.IS.Type
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The index set types.
Attributes Summary
BLOCK Object BLOCK of type str <https://docs.python.org/3/library/stdtypes.html#str> GENERAL Object GENERAL of type str <https://docs.python.org/3/library/stdtypes.html#str> STRIDE Object STRIDE of type str <https://docs.python.org/3/library/stdtypes.html#str> Attributes Documentation
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
- allGather()
- 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>
- Return type
- IS <#petsc4py.PETSc.IS>
- buildTwoSided(toindx=None)
- 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.
- Parameters
- 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.
- Returns
- New index set containing the new numbers from remote or local.
- Return type
- 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>
- complement(nmin, nmax)
- 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).
- nmin (int <https://docs.python.org/3/library/functions.html#int>) -- Minimum index that can be found in the local part of the complement index set.
- nmax (int <https://docs.python.org/3/library/functions.html#int>) -- One greater than the maximum index that can be found in the local part of the complement index set.
- Return type
- 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(result=None)
- Copy the contents of the index set into another.
Collective.
- Parameters
- 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.
- Returns
- The copied index set. If result is not None <https://docs.python.org/3/library/constants.html#None> then this is returned here.
- Return type
- 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(comm=None)
- Create an IS.
Collective.
- Parameters
- 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>.
- Return type
- 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>
- createBlock(bsize, indices, comm=None)
- Create a blocked index set.
Collective.
- bsize (int <https://docs.python.org/3/library/functions.html#int>) -- Block size.
- indices (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Integer array of indices.
- 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>.
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>
- createGeneral(indices, comm=None)
- Create an IS with indices.
Collective.
- indices (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Integer array.
- 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>.
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>
- createStride(size, first=0, step=1, comm=None)
- Create an index set consisting of evenly spaced values.
Collective.
- size (int <https://docs.python.org/3/library/functions.html#int>) -- The length of the locally owned portion of the index set.
- first (int <https://docs.python.org/3/library/functions.html#int>) -- The first element of the index set.
- step (int <https://docs.python.org/3/library/functions.html#int>) -- The difference between adjacent indices.
- 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>.
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>
- destroy()
- Destroy the index set.
Collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:75 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L75>
- difference(iset)
- Return the difference between two index sets.
Collective.
- Parameters
- iset (IS <#petsc4py.PETSc.IS>) -- Index set to compute the difference with.
- Returns
- Index set representing the difference between self and iset.
- Return type
- 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>
- duplicate()
- 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>
- Return type
- IS <#petsc4py.PETSc.IS>
- embed(iset, drop)
- Embed self into iset.
Not collective.
The embedding is performed by finding the locations in iset that have the same indices as self.
- iset (IS <#petsc4py.PETSc.IS>) -- The index set to embed into.
- drop (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag indicating whether to drop indices from self that are not in iset.
- Returns
- The embedded index set.
- Return type
- 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>
- equal(iset)
- Return whether the index sets have the same set of indices or not.
Collective.
- Parameters
- iset (IS <#petsc4py.PETSc.IS>) -- The index set to compare indices with.
- Return type
- 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>
- expand(iset)
- Return the union of two (possibly unsorted) index sets.
Collective.
To compute the union, expand concatenates the two index sets and removes any duplicates.
- Parameters
- iset (IS <#petsc4py.PETSc.IS>) -- Index set to compute the union with.
- Returns
- The new, combined, index set.
- Return type
- 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>
- getBlockIndices()
- 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>
- Return type
- ArrayInt <#petsc4py.typing.ArrayInt>
- getBlockSize()
- Return the number of elements in a block.
Not collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:486 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L486>
- getIndices()
- 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>
- Return type
- ArrayInt <#petsc4py.typing.ArrayInt>
- getInfo()
- Return stride information for an index set with type IS.Type.STRIDE
<#petsc4py.PETSc.IS.Type.STRIDE>.
Not collective.
- first (int <https://docs.python.org/3/library/functions.html#int>) -- First element of the index set.
- step (int <https://docs.python.org/3/library/functions.html#int>) -- Difference between adjacent indices.
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>
- getLocalSize()
- Return the process-local length of the index set.
Not collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:450 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L450>
- getSize()
- Return the global length of an index set.
Not collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:436 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L436>
- getSizes()
- Return the local and global sizes of the index set.
Not collective.
- local_size (int <https://docs.python.org/3/library/functions.html#int>) -- The local size.
- global_size (int <https://docs.python.org/3/library/functions.html#int>) -- The global size.
See also:
Source code at petsc4py/PETSc/IS.pyx:464 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L464>
- getStride()
- Return size and stride information.
Not collective.
- size (int <https://docs.python.org/3/library/functions.html#int>) -- Length of the locally owned portion of the index set.
- first (int <https://docs.python.org/3/library/functions.html#int>) -- First element of the index set.
- step (int <https://docs.python.org/3/library/functions.html#int>) -- Difference between adjacent indices.
See also:
Source code at petsc4py/PETSc/IS.pyx:928 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L928>
- getType()
- Return the index set type associated with the IS.
Not collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:128 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L128>
- invertPermutation(nlocal=None)
- Invert the index set.
Collective.
For this to be correct the index set must be a permutation.
- Parameters
- 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.
- Return type
- 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>
- isIdentity()
- 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>
- isPermutation()
- 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>
- isSorted()
- Return whether the indices have been sorted.
Collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:531 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L531>
- load(viewer)
- Load a stored index set.
Collective.
- Parameters
- 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>.
- Return type
- 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>
- partitioningCount(npart=None)
- 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.
- Parameters
- 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.
- Return type
- 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>
- partitioningToNumbering()
- 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>
- Return type
- IS <#petsc4py.PETSc.IS>
- renumber(mult=None)
- Renumber the non-negative entries of an index set, starting from 0.
Collective.
- Parameters
- 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.
- Returns
- int <https://docs.python.org/3/library/functions.html#int> -- One past the largest entry of the new index set.
- IS -- The renumbered index set.
- Return type
- 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>
- setBlockIndices(bsize, indices)
- Set the indices for an index set with type IS.Type.BLOCK
<#petsc4py.PETSc.IS.Type.BLOCK>.
Collective.
- bsize (int <https://docs.python.org/3/library/functions.html#int>) -- Number of elements in each block.
- indices (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- List of integers.
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>
- setBlockSize(bs)
- Set the block size of the index set.
Logically collective.
- Parameters
- bs (int <https://docs.python.org/3/library/functions.html#int>) -- Block size.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/IS.pyx:500 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L500>
- setIdentity()
- Mark the index set as being an identity.
Logically collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:572 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L572>
- setIndices(indices)
- 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>
- setPermutation()
- Mark the index set as being a permutation.
Logically collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:545 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L545>
- setStride(size, first=0, step=1)
- Set the stride information for an index set with type
IS.Type.STRIDE <#petsc4py.PETSc.IS.Type.STRIDE>.
Logically collective.
- size (int <https://docs.python.org/3/library/functions.html#int>) -- Length of the locally owned portion of the index set.
- first (int <https://docs.python.org/3/library/functions.html#int>) -- First element of the index set.
- step (int <https://docs.python.org/3/library/functions.html#int>) -- Difference between adjacent indices.
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>
- setType(is_type)
- Set the type of the index set.
Collective.
- Parameters
- is_type (Type <#petsc4py.PETSc.IS.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The index set type.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/IS.pyx:109 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L109>
- sort()
- Sort the indices of an index set.
Collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:518 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L518>
- sum(iset)
- Return the union of two (sorted) index sets.
Collective.
- Parameters
- iset (IS <#petsc4py.PETSc.IS>) -- The index set to compute the union with.
- Return type
- 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>
- toGeneral()
- Convert the index set type to IS.Type.GENERAL
<#petsc4py.PETSc.IS.Type.GENERAL>.
Collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:320 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L320>
- union(iset)
- 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).
- Parameters
- iset (IS <#petsc4py.PETSc.IS>) -- Index set to compute the union with.
- Returns
- The new, combined, index set.
- Return type
- IS
See also:
Source code at petsc4py/PETSc/IS.pyx:664 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L664>
- view(viewer=None)
- Display the index set.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- Viewer used to display the IS.
- Return type
- 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
- array
- 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>
- block_size
- The number of elements in a block.
Not collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:1055 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1055>
- 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.
Collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:988 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L988>
- indices
- The indices of the index set.
Not collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:1068 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1068>
- local_size
- The local size of the index set.
Not collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:1042 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1042>
- 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.
Logically collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:975 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L975>
- size
- The global size of the index set.
Not collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:1029 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1029>
- sizes
- The local and global sizes of the index set.
Not collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:1016 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1016>
- 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.
Collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:1001 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1001>
petsc4py.PETSc.InsertMode¶
- class petsc4py.PETSc.InsertMode
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Insertion mode.
Most commonly used insertion modes are:
See also:
Attributes Summary
Attributes Documentation
petsc4py.PETSc.KSP¶
- class 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:
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¶
- class petsc4py.PETSc.KSP.ConvergedReason
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
KSP Converged Reason.
- CONVERGED_ITERATING
- Still iterating
- ITERATING
- Still iterating
- CONVERGED_RTOL_NORMAL_EQUATIONS
- Undocumented.
- CONVERGED_ATOL_NORMAL_EQUATIONS
- Undocumented.
- CONVERGED_RTOL
- ∥r∥ <= rtolnorm(b) or rtolnorm(b - Ax₀)
- CONVERGED_ATOL
- ∥r∥ <= atol
- CONVERGED_ITS
- 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.
- CONVERGED_NEG_CURVE
- Undocumented.
- CONVERGED_STEP_LENGTH
- Undocumented.
- CONVERGED_HAPPY_BREAKDOWN
- Undocumented.
- DIVERGED_NULL
- Undocumented.
- DIVERGED_MAX_IT
- Ran out of iterations before any convergence criteria was reached.
- DIVERGED_DTOL
- norm(r) >= dtol*norm(b)
- DIVERGED_BREAKDOWN
- 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.
- DIVERGED_BREAKDOWN_BICG
- A breakdown in the KSPBICG method was detected so the method could not continue to enlarge the Krylov space.
- DIVERGED_NONSYMMETRIC
- 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.
- DIVERGED_INDEFINITE_PC
- 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.
- DIVERGED_NANORINF
- Undocumented.
- DIVERGED_INDEFINITE_MAT
- Undocumented.
- DIVERGED_PCSETUP_FAILED
- 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¶
- class 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¶
- class petsc4py.PETSc.KSP.NormType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
KSP norm type.
The available norm types are:
- NONE
- 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.
- PRECONDITIONED
- The default for left preconditioned solves, uses the l₂ norm of the preconditioned residual P⁻¹(b - Ax).
- UNPRECONDITIONED
- Uses the l₂ norm of the true b - Ax residual.
- NATURAL
- 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
Attributes Documentation
petsc4py.PETSc.KSP.Type¶
- class petsc4py.PETSc.KSP.Type
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
KSP Type.
The available types are:
- RICHARDSON
- The preconditioned Richardson iterative method KSPRICHARDSON <https://petsc.org/release/manualpages/KSP/KSPRICHARDSON.html>.
- CHEBYSHEV
- The preconditioned Chebyshev iterative method. KSPCHEBYSHEV <https://petsc.org/release/manualpages/KSP/KSPCHEBYSHEV.html>.
- CG
- The Preconditioned Conjugate Gradient (PCG) iterative method. KSPCG <https://petsc.org/release/manualpages/KSP/KSPCG.html>
- GROPPCG
- A pipelined conjugate gradient method (Gropp). KSPGROPPCG <https://petsc.org/release/manualpages/KSP/KSPGROPPCG.html>
- PIPECG
- A pipelined conjugate gradient method. KSPPIPECG <https://petsc.org/release/manualpages/KSP/KSPPIPECG.html>
- PIPECGRR
- Pipelined Conjugate Gradients with Residual Replacement. KSPPIPECGRR <https://petsc.org/release/manualpages/KSP/KSPPIPECGRR.html>
- PIPELCG
- Deep pipelined (length l) Conjugate Gradient method. KSPPIPELCG <https://petsc.org/release/manualpages/KSP/KSPPIPELCG.html>
- PIPEPRCG
- Pipelined predict-and-recompute conjugate gradient method. KSPPIPEPRCG <https://petsc.org/release/manualpages/KSP/KSPPIPEPRCG.html>
- PIPECG2
- Pipelined conjugate gradient method with a single non-blocking reduction per two iterations. KSPPIPECG2 <https://petsc.org/release/manualpages/KSP/KSPPIPECG2.html>
- CGNE
- Applies the preconditioned conjugate gradient method to the normal equations without explicitly forming AᵀA. KSPCGNE <https://petsc.org/release/manualpages/KSP/KSPCGNE.html>
- NASH
- Conjugate gradient method subject to a constraint on the solution norm. KSPNASH <https://petsc.org/release/manualpages/KSP/KSPNASH.html>
- STCG
- Conjugate gradient method subject to a constraint on the solution norm. KSPSTCG <https://petsc.org/release/manualpages/KSP/KSPSTCG.html>
- GLTR
- Conjugate gradient method subject to a constraint on the solution norm. KSPGLTR <https://petsc.org/release/manualpages/KSP/KSPGLTR.html>
- FCG
- 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>
- PIPEFCG
- Pipelined, Flexible Conjugate Gradient method. KSPPIPEFCG <https://petsc.org/release/manualpages/KSP/KSPPIPEFCG.html>
- GMRES
- Generalized Minimal Residual method with restart. KSPGMRES <https://petsc.org/release/manualpages/KSP/KSPGMRES.html>
- PIPEFGMRES
- Pipelined (1-stage) Flexible Generalized Minimal Residual method. KSPPIPEFGMRES <https://petsc.org/release/manualpages/KSP/KSPPIPEFGMRES.html>
- FGMRES
- Implements the Flexible Generalized Minimal Residual method. KSPFGMRES <https://petsc.org/release/manualpages/KSP/KSPFGMRES.html>
- LGMRES
- 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>
- DGMRES
- 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>
- PGMRES
- Pipelined Generalized Minimal Residual method. KSPPGMRES <https://petsc.org/release/manualpages/KSP/KSPPGMRES.html>
- TCQMR
- A variant of Quasi Minimal Residual (QMR). KSPTCQMR <https://petsc.org/release/manualpages/KSP/KSPTCQMR.html>
- BCGS
- Stabilized version of Biconjugate Gradient (BiCGStab) method. KSPBCGS <https://petsc.org/release/manualpages/KSP/KSPBCGS.html>
- IBCGS
- 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>
- QMRCGS
- Quasi- Minimal Residual variant of the Bi-CGStab algorithm (QMRCGStab) method. KSPQMRCGS <https://petsc.org/release/manualpages/KSP/KSPQMRCGS.html>
- FBCGS
- Flexible Stabilized version of BiConjugate Gradient (BiCGStab) method. KSPFBCGS <https://petsc.org/release/manualpages/KSP/KSPFBCGS.html>
- FBCGSR
- A mathematically equivalent variant of flexible stabilized BiConjugate Gradient (BiCGStab). KSPFBCGSR <https://petsc.org/release/manualpages/KSP/KSPFBCGSR.html>
- BCGSL
- 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>
- PIPEBCGS
- Pipelined stabilized BiConjugate Gradient (BiCGStab) method. KSPPIPEBCGS <https://petsc.org/release/manualpages/KSP/KSPPIPEBCGS.html>
- CGS
- Conjugate Gradient Squared method. KSPCGS <https://petsc.org/release/manualpages/KSP/KSPCGS.html>
- TFQMR
- A Transpose Tree Quasi- Minimal Residual (QMR). KSPCR <https://petsc.org/release/manualpages/KSP/KSPCR.html>
- CR
- (Preconditioned) Conjugate Residuals (CR) method. KSPCR <https://petsc.org/release/manualpages/KSP/KSPCR.html>
- PIPECR
- Pipelined Conjugate Residual (CR) method. KSPPIPECR <https://petsc.org/release/manualpages/KSP/KSPPIPECR.html>
- LSQR
- Least squares solver. KSPLSQR <https://petsc.org/release/manualpages/KSP/KSPLSQR.html>
- PREONLY
- 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>
- NONE
- No solver KSPNONE
- QCG
- Conjugate Gradient (CG) method subject to a constraint on the solution norm. KSPQCG <https://petsc.org/release/manualpages/KSP/KSPQCG.html>
- BICG
- 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>
- MINRES
- Minimum Residual (MINRES) method. KSPMINRES <https://petsc.org/release/manualpages/KSP/KSPMINRES.html>
- SYMMLQ
- Symmetric LQ method (SymmLQ). Uses LQ decomposition (lower trapezoidal). KSPSYMMLQ <https://petsc.org/release/manualpages/KSP/KSPSYMMLQ.html>
- LCD
- Left Conjugate Direction (LCD) method. KSPLCD <https://petsc.org/release/manualpages/KSP/KSPLCD.html>
- PYTHON
- Python shell solver. Call Python function to implement solver. KSPPYTHON
- GCR
- Preconditioned flexible Generalized Conjugate Residual (GCR) method. KSPGCR <https://petsc.org/release/manualpages/KSP/KSPGCR.html>
- PIPEGCR
- Pipelined Generalized Conjugate Residual method. KSPPIPEGCR <https://petsc.org/release/manualpages/KSP/KSPPIPEGCR.html>
- TSIRM
- Two-Stage Iteration with least-squares Residual Minimization method. KSPTSIRM <https://petsc.org/release/manualpages/KSP/KSPTSIRM.html>
- CGLS
- Conjugate Gradient method for Least-Squares problems. Supports non-square (rectangular) matrices. KSPCGLS <https://petsc.org/release/manualpages/KSP/KSPCGLS.html>
- FETIDP
- Dual-Primal (DP) Finite Element Tearing and Interconnect (FETI) method. KSPFETIDP <https://petsc.org/release/manualpages/KSP/KSPFETIDP.html>
- HPDDM
- 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:
Attributes Summary
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
- addConvergenceTest(converged, args=None, kargs=None, prepend=False)
- Add the function to be used to determine convergence.
Logically collective.
- converged (KSPConvergenceTestFunction <#petsc4py.typing.KSPConvergenceTestFunction>) -- Callback which computes the convergence.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for callback function.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for callback function.
- prepend (bool <https://docs.python.org/3/library/functions.html#bool>) -- Whether to prepend this call before the default convergence test or call it after.
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:
Source code at petsc4py/PETSc/KSP.pyx:1065 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1065>
- appendOptionsPrefix(prefix)
- Append to prefix used for all KSP options in the database.
Logically collective.
- Parameters
- prefix (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The options prefix to append.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- buildResidual(r=None)
- Return the residual of the linear system.
Collective.
- Parameters
- r (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional vector to use for the result.
- Return type
- 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>
- buildSolution(x=None)
- Return the solution vector.
Collective.
- Parameters
- x (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional vector to store the solution.
- Return type
- 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>
- callConvergenceTest(its, rnorm)
- Call the convergence test callback.
Collective.
- its (int <https://docs.python.org/3/library/functions.html#int>) -- Number of iterations.
- rnorm (float <https://docs.python.org/3/library/functions.html#float>) -- The residual norm.
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>
- computeEigenvalues()
- 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>
- Return type
- ArrayComplex <#petsc4py.typing.ArrayComplex>
- computeExtremeSingularValues()
- Compute the extreme singular values for the preconditioned operator.
Collective.
- smax (float <https://docs.python.org/3/library/functions.html#float>) -- The maximum singular value.
- smin (float <https://docs.python.org/3/library/functions.html#float>) -- The minimum singular value.
See also:
Source code at petsc4py/PETSc/KSP.pyx:2108 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2108>
- create(comm=None)
- Create the KSP context.
Collective.
See also:
Source code at petsc4py/PETSc/KSP.pyx:457 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L457>
- Parameters
- comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>)
- Return type
- Self <https://docs.python.org/3/library/typing.html#typing.Self>
- createPython(context=None, comm=None)
- Create a linear solver of Python type.
Collective.
- context (Any <https://docs.python.org/3/library/typing.html#typing.Any>) -- An instance of the Python class implementing the required methods.
- 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>.
See also:
Source code at petsc4py/PETSc/KSP.pyx:2154 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2154>
- destroy()
- Destroy KSP context.
Collective.
See also:
Source code at petsc4py/PETSc/KSP.pyx:444 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L444>
- getAppCtx()
- Return the user-defined context for the linear solver.
Not collective.
See also:
Source code at petsc4py/PETSc/KSP.pyx:640 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L640>
- getCGObjectiveValue()
- Return the CG objective function value.
Not collective.
See also:
Source code at petsc4py/PETSc/KSP.pyx:1882 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1882>
- getComputeEigenvalues()
- 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:
Source code at petsc4py/PETSc/KSP.pyx:1430 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1430>
- getComputeSingularValues()
- 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:
Source code at petsc4py/PETSc/KSP.pyx:1474 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1474>
- getConvergedReason()
- 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>
- Return type
- ConvergedReason <#petsc4py.PETSc.KSP.ConvergedReason>
- getConvergenceHistory()
- Return array containing the residual history.
Not collective.
See also:
Source code at petsc4py/PETSc/KSP.pyx:1188 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1188>
- Return type
- ArrayReal <#petsc4py.typing.ArrayReal>
- getConvergenceTest()
- 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>
- Return type
- KSPConvergenceTestFunction <#petsc4py.typing.KSPConvergenceTestFunction>
- getDM()
- Return the DM <#petsc4py.PETSc.DM> that may be used by some
preconditioners.
Not collective.
See also:
Source code at petsc4py/PETSc/KSP.pyx:654 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L654>
- Return type
- DM <#petsc4py.PETSc.DM>
- getErrorIfNotConverged()
- 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>
- getHPDDMType()
- 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>
- Return type
- HPDDMType <#petsc4py.PETSc.KSP.HPDDMType>
- getInitialGuessKnoll()
- 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>
- getInitialGuessNonzero()
- Determine whether the KSP solver uses a zero initial guess.
Not collective.
See also:
Source code at petsc4py/PETSc/KSP.pyx:1516 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1516>
- getIterationNumber()
- Use its property.
Source code at petsc4py/PETSc/KSP.pyx:1854 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1854>
- getMonitor()
- Return function used to monitor the residual.
Not collective.
See also:
Source code at petsc4py/PETSc/KSP.pyx:1266 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1266>
- Return type
- KSPMonitorFunction <#petsc4py.typing.KSPMonitorFunction>
- getNormType()
- Return the norm that is used for convergence testing.
Not collective.
See also:
Source code at petsc4py/PETSc/KSP.pyx:1390 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1390>
- Return type
- NormType <#petsc4py.PETSc.NormType>
- getOperators()
- 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.
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>]
See also:
Source code at petsc4py/PETSc/KSP.pyx:850 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L850>
- getOptionsPrefix()
- 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>
- getPC()
- 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>
- Return type
- PC <#petsc4py.PETSc.PC>
- getPCSide()
- Return the preconditioning side.
Not collective.
See also:
Source code at petsc4py/PETSc/KSP.pyx:1349 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1349>
- Return type
- Side <#petsc4py.PETSc.PC.Side>
- getPythonContext()
- Return the instance of the class implementing Python methods.
Not collective.
See also:
Source code at petsc4py/PETSc/KSP.pyx:2195 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2195>
- getPythonType()
- Return the fully qualified Python name of the class used by the solver.
Not collective.
See also:
Source code at petsc4py/PETSc/KSP.pyx:2225 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2225>
- getResidualNorm()
- Use norm property.
Source code at petsc4py/PETSc/KSP.pyx:1865 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1865>
- getRhs()
- 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>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- getSolution()
- 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>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- getTolerances()
- 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.
- rtol (float <https://docs.python.org/3/library/functions.html#float>) -- The relative convergence tolerance
- atol (float <https://docs.python.org/3/library/functions.html#float>) -- The absolute convergence tolerance
- dtol (float <https://docs.python.org/3/library/functions.html#float>) -- The divergence tolerance
- maxits (int <https://docs.python.org/3/library/functions.html#int>) -- Maximum number of iterations
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[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>, int <https://docs.python.org/3/library/functions.html#int>]
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>
- getType()
- Return the KSP type as a string from the KSP object.
Not collective.
See also:
Source code at petsc4py/PETSc/KSP.pyx:509 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L509>
- getWorkVecs(right=None, left=None)
- Create working vectors.
Collective.
- right (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Number of right hand vectors to allocate.
- left (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Number of left hand vectors to allocate.
- R (list <https://docs.python.org/3/library/stdtypes.html#list> of Vec <#petsc4py.PETSc.Vec>) -- List of correctly allocated right hand vectors.
- L (list <https://docs.python.org/3/library/stdtypes.html#list> of Vec <#petsc4py.PETSc.Vec>) -- List of correctly allocated left hand vectors.
- Return type
- 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>
- logConvergenceHistory(rnorm)
- Add residual to convergence history.
Logically collective.
- Parameters
- rnorm (float <https://docs.python.org/3/library/functions.html#float>) -- Residual norm to be added to convergence history.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
Source code at petsc4py/PETSc/KSP.pyx:1203 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1203>
- matSolve(B, X)
- 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.
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>
- matSolveTranspose(B, X)
- 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.
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>
- monitor(its, rnorm)
- 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>
- its (int <https://docs.python.org/3/library/functions.html#int>)
- rnorm (float <https://docs.python.org/3/library/functions.html#float>)
- monitorCancel()
- Clear all monitors for a KSP object.
Logically collective.
See also:
Source code at petsc4py/PETSc/KSP.pyx:1279 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1279>
- reset()
- 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>
- setAppCtx(appctx)
- Set the optional user-defined context for the linear solver.
Not collective.
- Parameters
- appctx (Any <https://docs.python.org/3/library/typing.html#typing.Any>) -- The user defined context
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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:
Source code at petsc4py/PETSc/KSP.pyx:617 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L617>
- setComputeEigenvalues(flag)
- 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.
- Parameters
- flag (bool <https://docs.python.org/3/library/functions.html#bool>) -- Boolean whether to compute eigenvalues (or not).
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
Notes
Currently this option is not valid for all iterative methods.
See also:
Source code at petsc4py/PETSc/KSP.pyx:1404 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1404>
- setComputeOperators(operators, args=None, kargs=None)
- Set routine to compute the linear operators.
Logically collective.
- operators (KSPOperatorsFunction <#petsc4py.typing.KSPOperatorsFunction>) -- Function which computes the operators.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for callback function operators.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for callback function operators.
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>
- setComputeRHS(rhs, args=None, kargs=None)
- Set routine to compute the right-hand side of the linear system.
Logically collective.
- rhs (KSPRHSFunction <#petsc4py.typing.KSPRHSFunction>) -- Function which computes the right-hand side.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for callback function rhs.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for callback function rhs.
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>
- setComputeSingularValues(flag)
- 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.
- Parameters
- flag (bool <https://docs.python.org/3/library/functions.html#bool>) -- Boolean whether to compute singular values (or not).
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
Notes
Currently this option is not valid for all iterative methods.
See also:
Source code at petsc4py/PETSc/KSP.pyx:1448 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1448>
- setConvergedReason(reason)
- 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>
- Parameters
- reason (ConvergedReason <#petsc4py.PETSc.KSP.ConvergedReason>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setConvergenceHistory(length=None, reset=False)
- 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.
- length (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Length of array to store history in.
- reset (bool <https://docs.python.org/3/library/functions.html#bool>) -- True <https://docs.python.org/3/library/constants.html#True> indicates the history counter is reset to zero for each new linear solve.
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:
Source code at petsc4py/PETSc/KSP.pyx:1144 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1144>
- setConvergenceTest(converged, args=None, kargs=None)
- Set the function to be used to determine convergence.
Logically collective.
- converged (KSPConvergenceTestFunction <#petsc4py.typing.KSPConvergenceTestFunction>) -- Callback which computes the convergence.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for callback function.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for callback function.
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:
Source code at petsc4py/PETSc/KSP.pyx:1000 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1000>
- setDM(dm)
- Set the DM <#petsc4py.PETSc.DM> that may be used by some
preconditioners.
Logically collective.
- Parameters
- dm (DM <#petsc4py.PETSc.DM>) -- The DM <#petsc4py.PETSc.DM> object, cannot be None <https://docs.python.org/3/library/constants.html#None>.
- Return type
- 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:
Source code at petsc4py/PETSc/KSP.pyx:671 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L671>
- setDMActive(flag)
- DM <#petsc4py.PETSc.DM> should be used to generate system
matrix & RHS vector.
Logically collective.
- Parameters
- flag (bool <https://docs.python.org/3/library/functions.html#bool>) -- Whether to use the DM <#petsc4py.PETSc.DM>.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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:
Source code at petsc4py/PETSc/KSP.pyx:704 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L704>
- setErrorIfNotConverged(flag)
- Cause solve to generate an error if not converged.
Logically collective.
- Parameters
- flag (bool <https://docs.python.org/3/library/functions.html#bool>) -- True <https://docs.python.org/3/library/constants.html#True> enables this behavior.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/KSP.pyx:1928 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1928>
- setFromOptions()
- 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:
Source code at petsc4py/PETSc/KSP.pyx:600 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L600>
- setGMRESRestart(restart)
- Set number of iterations at which KSP restarts.
Logically collective.
Suitable KSPs are: KSPGMRES, KSPFGMRES and KSPLGMRES.
- Parameters
- restart (int <https://docs.python.org/3/library/functions.html#int>) -- Integer restart value.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setHPDDMType(hpddm_type)
- Set the Krylov solver type.
Collective.
- Parameters
- hpddm_type (HPDDMType <#petsc4py.PETSc.KSP.HPDDMType>) -- The type of Krylov solver to use.
- Return type
- 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>
- setInitialGuessKnoll(flag)
- Tell solver to use PC.apply <#petsc4py.PETSc.PC.apply> to
compute the initial guess.
Logically collective.
This is the Knoll trick.
- Parameters
- flag (bool <https://docs.python.org/3/library/functions.html#bool>) -- True <https://docs.python.org/3/library/constants.html#True> uses Knoll trick.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setInitialGuessNonzero(flag)
- 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).
- Parameters
- flag (bool <https://docs.python.org/3/library/functions.html#bool>) -- True <https://docs.python.org/3/library/constants.html#True> indicates the guess is non-zero, False <https://docs.python.org/3/library/constants.html#False> indicates the guess is zero.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setIterationNumber(its)
- Use its property.
Source code at petsc4py/PETSc/KSP.pyx:1849 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1849>
- setMonitor(monitor, args=None, kargs=None)
- 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.
- monitor (KSPMonitorFunction <#petsc4py.typing.KSPMonitorFunction>) -- Callback which monitors the convergence.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for callback function.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for callback function.
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:
Source code at petsc4py/PETSc/KSP.pyx:1219 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1219>
- setNormType(normtype)
- Set the norm that is used for convergence testing.
Logically collective.
- Parameters
- normtype (NormType <#petsc4py.PETSc.NormType>) -- The norm type to use (see NormType <#petsc4py.PETSc.KSP.NormType>).
- Return type
- 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:
Source code at petsc4py/PETSc/KSP.pyx:1363 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1363>
- setOperators(A=None, P=None)
- 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.
- A (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- Matrix that defines the linear system.
- P (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- Matrix to be used in constructing the preconditioner, usually the same as A.
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:
Source code at petsc4py/PETSc/KSP.pyx:809 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L809>
- setOptionsPrefix(prefix)
- Set the prefix used for all KSP options in the database.
Logically collective.
- Parameters
- prefix (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The options prefix.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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:
Source code at petsc4py/PETSc/KSP.pyx:523 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L523>
- setPC(pc)
- Set the preconditioner.
Collective.
Set the preconditioner to be used to calculate the application of the preconditioner on a vector.
- Parameters
- pc (PC <#petsc4py.PETSc.PC>) -- The preconditioner object
- Return type
- 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>
- setPCSide(side)
- Set the preconditioning side.
Logically collective.
- Parameters
- side (Side <#petsc4py.PETSc.PC.Side>) -- The preconditioning side (see PC.Side <#petsc4py.PETSc.PC.Side>).
- Return type
- 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:
Source code at petsc4py/PETSc/KSP.pyx:1315 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1315>
- setPostSolve(postsolve, args=None, kargs=None)
- Set the function that is called at the end of each KSP.solve.
Logically collective.
- postsolve (KSPPostSolveFunction <#petsc4py.typing.KSPPostSolveFunction> | None <https://docs.python.org/3/library/constants.html#None>) -- The callback function.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback function.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback function.
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>
- setPreSolve(presolve, args=None, kargs=None)
- Set the function that is called at the beginning of each KSP.solve.
Logically collective.
- presolve (KSPPreSolveFunction <#petsc4py.typing.KSPPreSolveFunction> | None <https://docs.python.org/3/library/constants.html#None>) -- The callback function.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback function.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback function.
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>
- setPythonContext(context=None)
- Set the instance of the class implementing Python methods.
Not collective.
See also:
Source code at petsc4py/PETSc/KSP.pyx:2183 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2183>
- setPythonType(py_type)
- Set the fully qualified Python name of the class to be used.
Collective.
See also:
Source code at petsc4py/PETSc/KSP.pyx:2210 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2210>
- setResidualNorm(rnorm)
- Use norm property.
Source code at petsc4py/PETSc/KSP.pyx:1860 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1860>
- setTolerances(rtol=None, atol=None, divtol=None, max_it=None)
- 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.
- rtol (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The relative convergence tolerance, relative decrease in the (possibly preconditioned) residual norm. Or DETERMINE <#petsc4py.PETSc.DETERMINE> to use the value when the object's type was set.
- atol (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The absolute convergence tolerance absolute size of the (possibly preconditioned) residual norm. Or DETERMINE <#petsc4py.PETSc.DETERMINE> to use the value when the object's type was set.
- dtol -- The divergence tolerance, amount (possibly preconditioned) residual norm can increase before KSPConvergedDefault <https://petsc.org/release/manualpages/KSP/KSPConvergedDefault.html> concludes that the method is diverging. Or DETERMINE <#petsc4py.PETSc.DETERMINE> to use the value when the object's type was set.
- max_it (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Maximum number of iterations to use. Or DETERMINE <#petsc4py.PETSc.DETERMINE> to use the value when the object's type was set.
- divtol (float <https://docs.python.org/3/library/functions.html#float> | 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:
Source code at petsc4py/PETSc/KSP.pyx:914 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L914>
- setType(ksp_type)
- Build the KSP data structure for a particular Type
<#petsc4py.PETSc.KSP.Type>.
Logically collective.
- Parameters
- ksp_type (Type <#petsc4py.PETSc.KSP.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- KSP Type object
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setUp()
- Set up internal data structures for an iterative solver.
Collective.
See also:
Source code at petsc4py/PETSc/KSP.pyx:1595 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1595>
- setUpOnBlocks()
- 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>
- setUseFischerGuess(model, size)
- 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.
- model (int <https://docs.python.org/3/library/functions.html#int>) -- Use model 1, model 2, model 3, any other number to turn it off.
- size (int <https://docs.python.org/3/library/functions.html#int>) -- Size of subspace used to generate initial guess.
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(b, x)
- Solve the linear system.
Collective.
- b (Vec <#petsc4py.PETSc.Vec>) -- Right hand side vector.
- x (Vec <#petsc4py.PETSc.Vec>) -- Solution vector.
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:
Source code at petsc4py/PETSc/KSP.pyx:1703 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L1703>
- solveTranspose(b, x)
- Solve the transpose of a linear system.
Collective.
- b (Vec <#petsc4py.PETSc.Vec>) -- Right hand side vector.
- x (Vec <#petsc4py.PETSc.Vec>) -- Solution vector.
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>
- view(viewer=None)
- Print the KSP data structure.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- Viewer used to display the KSP.
- Return type
- 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
- appctx
- 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>
- atol
- 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>
- divtol
- 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>
- dm
- 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>
- guess_knoll
- 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>
- guess_nonzero
- 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>
- history
- 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>
- is_converged
- 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>
- is_diverged
- 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>
- is_iterating
- 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>
- its
- 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>
- mat_op
- 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>
- mat_pc
- 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>
- max_it
- 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>
- norm
- 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>
- norm_type
- 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>
- pc
- 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>
- pc_side
- 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>
- reason
- 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>
- rtol
- 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>
- vec_rhs
- 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>
- vec_sol
- The solution vector.
Source code at petsc4py/PETSc/KSP.pyx:2262 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/KSP.pyx#L2262>
petsc4py.PETSc.LGMap¶
- class 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¶
- class petsc4py.PETSc.LGMap.GLMapMode
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Enum describing mapping behavior when global indices are missing.
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¶
- class petsc4py.PETSc.LGMap.Type
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Local to global map types.
Attributes Summary
BASIC Object BASIC of type str <https://docs.python.org/3/library/stdtypes.html#str> HASH Object HASH of type str <https://docs.python.org/3/library/stdtypes.html#str> Attributes Documentation
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
- apply(indices, result=None)
- Convert a locally numbered list of integers to a global numbering.
Not collective.
- indices (Sequence[int <https://docs.python.org/3/library/functions.html#int>]) -- Input indices in local numbering.
- result (ArrayInt <#petsc4py.typing.ArrayInt> | None <https://docs.python.org/3/library/constants.html#None>) -- Array to write the global numbering to. If None <https://docs.python.org/3/library/constants.html#None> then a new array will be allocated.
- Returns
- Indices in global numbering. If result is not None <https://docs.python.org/3/library/constants.html#None> then this is returned here.
- Return type
- 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>
- applyBlock(indices, result=None)
- Convert a local block numbering to a global block numbering.
Not collective.
- indices (Sequence[int <https://docs.python.org/3/library/functions.html#int>]) -- Input block indices in local numbering.
- result (ArrayInt <#petsc4py.typing.ArrayInt> | None <https://docs.python.org/3/library/constants.html#None>) -- Array to write the global numbering to. If None <https://docs.python.org/3/library/constants.html#None> then a new array will be allocated.
- Returns
- Block indices in global numbering. If result is not None <https://docs.python.org/3/library/constants.html#None> then this is returned here.
- Return type
- 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>
- applyBlockInverse(indices, mode=None)
- Compute blocked local numbering from blocked global numbering.
Not collective.
- indices (Sequence[int <https://docs.python.org/3/library/functions.html#int>]) -- Indices with a global block numbering.
- mode (GLMapMode <#petsc4py.PETSc.LGMap.GLMapMode> | str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- Flag indicating what to do with indices that have no local value, defaults to "mask".
- Returns
- Indices with a local block numbering.
- Return type
- 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>
- applyIS(iset)
- Create an index set with global numbering from a local numbering.
Collective.
- Parameters
- iset (IS <#petsc4py.PETSc.IS>) -- Index set with local numbering.
- Returns
- Index set with global numbering.
- Return type
- 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>
- applyInverse(indices, mode=None)
- Compute local numbering from global numbering.
Not collective.
- indices (Sequence[int <https://docs.python.org/3/library/functions.html#int>]) -- Indices with a global numbering.
- mode (GLMapMode <#petsc4py.PETSc.LGMap.GLMapMode> | str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- Flag indicating what to do with indices that have no local value, defaults to "mask".
- Returns
- Indices with a local numbering.
- Return type
- 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(indices, bsize=None, comm=None)
- Create a local-to-global mapping.
Not collective.
- indices (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Global index for each local element.
- bsize (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Block size, defaults to 1.
- 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>.
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>
- createIS(iset)
- Create a local-to-global mapping from an index set.
Not collective.
- Parameters
- iset (IS <#petsc4py.PETSc.IS>) -- Index set containing the global numbers for each local number.
- Return type
- 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>
- createSF(sf, start)
- Create a local-to-global mapping from a star forest.
Collective.
- sf (SF <#petsc4py.PETSc.SF>) -- Star forest mapping contiguous local indices to (rank, offset).
- start (int <https://docs.python.org/3/library/functions.html#int>) -- First global index on this process.
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>
- destroy()
- Destroy the local-to-global mapping.
Not collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:1241 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1241>
- getBlockIndices()
- 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>
- Return type
- ArrayInt <#petsc4py.typing.ArrayInt>
- getBlockInfo()
- Determine the block indices shared with neighboring processes.
Collective.
- Returns
- Mapping from neighboring processor number to an array of shared block indices (in local numbering).
- Return type
- 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>
- getBlockSize()
- 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>
- getIndices()
- 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>
- Return type
- ArrayInt <#petsc4py.typing.ArrayInt>
- getInfo()
- Determine the indices shared with neighboring processes.
Collective.
- Returns
- Mapping from neighboring processor number to an array of shared indices (in local numbering).
- Return type
- 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>
- getSize()
- 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(viewer)
- 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>
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer>)
- Return type
- Self <https://docs.python.org/3/library/typing.html#typing.Self>
- setFromOptions()
- Set mapping options from the options database.
Not collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:1192 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1192>
- setType(lgmap_type)
- Set the type of the local-to-global map.
Logically collective.
- Parameters
- 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.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
Notes
Use -islocaltoglobalmapping_type to set the type in the options database.
See also:
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(viewer=None)
- View the local-to-global mapping.
Not collective.
- Parameters
- 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>.
- Return type
- 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
- block_indices
- The global indices for each local block in the mapping.
Not collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:1688 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1688>
- block_info
- Mapping describing block indices shared with neighboring processes.
Collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:1714 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1714>
- block_size
- The block size.
Not collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:1662 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1662>
- indices
- The global indices for each local point in the mapping.
Not collective.
See also:
Source code at petsc4py/PETSc/IS.pyx:1675 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/IS.pyx#L1675>
- info
- 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>
- size
- The local size.
Not collective.
See also:
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¶
- class 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
- classmethod Class(name)
- Create a log class.
Not collective.
- Parameters
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- Class name.
- Returns
- klass -- The log class. If a class already exists with name name then it is reused.
- Return type
- 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>
- classmethod Event(name, klass=None)
- Create a log event.
Not collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- Event name.
- klass (LogClass <#petsc4py.PETSc.LogClass> | None <https://docs.python.org/3/library/constants.html#None>) -- Log class. If None <https://docs.python.org/3/library/constants.html#None>, defaults to PETSC_OBJECT_CLASSID.
- Returns
- event -- The log event. If an event already exists with name name then it is reused.
- Return type
- 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>
- classmethod EventDecorator(name=None, klass=None)
- Decorate a function with a PETSc <#module-petsc4py.PETSc>
event.
Source code at petsc4py/PETSc/Log.pyx:240 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L240>
- classmethod Stage(name)
- Create a log stage.
Not collective.
- Parameters
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- Stage name.
- Returns
- stage -- The log stage. If a stage already exists with name name then it is reused.
- Return type
- 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>
- classmethod addFlops(flops)
- Add floating point operations to the current event.
Not collective.
- Parameters
- flops (float <https://docs.python.org/3/library/functions.html#float>) -- The number of flops to log.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- classmethod begin()
- Turn on logging of objects and events.
Collective.
See also:
Source code at petsc4py/PETSc/Log.pyx:117 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L117>
- classmethod getCPUTime()
- Return the CPU time.
Source code at petsc4py/PETSc/Log.pyx:233 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L233>
- classmethod getFlops()
- Return the number of flops used on this processor since the program began.
Not collective.
- Returns
- Number of floating point operations.
- Return type
- 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>
- classmethod getTime()
- Return the current time of day in seconds.
Collective.
- Returns
- wctime -- Current time.
- Return type
- float <https://docs.python.org/3/library/functions.html#float>
See also:
Source code at petsc4py/PETSc/Log.pyx:213 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L213>
- classmethod isActive()
- Return whether logging is currently in progress.
Not collective.
See also:
Source code at petsc4py/PETSc/Log.pyx:255 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L255>
- classmethod logFlops(flops)
- Add floating point operations to the current event.
Not collective.
- Parameters
- flops (float <https://docs.python.org/3/library/functions.html#float>) -- The number of flops to log.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Log.pyx:151 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L151>
- classmethod view(viewer=None)
- Print the log.
Collective.
- Parameters
- 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.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
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¶
- class 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
- activate()
- Activate the log class.
Source code at petsc4py/PETSc/Log.pyx:493 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L493>
- deactivate()
- Deactivate the log class.
Source code at petsc4py/PETSc/Log.pyx:497 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L497>
- getActive()
- Not implemented.
Source code at petsc4py/PETSc/Log.pyx:501 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L501>
- getName()
- Return the log class name.
Source code at petsc4py/PETSc/Log.pyx:476 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L476>
- setActive(flag)
- Activate or deactivate the log class.
Source code at petsc4py/PETSc/Log.pyx:506 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L506>
Attributes Documentation
- active
- Log class activation.
Source code at petsc4py/PETSc/Log.pyx:513 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L513>
- id
- 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>
- name
- The log class name.
Source code at petsc4py/PETSc/Log.pyx:482 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L482>
petsc4py.PETSc.LogEvent¶
- class 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
- activate()
- Indicate that the event should be logged.
Logically collective.
See also:
Source code at petsc4py/PETSc/Log.pyx:614 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L614>
- begin(*objs)
- Log the beginning of a user event.
Collective.
- Parameters
- *objs -- objects associated with the event
- Return type
- 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>
- deactivate()
- Indicate that the event should not be logged.
Logically collective.
See also:
Source code at petsc4py/PETSc/Log.pyx:626 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L626>
- end(*objs)
- Log the end of a user event.
Collective.
- Parameters
- *objs -- Objects associated with the event.
- Return type
- 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>
- getActive()
- Not implemented.
Source code at petsc4py/PETSc/Log.pyx:638 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L638>
- getActiveAll()
- Not implemented.
Source code at petsc4py/PETSc/Log.pyx:671 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L671>
- getName()
- The current event name.
Source code at petsc4py/PETSc/Log.pyx:597 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L597>
- getPerfInfo(stage=None)
- Get the performance information about the given event in the given event.
Not collective.
- Parameters
- stage (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- The stage number.
- Returns
- info -- This structure is filled with the performance information.
- Return type
- 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>
- setActive(flag)
- Indicate whether or not the event should be logged.
Logically collective.
- Parameters
- flag (bool <https://docs.python.org/3/library/functions.html#bool>) -- Activate or deactivate the event.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Log.pyx:643 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L643>
- setActiveAll(flag)
- Turn on logging of all events.
Logically collective.
- Parameters
- flag (bool <https://docs.python.org/3/library/functions.html#bool>) -- Activate (if True <https://docs.python.org/3/library/constants.html#True>) or deactivate (if False <https://docs.python.org/3/library/constants.html#False>) the logging of all events.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Log.pyx:676 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L676>
Attributes Documentation
- active
- Event activation.
Source code at petsc4py/PETSc/Log.pyx:663 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L663>
- active_all
- All events activation.
Source code at petsc4py/PETSc/Log.pyx:695 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L695>
- id
- 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>
- name
- 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¶
- class 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
- activate()
- Activate the stage.
Logically collective.
See also:
Source code at petsc4py/PETSc/Log.pyx:341 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L341>
- deactivate()
- Deactivate the stage.
Logically collective.
See also:
Source code at petsc4py/PETSc/Log.pyx:353 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L353>
- getActive()
- Check if the stage is activated.
Not collective.
See also:
Source code at petsc4py/PETSc/Log.pyx:365 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L365>
- getName()
- Return the current stage name.
Source code at petsc4py/PETSc/Log.pyx:324 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L324>
- getVisible()
- Return whether the stage is visible.
Not collective.
See also:
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()
- 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()
- 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>
- setActive(flag)
- Activate or deactivate the current stage.
Logically collective.
See also:
Source code at petsc4py/PETSc/Log.pyx:379 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L379>
- setVisible(flag)
- Set the visibility of the stage.
Logically collective.
- Parameters
- flag (bool <https://docs.python.org/3/library/functions.html#bool>) -- True <https://docs.python.org/3/library/constants.html#True> to make the stage visible, False <https://docs.python.org/3/library/constants.html#False> otherwise.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Log.pyx:417 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Log.pyx#L417>
Attributes Documentation
- active
- 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>
- id
- 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>
- name
- 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>
- visible
- 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¶
- class 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¶
- class petsc4py.PETSc.Mat.AssemblyType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Matrix assembly type.
See also:
Attributes Summary
| FINAL | Constant FINAL of type int <https://docs.python.org/3/library/functions.html#int> |
| FINAL_ASSEMBLY | Constant FINAL_ASSEMBLY of type int <https://docs.python.org/3/library/functions.html#int> |
| FLUSH | Constant FLUSH of type int <https://docs.python.org/3/library/functions.html#int> |
| FLUSH_ASSEMBLY | Constant FLUSH_ASSEMBLY of type int <https://docs.python.org/3/library/functions.html#int> |
Attributes Documentation
petsc4py.PETSc.Mat.DuplicateOption¶
- class 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¶
- class 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¶
- class petsc4py.PETSc.Mat.InfoType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Matrix info type.
Attributes Summary
GLOBAL_MAX Constant GLOBAL_MAX of type int <https://docs.python.org/3/library/functions.html#int> GLOBAL_SUM Constant GLOBAL_SUM of type int <https://docs.python.org/3/library/functions.html#int> LOCAL Constant LOCAL of type int <https://docs.python.org/3/library/functions.html#int> Attributes Documentation
petsc4py.PETSc.Mat.Option¶
- class 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¶
- class 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¶
- class 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¶
- class petsc4py.PETSc.Mat.SolverType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Factored matrix solver type.
See also:
Attributes Summary
Attributes Documentation
petsc4py.PETSc.Mat.Stencil¶
- class 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
- c
- Field component.
Source code at petsc4py/PETSc/Mat.pyx:320 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L320>
- field
- Field component.
Source code at petsc4py/PETSc/Mat.pyx:339 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L339>
- i
- 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>
- index
- 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>
- j
- 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>
- k
- 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¶
- class petsc4py.PETSc.Mat.Structure
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Matrix modification structure.
See also:
Attributes Summary
Attributes Documentation
petsc4py.PETSc.Mat.Type¶
- class petsc4py.PETSc.Mat.Type
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Matrix type.
See also:
Attributes Summary
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
- H2OpusCompress(tol)
- Compress a hierarchical matrix.
Collective.
- Parameters
- tol (float <https://docs.python.org/3/library/functions.html#float>) -- The absolute truncation threshold.
- Return type
- Self <https://docs.python.org/3/library/typing.html#typing.Self>
See also:
Source code at petsc4py/PETSc/Mat.pyx:5124 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5124>
- H2OpusLowRankUpdate(U, V=None, s=1.0)
- Perform a low-rank update of the form self += sUVᵀ.
Collective.
- U (Mat <#petsc4py.PETSc.Mat>) -- The dense low-rank update matrix.
- V (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The dense low-rank update matrix. If None <https://docs.python.org/3/library/constants.html#None>, V = U.
- s (float <https://docs.python.org/3/library/functions.html#float>) -- The scaling factor.
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>
- H2OpusOrthogonalize()
- Orthogonalize the basis tree of a hierarchical matrix.
Collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:5111 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5111>
- SOR(b, x, omega=1.0, sortype=None, shift=0.0, its=1, lits=1)
- Compute relaxation (SOR, Gauss-Seidel) sweeps.
Neighborwise collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:3957 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3957>
- b (Vec <#petsc4py.PETSc.Vec>)
- x (Vec <#petsc4py.PETSc.Vec>)
- omega (float <https://docs.python.org/3/library/functions.html#float>)
- sortype (SORType <#petsc4py.PETSc.Mat.SORType> | None <https://docs.python.org/3/library/constants.html#None>)
- shift (float <https://docs.python.org/3/library/functions.html#float>)
- its (int <https://docs.python.org/3/library/functions.html#int>)
- lits (int <https://docs.python.org/3/library/functions.html#int>)
- appendOptionsPrefix(prefix=None)
- Append to the prefix used for searching for options in the database.
Logically collective.
See also:
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(assembly=None)
- Assemble the matrix.
Collective.
- Parameters
- assembly (MatAssemblySpec <#petsc4py.typing.MatAssemblySpec>) -- The assembly type.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Mat.pyx:3470 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3470>
- assemblyBegin(assembly=None)
- Begin an assembling stage of the matrix.
Collective.
- Parameters
- assembly (MatAssemblySpec <#petsc4py.typing.MatAssemblySpec>) -- The assembly type.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Mat.pyx:3434 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3434>
- assemblyEnd(assembly=None)
- Complete an assembling stage of the matrix initiated with
assemblyBegin.
Collective.
- Parameters
- assembly (MatAssemblySpec <#petsc4py.typing.MatAssemblySpec>) -- The assembly type.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Mat.pyx:3452 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3452>
- axpy(alpha, X, structure=None)
- 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.
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>
- aypx(alpha, X, structure=None)
- 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.
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>
- bindToCPU(flg)
- Mark a matrix to temporarily stay on the CPU.
Collective.
Once marked, perform computations on the CPU.
- Parameters
- flg (bool <https://docs.python.org/3/library/functions.html#bool>) -- Bind to the CPU if True <https://docs.python.org/3/library/constants.html#True>.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Mat.pyx:4652 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4652>
- boundToCPU()
- Query if a matrix is bound to the CPU.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:4672 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4672>
- chop(tol)
- Set entries smallest of tol (in absolute values) to zero.
Collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:4253 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4253>
- conjugate(out=None)
- Return the conjugate matrix.
Collective.
- Parameters
- 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.
- Return type
- 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(mat_type=None, out=None)
- Convert the matrix type.
Collective.
- mat_type (Type <#petsc4py.PETSc.Mat.Type> | str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The type of the new matrix. If None <https://docs.python.org/3/library/constants.html#None> uses Type.SAME <#petsc4py.PETSc.Mat.Type.SAME>.
- 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 conversion is performed. Otherwise, the matrix is reused.
- Return type
- 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>
- copy(result=None, structure=None)
- Return a copy of the matrix.
Collective.
- result (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>, it is internally created.
- structure (Structure <#petsc4py.PETSc.Mat.Structure> | None <https://docs.python.org/3/library/constants.html#None>) -- The copy structure. Only relevant if result is not None <https://docs.python.org/3/library/constants.html#None>.
- Return type
- 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(comm=None)
- 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.
- Parameters
- 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>.
- Return type
- 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>
- createAIJ(size, bsize=None, nnz=None, csr=None, comm=None)
- 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.
- size (MatSizeSpec <#petsc4py.typing.MatSizeSpec>) -- Matrix size.
- bsize (MatBlockSizeSpec <#petsc4py.typing.MatBlockSizeSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Matrix block size. If None <https://docs.python.org/3/library/constants.html#None>, a block size of 1 is set.
- nnz (NNZSpec <#petsc4py.typing.NNZSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional non-zeros preallocation pattern.
- csr (CSRIndicesSpec <#petsc4py.typing.CSRIndicesSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional compressed sparse row layout information. If provided, it takes precedence on nnz.
- 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>.
- Return type
- 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>
- createAIJCRL(size, bsize=None, nnz=None, csr=None, comm=None)
- 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.
- size (MatSizeSpec <#petsc4py.typing.MatSizeSpec>) -- Matrix size.
- bsize (MatBlockSizeSpec <#petsc4py.typing.MatBlockSizeSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Matrix block size. If None <https://docs.python.org/3/library/constants.html#None>, a block size of 1 is set.
- nnz (NNZSpec <#petsc4py.typing.NNZSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional non-zeros preallocation pattern.
- csr (CSRIndicesSpec <#petsc4py.typing.CSRIndicesSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional compressed sparse row layout information. If provided, it takes precedence on nnz.
- 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>.
- Return type
- 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>
- createAIJWithArrays(size, csr, bsize=None, comm=None)
- Create a sparse Type.AIJ <#petsc4py.PETSc.Mat.Type.AIJ>
matrix with data in CSR format.
Collective.
- size (MatSizeSpec <#petsc4py.typing.MatSizeSpec>) -- Matrix size.
- csr (CSRSpec <#petsc4py.typing.CSRSpec> | tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[CSRSpec <#petsc4py.typing.CSRSpec>, CSRSpec <#petsc4py.typing.CSRSpec>]) -- Local matrix data in compressed sparse row format.
- bsize (MatBlockSizeSpec <#petsc4py.typing.MatBlockSizeSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Matrix block size. If None <https://docs.python.org/3/library/constants.html#None>, a block size of 1 is set.
- 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>.
- Return type
- 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>
- createBAIJ(size, bsize, nnz=None, csr=None, comm=None)
- 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.
- size (MatSizeSpec <#petsc4py.typing.MatSizeSpec>) -- Matrix size.
- bsize (MatBlockSizeSpec <#petsc4py.typing.MatBlockSizeSpec>) -- Matrix block size.
- nnz (NNZSpec <#petsc4py.typing.NNZSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional non-zeros preallocation pattern for block rows.
- csr (CSRIndicesSpec <#petsc4py.typing.CSRIndicesSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional block-compressed sparse row layout information. If provided, it takes precedence on nnz.
- 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>.
- Return type
- 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>
- createConstantDiagonal(size, diag, comm=None)
- Create a diagonal matrix of type Type.CONSTANTDIAGONAL
<#petsc4py.PETSc.Mat.Type.CONSTANTDIAGONAL>.
Collective.
- size (MatSizeSpec <#petsc4py.typing.MatSizeSpec>) -- Matrix size.
- diag (float <https://docs.python.org/3/library/functions.html#float>) -- The diagonal value.
- 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>.
See also:
Source code at petsc4py/PETSc/Mat.pyx:1655 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1655>
- createDense(size, bsize=None, array=None, comm=None)
- Create a Type.DENSE <#petsc4py.PETSc.Mat.Type.DENSE> matrix.
Collective.
- size (MatSizeSpec <#petsc4py.typing.MatSizeSpec>) -- Matrix size.
- bsize (MatBlockSizeSpec <#petsc4py.typing.MatBlockSizeSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Matrix block size. If None <https://docs.python.org/3/library/constants.html#None>, a block size of 1 is set.
- array (Sequence[Scalar <#petsc4py.typing.Scalar>] | None <https://docs.python.org/3/library/constants.html#None>) -- Optional matrix data. If None <https://docs.python.org/3/library/constants.html#None>, memory is internally allocated.
- 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>.
- Return type
- 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>
- createDenseCUDA(size, bsize=None, array=None, cudahandle=None, comm=None)
- Create a Type.DENSECUDA <#petsc4py.PETSc.Mat.Type.DENSECUDA>
matrix with optional host and device data.
Collective.
- size (MatSizeSpec <#petsc4py.typing.MatSizeSpec>) -- Matrix size.
- bsize (MatBlockSizeSpec <#petsc4py.typing.MatBlockSizeSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Matrix block size. If None <https://docs.python.org/3/library/constants.html#None>, a block size of 1 is set.
- array (Sequence[Scalar <#petsc4py.typing.Scalar>] | None <https://docs.python.org/3/library/constants.html#None>) -- Host data. Will be lazily allocated if None <https://docs.python.org/3/library/constants.html#None>.
- cudahandle (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Address of the array on the GPU. Will be lazily allocated if None <https://docs.python.org/3/library/constants.html#None>. If cudahandle is provided, array will be ignored.
- 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>.
- Return type
- 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>
- createDiagonal(diag)
- Create a diagonal matrix of type Type.DIAGONAL
<#petsc4py.PETSc.Mat.Type.DIAGONAL>.
Collective.
- Parameters
- diag (Vec <#petsc4py.PETSc.Vec>) -- The vector holding diagonal values.
- Return type
- Self <https://docs.python.org/3/library/typing.html#typing.Self>
See also:
Source code at petsc4py/PETSc/Mat.pyx:1688 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1688>
- createH2OpusFromMat(A, coordinates=None, dist=None, eta=None, leafsize=None, maxrank=None, bs=None, rtol=None)
- Create a hierarchical Type.H2OPUS
<#petsc4py.PETSc.Mat.Type.H2OPUS> matrix sampling from a provided
operator.
Collective.
- A (Mat <#petsc4py.PETSc.Mat>) -- Matrix to be sampled.
- coordinates (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>) -- Coordinates of the points.
- dist (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Whether or not coordinates are distributed, defaults to False <https://docs.python.org/3/library/constants.html#False>.
- eta (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- Admissibility condition tolerance, defaults to DECIDE <#petsc4py.PETSc.DECIDE>.
- leafsize (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Leaf size in cluster tree, defaults to DECIDE <#petsc4py.PETSc.DECIDE>.
- maxrank (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Maximum rank permitted, defaults to DECIDE <#petsc4py.PETSc.DECIDE>.
- bs (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Maximum number of samples to take concurrently, defaults to DECIDE <#petsc4py.PETSc.DECIDE>.
- rtol (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- Relative tolerance for construction, defaults to DECIDE <#petsc4py.PETSc.DECIDE>.
Notes
See MatCreateH2OpusFromMat <https://petsc.org/release/manualpages/Mat/MatCreateH2OpusFromMat.html> for the appropriate database options.
See also:
Source code at petsc4py/PETSc/Mat.pyx:1521 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1521>
- createHermitianTranspose(mat)
- Create a Type.HERMITIANTRANSPOSE
<#petsc4py.PETSc.Mat.Type.HERMITIANTRANSPOSE> matrix that behaves
like (A*)ᵀ.
Collective.
- Parameters
- mat (Mat <#petsc4py.PETSc.Mat>) -- Matrix A to represent the hermitian transpose of.
- Return type
- Self <https://docs.python.org/3/library/typing.html#typing.Self>
Notes
The Hermitian transpose is never actually formed.
See also:
Source code at petsc4py/PETSc/Mat.pyx:1350 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1350>
- createIS(size, bsize=None, lgmapr=None, lgmapc=None, comm=None)
- Create a Type.IS <#petsc4py.PETSc.Mat.Type.IS> matrix
representing globally unassembled operators.
Collective.
- size (MatSizeSpec <#petsc4py.typing.MatSizeSpec>) -- Matrix size.
- bsize (MatBlockSizeSpec <#petsc4py.typing.MatBlockSizeSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Matrix block size. If None <https://docs.python.org/3/library/constants.html#None>, a block size of 1 is set.
- lgmapr (LGMap <#petsc4py.PETSc.LGMap> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional local-to-global mapping for the rows. If None <https://docs.python.org/3/library/constants.html#None>, the local row space matches the global row space.
- lgmapc (LGMap <#petsc4py.PETSc.LGMap> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional local-to-global mapping for the columns. If None <https://docs.python.org/3/library/constants.html#None>, the local column space matches the global column space.
- 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>.
- Return type
- 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>
- createLRC(A, U, c, V)
- Create a low-rank correction Type.LRC
<#petsc4py.PETSc.Mat.Type.LRC> matrix representing A + UCVᵀ.
Collective.
- A (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- Sparse matrix, can be None <https://docs.python.org/3/library/constants.html#None>.
- U (Mat <#petsc4py.PETSc.Mat>) -- Dense rectangular matrix.
- c (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector containing the diagonal of C, can be None <https://docs.python.org/3/library/constants.html#None>.
- V (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- Dense rectangular matrix, can be set to U or 'None'.
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>
- createNest(mats, isrows=None, iscols=None, comm=None)
- Create a Type.NEST <#petsc4py.PETSc.Mat.Type.NEST> matrix
containing multiple submatrices.
Collective.
- mats (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Mat <#petsc4py.PETSc.Mat>]]) -- Iterable of matrix block rows with size len(isrows). Each matrix block row must be of size len(iscols). Empty submatrices can be set with None <https://docs.python.org/3/library/constants.html#None>.
- isrows (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[IS <#petsc4py.PETSc.IS>] | None <https://docs.python.org/3/library/constants.html#None>) -- Index set for each nested row block, defaults to contiguous ordering.
- iscols (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[IS <#petsc4py.PETSc.IS>] | None <https://docs.python.org/3/library/constants.html#None>) -- Index set for each nested column block, defaults to contiguous ordering.
- 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>.
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>
- createNormal(mat)
- Create a Type.NORMAL <#petsc4py.PETSc.Mat.Type.NORMAL> matrix
representing AᵀA.
Collective.
- Parameters
- mat (Mat <#petsc4py.PETSc.Mat>) -- The (possibly rectangular) matrix A.
- Return type
- 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>
- createNormalHermitian(mat)
- Create a Type.NORMALHERMITIAN
<#petsc4py.PETSc.Mat.Type.NORMALHERMITIAN> matrix representing
(A*)ᵀA.
Collective.
- Parameters
- mat (Mat <#petsc4py.PETSc.Mat>) -- The (possibly rectangular) matrix A.
- Return type
- 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>
- createPython(size, context=None, comm=None)
- Create a Type.PYTHON <#petsc4py.PETSc.Mat.Type.PYTHON>
matrix.
Collective.
- size (MatSizeSpec <#petsc4py.typing.MatSizeSpec>) -- Matrix size.
- context (Any <https://docs.python.org/3/library/typing.html#typing.Any>) -- An instance of the Python class implementing the required methods.
- 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>.
See also:
Source code at petsc4py/PETSc/Mat.pyx:1711 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1711>
- createSBAIJ(size, bsize, nnz=None, csr=None, comm=None)
- 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.
- size (MatSizeSpec <#petsc4py.typing.MatSizeSpec>) -- Matrix size.
- bsize (MatBlockSizeSpec <#petsc4py.typing.MatBlockSizeSpec>) -- Matrix block size.
- nnz (NNZSpec <#petsc4py.typing.NNZSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional upper-triangular (including diagonal) non-zeros preallocation pattern for block rows.
- csr (CSRIndicesSpec <#petsc4py.typing.CSRIndicesSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional block-compressed sparse row layout information. If provided, it takes precedence on nnz.
- 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>.
- Return type
- 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>
- createScatter(scatter, comm=None)
- Create a Type.SCATTER <#petsc4py.PETSc.Mat.Type.SCATTER>
matrix from a vector scatter.
Collective.
- scatter (Scatter <#petsc4py.PETSc.Scatter>) -- Vector scatter.
- 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>.
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>
- createSchurComplement(A00, Ap00, A01, A10, A11=None)
- 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].
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>
- createSubMatrices(isrows, iscols=None, submats=None)
- Return several sequential submatrices.
Collective.
- isrows (IS <#petsc4py.PETSc.IS> | Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[IS <#petsc4py.PETSc.IS>]) -- Row index sets.
- iscols (IS <#petsc4py.PETSc.IS> | Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[IS <#petsc4py.PETSc.IS>] | None <https://docs.python.org/3/library/constants.html#None>) -- Column index sets. If None <https://docs.python.org/3/library/constants.html#None>, iscols = isrows.
- submats (Mat <#petsc4py.PETSc.Mat> | Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Mat <#petsc4py.PETSc.Mat>] | None <https://docs.python.org/3/library/constants.html#None>) -- Optional resultant matrices. When None <https://docs.python.org/3/library/constants.html#None>, new matrices are created, and MAT_INITIAL_MATRIX is used. When not None <https://docs.python.org/3/library/constants.html#None>, the matrices are reused with MAT_REUSE_MATRIX.
- Return type
- 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>
- createSubMatrix(isrow, iscol=None, submat=None)
- Return a submatrix.
Collective.
- isrow (IS <#petsc4py.PETSc.IS>) -- Row index set.
- iscol (IS <#petsc4py.PETSc.IS> | None <https://docs.python.org/3/library/constants.html#None>) -- Column index set. If None <https://docs.python.org/3/library/constants.html#None>, iscol = isrow.
- submat (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional resultant matrix. When None <https://docs.python.org/3/library/constants.html#None>, a new matrix is created, and MAT_INITIAL_MATRIX is used. When not None <https://docs.python.org/3/library/constants.html#None>, the matrix is reused with MAT_REUSE_MATRIX.
- Return type
- 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>
- createSubMatrixVirtual(A, isrow, iscol=None)
- 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.
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>
- createTranspose(mat)
- Create a Type.TRANSPOSE <#petsc4py.PETSc.Mat.Type.TRANSPOSE>
matrix that behaves like Aᵀ.
Collective.
- Parameters
- mat (Mat <#petsc4py.PETSc.Mat>) -- Matrix A to represent the transpose of.
- Return type
- 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>
- createVecLeft()
- Return a left vector, a vector that the matrix vector product can be
stored in.
Collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:3570 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3570>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- createVecRight()
- Return a right vector, a vector that the matrix can be multiplied against.
Collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:3556 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3556>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- createVecs(side=None)
- Return vectors that can be used in matrix vector products.
Collective.
- Parameters
- 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.
- Return type
- 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:
Source code at petsc4py/PETSc/Mat.pyx:3517 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3517>
- destroy()
- Destroy the matrix.
Collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:478 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L478>
- diagonalScale(L=None, R=None)
- Perform left and/or right diagonal scaling of the matrix.
Collective.
- L (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional left scaling vector.
- R (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional right scaling vector.
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>
- duplicate(copy=False)
- Return a clone of the matrix.
Collective.
- Parameters
- 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.
- Return type
- 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>
- equal(mat)
- 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>
- Parameters
- mat (Mat <#petsc4py.PETSc.Mat>)
- Return type
- bool <https://docs.python.org/3/library/functions.html#bool>
- factorCholesky(isperm, options=None)
- Perform an in-place Cholesky factorization.
Collective.
- isperm (IS <#petsc4py.PETSc.IS>) -- The row and column permutations.
- options (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- An optional dictionary of options for the factorization. These include fill, the expected fill as a ratio of the original fill.
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>
- factorICC(isperm, options=None)
- Perform an in-place an incomplete Cholesky factorization.
Collective.
- isperm (IS <#petsc4py.PETSc.IS>) -- The row and column permutations
- options (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- An optional dictionary of options for the factorization. These include fill, the expected fill as a ratio of the original fill.
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>
- factorILU(isrow, iscol, options=None)
- Perform an in-place ILU factorization.
Collective.
- isrow (IS <#petsc4py.PETSc.IS>) -- The row permutation.
- iscol (IS <#petsc4py.PETSc.IS>) -- The column permutation.
- options (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- An optional dictionary of options for the factorization. These include levels, the number of levels of fill, fill, the expected fill as a ratio of the original fill, and dtcol, the pivot tolerance where 0 indicates no pivot and 1 indicates full column pivoting.
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>
- factorLU(isrow, iscol, options=None)
- Perform an in-place LU factorization.
Collective.
- isrow (IS <#petsc4py.PETSc.IS>) -- The row permutation.
- iscol (IS <#petsc4py.PETSc.IS>) -- The column permutation.
- options (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- An optional dictionary of options for the factorization. These include fill, the expected fill as a ratio of the original fill and dtcol, the pivot tolerance where 0 indicates no pivot and 1 indicates full column pivoting.
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>
- factorNumericCholesky(mat, options=None)
- Not implemented.
Source code at petsc4py/PETSc/Mat.pyx:4845 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4845>
- Parameters
- mat (Mat <#petsc4py.PETSc.Mat>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- factorNumericLU(mat, options=None)
- Not implemented.
Source code at petsc4py/PETSc/Mat.pyx:4778 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4778>
- Parameters
- mat (Mat <#petsc4py.PETSc.Mat>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- factorSymbolicCholesky(isperm, options=None)
- Not implemented.
Source code at petsc4py/PETSc/Mat.pyx:4841 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4841>
- Parameters
- isperm (IS <#petsc4py.PETSc.IS>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- factorSymbolicICC(isperm, options=None)
- Not implemented.
Source code at petsc4py/PETSc/Mat.pyx:4874 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4874>
- Parameters
- isperm (IS <#petsc4py.PETSc.IS>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- factorSymbolicILU(isrow, iscol, options=None)
- Not implemented.
Source code at petsc4py/PETSc/Mat.pyx:4812 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4812>
- isrow (IS <#petsc4py.PETSc.IS>)
- iscol (IS <#petsc4py.PETSc.IS>)
- factorSymbolicLU(mat, isrow, iscol, options=None)
- 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>)
- findZeroRows()
- 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>
- Return type
- IS <#petsc4py.PETSc.IS>
- fixISLocalEmpty(fix=True)
- Compress out zero local rows from the local matrices.
Collective.
- Parameters
- 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.
- Return type
- 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>
- getBlockSize()
- Return the matrix block size.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:1968 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1968>
- getBlockSizes()
- Return the row and column block sizes.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:1982 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1982>
- getColumnIJ(symmetric=False, compressed=False)
- Return the CSC representation of the local sparsity pattern.
Collective.
- symmetric (bool <https://docs.python.org/3/library/functions.html#bool>) -- If True <https://docs.python.org/3/library/constants.html#True>, return the symmetrized graph.
- compressed (bool <https://docs.python.org/3/library/functions.html#bool>) -- If True <https://docs.python.org/3/library/constants.html#True>, return the compressed graph.
- Return type
- 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>
- getColumnVector(column, result=None)
- Return the columnᵗʰ column vector of the matrix.
Collective.
- column (int <https://docs.python.org/3/library/functions.html#int>) -- Column index.
- result (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional vector to store the result.
- Return type
- 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>
- getDM()
- 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>
- Return type
- DM <#petsc4py.PETSc.DM>
- getDenseArray(readonly=False)
- Return the array where the data is stored.
Not collective.
- Parameters
- readonly (bool <https://docs.python.org/3/library/functions.html#bool>) -- Enable to obtain a read only array.
- Return type
- 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>
- getDenseColumnVec(i, mode='rw')
- Return the iᵗʰ column vector of the dense matrix.
Collective.
- i (int <https://docs.python.org/3/library/functions.html#int>) -- The column index to access.
- mode (AccessModeSpec <#petsc4py.typing.AccessModeSpec>) -- The access type of the vector to be returned.
- Return type
- 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>
- getDenseLDA()
- 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>
- getDenseLocalMatrix()
- 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>
- Return type
- Mat <#petsc4py.PETSc.Mat>
- getDenseSubMatrix(rbegin=DECIDE, rend=DECIDE, cbegin=DECIDE, cend=DECIDE)
- Get access to a submatrix of a Type.DENSE
<#petsc4py.PETSc.Mat.Type.DENSE> matrix.
Collective.
- rbegin (int <https://docs.python.org/3/library/functions.html#int>) -- the first global row index.
- rend (int <https://docs.python.org/3/library/functions.html#int>) -- the global row index past the last one.
- cbegin (int <https://docs.python.org/3/library/functions.html#int>) -- the first global column index.
- cend (int <https://docs.python.org/3/library/functions.html#int>) -- the global column index past the last one.
- Return type
- Mat <#petsc4py.PETSc.Mat>
See also:
Source code at petsc4py/PETSc/Mat.pyx:5624 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5624>
- getDiagonal(result=None)
- Return the diagonal of the matrix.
Collective.
- Parameters
- result (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional vector to store the result.
- Return type
- 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>
- getDiagonalBlock()
- 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>
- Return type
- Mat <#petsc4py.PETSc.Mat>
- getISAllowRepeated()
- 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>
- getISLocalMat()
- 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>
- Return type
- Mat <#petsc4py.PETSc.Mat>
- getInertia()
- Return the inertia from a factored matrix.
Collective.
The matrix must have been factored by calling factorCholesky.
- n (int <https://docs.python.org/3/library/functions.html#int>) -- The number of negative eigenvalues.
- z (int <https://docs.python.org/3/library/functions.html#int>) -- The number of zero eigenvalues.
- p (int <https://docs.python.org/3/library/functions.html#int>) -- The number of positive eigenvalues.
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>
- getInfo(info=None)
- Return summary information.
Collective.
- Parameters
- info (InfoType <#petsc4py.PETSc.Mat.InfoType> | None <https://docs.python.org/3/library/constants.html#None>) -- If None <https://docs.python.org/3/library/constants.html#None>, it uses InfoType.GLOBAL_SUM <#petsc4py.PETSc.Mat.InfoType.GLOBAL_SUM>.
- Return type
- dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, float <https://docs.python.org/3/library/functions.html#float>]
See also:
Source code at petsc4py/PETSc/Mat.pyx:2078 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2078>
- getLGMap()
- 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>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[LGMap <#petsc4py.PETSc.LGMap>, LGMap <#petsc4py.PETSc.LGMap>]
- getLMVMJ0()
- 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>
- Return type
- Mat <#petsc4py.PETSc.Mat>
- getLMVMJ0KSP()
- 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>
- Return type
- Mat <#petsc4py.PETSc.Mat>
- getLRCMats()
- 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.
- Return type
- 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>
- getLocalSize()
- Return the local number of rows and columns.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:1938 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1938>
- getLocalSubMatrix(isrow, iscol, submat=None)
- Return a reference to a submatrix specified in local numbering.
Collective.
- isrow (IS <#petsc4py.PETSc.IS>) -- Row index set.
- iscol (IS <#petsc4py.PETSc.IS>) -- Column index set.
- submat (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional resultant matrix. When None <https://docs.python.org/3/library/constants.html#None>, a new matrix is created. When not None <https://docs.python.org/3/library/constants.html#None>, the matrix is first destroyed and then recreated.
- Return type
- Mat <#petsc4py.PETSc.Mat>
See also:
Source code at petsc4py/PETSc/Mat.pyx:4156 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4156>
- getMumpsCntl(icntl)
- Return the MUMPS parameter, CNTL[icntl].
Logically collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:5292 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5292>
- getMumpsIcntl(icntl)
- Return the MUMPS parameter, ICNTL[icntl].
Logically collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:5256 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5256>
- getMumpsInfo(icntl)
- Return the MUMPS parameter, INFO[icntl].
Logically collective.
- Parameters
- icntl (int <https://docs.python.org/3/library/functions.html#int>) -- The index of the MUMPS INFO array.
- Return type
- int <https://docs.python.org/3/library/functions.html#int>
See also:
Source code at petsc4py/PETSc/Mat.pyx:5307 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5307>
- getMumpsInfog(icntl)
- Return the MUMPS parameter, INFOG[icntl].
Logically collective.
- Parameters
- icntl (int <https://docs.python.org/3/library/functions.html#int>) -- The index of the MUMPS INFOG array.
- Return type
- int <https://docs.python.org/3/library/functions.html#int>
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>
- getMumpsRinfo(icntl)
- Return the MUMPS parameter, RINFO[icntl].
Logically collective.
- Parameters
- icntl (int <https://docs.python.org/3/library/functions.html#int>) -- The index of the MUMPS RINFO array.
- Return type
- float <https://docs.python.org/3/library/functions.html#float>
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>
- getMumpsRinfog(icntl)
- Return the MUMPS parameter, RINFOG[icntl].
Logically collective.
- Parameters
- icntl (int <https://docs.python.org/3/library/functions.html#int>) -- The index of the MUMPS RINFOG array.
- Return type
- float <https://docs.python.org/3/library/functions.html#float>
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>
- getNearNullSpace()
- Return the near-nullspace.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:3818 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3818>
- Return type
- NullSpace <#petsc4py.PETSc.NullSpace>
- getNestISs()
- 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 type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[list <https://docs.python.org/3/library/stdtypes.html#list>[IS <#petsc4py.PETSc.IS>], list <https://docs.python.org/3/library/stdtypes.html#list>[IS <#petsc4py.PETSc.IS>]]
- getNestLocalISs()
- 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 type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[list <https://docs.python.org/3/library/stdtypes.html#list>[IS <#petsc4py.PETSc.IS>], list <https://docs.python.org/3/library/stdtypes.html#list>[IS <#petsc4py.PETSc.IS>]]
- getNestSize()
- Return the number of rows and columns of the matrix.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:5744 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5744>
- getNestSubMatrix(i, j)
- Return a single submatrix.
Not collective.
- i (int <https://docs.python.org/3/library/functions.html#int>) -- The first index of the matrix within the nesting.
- j (int <https://docs.python.org/3/library/functions.html#int>) -- The second index of the matrix within the nesting.
- Return type
- 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>
- getNullSpace()
- 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>
- Return type
- NullSpace <#petsc4py.PETSc.NullSpace>
- getOption(option)
- 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>
- Parameters
- option (Option <#petsc4py.PETSc.Mat.Option>)
- Return type
- bool <https://docs.python.org/3/library/functions.html#bool>
- getOptionsPrefix()
- Return the prefix used for searching for options in the database.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:1831 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1831>
- getOrdering(ord_type)
- Return a reordering for a matrix to improve a LU factorization.
Collective.
- Parameters
- ord_type (OrderingType <#petsc4py.PETSc.Mat.OrderingType>) -- The type of reordering.
- Returns
- rp (IS <#petsc4py.PETSc.IS>) -- The row permutation indices.
- cp (IS <#petsc4py.PETSc.IS>) -- The column permutation indices.
- Return type
- 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>
- getOwnershipIS()
- Return the ranges of rows and columns owned by each process as index sets.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:2063 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2063>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[IS <#petsc4py.PETSc.IS>, IS <#petsc4py.PETSc.IS>]
- getOwnershipRange()
- Return the locally owned range of rows.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:1996 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1996>
- getOwnershipRangeColumn()
- Return the locally owned range of columns.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:2030 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2030>
- getOwnershipRanges()
- 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>
- Return type
- ArrayInt <#petsc4py.typing.ArrayInt>
- getOwnershipRangesColumn()
- Return the range of columns owned by each process.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:2045 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2045>
- Return type
- ArrayInt <#petsc4py.typing.ArrayInt>
- getPythonContext()
- Return the instance of the class implementing the required Python methods.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:1765 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1765>
- getPythonType()
- Return the fully qualified Python name of the class used by the matrix.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:1800 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1800>
- getRedundantMatrix(nsubcomm, subcomm=None, out=None)
- Return redundant matrices on subcommunicators.
Collective.
- nsubcomm (int <https://docs.python.org/3/library/functions.html#int>) -- The number of subcommunicators.
- subcomm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- Communicator split or None <https://docs.python.org/3/library/constants.html#None> for the null communicator.
- out (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional resultant matrix. When None <https://docs.python.org/3/library/constants.html#None>, a new matrix is created, and MAT_INITIAL_MATRIX is used. When not None <https://docs.python.org/3/library/constants.html#None>, the matrix is reused with MAT_REUSE_MATRIX.
- Return type
- 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>
- getRow(row)
- 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>
- Parameters
- row (int <https://docs.python.org/3/library/functions.html#int>)
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[ArrayInt <#petsc4py.typing.ArrayInt>, ArrayScalar <#petsc4py.typing.ArrayScalar>]
- getRowIJ(symmetric=False, compressed=False)
- Return the CSR representation of the local sparsity pattern.
Collective.
- symmetric (bool <https://docs.python.org/3/library/functions.html#bool>) -- If True <https://docs.python.org/3/library/constants.html#True>, return the symmetrized graph.
- compressed (bool <https://docs.python.org/3/library/functions.html#bool>) -- If True <https://docs.python.org/3/library/constants.html#True>, return the compressed graph.
- Return type
- 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>
- getRowSum(result=None)
- Return the row-sum vector.
Collective.
- Parameters
- result (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional vector to store the result.
- Return type
- 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>
- getSchurComplementSubMatrices()
- 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>
- Return type
- 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>]
- getSize()
- Return the global number of rows and columns.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:1924 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1924>
- getSizes()
- Return the tuple of matrix layouts.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:1952 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1952>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[LayoutSizeSpec <#petsc4py.typing.LayoutSizeSpec>, LayoutSizeSpec <#petsc4py.typing.LayoutSizeSpec>]
- getTransposeMat()
- Return the internal matrix of a Type.TRANSPOSE
<#petsc4py.PETSc.Mat.Type.TRANSPOSE> matrix.
Not collective.
- Parameters
- mat -- Matrix A of type Type.TRANSPOSE <#petsc4py.PETSc.Mat.Type.TRANSPOSE>.
- Return type
- 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>
- getTransposeNullSpace()
- Return the transpose nullspace.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:3791 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3791>
- Return type
- NullSpace <#petsc4py.PETSc.NullSpace>
- getType()
- Return the type of the matrix.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:1910 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1910>
- getValue(row, col)
- 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>
- Return type
- Scalar <#petsc4py.typing.Scalar>
- getValues(rows, cols, values=None)
- Return the values in the zip(rows, cols) positions.
Not collective.
- rows (Sequence[int <https://docs.python.org/3/library/functions.html#int>]) -- Row indices.
- cols (Sequence[int <https://docs.python.org/3/library/functions.html#int>]) -- Column indices.
- values (ArrayScalar <#petsc4py.typing.ArrayScalar> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional array where to store the values.
- Return type
- 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>
- getValuesCSR()
- 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>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[ArrayInt <#petsc4py.typing.ArrayInt>, ArrayInt <#petsc4py.typing.ArrayInt>, ArrayScalar <#petsc4py.typing.ArrayScalar>]
- getVecType()
- Return the vector type used by the matrix.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:661 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L661>
- hermitianTranspose(out=None)
- Return the transposed Hermitian matrix.
Collective.
- Parameters
- 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.
- Return type
- 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>
- imagPart(out=None)
- Return the imaginary part of the matrix.
Collective.
- Parameters
- 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.
- Return type
- 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>
- increaseOverlap(iset, overlap=1)
- Increase the overlap of a index set.
Collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:4001 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4001>
- iset (IS <#petsc4py.PETSc.IS>)
- overlap (int <https://docs.python.org/3/library/functions.html#int>)
- invertBlockDiagonal()
- 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>
- Return type
- ArrayScalar <#petsc4py.typing.ArrayScalar>
- isAssembled()
- 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>
- isHermitian(tol=0)
- Return the boolean indicating if the matrix is Hermitian.
Collective.
- Parameters
- tol (float <https://docs.python.org/3/library/functions.html#float>) -- Tolerance for comparison.
- Return type
- bool <https://docs.python.org/3/library/functions.html#bool>
See also:
Source code at petsc4py/PETSc/Mat.pyx:2423 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2423>
- isHermitianKnown()
- Return the 2-tuple indicating if the matrix is known to be Hermitian.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:2443 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2443>
- isLinear(n=1)
- Return whether the Mat is a linear operator.
Collective.
- Parameters
- n (int <https://docs.python.org/3/library/functions.html#int>) -- Number of random vectors to be tested.
- Return type
- bool <https://docs.python.org/3/library/functions.html#bool>
See also:
Source code at petsc4py/PETSc/Mat.pyx:2472 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2472>
- isStructurallySymmetric()
- 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>
- isSymmetric(tol=0)
- Return the boolean indicating if the matrix is symmetric.
Collective.
- Parameters
- tol (float <https://docs.python.org/3/library/functions.html#float>) -- Tolerance for comparison.
- Return type
- bool <https://docs.python.org/3/library/functions.html#bool>
See also:
Source code at petsc4py/PETSc/Mat.pyx:2388 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2388>
- isSymmetricKnown()
- Return the 2-tuple indicating if the matrix is known to be symmetric.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:2408 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2408>
- isTranspose(mat=None, tol=0)
- Return the result of matrix comparison with transposition.
Collective.
- mat (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- Matrix to compare against. Uses self if None <https://docs.python.org/3/library/constants.html#None>.
- tol (float <https://docs.python.org/3/library/functions.html#float>) -- Tolerance for comparison.
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>
- kron(mat, result=None)
- Compute C, the Kronecker product of A and B.
Collective.
- mat (Mat <#petsc4py.PETSc.Mat>) -- The right hand matrix B.
- result (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The optional resultant matrix. When None <https://docs.python.org/3/library/constants.html#None>, a new matrix is created, and MAT_INITIAL_MATRIX is used. When it is not None <https://docs.python.org/3/library/constants.html#None>, the matrix is reused with MAT_REUSE_MATRIX.
- Returns
- result -- The resultant matrix C, the Kronecker product of A and B.
- Return type
- 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>
- load(viewer)
- Load a matrix.
Collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:2145 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2145>
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer>)
- Return type
- Self <https://docs.python.org/3/library/typing.html#typing.Self>
- matMatMult(B, C, result=None, fill=None)
- Perform matrix-matrix-matrix multiplication D=ABC.
Neighborwise collective.
- B (Mat <#petsc4py.PETSc.Mat>) -- The middle matrix B.
- C (Mat <#petsc4py.PETSc.Mat>) -- The right hand matrix C.
- result (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The optional resultant matrix D. When None <https://docs.python.org/3/library/constants.html#None>, a new matrix is created, and MAT_INITIAL_MATRIX is used. When D is not None <https://docs.python.org/3/library/constants.html#None>, the matrix is reused with MAT_REUSE_MATRIX.
- fill (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- Expected fill as ratio of nnz(C)/nnz(A), use None <https://docs.python.org/3/library/constants.html#None> if you do not have a good estimate. If the result is a dense matrix this is irrelevant.
- Returns
- result -- The resultant product matrix D.
- Return type
- 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>
- matMult(mat, result=None, fill=None)
- Perform matrix-matrix multiplication C=AB.
Neighborwise collective.
- mat (Mat <#petsc4py.PETSc.Mat>) -- The right hand matrix B.
- result (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The optional resultant matrix C. When None <https://docs.python.org/3/library/constants.html#None>, a new matrix is created, and MAT_INITIAL_MATRIX is used. When C is not None <https://docs.python.org/3/library/constants.html#None>, the matrix is reused with MAT_REUSE_MATRIX.
- fill (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- Expected fill as ratio of nnz(C)/(nnz(A) + nnz(B)), use None <https://docs.python.org/3/library/constants.html#None> if you do not have a good estimate. If the result is a dense matrix this is irrelevant.
- Returns
- result -- The resultant product matrix C.
- Return type
- 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>
- matSolve(B, X)
- 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.
See also:
Source code at petsc4py/PETSc/Mat.pyx:5517 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5517>
- matTransposeMult(mat, result=None, fill=None)
- Perform matrix-matrix multiplication C=ABᵀ.
Neighborwise collective.
- mat (Mat <#petsc4py.PETSc.Mat>) -- The right hand matrix B.
- result (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The optional resultant matrix C. When None <https://docs.python.org/3/library/constants.html#None>, a new matrix is created, and MAT_INITIAL_MATRIX is used. When C is not None <https://docs.python.org/3/library/constants.html#None>, the matrix is reused with MAT_REUSE_MATRIX.
- fill (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- Expected fill as ratio of nnz(C)/(nnz(A) + nnz(B)), use None <https://docs.python.org/3/library/constants.html#None> if you do not have a good estimate. If the result is a dense matrix this is irrelevant.
- Returns
- result -- The resultant product matrix C.
- Return type
- 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>
- mult(x, y)
- 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.
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>
- multAdd(x, v, y)
- 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.
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>
- multHermitian(x, y)
- 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.
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>
- multHermitianAdd(x, v, y)
- 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.
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>
- multTranspose(x, y)
- 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.
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>
- multTransposeAdd(x, v, y)
- 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.
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>
- norm(norm_type=None)
- 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>
- Parameters
- norm_type (NormTypeSpec <#petsc4py.typing.NormTypeSpec>)
- Return type
- float <https://docs.python.org/3/library/functions.html#float> | tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[float <https://docs.python.org/3/library/functions.html#float>, float <https://docs.python.org/3/library/functions.html#float>]
- permute(row, col)
- Return the permuted matrix.
Collective.
- row (IS <#petsc4py.PETSc.IS>) -- Row permutation.
- col (IS <#petsc4py.PETSc.IS>) -- Column permutation.
- Return type
- 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>
- preallocatorPreallocate(A, fill=True)
- 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>.
- A (Mat <#petsc4py.PETSc.Mat>) -- The matrix to be preallocated.
- fill (bool <https://docs.python.org/3/library/functions.html#bool>) -- Flag indicating whether or not to insert zeros into the newly allocated matrix, defaults to True <https://docs.python.org/3/library/constants.html#True>.
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>
- ptap(P, result=None, fill=None)
- Creates the matrix product C = PᵀAP.
Neighborwise collective.
- P (Mat <#petsc4py.PETSc.Mat>) -- The matrix P.
- result (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The optional resultant matrix C. When None <https://docs.python.org/3/library/constants.html#None>, a new matrix is created, and MAT_INITIAL_MATRIX is used. When C is not None <https://docs.python.org/3/library/constants.html#None>, the matrix is reused with MAT_REUSE_MATRIX.
- fill (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- Expected fill as ratio of nnz(C)/(nnz(A) + nnz(P)), use None <https://docs.python.org/3/library/constants.html#None> if you do not have a good estimate. If the result is a dense matrix this is irrelevant.
- Returns
- result -- The resultant product matrix C.
- Return type
- 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>
- rart(R, result=None, fill=None)
- Create the matrix product C = RARᵀ.
Neighborwise collective.
- R (Mat <#petsc4py.PETSc.Mat>) -- The projection matrix.
- result (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The optional resultant matrix C. When None <https://docs.python.org/3/library/constants.html#None>, a new matrix is created, and MAT_INITIAL_MATRIX is used. When C is not None <https://docs.python.org/3/library/constants.html#None>, the matrix is reused with MAT_REUSE_MATRIX.
- fill (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- Expected fill as ratio of nnz(C)/nnz(A), use None <https://docs.python.org/3/library/constants.html#None> if you do not have a good estimate. If the result is a dense matrix this is irrelevant.
- Returns
- result -- The resultant product matrix C.
- Return type
- 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>
- realPart(out=None)
- Return the real part of the matrix.
Collective.
- Parameters
- 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.
- Return type
- 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>
- reorderForNonzeroDiagonal(isrow, iscol, atol=0)
- 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.
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>
- restoreDenseColumnVec(i, mode='rw', V=None)
- Restore the iᵗʰ column vector of the dense matrix.
Collective.
- i (int <https://docs.python.org/3/library/functions.html#int>) -- The column index to be restored.
- mode (AccessModeSpec <#petsc4py.typing.AccessModeSpec>) -- The access type of the vector to be restored.
- V (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- The vector obtained from calling getDenseColumnVec.
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>
- restoreDenseSubMatrix(mat)
- Restore access to a submatrix of a Type.DENSE
<#petsc4py.PETSc.Mat.Type.DENSE> matrix.
Collective.
- Parameters
- mat (Mat <#petsc4py.PETSc.Mat>) -- the matrix obtained from getDenseSubMatrix.
- Return type
- 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>
- restoreISLocalMat(local)
- Restore the local matrix obtained with getISLocalMat.
Not collective.
- Parameters
- local (Mat <#petsc4py.PETSc.Mat>) -- The local matrix.
- Return type
- 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>
- restoreLocalSubMatrix(isrow, iscol, submat)
- 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.
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>
- retrieveValues()
- 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>
- scale(alpha)
- Scale the matrix.
Collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:4227 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4227>
- Parameters
- alpha (Scalar <#petsc4py.typing.Scalar>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setBlockSize(bsize)
- Set the matrix block size (same for rows and columns).
Logically collective.
- Parameters
- bsize (int <https://docs.python.org/3/library/functions.html#int>) -- Block size.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Mat.pyx:589 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L589>
- setBlockSizes(row_bsize, col_bsize)
- Set the row and column block sizes.
Logically collective.
- row_bsize (int <https://docs.python.org/3/library/functions.html#int>) -- Row block size.
- col_bsize (int <https://docs.python.org/3/library/functions.html#int>) -- Column block size.
See also:
Source code at petsc4py/PETSc/Mat.pyx:607 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L607>
- setDM(dm)
- Set the DM defining the data layout of the matrix.
Not collective.
- Parameters
- dm (DM <#petsc4py.PETSc.DM>) -- The DM <#petsc4py.PETSc.DM>.
- Return type
- 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>
- setDenseLDA(lda)
- Set the leading dimension of the array used by the dense matrix.
Not collective.
- Parameters
- lda (int <https://docs.python.org/3/library/functions.html#int>) -- The leading dimension.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setDiagonal(diag, addv=None)
- Set the diagonal values of the matrix.
Collective.
- diag (Vec <#petsc4py.PETSc.Vec>) -- Vector storing diagonal values.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
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>
- setFromOptions()
- Configure the matrix from the options database.
Collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:1859 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1859>
- setISAllowRepeated(allow=True)
- Allow repeated entries in the local to global map.
Logically collective.
- Parameters
- allow (bool <https://docs.python.org/3/library/functions.html#bool>) -- When True <https://docs.python.org/3/library/constants.html#True>, local dofs are allowed to map to the same global dof.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setISLocalMat(local)
- Set the local matrix stored inside a Type.IS
<#petsc4py.PETSc.Mat.Type.IS>.
Not collective.
- Parameters
- local (Mat <#petsc4py.PETSc.Mat>) -- The local matrix.
- Return type
- 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>
- setISPreallocation(nnz, onnz)
- Preallocate memory for a Type.IS
<#petsc4py.PETSc.Mat.Type.IS> parallel matrix.
Collective.
- nnz (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- The sequence whose length corresponds to the number of local rows and values which represent the number of nonzeros in the various rows of the diagonal of the local submatrix.
- onnz (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- The sequence whose length corresponds to the number of local rows and values which represent the number of nonzeros in the various rows of the off-diagonal of the local submatrix.
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>
- setLGMap(rmap, cmap=None)
- Set the local-to-global mappings.
Collective.
- rmap (LGMap <#petsc4py.PETSc.LGMap>) -- Row mapping.
- cmap (LGMap <#petsc4py.PETSc.LGMap> | None <https://docs.python.org/3/library/constants.html#None>) -- Column mapping. If None <https://docs.python.org/3/library/constants.html#None>, cmap = rmap.
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>
- setLMVMJ0(J0)
- Set the initial Jacobian of the LMVM matrix.
Logically collective.
- Parameters
- J0 (Mat <#petsc4py.PETSc.Mat>) -- The initial Jacobian matrix.
- Return type
- 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>
- setLMVMJ0KSP(ksp)
- Set the KSP of the LMVM matrix.
Logically collective.
- Parameters
- ksp (KSP <#petsc4py.PETSc.KSP>) -- The KSP.
- Return type
- 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>
- setLRCMats(A, U, c=None, V=None)
- Set the constituents of a Type.LRC
<#petsc4py.PETSc.Mat.Type.LRC> matrix.
Logically collective.
- A (Mat) -- The A matrix, or None <https://docs.python.org/3/library/constants.html#None> to omit A.
- U (Mat) -- The first dense rectangular matrix.
- c (Vec <#petsc4py.PETSc.Vec>) -- The sequential vector containing the diagonal of C, or None <https://docs.python.org/3/library/constants.html#None> for all ones.
- V (Mat) -- The second dense rectangular matrix, or None <https://docs.python.org/3/library/constants.html#None> for a copy of U.
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>
- setMumpsCntl(icntl, val)
- Set a MUMPS parameter, CNTL[icntl] = val.
Logically collective.
- icntl (int <https://docs.python.org/3/library/functions.html#int>) -- The index of the MUMPS parameter array.
- val (float <https://docs.python.org/3/library/functions.html#float>) -- The value to set.
See also:
Source code at petsc4py/PETSc/Mat.pyx:5271 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5271>
- setMumpsIcntl(icntl, ival)
- Set a MUMPS parameter, ICNTL[icntl] = ival.
Logically collective.
- icntl (int <https://docs.python.org/3/library/functions.html#int>) -- The index of the MUMPS parameter array.
- ival (int <https://docs.python.org/3/library/functions.html#int>) -- The value to set.
See also:
Source code at petsc4py/PETSc/Mat.pyx:5235 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5235>
- setNearNullSpace(nsp)
- Set the near-nullspace.
Collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:3806 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3806>
- Parameters
- nsp (NullSpace <#petsc4py.PETSc.NullSpace>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setNestVecType(vec_type)
- Set the vector type for a Type.NEST
<#petsc4py.PETSc.Mat.Type.NEST> matrix.
Collective.
- Parameters
- 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.
- Return type
- 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>
- setNullSpace(nsp)
- 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>
- Parameters
- nsp (NullSpace <#petsc4py.PETSc.NullSpace>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setOption(option, flag)
- Set option.
Collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:1884 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1884>
- option (Option <#petsc4py.PETSc.Mat.Option>)
- flag (bool <https://docs.python.org/3/library/functions.html#bool>)
- setOptionsPrefix(prefix=None)
- Set the prefix used for searching for options in the database.
Logically collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:1817 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1817>
- setPreallocationCOO(coo_i, coo_j)
- Set preallocation using coordinate format with global indices.
Collective.
- coo_i (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Row indices in COO format.
- coo_j (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Column indices in COO format.
See also:
Source code at petsc4py/PETSc/Mat.pyx:902 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L902>
- setPreallocationCOOLocal(coo_i, coo_j)
- Set preallocation using coordinate format with local indices.
Collective.
- coo_i (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Row indices in COO format.
- coo_j (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Column indices in COO format.
See also:
Source code at petsc4py/PETSc/Mat.pyx:934 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L934>
- setPreallocationCSR(csr)
- Preallocate memory for the matrix with a CSR layout.
Collective.
Correct preallocation can result in a dramatic reduction in matrix assembly time.
- Parameters
- csr (CSRIndicesSpec <#petsc4py.typing.CSRIndicesSpec>) -- Local matrix data in compressed sparse row layout format.
- Return type
- 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>
- setPreallocationDense(array)
- Set the array used for storing matrix elements for a dense matrix.
Collective.
- Parameters
- 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.
- Return type
- 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>
- setPreallocationNNZ(nnz)
- Preallocate memory for the matrix with a non-zero pattern.
Collective.
Correct preallocation can result in a dramatic reduction in matrix assembly time.
- Parameters
- 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.
- Return type
- 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>
- setPythonContext(context)
- 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:
Source code at petsc4py/PETSc/Mat.pyx:1748 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1748>
- setPythonType(py_type)
- 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:
Source code at petsc4py/PETSc/Mat.pyx:1780 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1780>
- setRandom(random=None)
- Set random values in the matrix.
Collective.
- Parameters
- 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.
- Return type
- 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>
- setSizes(size, bsize=None)
- Set the local, global and block sizes.
Collective.
- size (MatSizeSpec <#petsc4py.typing.MatSizeSpec>) -- Matrix size.
- bsize (MatBlockSizeSpec <#petsc4py.typing.MatBlockSizeSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Matrix block size. If None <https://docs.python.org/3/library/constants.html#None>, a block size of 1 is set.
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>
- setStencil(dims, starts=None, dof=1)
- Set matrix stencil.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:3154 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3154>
- dims (DimsSpec <#petsc4py.typing.DimsSpec>)
- starts (DimsSpec <#petsc4py.typing.DimsSpec> | None <https://docs.python.org/3/library/constants.html#None>)
- dof (int <https://docs.python.org/3/library/functions.html#int>)
- setTransposeNullSpace(nsp)
- Set the transpose nullspace.
Collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:3779 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3779>
- Parameters
- nsp (NullSpace <#petsc4py.PETSc.NullSpace>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setTransposePrecursor(out)
- Set transpose precursor.
Logically collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:2222 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2222>
- Parameters
- out (Mat <#petsc4py.PETSc.Mat>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setType(mat_type)
- Set the matrix type.
Collective.
- Parameters
- mat_type (Type <#petsc4py.PETSc.Mat.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The matrix type.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setUnfactored()
- Set a factored matrix to be treated as unfactored.
Logically collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:4903 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4903>
- setUp()
- Set up the internal data structures for using the matrix.
Collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:1871 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L1871>
- setValue(row, col, value, addv=None)
- Set a value to the (row, col) entry of the matrix.
Not collective.
- row (int <https://docs.python.org/3/library/functions.html#int>) -- Row index.
- col (int <https://docs.python.org/3/library/functions.html#int>) -- Column index.
- value (Scalar <#petsc4py.typing.Scalar>) -- The scalar value.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
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>
- setValueBlockedStagStencil(row, col, value, addv=None)
- Not implemented.
Source code at petsc4py/PETSc/Mat.pyx:3238 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3238>
- setValueBlockedStencil(row, col, value, addv=None)
- 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.
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>
- setValueLocal(row, col, value, addv=None)
- Set a value to the (row, col) entry of the matrix in local
ordering.
Not collective.
- row (int <https://docs.python.org/3/library/functions.html#int>) -- Local row index.
- col (int <https://docs.python.org/3/library/functions.html#int>) -- Local column index.
- value (Scalar <#petsc4py.typing.Scalar>) -- The scalar value.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
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>
- setValueStagStencil(row, col, value, addv=None)
- Not implemented.
Source code at petsc4py/PETSc/Mat.pyx:3204 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3204>
- setValueStencil(row, col, value, addv=None)
- 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.
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>
- setValues(rows, cols, values, addv=None)
- Set values to the rows ⊗ cols entries of the matrix.
Not collective.
- rows (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Row indices.
- cols (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Column indices.
- values (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>]) -- The scalar values. A sequence of length at least len(rows) * len(cols).
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
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>
- setValuesBlocked(rows, cols, values, addv=None)
- Set values to the rows ⊗ col block entries of the matrix.
Not collective.
- rows (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Block row indices.
- cols (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Block column indices.
- values (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>]) -- The scalar values. A sequence of length at least len(rows) * len(cols) * bs * bs, where bs is the block size of the matrix.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
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>
- setValuesBlockedCSR(I, J, V, addv=None)
- Set values stored in block CSR format.
Not collective.
- I (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Block row pointers.
- J (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Block column indices.
- V (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>]) -- The scalar values.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
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>
- setValuesBlockedIJV(I, J, V, addv=None, rowmap=None)
- Set a subset of values stored in block CSR format.
Not collective.
- I (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Block row pointers.
- J (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Block column indices.
- V (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>]) -- The scalar values.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
- rowmap (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | None <https://docs.python.org/3/library/constants.html#None>) -- Optional iterable indicating which block row to insert.
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>
- setValuesBlockedLocal(rows, cols, values, addv=None)
- Set values to the rows ⊗ col block entries of the matrix in local
ordering.
Not collective.
- rows (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Local block row indices.
- cols (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Local block column indices.
- values (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>]) -- The scalar values. A sequence of length at least len(rows) * len(cols) * bs * bs, where bs is the block size of the matrix.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
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>
- setValuesBlockedLocalCSR(I, J, V, addv=None)
- Set values stored in block CSR format.
Not collective.
- I (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Block row pointers.
- J (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Local block column indices.
- V (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>]) -- The scalar values.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
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>
- setValuesBlockedLocalIJV(I, J, V, addv=None, rowmap=None)
- Set a subset of values stored in block CSR format.
Not collective.
- I (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Block row pointers.
- J (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Local block column indices.
- V (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>]) -- The scalar values.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
- rowmap (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | None <https://docs.python.org/3/library/constants.html#None>) -- Optional iterable indicating which block row to insert.
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>
- setValuesBlockedLocalRCV(R, C, V, addv=None)
- Undocumented.
Source code at petsc4py/PETSc/Mat.pyx:3087 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3087>
- setValuesBlockedRCV(R, C, V, addv=None)
- Undocumented.
Source code at petsc4py/PETSc/Mat.pyx:2833 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2833>
- setValuesCOO(coo_v, addv=None)
- Set values after preallocation with coordinate format.
Collective.
- coo_v (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>]) -- The matrix values.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
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>
- setValuesCSR(I, J, V, addv=None)
- Set values stored in CSR format.
Not collective.
- I (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Row pointers.
- J (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Column indices.
- V (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>]) -- The scalar values.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
See also:
Source code at petsc4py/PETSc/Mat.pyx:2775 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2775>
- setValuesIJV(I, J, V, addv=None, rowmap=None)
- Set a subset of values stored in CSR format.
Not collective.
- I (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Row pointers.
- J (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Column indices.
- V (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>]) -- The scalar values.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
- rowmap (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | None <https://docs.python.org/3/library/constants.html#None>) -- Optional iterable indicating which row to insert.
See also:
Source code at petsc4py/PETSc/Mat.pyx:2723 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2723>
- setValuesLocal(rows, cols, values, addv=None)
- Set values to the rows ⊗ col entries of the matrix in local
ordering.
Not collective.
- rows (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Local row indices.
- cols (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Local column indices.
- values (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>]) -- The scalar values. A sequence of length at least len(rows) * len(cols).
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
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>
- setValuesLocalCSR(I, J, V, addv=None)
- Set values stored in CSR format.
Not collective.
- I (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Row pointers.
- J (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Local column indices.
- V (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>]) -- The scalar values.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
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>
- setValuesLocalIJV(I, J, V, addv=None, rowmap=None)
- Set a subset of values stored in CSR format.
Not collective.
- I (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Row pointers.
- J (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Local column indices.
- V (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>]) -- The scalar values.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
- rowmap (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | None <https://docs.python.org/3/library/constants.html#None>) -- Optional iterable indicating which row to insert.
See also:
Source code at petsc4py/PETSc/Mat.pyx:2998 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2998>
- setValuesLocalRCV(R, C, V, addv=None)
- Undocumented.
Source code at petsc4py/PETSc/Mat.pyx:2994 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2994>
- setValuesRCV(R, C, V, addv=None)
- Undocumented.
Source code at petsc4py/PETSc/Mat.pyx:2719 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2719>
- setVariableBlockSizes(blocks)
- Set diagonal point-blocks of the matrix.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:628 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L628>
- setVecType(vec_type)
- Set the vector type.
Collective.
- Parameters
- 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.
- Return type
- 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>
- shift(alpha)
- Shift the matrix.
Collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:4240 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L4240>
- Parameters
- alpha (Scalar <#petsc4py.typing.Scalar>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- solve(b, x)
- 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.
See also:
Source code at petsc4py/PETSc/Mat.pyx:5427 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5427>
- solveAdd(b, y, x)
- 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.
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>
- solveBackward(b, x)
- 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.
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>
- solveForward(b, x)
- 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.
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>
- solveTranspose(b, x)
- 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.
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>
- solveTransposeAdd(b, y, x)
- 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.
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>
- storeValues()
- Stash a copy of the matrix values.
Collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:3410 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3410>
- toDLPack(mode='rw')
- 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>
- Parameters
- mode (AccessModeSpec <#petsc4py.typing.AccessModeSpec>)
- Return type
- Any <https://docs.python.org/3/library/typing.html#typing.Any>
- transpose(out=None)
- Return the transposed matrix.
Collective.
- Parameters
- 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.
- Return type
- 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>
- transposeMatMult(mat, result=None, fill=None)
- Perform matrix-matrix multiplication C=AᵀB.
Neighborwise collective.
- mat (Mat <#petsc4py.PETSc.Mat>) -- The right hand matrix B.
- result (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The optional resultant matrix C. When None <https://docs.python.org/3/library/constants.html#None>, a new matrix is created, and MAT_INITIAL_MATRIX is used. When C is not None <https://docs.python.org/3/library/constants.html#None>, the matrix is reused with MAT_REUSE_MATRIX.
- fill (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- Expected fill as ratio of nnz(C)/(nnz(A) + nnz(B)), use None <https://docs.python.org/3/library/constants.html#None> if you do not have a good estimate. If the result is a dense matrix this is irrelevant.
- Returns
- result -- The resultant product matrix C.
- Return type
- 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(viewer=None)
- View the matrix.
Collective.
- Parameters
- 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.
- Return type
- 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:
Source code at petsc4py/PETSc/Mat.pyx:453 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L453>
- zeroEntries()
- Zero the entries of the matrix.
Collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:2491 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L2491>
- zeroRows(rows, diag=1.0, x=None, b=None)
- Zero selected rows of the matrix.
Collective.
- rows (IS <#petsc4py.PETSc.IS> | Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Row indices to be zeroed.
- 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.
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>
- zeroRowsColumns(rows, diag=1.0, x=None, b=None)
- Zero selected rows and columns of the matrix.
Collective.
- rows (IS <#petsc4py.PETSc.IS> | Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Row/column indices to be zeroed.
- 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.
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>
- zeroRowsColumnsLocal(rows, diag=1.0, x=None, b=None)
- Zero selected rows and columns of the matrix in local ordering.
Collective.
- rows (IS <#petsc4py.PETSc.IS> | Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Local row/column indices to be zeroed.
- 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.
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>
- zeroRowsColumnsStencil(rows, diag=1.0, x=None, b=None)
- 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.
See also:
Source code at petsc4py/PETSc/Mat.pyx:3376 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L3376>
- zeroRowsLocal(rows, diag=1.0, x=None, b=None)
- Zero selected rows of the matrix in local ordering.
Collective.
- rows (IS <#petsc4py.PETSc.IS> | Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Local row indices to be zeroed.
- 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.
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
- assembled
- 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>
- block_size
- Matrix block size.
Source code at petsc4py/PETSc/Mat.pyx:5884 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5884>
- block_sizes
- 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>
- hermitian
- 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>
- local_size
- Matrix local size.
Source code at petsc4py/PETSc/Mat.pyx:5879 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5879>
- owner_range
- Matrix local row range.
Source code at petsc4py/PETSc/Mat.pyx:5894 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5894>
- owner_ranges
- Matrix row ranges.
Source code at petsc4py/PETSc/Mat.pyx:5899 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5899>
- size
- Matrix global size.
Source code at petsc4py/PETSc/Mat.pyx:5874 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L5874>
- sizes
- 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>
- structsymm
- 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>
- symmetric
- 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¶
- class 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¶
- class 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
- apply(partitioning)
- 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>
- Parameters
- partitioning (IS <#petsc4py.PETSc.IS>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- create(comm=None)
- Create a partitioning context.
Collective.
- Parameters
- 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>.
- Return type
- 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>
- destroy()
- Destroy the partitioning context.
Collective.
See also:
Source code at petsc4py/PETSc/MatPartitioning.pyx:49 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/MatPartitioning.pyx#L49>
- getType()
- Return the partitioning method.
Not collective.
See also:
Source code at petsc4py/PETSc/MatPartitioning.pyx:100 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/MatPartitioning.pyx#L100>
- setAdjacency(adj)
- Set the adjacency graph (matrix) of the thing to be partitioned.
Collective.
- Parameters
- 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>.
- Return type
- 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>
- setFromOptions()
- Set parameters in the partitioner from the options database.
Collective.
See also:
Source code at petsc4py/PETSc/MatPartitioning.pyx:114 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/MatPartitioning.pyx#L114>
- setType(matpartitioning_type)
- Set the type of the partitioner to use.
Collective.
- Parameters
- matpartitioning_type (Type <#petsc4py.PETSc.MatPartitioning.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The partitioner type.
- Return 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(viewer=None)
- View the partitioning data structure.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the graph.
- Return type
- 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¶
- class petsc4py.PETSc.NormType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Norm type.
Commonly used norm types:
See also:
Attributes Summary
Attributes Documentation
petsc4py.PETSc.NullSpace¶
- class 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(constant=False, vectors=(), comm=None)
- Create the null space.
Collective.
- constant (bool <https://docs.python.org/3/library/functions.html#bool>) -- A flag to indicate the null space contains the constant vector.
- vectors (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Vec <#petsc4py.PETSc.Vec>]) -- The sequence of vectors that span the null space.
- comm -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
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>
- createRigidBody(coords)
- Create rigid body modes from coordinates.
Collective.
- Parameters
- coords (Vec <#petsc4py.PETSc.Vec>) -- The block coordinates of each node. Requires the block size to have been set.
- Return type
- 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>
- destroy()
- Destroy the null space.
Collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:6042 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L6042>
- getFunction()
- Return the callback to remove the nullspace.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:6182 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L6182>
- Return type
- MatNullFunction <#petsc4py.typing.MatNullFunction>
- getVecs()
- 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>
- Return type
- list <https://docs.python.org/3/library/stdtypes.html#list>[Vec <#petsc4py.PETSc.Vec>]
- hasConstant()
- Return whether the null space contains the constant.
Not collective.
See also:
Source code at petsc4py/PETSc/Mat.pyx:6146 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L6146>
- remove(vec)
- Remove all components of a null space from a vector.
Collective.
- Parameters
- vec (Vec <#petsc4py.PETSc.Vec>) -- The vector from which the null space is removed.
- Return type
- 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>
- setFunction(function, args=None, kargs=None)
- Set the callback to remove the nullspace.
Logically collective.
- function (MatNullFunction <#petsc4py.typing.MatNullFunction>) -- The callback.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
See also:
Source code at petsc4py/PETSc/Mat.pyx:6112 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Mat.pyx#L6112>
- test(mat)
- Return if the claimed null space is valid for a matrix.
Collective.
- Parameters
- mat (Mat <#petsc4py.PETSc.Mat>) -- The matrix to check.
- Return type
- 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(viewer=None)
- View the null space.
Collective.
- Parameters
- 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.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
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¶
- class 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
- appendOptionsPrefix(prefix)
- Append to the prefix used for searching for options in the database.
Logically collective.
See also:
Source code at petsc4py/PETSc/Object.pyx:138 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L138>
- compose(name, obj)
- Associate a PETSc object using a key string.
Logically collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The string identifying the object to be composed.
- obj (Object <#petsc4py.PETSc.Object>) -- The object to be composed.
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>
- decRef()
- 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>
- destroy()
- Destroy the object.
Collective.
See also:
Source code at petsc4py/PETSc/Object.pyx:81 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L81>
- destroyOptionsHandlers()
- Clear all the option handlers.
Collective.
See also:
Source code at petsc4py/PETSc/Object.pyx:213 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L213>
- getAttr(name)
- Return the attribute associated with a given name.
Not collective.
See also:
Source code at petsc4py/PETSc/Object.pyx:408 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L408>
- getClassId()
- Return the class identifier of the object.
Not collective.
See also:
Source code at petsc4py/PETSc/Object.pyx:270 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L270>
- getClassName()
- Return the class name of the object.
Not collective.
See also:
Source code at petsc4py/PETSc/Object.pyx:284 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L284>
- getComm()
- 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>
- Return type
- Comm <#petsc4py.PETSc.Comm>
- getDict()
- Return the dictionary of attributes.
Not collective.
See also:
Source code at petsc4py/PETSc/Object.pyx:436 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L436>
- getId()
- Return the unique identifier of the object.
Not collective.
See also:
Source code at petsc4py/PETSc/Object.pyx:313 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L313>
- getName()
- Return the name of the object.
Not collective.
See also:
Source code at petsc4py/PETSc/Object.pyx:242 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L242>
- getOptionsPrefix()
- Return the prefix used for searching for options in the database.
Not collective.
See also:
Source code at petsc4py/PETSc/Object.pyx:124 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L124>
- getRefCount()
- Return the reference count of the object.
Not collective.
See also:
Source code at petsc4py/PETSc/Object.pyx:298 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L298>
- getTabLevel()
- Return the PETSc object tab level.
Not collective.
See also:
Source code at petsc4py/PETSc/Object.pyx:518 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L518>
- getType()
- Return the object type name.
Not collective.
See also:
Source code at petsc4py/PETSc/Object.pyx:94 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L94>
- incRef()
- 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>
- incrementTabLevel(tab, parent=None)
- Increment the PETSc object tab level.
Logically collective.
See also:
Source code at petsc4py/PETSc/Object.pyx:491 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L491>
- tab (int <https://docs.python.org/3/library/functions.html#int>)
- parent (Object <#petsc4py.PETSc.Object> | None <https://docs.python.org/3/library/constants.html#None>)
- query(name)
- 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>
- Parameters
- name (str <https://docs.python.org/3/library/stdtypes.html#str>)
- Return type
- Object <#petsc4py.PETSc.Object>
- setAttr(name, attr)
- Set an the attribute associated with a given name.
Not collective.
See also:
Source code at petsc4py/PETSc/Object.pyx:422 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L422>
- name (str <https://docs.python.org/3/library/stdtypes.html#str>)
- attr (object <https://docs.python.org/3/library/functions.html#object>)
- setFromOptions()
- 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:
Source code at petsc4py/PETSc/Object.pyx:152 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L152>
- setName(name)
- Associate a name to the object.
Not collective.
See also:
Source code at petsc4py/PETSc/Object.pyx:256 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L256>
- setOptionsHandler(handler)
- Set the callback for processing extra options.
Logically collective.
- Parameters
- 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.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Object.pyx:190 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L190>
- setOptionsPrefix(prefix)
- Set the prefix used for searching for options in the database.
Logically collective.
See also:
Source code at petsc4py/PETSc/Object.pyx:110 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L110>
- setTabLevel(level)
- Set the PETSc object tab level.
Logically collective.
See also:
Source code at petsc4py/PETSc/Object.pyx:505 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L505>
- stateGet()
- Return the PETSc object state.
Not collective.
See also:
Source code at petsc4py/PETSc/Object.pyx:462 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L462>
- stateIncrease()
- 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>
- stateSet(state)
- Set the PETSc object state.
Logically collective.
See also:
Source code at petsc4py/PETSc/Object.pyx:476 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L476>
- view(viewer=None)
- Display the object.
Collective.
- Parameters
- 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.
- Return type
- 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>
- viewFromOptions(name, objpre=None)
- View the object via command line options.
Collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The command line option.
- objpre (Object <#petsc4py.PETSc.Object> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional object that provides prefix.
See also:
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
- classid
- 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>
- comm
- 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>
- fortran
- Fortran handle.
Source code at petsc4py/PETSc/Object.pyx:593 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L593>
- handle
- 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>
- id
- 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>
- klass
- The class name.
Source code at petsc4py/PETSc/Object.pyx:573 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L573>
- name
- The object name.
Source code at petsc4py/PETSc/Object.pyx:555 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L555>
- prefix
- Options prefix.
Source code at petsc4py/PETSc/Object.pyx:542 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L542>
- refcount
- Reference count.
Source code at petsc4py/PETSc/Object.pyx:578 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L578>
- type
- Object type.
Source code at petsc4py/PETSc/Object.pyx:534 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Object.pyx#L534>
petsc4py.PETSc.Options¶
- class 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.
- Parameters
- 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:
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
- clear()
- Clear an options database.
Source code at petsc4py/PETSc/Options.pyx:91 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L91>
- create()
- Create an options database.
Source code at petsc4py/PETSc/Options.pyx:79 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L79>
- delValue(name)
- Delete an option from the database.
Logically collective.
See also:
Source code at petsc4py/PETSc/Options.pyx:203 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L203>
- destroy()
- Destroy an options database.
Source code at petsc4py/PETSc/Options.pyx:85 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L85>
- getAll()
- Return all the options and their values.
Not collective.
See also:
Source code at petsc4py/PETSc/Options.pyx:422 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L422>
- getBool(name, default=None)
- Return the boolean value associated with the option.
Not collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The option name.
- default -- The default value. If None <https://docs.python.org/3/library/constants.html#None>, it raises a KeyError <https://docs.python.org/3/library/exceptions.html#KeyError> if the option is not found.
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>
- getBoolArray(name, default=None)
- Return the boolean values associated with the option.
Not collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The option name.
- default -- The default value. If None <https://docs.python.org/3/library/constants.html#None>, it raises a KeyError <https://docs.python.org/3/library/exceptions.html#KeyError> if the option is not found.
- Return type
- 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>
- getInt(name, default=None)
- Return the integer value associated with the option.
Not collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The option name.
- default -- The default value. If None <https://docs.python.org/3/library/constants.html#None>, it raises a KeyError <https://docs.python.org/3/library/exceptions.html#KeyError> if the option is not found.
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>
- getIntArray(name, default=None)
- Return the integer array associated with the option.
Not collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The option name.
- default -- The default value. If None <https://docs.python.org/3/library/constants.html#None>, it raises a KeyError <https://docs.python.org/3/library/exceptions.html#KeyError> if the option is not found.
- Return type
- 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>
- getReal(name, default=None)
- Return the real value associated with the option.
Not collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The option name.
- default -- The default value. If None <https://docs.python.org/3/library/constants.html#None>, it raises a KeyError <https://docs.python.org/3/library/exceptions.html#KeyError> if the option is not found.
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>
- getRealArray(name, default=None)
- Return the real array associated with the option.
Not collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The option name.
- default -- The default value. If None <https://docs.python.org/3/library/constants.html#None>, it raises a KeyError <https://docs.python.org/3/library/exceptions.html#KeyError> if the option is not found.
- Return type
- 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>
- getScalar(name, default=None)
- Return the scalar value associated with the option.
Not collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The option name.
- default -- The default value. If None <https://docs.python.org/3/library/constants.html#None>, it raises a KeyError <https://docs.python.org/3/library/exceptions.html#KeyError> if the option is not found.
- Return type
- 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>
- getScalarArray(name, default=None)
- Return the scalar array associated with the option.
Not collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The option name.
- default -- The default value. If None <https://docs.python.org/3/library/constants.html#None>, it raises a KeyError <https://docs.python.org/3/library/exceptions.html#KeyError> if the option is not found.
- Return type
- 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>
- getString(name, default=None)
- Return the string associated with the option.
Not collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The option name.
- default -- The default value. If None <https://docs.python.org/3/library/constants.html#None>, it raises a KeyError <https://docs.python.org/3/library/exceptions.html#KeyError> if the option is not found.
See also:
Source code at petsc4py/PETSc/Options.pyx:386 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L386>
- hasName(name)
- Return the boolean indicating if the option is in the database.
Source code at petsc4py/PETSc/Options.pyx:144 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L144>
- insertString(string)
- Insert a string in the options database.
Logically collective.
See also:
Source code at petsc4py/PETSc/Options.pyx:408 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L408>
- prefixPop()
- 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>
- prefixPush(prefix)
- 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>
- Parameters
- prefix (str <https://docs.python.org/3/library/stdtypes.html#str> | Options <#petsc4py.PETSc.Options> | Object <#petsc4py.PETSc.Object> | None <https://docs.python.org/3/library/constants.html#None>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setValue(name, value)
- Set a value for an option.
Logically collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The string identifying the option.
- value (bool <https://docs.python.org/3/library/functions.html#bool> | int <https://docs.python.org/3/library/functions.html#int> | float <https://docs.python.org/3/library/functions.html#float> | Scalar <#petsc4py.typing.Scalar> | Sequence[bool <https://docs.python.org/3/library/functions.html#bool>] | Sequence[int <https://docs.python.org/3/library/functions.html#int>] | Sequence[float <https://docs.python.org/3/library/functions.html#float>] | Sequence[Scalar <#petsc4py.typing.Scalar>] | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The option value.
See also:
Source code at petsc4py/PETSc/Options.pyx:161 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L161>
- used(name)
- Return the boolean indicating if the option was queried from the database.
Source code at petsc4py/PETSc/Options.pyx:153 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L153>
- view(viewer=None)
- View the options database.
Collective.
- Parameters
- 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.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
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
- prefix
- Prefix for options.
Source code at petsc4py/PETSc/Options.pyx:67 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Options.pyx#L67>
petsc4py.PETSc.PC¶
- class 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 argumentSee 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¶
- class petsc4py.PETSc.PC.ASMType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The ASM subtype.
Attributes Summary
BASIC Constant BASIC of type int <https://docs.python.org/3/library/functions.html#int> INTERPOLATE Constant INTERPOLATE 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> RESTRICT Constant RESTRICT of type int <https://docs.python.org/3/library/functions.html#int> Attributes Documentation
petsc4py.PETSc.PC.CompositeType¶
- class 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¶
- class 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¶
- class 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¶
- class petsc4py.PETSc.PC.FieldSplitSchurFactType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The field split Schur factorization type.
Attributes Summary
DIAG Constant DIAG of type int <https://docs.python.org/3/library/functions.html#int> FULL Constant FULL of type int <https://docs.python.org/3/library/functions.html#int> LOWER Constant LOWER of type int <https://docs.python.org/3/library/functions.html#int> UPPER Constant UPPER of type int <https://docs.python.org/3/library/functions.html#int> Attributes Documentation
petsc4py.PETSc.PC.FieldSplitSchurPreType¶
- class petsc4py.PETSc.PC.FieldSplitSchurPreType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The field split Schur subtype.
Attributes Summary
A11 Constant A11 of type int <https://docs.python.org/3/library/functions.html#int> FULL Constant FULL of type int <https://docs.python.org/3/library/functions.html#int> SELF Constant SELF of type int <https://docs.python.org/3/library/functions.html#int> SELFP Constant SELFP 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.GAMGType¶
- class petsc4py.PETSc.PC.GAMGType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The GAMG subtype.
Attributes Summary
AGG Object AGG of type str <https://docs.python.org/3/library/stdtypes.html#str> CLASSICAL Object CLASSICAL of type str <https://docs.python.org/3/library/stdtypes.html#str> GEO Object GEO of type str <https://docs.python.org/3/library/stdtypes.html#str> Attributes Documentation
petsc4py.PETSc.PC.GASMType¶
- class petsc4py.PETSc.PC.GASMType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The GASM subtype.
Attributes Summary
BASIC Constant BASIC of type int <https://docs.python.org/3/library/functions.html#int> INTERPOLATE Constant INTERPOLATE 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> RESTRICT Constant RESTRICT of type int <https://docs.python.org/3/library/functions.html#int> Attributes Documentation
petsc4py.PETSc.PC.HPDDMCoarseCorrectionType¶
- class petsc4py.PETSc.PC.HPDDMCoarseCorrectionType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The HPDDM coarse correction type.
Attributes Summary
ADDITIVE Constant ADDITIVE of type int <https://docs.python.org/3/library/functions.html#int> BALANCED Constant BALANCED of type int <https://docs.python.org/3/library/functions.html#int> DEFLATED Constant DEFLATED 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> Attributes Documentation
petsc4py.PETSc.PC.MGCycleType¶
- class petsc4py.PETSc.PC.MGCycleType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The MG cycle type.
Attributes Summary
V Constant V 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> Attributes Documentation
petsc4py.PETSc.PC.MGType¶
- class petsc4py.PETSc.PC.MGType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The MG subtype.
Attributes Summary
ADDITIVE Constant ADDITIVE of type int <https://docs.python.org/3/library/functions.html#int> FULL Constant FULL of type int <https://docs.python.org/3/library/functions.html#int> KASKADE Constant KASKADE 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> Attributes Documentation
petsc4py.PETSc.PC.PatchConstructType¶
- class petsc4py.PETSc.PC.PatchConstructType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The patch construction type.
Attributes Summary
PARDECOMP Constant PARDECOMP of type int <https://docs.python.org/3/library/functions.html#int> PYTHON Constant PYTHON of type int <https://docs.python.org/3/library/functions.html#int> STAR Constant STAR 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> VANKA Constant VANKA of type int <https://docs.python.org/3/library/functions.html#int> Attributes Documentation
petsc4py.PETSc.PC.Side¶
- class 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¶
- class petsc4py.PETSc.PC.Type
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The preconditioner method.
Attributes Summary
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
- addCompositePCType(pc_type)
- Add a PC of the given type to the composite PC.
Collective.
- Parameters
- pc_type (Type <#petsc4py.PETSc.PC.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of the preconditioner to add.
- Return type
- 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>
- appendOptionsPrefix(prefix)
- Append to the prefix used for all the PC options.
Logically collective.
- Parameters
- prefix (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The prefix to append to the current prefix.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
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(x, y)
- 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.
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>
- applySymmetricLeft(x, y)
- 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.
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>
- applySymmetricRight(x, y)
- 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.
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>
- applyTranspose(x, y)
- 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.
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(comm=None)
- 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>.
- Parameters
- 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>.
- Return type
- 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>
- createPython(context=None, comm=None)
- Create a preconditioner of Python type.
Collective.
- context (Any <https://docs.python.org/3/library/typing.html#typing.Any>) -- An instance of the Python class implementing the required methods.
- 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>.
See also:
Source code at petsc4py/PETSc/PC.pyx:760 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L760>
- destroy()
- Destroy the PC that was created with create.
Collective.
See also:
Source code at petsc4py/PETSc/PC.pyx:249 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L249>
- getASMSubKSP()
- 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 type
- list <https://docs.python.org/3/library/stdtypes.html#list>[KSP <#petsc4py.PETSc.KSP>]
- getBJacobiSubKSP()
- 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 type
- list <https://docs.python.org/3/library/stdtypes.html#list>[KSP <#petsc4py.PETSc.KSP>]
- getCompositePC(n)
- Return a component of the composite PC.
Not collective.
- Parameters
- n (int <https://docs.python.org/3/library/functions.html#int>) -- The index of the PC in the composition.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/PC.pyx:1679 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1679>
- getDM()
- 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>
- Return type
- DM <#petsc4py.PETSc.DM>
- getDeflationCoarseKSP()
- 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>
- Return type
- KSP <#petsc4py.PETSc.KSP>
- getDeflationPC()
- 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>
- Return type
- PC <#petsc4py.PETSc.PC>
- getFactorMatrix()
- 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>
- Return type
- Mat <#petsc4py.PETSc.Mat>
- getFactorSolverType()
- 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>
- getFailedReason()
- 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>
- Return type
- FailedReason <#petsc4py.PETSc.PC.FailedReason>
- getFieldSplitSchurGetSubKSP()
- 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 type
- list <https://docs.python.org/3/library/stdtypes.html#list>[KSP <#petsc4py.PETSc.KSP>]
- getFieldSplitSubIS(splitname)
- 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>
- Parameters
- splitname (str <https://docs.python.org/3/library/stdtypes.html#str>)
- Return type
- IS <#petsc4py.PETSc.IS>
- getFieldSplitSubKSP()
- 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 type
- list <https://docs.python.org/3/library/stdtypes.html#list>[KSP <#petsc4py.PETSc.KSP>]
- getHPDDMCoarseCorrectionType()
- 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>
- Return type
- HPDDMCoarseCorrectionType <#petsc4py.PETSc.PC.HPDDMCoarseCorrectionType>
- getHPDDMComplexities()
- Compute the grid and operator complexities.
Collective.
See also:
Source code at petsc4py/PETSc/PC.pyx:2547 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2547>
- 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>
- getHYPREType()
- 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>
- getKSP()
- 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>
- Return type
- KSP <#petsc4py.PETSc.KSP>
- getMGCoarseSolve()
- 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>
- Return type
- KSP <#petsc4py.PETSc.KSP>
- getMGInterpolation(level)
- Return the interpolation operator for the given level.
Logically collective.
- Parameters
- level (int <https://docs.python.org/3/library/functions.html#int>) -- The level where interpolation is defined from level-1 to level.
- Return type
- 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>
- getMGLevels()
- 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>
- getMGRScale(level)
- Return the pointwise scaling for the restriction operator on the given
level.
Logically collective.
- Parameters
- level (int <https://docs.python.org/3/library/functions.html#int>) -- The level where restriction is defined from level to level-1.
- Return type
- 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>
- getMGRestriction(level)
- Return the restriction operator for the given level.
Logically collective.
- Parameters
- level (int <https://docs.python.org/3/library/functions.html#int>) -- The level where restriction is defined from level to level-1.
- Return type
- 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>
- getMGSmoother(level)
- Return the KSP <#petsc4py.PETSc.KSP> to be used as a
smoother.
Not collective.
- Parameters
- level (int <https://docs.python.org/3/library/functions.html#int>) -- The level of the smoother.
- Return type
- KSP <#petsc4py.PETSc.KSP>
See also:
Source code at petsc4py/PETSc/PC.pyx:1935 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1935>
- getMGSmootherDown(level)
- Return the KSP <#petsc4py.PETSc.KSP> to be used as a smoother
before coarse grid correction.
Not collective.
- Parameters
- level (int <https://docs.python.org/3/library/functions.html#int>) -- The level of the smoother.
- Return type
- KSP <#petsc4py.PETSc.KSP>
See also:
Source code at petsc4py/PETSc/PC.pyx:1956 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1956>
- getMGSmootherUp(level)
- Return the KSP <#petsc4py.PETSc.KSP> to be used as a smoother
after coarse grid correction.
Not collective.
- Parameters
- level (int <https://docs.python.org/3/library/functions.html#int>) -- The level of the smoother.
- Return type
- KSP <#petsc4py.PETSc.KSP>
See also:
Source code at petsc4py/PETSc/PC.pyx:1977 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1977>
- getMGType()
- 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>
- Return type
- MGType <#petsc4py.PETSc.PC.MGType>
- getOperators()
- 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>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>]
- getOptionsPrefix()
- Return the prefix used for all the PC options.
Not collective.
See also:
Source code at petsc4py/PETSc/PC.pyx:340 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L340>
- getPatchSubKSP()
- 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 type
- list <https://docs.python.org/3/library/stdtypes.html#list>[KSP <#petsc4py.PETSc.KSP>]
- getPythonContext()
- Return the instance of the class implementing the required Python methods.
Not collective.
See also:
Source code at petsc4py/PETSc/PC.pyx:797 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L797>
- getPythonType()
- Return the fully qualified Python name of the class used by the
preconditioner.
Not collective.
See also:
Source code at petsc4py/PETSc/PC.pyx:826 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L826>
- getType()
- Return the preconditioner type.
Not collective.
See also:
Source code at petsc4py/PETSc/PC.pyx:307 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L307>
- getUseAmat()
- Return the flag to indicate if PC is applied to A or
P.
Logically collective.
- Returns
- flag -- True if A is used and False if P.
- Return type
- 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>
- matApply(x, y)
- 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.
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>
- matApplyTranspose(x, y)
- 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.
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>
- reset()
- Reset the PC, removing any allocated vectors and matrices.
Collective.
See also:
Source code at petsc4py/PETSc/PC.pyx:552 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L552>
- setASMLocalSubdomains(nsd, is_sub=None, is_local=None)
- Set the local subdomains.
Collective.
- nsd (int <https://docs.python.org/3/library/functions.html#int>) -- The number of subdomains for this process.
- is_sub (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[IS <#petsc4py.PETSc.IS>] | None <https://docs.python.org/3/library/constants.html#None>) -- Defines the subdomains for this process or None <https://docs.python.org/3/library/constants.html#None> to determine internally.
- is_local (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[IS <#petsc4py.PETSc.IS>] | None <https://docs.python.org/3/library/constants.html#None>) -- Defines the local part of the subdomains for this process, only used for PC.ASMType.RESTRICT <#petsc4py.PETSc.PC.ASMType.RESTRICT>.
See also:
Source code at petsc4py/PETSc/PC.pyx:895 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L895>
- setASMOverlap(overlap)
- Set the overlap between a pair of subdomains.
Logically collective.
- Parameters
- overlap (int <https://docs.python.org/3/library/functions.html#int>) -- The amount of overlap between subdomains.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setASMSortIndices(dosort)
- Set to sort subdomain indices.
Logically collective.
- Parameters
- dosort (bool <https://docs.python.org/3/library/functions.html#bool>) -- Set to True <https://docs.python.org/3/library/constants.html#True> to sort indices
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/PC.pyx:996 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L996>
- setASMTotalSubdomains(nsd, is_sub=None, is_local=None)
- Set the subdomains for all processes.
Collective.
- nsd (int <https://docs.python.org/3/library/functions.html#int>) -- The number of subdomains for all processes.
- is_sub (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[IS <#petsc4py.PETSc.IS>] | None <https://docs.python.org/3/library/constants.html#None>) -- Defines the subdomains for all processes or None <https://docs.python.org/3/library/constants.html#None> to determine internally.
- is_local (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[IS <#petsc4py.PETSc.IS>] | None <https://docs.python.org/3/library/constants.html#None>) -- Defines the local part of the subdomains for this process, only used for PC.ASMType.RESTRICT <#petsc4py.PETSc.PC.ASMType.RESTRICT>.
See also:
Source code at petsc4py/PETSc/PC.pyx:938 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L938>
- setASMType(asmtype)
- Set the type of restriction and interpolation.
Logically collective.
- Parameters
- asmtype (ASMType <#petsc4py.PETSc.PC.ASMType>) -- The type of ASM you wish to use.
- Return type
- 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>
- setBDDCChangeOfBasisMat(T, interior=False)
- Set a user defined change of basis for degrees of freedom.
Collective.
- T (Mat <#petsc4py.PETSc.Mat>) -- The matrix representing the change of basis.
- interior (bool <https://docs.python.org/3/library/functions.html#bool>) -- Enable to indicate the change of basis affects interior degrees of freedom.
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>
- setBDDCCoarseningRatio(cratio)
- Set the coarsening ratio used in the multilevel version.
Logically collective.
- Parameters
- cratio (int <https://docs.python.org/3/library/functions.html#int>) -- The coarsening ratio at the coarse level
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setBDDCDirichletBoundaries(bndr)
- Set the IS <#petsc4py.PETSc.IS> defining Dirichlet boundaries
for the global problem.
Collective.
- Parameters
- bndr (IS <#petsc4py.PETSc.IS>) -- The parallel IS <#petsc4py.PETSc.IS> defining Dirichlet boundaries.
- Return type
- 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>
- setBDDCDirichletBoundariesLocal(bndr)
- Set the IS <#petsc4py.PETSc.IS> defining Dirichlet boundaries
in local ordering.
Collective.
- Parameters
- bndr (IS <#petsc4py.PETSc.IS>) -- The parallel IS <#petsc4py.PETSc.IS> defining Dirichlet boundaries in local ordering.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/PC.pyx:2308 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2308>
- setBDDCDiscreteGradient(G, order=1, field=1, gord=True, conforming=True)
- Set the discrete gradient.
Collective.
- G (Mat <#petsc4py.PETSc.Mat>) -- The discrete gradient matrix in Mat.Type.AIJ <#petsc4py.PETSc.Mat.Type.AIJ> format.
- order (int <https://docs.python.org/3/library/functions.html#int>) -- The order of the Nedelec space.
- field (int <https://docs.python.org/3/library/functions.html#int>) -- The field number of the Nedelec degrees of freedom. This is not used if no fields have been specified.
- gord (bool <https://docs.python.org/3/library/functions.html#bool>) -- Enable to use global ordering in the rows of G.
- conforming (bool <https://docs.python.org/3/library/functions.html#bool>) -- Enable if the mesh is conforming.
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>
- setBDDCDivergenceMat(div, trans=False, l2l=None)
- Set the linear operator representing ∫ div(u)•p dx.
Collective.
- div (Mat <#petsc4py.PETSc.Mat>) -- The matrix in Mat.Type.IS <#petsc4py.PETSc.Mat.Type.IS> format.
- trans (bool <https://docs.python.org/3/library/functions.html#bool>) -- If True <https://docs.python.org/3/library/constants.html#True>, the pressure/velocity is in the trial/test space respectively. If False <https://docs.python.org/3/library/constants.html#False> the pressure/velocity is in the test/trial space.
- l2l (IS <#petsc4py.PETSc.IS> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional IS <#petsc4py.PETSc.IS> describing the local to local map for velocities.
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>
- setBDDCDofsSplitting(isfields)
- Set the index set(s) defining fields of the global matrix.
Collective.
- Parameters
- 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.
- Return type
- 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>
- setBDDCDofsSplittingLocal(isfields)
- 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.
- Parameters
- 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.
- Return type
- 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>
- setBDDCLevels(levels)
- Set the maximum number of additional levels allowed.
Logically collective.
- Parameters
- levels (int <https://docs.python.org/3/library/functions.html#int>) -- The maximum number of levels.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setBDDCLocalAdjacency(csr)
- Provide a custom connectivity graph for local dofs.
Not collective.
- Parameters
- csr (CSRIndicesSpec <#petsc4py.typing.CSRIndicesSpec>) -- Compressed sparse row layout information.
- Return type
- 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>
- setBDDCNeumannBoundaries(bndr)
- Set the IS <#petsc4py.PETSc.IS> defining Neumann boundaries
for the global problem.
Collective.
- Parameters
- bndr (IS <#petsc4py.PETSc.IS>) -- The parallel IS <#petsc4py.PETSc.IS> defining Neumann boundaries.
- Return type
- 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>
- setBDDCNeumannBoundariesLocal(bndr)
- Set the IS <#petsc4py.PETSc.IS> defining Neumann boundaries
in local ordering.
Collective.
- Parameters
- bndr (IS <#petsc4py.PETSc.IS>) -- The parallel IS <#petsc4py.PETSc.IS> defining Neumann boundaries in local ordering.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/PC.pyx:2342 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2342>
- setBDDCPrimalVerticesIS(primv)
- Set additional user defined primal vertices.
Collective.
- Parameters
- primv (IS <#petsc4py.PETSc.IS>) -- The IS <#petsc4py.PETSc.IS> of primal vertices in global numbering.
- Return type
- 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>
- setBDDCPrimalVerticesLocalIS(primv)
- Set additional user defined primal vertices.
Collective.
- Parameters
- primv (IS <#petsc4py.PETSc.IS>) -- The IS <#petsc4py.PETSc.IS> of primal vertices in local numbering.
- Return type
- 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>
- setCompositeType(ctype)
- Set the type of composite preconditioner.
Logically collective.
- Parameters
- ctype (CompositeType <#petsc4py.PETSc.PC.CompositeType>) -- The type of composition.
- Return type
- 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>
- setCoordinates(coordinates)
- Set the coordinates for the nodes on the local process.
Collective.
- Parameters
- coordinates (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[float <https://docs.python.org/3/library/functions.html#float>]]) -- The two dimensional coordinate array.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/PC.pyx:733 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L733>
- setDM(dm)
- Set the DM <#petsc4py.PETSc.DM> that may be used by some
preconditioners.
Logically collective.
- Parameters
- dm (DM <#petsc4py.PETSc.DM>) -- The DM <#petsc4py.PETSc.DM> object.
- Return type
- 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>
- setDeflationCoarseMat(mat)
- Set the coarse problem matrix.
Collective.
- Parameters
- mat (Mat <#petsc4py.PETSc.Mat>) -- The coarse problem matrix.
- Return type
- 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>
- setDeflationCorrectionFactor(fact)
- Set the coarse problem correction factor.
Logically collective.
- Parameters
- fact (float <https://docs.python.org/3/library/functions.html#float>) -- The correction factor.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/PC.pyx:2851 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2851>
- setDeflationInitOnly(flg)
- 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.
- Parameters
- flg (bool <https://docs.python.org/3/library/functions.html#bool>) -- Enable to only initialize the preconditioner.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setDeflationLevels(levels)
- Set the maximum level of deflation nesting.
Logically collective.
- Parameters
- levels (int <https://docs.python.org/3/library/functions.html#int>) -- The maximum deflation level.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/PC.pyx:2815 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2815>
- setDeflationProjectionNullSpaceMat(mat)
- Set the projection null space matrix.
Collective.
- Parameters
- mat (Mat <#petsc4py.PETSc.Mat>) -- The projection null space matrix.
- Return type
- 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>
- setDeflationReductionFactor(red)
- Set the reduction factor for the preconditioner.
Logically collective.
- Parameters
- red (int <https://docs.python.org/3/library/functions.html#int>) -- The reduction factor or DEFAULT.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/PC.pyx:2833 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2833>
- setDeflationSpace(W, transpose)
- Set the deflation space matrix or its (Hermitian) transpose.
Logically collective.
- W (Mat <#petsc4py.PETSc.Mat>) -- The deflation matrix.
- transpose (bool <https://docs.python.org/3/library/functions.html#bool>) -- Enable to indicate that W is an explicit transpose of the deflation matrix.
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>
- setDeflationSpaceToCompute(space_type, size)
- Set the deflation space type.
Logically collective.
- space_type (DeflationSpaceType <#petsc4py.PETSc.PC.DeflationSpaceType>) -- The deflation space type.
- size (int <https://docs.python.org/3/library/functions.html#int>) -- The size of the space to compute
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>
- setFactorLevels(levels)
- Set the number of levels of fill.
Logically collective.
- Parameters
- levels (int <https://docs.python.org/3/library/functions.html#int>) -- The number of levels to fill.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/PC.pyx:1451 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1451>
- setFactorOrdering(ord_type=None, nzdiag=None, reuse=None)
- Set options for the matrix factorization reordering.
Logically collective.
- ord_type (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The name of the matrix ordering or None <https://docs.python.org/3/library/constants.html#None> to leave unchanged.
- nzdiag (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- Threshold to consider diagonal entries in the matrix as zero.
- reuse (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Enable to reuse the ordering of a factored matrix.
See also:
Source code at petsc4py/PETSc/PC.pyx:1355 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1355>
- setFactorPivot(zeropivot=None, inblocks=None)
- Set options for matrix factorization pivoting.
Logically collective.
- zeropivot (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The size at which smaller pivots are treated as zero.
- inblocks (bool <https://docs.python.org/3/library/functions.html#bool> | None <https://docs.python.org/3/library/constants.html#None>) -- Enable to allow pivoting while factoring in blocks.
See also:
Source code at petsc4py/PETSc/PC.pyx:1392 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1392>
- setFactorSetUpSolverType()
- 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:
Source code at petsc4py/PETSc/PC.pyx:1339 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1339>
- setFactorShift(shift_type=None, amount=None)
- Set options for shifting diagonal entries of a matrix.
Logically collective.
- shift_type (FactorShiftType <#petsc4py.PETSc.Mat.FactorShiftType> | None <https://docs.python.org/3/library/constants.html#None>) -- The type of shift, or None <https://docs.python.org/3/library/constants.html#None> to leave unchanged.
- amount (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The amount of shift. Specify DEFAULT <#petsc4py.PETSc.DEFAULT> to determine internally or None <https://docs.python.org/3/library/constants.html#None> to leave unchanged.
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>
- setFactorSolverType(solver)
- Set the solver package used to perform the factorization.
Logically collective.
- Parameters
- solver (SolverType <#petsc4py.PETSc.Mat.SolverType> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The solver package used to factorize.
- Return type
- 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>
- setFailedReason(reason)
- Set the reason the PC terminated.
Logically collective.
- Parameters
- reason (FailedReason <#petsc4py.PETSc.PC.FailedReason> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- the reason the PC terminated
- Return type
- 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>
- setFieldSplitFields(bsize, *fields)
- Sets the elements for the field split.
Collective.
- bsize (int <https://docs.python.org/3/library/functions.html#int>) -- The block size
- fields (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[str <https://docs.python.org/3/library/stdtypes.html#str>, Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]]) -- A sequence of tuples containing the split name and a sequence of integers that define the elements in the split.
See also:
Source code at petsc4py/PETSc/PC.pyx:1530 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1530>
- setFieldSplitIS(*fields)
- 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_*.
- Parameters
- 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.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/PC.pyx:1504 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1504>
- setFieldSplitSchurFactType(ctype)
- Set the type of approximate block factorization.
Collective.
- Parameters
- ctype (FieldSplitSchurFactType <#petsc4py.PETSc.PC.FieldSplitSchurFactType>) -- The type indicating which blocks to retain.
- Return type
- 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>
- setFieldSplitSchurPreType(ptype, pre=None)
- 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.
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>
- setFieldSplitType(ctype)
- Set the type of composition of a field split preconditioner.
Collective.
- Parameters
- ctype (CompositeType <#petsc4py.PETSc.PC.CompositeType>) -- The type of composition.
- Return type
- 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>
- setFromOptions()
- Set various PC parameters from user options.
Collective.
See also:
Source code at petsc4py/PETSc/PC.pyx:373 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L373>
- setGAMGLevels(levels)
- Set the maximum number of levels.
Not collective.
- Parameters
- levels (int <https://docs.python.org/3/library/functions.html#int>) -- The maximum number of levels to use.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/PC.pyx:1073 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1073>
- setGAMGSmooths(smooths)
- Set the number of smoothing steps used on all levels.
Logically collective.
- Parameters
- smooths (int <https://docs.python.org/3/library/functions.html#int>) -- The maximum number of smooths.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setGAMGType(gamgtype)
- Set the type of algorithm.
Collective.
- Parameters
- 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>
- Return type
- 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>
- setGASMOverlap(overlap)
- Set the overlap between a pair of subdomains.
Logically collective.
- Parameters
- overlap (int <https://docs.python.org/3/library/functions.html#int>) -- The amount of overlap between subdomains.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setGASMType(gasmtype)
- Set the type of restriction and interpolation.
Logically collective.
- Parameters
- gasmtype (GASMType <#petsc4py.PETSc.PC.GASMType>) -- The type of GASM <#petsc4py.PETSc.PC.Type.GASM>.
- Return type
- 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>
- setHPDDMAuxiliaryMat(uis, uaux)
- 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
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>
- setHPDDMCoarseCorrectionType(correction_type)
- Set the coarse correction type.
Collective.
- Parameters
- correction_type (HPDDMCoarseCorrectionType <#petsc4py.PETSc.PC.HPDDMCoarseCorrectionType>) -- The type of coarse correction to apply.
- Return type
- 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>
- setHPDDMDeflationMat(uis, U)
- 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>.
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>
- setHPDDMHasNeumannMat(has)
- Set to indicate that the Mat <#petsc4py.PETSc.Mat> passed to
the PC is the local Neumann matrix.
Logically collective.
- Parameters
- has (bool <https://docs.python.org/3/library/functions.html#bool>) -- Enable to indicate the matrix is the local Neumann matrix.
- Return type
- 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>
- setHPDDMRHSMat(B)
- Set the right-hand side matrix of the preconditioner.
Logically collective.
- Parameters
- B (Mat <#petsc4py.PETSc.Mat>) -- The right-hand side sequential matrix.
- Return type
- 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>
- setHYPREAMSSetInteriorNodes(interior)
- Set the list of interior nodes to a zero conductivity region.
Collective.
- Parameters
- interior (Vec <#petsc4py.PETSc.Vec>) -- A vector where a value of 1.0 indicates an interior node.
- Return type
- 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>
- setHYPREDiscreteCurl(mat)
- Set the discrete curl matrix.
Collective.
- Parameters
- mat (Mat <#petsc4py.PETSc.Mat>) -- The discrete curl.
- Return type
- 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>
- setHYPREDiscreteGradient(mat)
- Set the discrete gradient matrix.
Collective.
- Parameters
- mat (Mat <#petsc4py.PETSc.Mat>) -- The discrete gradient.
- Return type
- 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>
- setHYPRESetAlphaPoissonMatrix(mat)
- Set the vector Poisson matrix.
Collective.
- Parameters
- mat (Mat <#petsc4py.PETSc.Mat>) -- The vector Poisson matrix.
- Return type
- 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>
- setHYPRESetBetaPoissonMatrix(mat=None)
- Set the Posson matrix.
Collective.
- Parameters
- mat (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The Poisson matrix or None <https://docs.python.org/3/library/constants.html#None> to turn off.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/PC.pyx:1196 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1196>
- setHYPRESetEdgeConstantVectors(ozz, zoz, zzo=None)
- Set the representation of the constant vector fields in the edge element
basis.
Collective.
- ozz (Vec <#petsc4py.PETSc.Vec>) -- A vector representing [1, 0, 0] or [1, 0] in 2D.
- zoz (Vec <#petsc4py.PETSc.Vec>) -- A vector representing [0, 1, 0] or [0, 1] in 2D.
- zzo (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- A vector representing [0, 0, 1] or None <https://docs.python.org/3/library/constants.html#None> in 2D.
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>
- setHYPRESetInterpolations(dim, RT_Pi_Full=None, RT_Pi=None, ND_Pi_Full=None, ND_Pi=None)
- Set the interpolation matrices.
Collective.
- dim (int <https://docs.python.org/3/library/functions.html#int>) -- The dimension of the problem.
- RT_Pi_Full (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The Raviart-Thomas interpolation matrix or None <https://docs.python.org/3/library/constants.html#None> to omit.
- RT_Pi -- The xyz components of the Raviart-Thomas interpolation matrix, or None <https://docs.python.org/3/library/constants.html#None> to omit.
- ND_Pi_Full (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The Nedelec interpolation matrix or None <https://docs.python.org/3/library/constants.html#None> to omit.
- ND_Pi -- The xyz components of the Nedelec interpolation matrix, or None <https://docs.python.org/3/library/constants.html#None> to omit.
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>
- setHYPREType(hypretype)
- Set the Type.HYPRE <#petsc4py.PETSc.PC.Type.HYPRE> type.
Collective.
- Parameters
- hypretype (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The name of the type, one of "euclid", "pilut", "parasails", "boomeramg", "ams", "ads"
- Return type
- 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>
- setMGCycleType(cycle_type)
- Set the type of cycles.
Logically collective.
- Parameters
- cycle_type (MGCycleType <#petsc4py.PETSc.PC.MGCycleType>) -- The type of multigrid cycles to use.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/PC.pyx:1998 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L1998>
- setMGCycleTypeOnLevel(level, cycle_type)
- Set the type of cycle on the given level.
Logically collective.
- level (int <https://docs.python.org/3/library/functions.html#int>) -- The level on which to set the cycle type.
- cycle_type (MGCycleType <#petsc4py.PETSc.PC.MGCycleType>) -- The type of multigrid cycles to use.
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>
- setMGInterpolation(level, mat)
- 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
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>
- setMGLevels(levels)
- Set the number of MG <#petsc4py.PETSc.PC.Type.MG> levels.
Logically collective.
- Parameters
- levels (int <https://docs.python.org/3/library/functions.html#int>) -- The number of levels
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setMGR(level, r)
- Set the vector where the residual is stored.
Logically collective.
If not provided, one will be set internally. Will be cleaned up in destroy.
- level (int <https://docs.python.org/3/library/functions.html#int>) -- The level on which to set the residual.
- r (Vec <#petsc4py.PETSc.Vec>) -- The vector where the residual is stored.
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>
- setMGRScale(level, rscale)
- Set 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.
- rscale (Vec <#petsc4py.PETSc.Vec>) -- The scaling vector.
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>
- setMGRestriction(level, mat)
- Set 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 (Mat <#petsc4py.PETSc.Mat>) -- The restriction operator
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>
- setMGRhs(level, rhs)
- 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.
- level (int <https://docs.python.org/3/library/functions.html#int>) -- The level on which to set the right-hand side.
- rhs (Vec <#petsc4py.PETSc.Vec>) -- The vector where the right-hand side is stored.
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>
- setMGType(mgtype)
- 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>
- Parameters
- mgtype (MGType <#petsc4py.PETSc.PC.MGType>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setMGX(level, x)
- Set the vector where the solution is stored.
Logically collective.
If not provided, one will be set internally. Will be cleaned up in destroy.
- level (int <https://docs.python.org/3/library/functions.html#int>) -- The level on which to set the solution.
- x (Vec <#petsc4py.PETSc.Vec>) -- The vector where the solution is stored.
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>
- setOperators(A=None, P=None)
- 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.
- A (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- the matrix which defines the linear system
- P (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- the matrix to be used in constructing the preconditioner, usually the same as A
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>
- setOptionsPrefix(prefix)
- Set the prefix used for all the PC options.
Logically collective.
- Parameters
- prefix (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The prefix to prepend to all option names.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/PC.pyx:321 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L321>
- setPatchCellNumbering(sec)
- Set the cell numbering.
Source code at petsc4py/PETSc/PC.pyx:2418 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2418>
- Parameters
- sec (Section <#petsc4py.PETSc.Section>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setPatchComputeFunction(function, args=None, kargs=None)
- Set compute operator callbacks.
Source code at petsc4py/PETSc/PC.pyx:2479 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2479>
- setPatchComputeFunctionInteriorFacets(function, args=None, kargs=None)
- Set compute operator callbacks.
Source code at petsc4py/PETSc/PC.pyx:2487 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2487>
- setPatchComputeOperator(operator, args=None, kargs=None)
- Set compute operator callbacks.
Source code at petsc4py/PETSc/PC.pyx:2463 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2463>
- setPatchComputeOperatorInteriorFacets(operator, args=None, kargs=None)
- Set compute operator callbacks.
Source code at petsc4py/PETSc/PC.pyx:2471 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2471>
- setPatchConstructType(typ, operator=None, args=None, kargs=None)
- Set compute operator callbacks.
Source code at petsc4py/PETSc/PC.pyx:2495 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2495>
- setPatchDiscretisationInfo(dms, bs, cellNodeMaps, subspaceOffsets, ghostBcNodes, globalBcNodes)
- Set discretisation info.
Source code at petsc4py/PETSc/PC.pyx:2422 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2422>
- setPythonContext(context)
- Set the instance of the class implementing the required Python methods.
Not collective.
See also:
Source code at petsc4py/PETSc/PC.pyx:785 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L785>
- setPythonType(py_type)
- Set the fully qualified Python name of the class to be used.
Collective.
See also:
Source code at petsc4py/PETSc/PC.pyx:812 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L812>
- setReusePreconditioner(flag)
- 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.
- Parameters
- flag (bool <https://docs.python.org/3/library/functions.html#bool>) -- Set to True <https://docs.python.org/3/library/constants.html#True> to use the reuse the current preconditioner and False <https://docs.python.org/3/library/constants.html#False> to recompute on changes to the matrix.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setSPAIBlockSize(n)
- Set the block size of the preconditioner.
Logically collective.
- Parameters
- n (int <https://docs.python.org/3/library/functions.html#int>) -- The block size, defaults to 1.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/PC.pyx:2719 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2719>
- setSPAICacheSize(size)
- Set the cache size.
Logically collective.
- Parameters
- size (int <https://docs.python.org/3/library/functions.html#int>) -- The size of the cache, defaults to 5.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/PC.pyx:2737 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2737>
- setSPAIEpsilon(val)
- Set the tolerance for the preconditioner.
Logically collective.
- Parameters
- val (float <https://docs.python.org/3/library/functions.html#float>) -- The tolerance, defaults to 0.4.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/PC.pyx:2646 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2646>
- setSPAIMax(maxval)
- Set the size of working buffers in the preconditioner.
Logically collective.
- Parameters
- maxval (int <https://docs.python.org/3/library/functions.html#int>) -- Number of entries in the work arrays to be allocated, defaults to 5000.
- Return type
- 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>
- setSPAIMaxNew(maxval)
- Set the maximum number of new non-zero candidates per step.
Logically collective.
- Parameters
- maxval (int <https://docs.python.org/3/library/functions.html#int>) -- Number of entries allowed, defaults to 5.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setSPAINBSteps(nbsteps)
- Set the maximum number of improvement steps per row.
Logically collective.
- Parameters
- nbsteps (int <https://docs.python.org/3/library/functions.html#int>) -- The number of steps, defaults to 5.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setSPAISp(sym)
- Set to specify a symmetric sparsity pattern.
Logically collective.
- Parameters
- sym (int <https://docs.python.org/3/library/functions.html#int>) -- Enable to indicate the matrix is symmetric.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setSPAIVerbose(level)
- Set the verbosity level.
Logically collective.
- Parameters
- level (int <https://docs.python.org/3/library/functions.html#int>) -- The level of verbosity, defaults to 1.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/PC.pyx:2755 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L2755>
- setType(pc_type)
- Set the preconditioner type.
Collective.
- Parameters
- pc_type (Type <#petsc4py.PETSc.PC.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The preconditioner type.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/PC.pyx:288 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L288>
- setUp()
- Set up the internal data structures for the PC.
Collective.
See also:
Source code at petsc4py/PETSc/PC.pyx:540 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L540>
- setUpOnBlocks()
- 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>
- setUseAmat(flag)
- 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.
- Parameters
- flag (bool <https://docs.python.org/3/library/functions.html#bool>) -- Set True to use A and False to use P.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- view(viewer=None)
- View the PC object.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- The visualization context.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/PC.pyx:230 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/PC.pyx#L230>
petsc4py.PETSc.Partitioner¶
- class petsc4py.PETSc.Partitioner
- Bases: Object <#petsc4py.PETSc.Object>
A graph partitioner.
Enumerations
Type <#petsc4py.PETSc.Partitioner.Type> The partitioner types.
petsc4py.PETSc.Partitioner.Type¶
- class 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(comm=None)
- Create an empty partitioner object.
Collective.
The type can be set with setType.
- Parameters
- 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>.
- Return type
- 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>
- destroy()
- Destroy the partitioner object.
Collective.
See also:
Source code at petsc4py/PETSc/Partitioner.pyx:45 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Partitioner.pyx#L45>
- getType()
- Return the partitioner type.
Not collective.
See also:
Source code at petsc4py/PETSc/Partitioner.pyx:100 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Partitioner.pyx#L100>
- reset()
- Reset data structures of the partitioner.
Collective.
See also:
Source code at petsc4py/PETSc/Partitioner.pyx:138 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Partitioner.pyx#L138>
- setFromOptions()
- Set parameters in the partitioner from the options database.
Collective.
See also:
Source code at petsc4py/PETSc/Partitioner.pyx:114 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Partitioner.pyx#L114>
- setShellPartition(numProcs, sizes=None, points=None)
- Set a custom partition for a mesh.
Collective.
- sizes (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | None <https://docs.python.org/3/library/constants.html#None>) -- The number of points in each partition.
- points (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | None <https://docs.python.org/3/library/constants.html#None>) -- A permutation of the points that groups those assigned to each partition in order (i.e., partition 0 first, partition 1 next, etc.).
- numProcs (int <https://docs.python.org/3/library/functions.html#int>)
See also:
Source code at petsc4py/PETSc/Partitioner.pyx:150 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Partitioner.pyx#L150>
- setType(part_type)
- Build a particular type of the partitioner.
Collective.
- Parameters
- part_type (Type <#petsc4py.PETSc.Partitioner.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The kind of partitioner.
- Return type
- 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>
- setUp()
- Construct data structures for the partitioner.
Collective.
See also:
Source code at petsc4py/PETSc/Partitioner.pyx:126 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Partitioner.pyx#L126>
- view(viewer=None)
- View the partitioner.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the graph.
- Return type
- 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¶
- class 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(comm=None)
- Create a Quad object.
Collective.
- Parameters
- 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>.
- Return type
- 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>
- destroy()
- Destroy the Quad object.
Collective.
See also:
Source code at petsc4py/PETSc/DT.pyx:63 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DT.pyx#L63>
- duplicate()
- 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>
- Return type
- Quad <#petsc4py.PETSc.Quad>
- getData()
- 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.
- Return type
- 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>
- getNumComponents()
- Return the number of components for functions to be integrated.
Not collective.
See also:
Source code at petsc4py/PETSc/DT.pyx:104 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DT.pyx#L104>
- getOrder()
- 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>
- setNumComponents(nc)
- Return the number of components for functions to be integrated.
Not collective.
- Parameters
- nc (int <https://docs.python.org/3/library/functions.html#int>) -- The number of components.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/DT.pyx:118 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/DT.pyx#L118>
- setOrder(order)
- Set the order of the method in the Quad.
Not collective.
- Parameters
- 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.
- Return type
- 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(viewer=None)
- View a Quad object.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the graph.
- Return type
- 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¶
- class 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¶
- class petsc4py.PETSc.Random.Type
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The random number generator type.
Attributes Summary
RAND Object RAND of type str <https://docs.python.org/3/library/stdtypes.html#str> RAND48 Object RAND48 of type str <https://docs.python.org/3/library/stdtypes.html#str> RANDER48 Object RANDER48 of type str <https://docs.python.org/3/library/stdtypes.html#str> RANDOM123 Object RANDOM123 of type str <https://docs.python.org/3/library/stdtypes.html#str> SPRNG Object SPRNG of type str <https://docs.python.org/3/library/stdtypes.html#str> Attributes Documentation
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(comm=None)
- Create a random number generator object.
Collective.
- Parameters
- 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>.
- Return type
- Self <https://docs.python.org/3/library/typing.html#typing.Self>
See also:
Source code at petsc4py/PETSc/Random.pyx:74 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Random.pyx#L74>
- destroy()
- Destroy the random number generator object.
Collective.
See also:
Source code at petsc4py/PETSc/Random.pyx:61 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Random.pyx#L61>
- getInterval()
- 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>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Scalar <#petsc4py.typing.Scalar>, Scalar <#petsc4py.typing.Scalar>]
- getSeed()
- Return the random number generator seed.
Not collective.
See also:
Source code at petsc4py/PETSc/Random.pyx:166 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Random.pyx#L166>
- getType()
- 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>
- getValue()
- 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>
- Return type
- Scalar <#petsc4py.typing.Scalar>
- getValueReal()
- Generate a real random number.
Not collective.
See also:
Source code at petsc4py/PETSc/Random.pyx:152 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Random.pyx#L152>
- setFromOptions()
- Configure the random number generator from the options database.
Collective.
See also:
Source code at petsc4py/PETSc/Random.pyx:126 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Random.pyx#L126>
- setInterval(interval)
- 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>
- Parameters
- interval (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Scalar <#petsc4py.typing.Scalar>, Scalar <#petsc4py.typing.Scalar>])
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setSeed(seed=None)
- Set the seed of random number generator.
Not collective.
- Parameters
- seed (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- The value for the seed. If None <https://docs.python.org/3/library/constants.html#None>, it only seeds the generator.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Random.pyx:180 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Random.pyx#L180>
- setType(rnd_type)
- Set the type of the random number generator object.
Collective.
- Parameters
- rnd_type (Type <#petsc4py.PETSc.Random.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of the generator.
- Return type
- 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(viewer=None)
- View a random number generator object.
Collective.
- Parameters
- 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.
- Return type
- 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
- interval
- 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>
- seed
- 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¶
- class 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¶
- class petsc4py.PETSc.Regressor.LinearType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Linear regressor type.
See also:
Attributes Summary
| LASSO | Constant LASSO of type int <https://docs.python.org/3/library/functions.html#int> |
| OLS | Constant OLS of type int <https://docs.python.org/3/library/functions.html#int> |
| RIDGE | Constant RIDGE of type int <https://docs.python.org/3/library/functions.html#int> |
Attributes Documentation
petsc4py.PETSc.Regressor.Type¶
- class petsc4py.PETSc.Regressor.Type
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
REGRESSOR solver type.
See also:
Attributes Summary
| LINEAR | Object LINEAR of type str <https://docs.python.org/3/library/stdtypes.html#str> |
Attributes Documentation
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(comm=None)
- Create a REGRESSOR solver.
Collective.
- Parameters
- comm -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
- Return type
- Self <https://docs.python.org/3/library/typing.html#typing.Self>
See also:
Source code at petsc4py/PETSc/Regressor.pyx:61 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L61>
- destroy()
- Destroy the solver.
Collective.
See also:
Source code at petsc4py/PETSc/Regressor.pyx:180 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L180>
- fit(X, y)
- 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
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>
- getLinearCoefficients()
- 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>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- getLinearIntercept()
- 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>
- Return type
- Scalar <#petsc4py.typing.Scalar>
- getLinearKSP()
- 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>
- Return type
- KSP <#petsc4py.PETSc.KSP>
- getLinearType()
- 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>
- Return type
- RegressorLinearType <#petsc4py.PETSc.RegressorLinearType>
- getTAO()
- 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>
- Return type
- TAO <#petsc4py.PETSc.TAO>
- getType()
- Return the type of the solver.
Not collective.
See also:
Source code at petsc4py/PETSc/Regressor.pyx:212 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L212>
- predict(X, y)
- 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
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>
- reset()
- Destroy internal data structures of the solver.
Collective.
See also:
Source code at petsc4py/PETSc/Regressor.pyx:168 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L168>
- setFromOptions()
- Configure the solver from the options database.
Collective.
See also:
Source code at petsc4py/PETSc/Regressor.pyx:93 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L93>
- setLinearFitIntercept(flag)
- Set a flag to indicate that the intercept should be calculated.
Logically collective.
See also:
Source code at petsc4py/PETSc/Regressor.pyx:228 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L228>
- setLinearType(lineartype)
- 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>
- Parameters
- lineartype (RegressorLinearType <#petsc4py.PETSc.RegressorLinearType>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setLinearUseKSP(flag)
- 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>
- setRegularizerWeight(weight)
- Set the weight to be used for the regularizer.
Logically collective.
See also:
Source code at petsc4py/PETSc/Regressor.pyx:82 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L82>
- setType(regressor_type)
- Set the type of the solver.
Logically collective.
- Parameters
- regressor_type (Type <#petsc4py.PETSc.Regressor.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of the solver.
- Return type
- 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>
- setUp()
- Set up the internal data structures for using the solver.
Collective.
See also:
Source code at petsc4py/PETSc/Regressor.pyx:104 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Regressor.pyx#L104>
- view(viewer=None)
- View the solver.
Collective.
- Parameters
- 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.
- Return type
- 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¶
- class petsc4py.PETSc.RegressorLinearType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Linear regressor type.
See also:
Attributes Summary
| LASSO | Constant LASSO of type int <https://docs.python.org/3/library/functions.html#int> |
| OLS | Constant OLS of type int <https://docs.python.org/3/library/functions.html#int> |
| RIDGE | Constant RIDGE of type int <https://docs.python.org/3/library/functions.html#int> |
Attributes Documentation
petsc4py.PETSc.SF¶
- class 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¶
- class 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
- bcastBegin(unit, rootdata, leafdata, op)
- Begin pointwise broadcast.
Collective.
Root values are reduced to leaf values. This call has to be concluded with a call to bcastEnd.
- unit (Datatype <https://mpi4py.readthedocs.io/en/stable/reference/mpi4py.MPI.Datatype.html#mpi4py.MPI.Datatype>) -- MPI datatype.
- rootdata (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- Buffer to broadcast.
- leafdata (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- Buffer to be reduced with values from each leaf's respective root.
- op (Op <https://mpi4py.readthedocs.io/en/stable/reference/mpi4py.MPI.Op.html#mpi4py.MPI.Op>) -- MPI reduction operation.
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>
- bcastEnd(unit, rootdata, leafdata, op)
- End a broadcast & reduce operation started with bcastBegin.
Collective.
- unit (Datatype <https://mpi4py.readthedocs.io/en/stable/reference/mpi4py.MPI.Datatype.html#mpi4py.MPI.Datatype>) -- MPI datatype.
- rootdata (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- Buffer to broadcast.
- leafdata (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- Buffer to be reduced with values from each leaf's respective root.
- op (Op <https://mpi4py.readthedocs.io/en/stable/reference/mpi4py.MPI.Op.html#mpi4py.MPI.Op>) -- MPI reduction operation.
See also:
Source code at petsc4py/PETSc/SF.pyx:463 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L463>
- compose(sf)
- Compose a new SF.
Collective.
Puts the sf under this object in a top (roots) down (leaves) view.
- Parameters
- sf (SF <#petsc4py.PETSc.SF>) -- SF to put under this object.
- Return type
- 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>
- computeDegree()
- 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>
- Return type
- ArrayInt <#petsc4py.typing.ArrayInt>
- create(comm=None)
- Create a star forest communication context.
Collective.
- Parameters
- 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>.
- Return type
- 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>
- createEmbeddedLeafSF(selected)
- Remove edges from all but the selected leaves.
Collective.
Does not remap indices.
- Parameters
- 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.
- Return type
- 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>
- createEmbeddedRootSF(selected)
- Remove edges from all but the selected roots.
Collective.
Does not remap indices.
- Parameters
- 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.
- Return type
- 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>
- createInverse()
- 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>
- Return type
- SF <#petsc4py.PETSc.SF>
- createSectionSF(rootSection, remoteOffsets, leafSection)
- Create an expanded SF of DOFs.
Collective.
Assumes the input SF relates points.
- rootSection (Section <#petsc4py.PETSc.Section>) -- Data layout of remote points for outgoing data (this is usually the serial section).
- remoteOffsets (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | None <https://docs.python.org/3/library/constants.html#None>) -- Offsets for point data on remote processes (these are offsets from the root section), or None <https://docs.python.org/3/library/constants.html#None>.
- leafSection (Section <#petsc4py.PETSc.Section>) -- Data layout of local points for incoming data (this is the distributed section).
- Return type
- 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>
- destroy()
- Destroy the star forest.
Collective.
See also:
Source code at petsc4py/PETSc/SF.pyx:50 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L50>
- distributeSection(rootSection, leafSection=None)
- Create a new, reorganized Section <#petsc4py.PETSc.Section>.
Collective.
Moves from the root to the leaves of the SF.
- rootSection (Section <#petsc4py.PETSc.Section>) -- Section defined on root space.
- leafSection (Section <#petsc4py.PETSc.Section> | None <https://docs.python.org/3/library/constants.html#None>) -- Section defined on the leaf space.
- Return type
- 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>
- fetchAndOpBegin(unit, rootdata, leafdata, leafupdate, op)
- 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.
- unit (Datatype <https://mpi4py.readthedocs.io/en/stable/reference/mpi4py.MPI.Datatype.html#mpi4py.MPI.Datatype>) -- MPI datatype.
- rootdata (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- Root values to be updated, input state is seen by first process to perform an update.
- leafdata (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- Leaf values to use in reduction.
- leafupdate (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- State at each leaf's respective root immediately prior to my atomic update.
- op (Op <https://mpi4py.readthedocs.io/en/stable/reference/mpi4py.MPI.Op.html#mpi4py.MPI.Op>) -- MPI reduction operation.
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>
- fetchAndOpEnd(unit, rootdata, leafdata, leafupdate, op)
- End operation started in a matching call to fetchAndOpBegin.
Collective.
- unit (Datatype <https://mpi4py.readthedocs.io/en/stable/reference/mpi4py.MPI.Datatype.html#mpi4py.MPI.Datatype>) -- MPI datatype.
- rootdata (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- Root values to be updated, input state is seen by first process to perform an update.
- leafdata (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- Leaf values to use in reduction.
- leafupdate (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- State at each leaf's respective root immediately prior to my atomic update.
- op (Op <https://mpi4py.readthedocs.io/en/stable/reference/mpi4py.MPI.Op.html#mpi4py.MPI.Op>) -- MPI reduction operation.
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>
- gatherBegin(unit, leafdata, multirootdata)
- Begin pointwise gather of all leaves into multi-roots.
Collective.
This call has to be completed with gatherEnd.
- unit (Datatype <https://mpi4py.readthedocs.io/en/stable/reference/mpi4py.MPI.Datatype.html#mpi4py.MPI.Datatype>) -- MPI datatype.
- leafdata (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- Leaf data to gather to roots.
- multirootdata (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- Root buffer to gather into, amount of space per root is equal to its degree.
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>
- gatherEnd(unit, leafdata, multirootdata)
- End gather operation that was started with gatherBegin.
Collective.
- unit (Datatype <https://mpi4py.readthedocs.io/en/stable/reference/mpi4py.MPI.Datatype.html#mpi4py.MPI.Datatype>) -- MPI datatype.
- leafdata (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- Leaf data to gather to roots.
- multirootdata (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- Root buffer to gather into, amount of space per root is equal to its degree.
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>
- getGraph()
- 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.
- Return type
- 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>
- getMulti()
- 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>
- Return type
- SF <#petsc4py.PETSc.SF>
- getType()
- Return the type name of the star forest.
Collective.
See also:
Source code at petsc4py/PETSc/SF.pyx:103 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L103>
- reduceBegin(unit, leafdata, rootdata, op)
- Begin reduction of leafdata into rootdata.
Collective.
This call has to be completed with call to reduceEnd.
- unit (Datatype <https://mpi4py.readthedocs.io/en/stable/reference/mpi4py.MPI.Datatype.html#mpi4py.MPI.Datatype>) -- MPI datatype.
- leafdata (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- Values to reduce.
- rootdata (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- Result of reduction of values from all leaves of each root.
- op (Op <https://mpi4py.readthedocs.io/en/stable/reference/mpi4py.MPI.Op.html#mpi4py.MPI.Op>) -- MPI reduction operation.
See also:
Source code at petsc4py/PETSc/SF.pyx:489 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L489>
- reduceEnd(unit, leafdata, rootdata, op)
- End a reduction operation started with reduceBegin.
Collective.
- unit (Datatype <https://mpi4py.readthedocs.io/en/stable/reference/mpi4py.MPI.Datatype.html#mpi4py.MPI.Datatype>) -- MPI datatype.
- leafdata (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- Values to reduce.
- rootdata (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- Result of reduction of values from all leaves of each root.
- op (Op <https://mpi4py.readthedocs.io/en/stable/reference/mpi4py.MPI.Op.html#mpi4py.MPI.Op>) -- MPI reduction operation.
See also:
Source code at petsc4py/PETSc/SF.pyx:517 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L517>
- reset()
- 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>
- scatterBegin(unit, multirootdata, leafdata)
- Begin pointwise scatter operation.
Collective.
Operation is from multi-roots to leaves. This call has to be completed with scatterEnd.
- unit (Datatype <https://mpi4py.readthedocs.io/en/stable/reference/mpi4py.MPI.Datatype.html#mpi4py.MPI.Datatype>) -- MPI datatype.
- multirootdata (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- Root buffer to send to each leaf, one unit of data per leaf.
- leafdata (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- Leaf data to be updated with personal data from each respective root.
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>
- scatterEnd(unit, multirootdata, leafdata)
- End scatter operation that was started with scatterBegin.
Collective.
- unit (Datatype <https://mpi4py.readthedocs.io/en/stable/reference/mpi4py.MPI.Datatype.html#mpi4py.MPI.Datatype>) -- MPI datatype.
- multirootdata (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- Root buffer to send to each leaf, one unit of data per leaf.
- leafdata (ndarray <https://numpy.org/doc/stable/reference/generated/numpy.ndarray.html#numpy.ndarray>) -- Leaf data to be updated with personal data from each respective root.
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>
- setFromOptions()
- Set options using the options database.
Logically collective.
See also:
Source code at petsc4py/PETSc/SF.pyx:117 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L117>
- setGraph(nroots, local, remote)
- Set star forest graph.
Collective.
The number of leaves argument can be determined from the size of local and/or remote.
- 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).
- local (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Locations of leaves in leafdata buffers, pass None <https://docs.python.org/3/library/constants.html#None> for contiguous storage.
- remote (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Remote locations of root vertices for each leaf on the current process. Should be 2*nleaves long as (rank, index) pairs.
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>
- setRankOrder(flag)
- Sort multi-points for gathers and scatters by rank order.
Logically collective.
- Parameters
- flag (bool <https://docs.python.org/3/library/functions.html#bool>) -- True <https://docs.python.org/3/library/constants.html#True> to sort, False <https://docs.python.org/3/library/constants.html#False> to skip sorting.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/SF.pyx:229 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L229>
- setType(sf_type)
- Set the type of the star forest.
Collective.
- Parameters
- sf_type (Type <#petsc4py.PETSc.SF.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The star forest type.
- Return 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>
- setUp()
- Set up communication structures.
Collective.
See also:
Source code at petsc4py/PETSc/SF.pyx:129 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SF.pyx#L129>
- view(viewer=None)
- View a star forest.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the graph.
- Return type
- 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¶
- class 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¶
- class 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¶
- class petsc4py.PETSc.SNES.NewtonALCorrectionType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
SNESNEWTONAL correction type.
See also:
Attributes Summary
| EXACT | Constant EXACT of type int <https://docs.python.org/3/library/functions.html#int> |
| NORMAL | Constant NORMAL of type int <https://docs.python.org/3/library/functions.html#int> |
Attributes Documentation
petsc4py.PETSc.SNES.NormSchedule¶
- class petsc4py.PETSc.SNES.NormSchedule
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
SNES norm schedule.
See also:
Attributes Summary
Attributes Documentation
petsc4py.PETSc.SNES.Type¶
- class petsc4py.PETSc.SNES.Type
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
SNES solver type.
See also:
Attributes Summary
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
- appendOptionsPrefix(prefix)
- Append to the prefix used for searching for options in the database.
Logically collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:241 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L241>
- callConvergenceTest(its, xnorm, ynorm, fnorm)
- Compute the convergence test.
Collective.
- its (int <https://docs.python.org/3/library/functions.html#int>) -- Iteration number.
- xnorm (float <https://docs.python.org/3/library/functions.html#float>) -- Solution norm.
- ynorm (float <https://docs.python.org/3/library/functions.html#float>) -- Update norm.
- fnorm (float <https://docs.python.org/3/library/functions.html#float>) -- Function norm.
- Return type
- ConvergedReason <#petsc4py.PETSc.SNES.ConvergedReason>
See also:
Source code at petsc4py/PETSc/SNES.pyx:1340 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1340>
- computeFunction(x, f)
- Compute the function.
Collective.
- x (Vec <#petsc4py.PETSc.Vec>) -- The input state vector.
- f (Vec <#petsc4py.PETSc.Vec>) -- The output vector.
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>
- computeJacobian(x, J, P=None)
- 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.
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>
- computeNGS(x, b=None)
- Compute a nonlinear Gauss-Seidel step.
Collective.
- x (Vec <#petsc4py.PETSc.Vec>) -- The input/output state vector.
- b (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- The input right-hand side vector.
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>
- computeObjective(x)
- Compute the value of the objective function.
Collective.
- Parameters
- x (Vec <#petsc4py.PETSc.Vec>) -- The input state vector.
- Return type
- 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>
- converged(its, xnorm, ynorm, fnorm)
- Compute the convergence test and update the solver converged reason.
Collective.
- its (int <https://docs.python.org/3/library/functions.html#int>) -- Iteration number.
- xnorm (float <https://docs.python.org/3/library/functions.html#float>) -- Solution norm.
- ynorm (float <https://docs.python.org/3/library/functions.html#float>) -- Update norm.
- fnorm (float <https://docs.python.org/3/library/functions.html#float>) -- Function norm.
See also:
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(comm=None)
- Create a SNES solver.
Collective.
- Parameters
- 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>.
- Return type
- Self <https://docs.python.org/3/library/typing.html#typing.Self>
See also:
Source code at petsc4py/PETSc/SNES.pyx:159 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L159>
- createPython(context=None, comm=None)
- Create a nonlinear solver of Python type.
Collective.
- context (Any <https://docs.python.org/3/library/typing.html#typing.Any>) -- An instance of the Python class implementing the required methods.
- 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>.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2208 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2208>
- destroy()
- Destroy the solver.
Collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:146 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L146>
- getApplicationContext()
- Return the application context.
Source code at petsc4py/PETSc/SNES.pyx:278 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L278>
- getCompositeNumber()
- Return the number of solvers in the composite.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2309 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2309>
- getCompositeSNES(n)
- 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>
- Parameters
- n (int <https://docs.python.org/3/library/functions.html#int>)
- Return type
- SNES <#petsc4py.PETSc.SNES>
- getConvergedReason()
- 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>
- Return type
- ConvergedReason <#petsc4py.PETSc.SNES.ConvergedReason>
- getConvergenceHistory()
- 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>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[ArrayReal <#petsc4py.typing.ArrayReal>, ArrayInt <#petsc4py.typing.ArrayInt>]
- getConvergenceTest()
- Return the callback to used as convergence test.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1328 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1328>
- Return type
- SNESConvergedFunction <#petsc4py.typing.SNESConvergedFunction>
- getDM()
- 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>
- Return type
- DM <#petsc4py.PETSc.DM>
- getDivergenceTolerance()
- Get the divergence tolerance parameter used in the convergence tests.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1253 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1253>
- getErrorIfNotConverged()
- Return the flag indicating error on divergence.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1780 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1780>
- getFASCoarseSolve()
- 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>
- Return type
- SNES <#petsc4py.PETSc.SNES>
- getFASCycleSNES(level)
- 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>
- Parameters
- level (int <https://docs.python.org/3/library/functions.html#int>)
- Return type
- SNES <#petsc4py.PETSc.SNES>
- getFASInjection(level)
- 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>
- Parameters
- level (int <https://docs.python.org/3/library/functions.html#int>)
- Return type
- Mat <#petsc4py.PETSc.Mat>
- getFASInterpolation(level)
- 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>
- Parameters
- level (int <https://docs.python.org/3/library/functions.html#int>)
- Return type
- Mat <#petsc4py.PETSc.Mat>
- getFASLevels()
- Return the number of levels used.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:577 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L577>
- getFASRestriction(level)
- 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>
- Parameters
- level (int <https://docs.python.org/3/library/functions.html#int>)
- Return type
- Mat <#petsc4py.PETSc.Mat>
- getFASSmoother(level)
- Return the smoother used at a given level of the FAS hierarchy.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:623 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L623>
- Parameters
- level (int <https://docs.python.org/3/library/functions.html#int>)
- Return type
- SNES <#petsc4py.PETSc.SNES>
- getFASSmootherDown(level)
- Return the downsmoother used at a given level of the FAS hierarchy.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:640 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L640>
- Parameters
- level (int <https://docs.python.org/3/library/functions.html#int>)
- Return type
- SNES <#petsc4py.PETSc.SNES>
- getFASSmootherUp(level)
- Return the upsmoother used at a given level of the FAS hierarchy.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:657 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L657>
- Parameters
- level (int <https://docs.python.org/3/library/functions.html#int>)
- Return type
- SNES <#petsc4py.PETSc.SNES>
- getFunction()
- 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>
- Return type
- SNESFunction <#petsc4py.typing.SNESFunction>
- getFunctionEvaluations()
- Return the current number of function evaluations.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1574 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1574>
- getFunctionNorm()
- Return the function norm.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1851 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1851>
- getInitialGuess()
- Return the callback to compute the initial guess.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:810 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L810>
- Return type
- SNESGuessFunction <#petsc4py.typing.SNESGuessFunction>
- getIterationNumber()
- Return the current iteration number.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1809 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1809>
- getJacobian()
- 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.
- Return type
- 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>
- getKSP()
- 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>
- Return type
- KSP <#petsc4py.PETSc.KSP>
- getKSPFailures()
- 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>
- getLineSearch()
- Return the linesearch object associated with this SNES.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2617 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2617>
- Return type
- SNESLineSearch <#petsc4py.PETSc.SNESLineSearch>
- getLinearSolveIterations()
- Return the total number of linear iterations.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1865 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1865>
- getMaxFunctionEvaluations()
- Return the maximum allowed number of function evaluations.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1558 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1558>
- getMaxKSPFailures()
- 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>
- getMaxStepFailures()
- Return the maximum allowed number of step failures.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1601 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1601>
- getMonitor()
- Return the callback used to monitor solver convergence.
Not collective.
See also:
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 type
- list <https://docs.python.org/3/library/stdtypes.html#list>[tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[SNESMonitorFunction <#petsc4py.typing.SNESMonitorFunction>, tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...], dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any]]]
- getNASMNumber()
- Return the number of solvers in NASM.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2341 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2341>
- getNASMSNES(n)
- Return the n-th solver in NASM.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2325 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2325>
- Parameters
- n (int <https://docs.python.org/3/library/functions.html#int>)
- Return type
- SNES <#petsc4py.PETSc.SNES>
- getNGS()
- Return the nonlinear Gauss-Seidel callback tuple.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1133 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1133>
- Return type
- SNESNGSFunction <#petsc4py.typing.SNESNGSFunction>
- getNPC()
- Return the nonlinear preconditioner associated with the solver.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:676 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L676>
- Return type
- SNES <#petsc4py.PETSc.SNES>
- getNPCSide()
- Return the nonlinear preconditioning side.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:729 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L729>
- Return type
- Side <#petsc4py.PETSc.PC.Side>
- getNewtonALLoadParameter()
- Return the load parameter for SNESNEWTONAL.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2685 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2685>
- getNormSchedule()
- 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>
- Return type
- NormSchedule <#petsc4py.PETSc.SNES.NormSchedule>
- getObjective()
- Return the objective callback tuple.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1027 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1027>
- Return type
- SNESObjFunction <#petsc4py.typing.SNESObjFunction>
- getOptionsPrefix()
- Return the prefix used for searching for options in the database.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:227 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L227>
- getParamsEW()
- Get the parameters of the Eisenstat and Walker trick.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2054 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2054>
- getPythonContext()
- Return the instance of the class implementing the required Python methods.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2245 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2245>
- getPythonType()
- Return the fully qualified Python name of the class used by the solver.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2275 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2275>
- getRhs()
- 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>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- getSolution()
- 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>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- getSolutionUpdate()
- 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>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- getStepFailures()
- Return the current number of step failures.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1615 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1615>
- getTRTolerances()
- Return the tolerance parameters used for the trust region.
Not collective.
- delta_min (float <https://docs.python.org/3/library/functions.html#float>) -- The minimum allowed trust region size.
- delta_max (float <https://docs.python.org/3/library/functions.html#float>) -- The maximum allowed trust region size.
- delta_0 (float <https://docs.python.org/3/library/functions.html#float>) -- The initial trust region size.
See also:
Source code at petsc4py/PETSc/SNES.pyx:351 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L351>
- getTRUpdateParameters()
- Return the update parameters used for the trust region.
Not collective.
- eta1 (float <https://docs.python.org/3/library/functions.html#float>) -- The step acceptance tolerance.
- eta2 (float <https://docs.python.org/3/library/functions.html#float>) -- The shrinking tolerance.
- eta3 (float <https://docs.python.org/3/library/functions.html#float>) -- The enlarging tolerance.
- t1 (float <https://docs.python.org/3/library/functions.html#float>) -- The shrinking factor.
- t2 (float <https://docs.python.org/3/library/functions.html#float>) -- The enlarging factor.
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[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>, float <https://docs.python.org/3/library/functions.html#float>]
See also:
Source code at petsc4py/PETSc/SNES.pyx:410 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L410>
- getTolerances()
- Return the tolerance parameters used in the solver convergence tests.
Not collective.
- rtol (float <https://docs.python.org/3/library/functions.html#float>) -- The relative norm of the residual.
- atol (float <https://docs.python.org/3/library/functions.html#float>) -- The absolute norm of the residual.
- stol (float <https://docs.python.org/3/library/functions.html#float>) -- The absolute norm of the step.
- max_it (int <https://docs.python.org/3/library/functions.html#int>) -- The maximum allowed number of iterations.
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[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>, int <https://docs.python.org/3/library/functions.html#int>]
See also:
Source code at petsc4py/PETSc/SNES.pyx:1209 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1209>
- getType()
- Return the type of the solver.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:199 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L199>
- getUpdate()
- Return the callback to compute the update at the beginning of each step.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:918 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L918>
- Return type
- SNESUpdateFunction <#petsc4py.typing.SNESUpdateFunction>
- getUseEW()
- 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>
- getUseFD()
- Return true if the solver uses color finite-differencing for the
Jacobian.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2148 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2148>
- getUseKSP()
- Return the flag indicating if the solver uses a linear solver.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2092 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2092>
- getUseMF()
- Return the flag indicating if the solver uses matrix-free
finite-differencing.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2121 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2121>
- getVIInactiveSet()
- 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>
- Return type
- IS <#petsc4py.PETSc.IS>
- getVariableBounds()
- 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>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>]
- hasNPC()
- Return a boolean indicating whether the solver has a nonlinear
preconditioner.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:691 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L691>
- logConvergenceHistory(norm, linear_its=0)
- Log residual norm and linear iterations.
Source code at petsc4py/PETSc/SNES.pyx:1439 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1439>
- norm (float <https://docs.python.org/3/library/functions.html#float>)
- linear_its (int <https://docs.python.org/3/library/functions.html#int>)
- monitor(its, rnorm)
- Monitor the solver.
Collective.
- its -- Current number of iterations.
- rnorm -- Current value of the residual norm.
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>
- monitorCancel()
- Cancel all the monitors of the solver.
Logically collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1505 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1505>
- reset()
- Reset the solver.
Collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1705 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1705>
- setApplicationContext(appctx)
- Set the application context.
Source code at petsc4py/PETSc/SNES.pyx:269 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L269>
- setConvergedReason(reason)
- 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>
- Parameters
- reason (ConvergedReason <#petsc4py.PETSc.SNES.ConvergedReason>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setConvergenceHistory(length=None, reset=False)
- Set the convergence history.
Logically collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1397 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1397>
- setConvergenceTest(converged, args=None, kargs=None)
- Set the callback to use as convergence test.
Logically collective.
- converged (SNESConvergedFunction <#petsc4py.typing.SNESConvergedFunction> | Literal['skip', 'default']) -- The convergence testing callback.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1293 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1293>
- setDM(dm)
- 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>
- Parameters
- dm (DM <#petsc4py.PETSc.DM>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setDivergenceTolerance(dtol)
- Set the divergence tolerance parameter used in the convergence tests.
Logically collective.
- Parameters
- dtol (float <https://docs.python.org/3/library/functions.html#float>) -- The divergence tolerance.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/SNES.pyx:1236 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1236>
- setErrorIfNotConverged(flag)
- Immediately generate an error if the solver has not converged.
Collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1767 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1767>
- setFASInjection(level, mat)
- Set the Mat <#petsc4py.PETSc.Mat> to be used to apply the
injection from level-1 to level.
Collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:500 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L500>
- level (int <https://docs.python.org/3/library/functions.html#int>)
- mat (Mat <#petsc4py.PETSc.Mat>)
- setFASInterpolation(level, mat)
- Set the Mat <#petsc4py.PETSc.Mat> to be used to apply the
interpolation from level-1 to level.
Collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:440 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L440>
- level (int <https://docs.python.org/3/library/functions.html#int>)
- mat (Mat <#petsc4py.PETSc.Mat>)
- setFASLevels(levels, comms=None)
- Set the number of levels to use with FAS.
Collective.
- levels (int <https://docs.python.org/3/library/functions.html#int>) -- The number of levels
- comms (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Comm <#petsc4py.PETSc.Comm>] | None <https://docs.python.org/3/library/constants.html#None>) -- An optional sequence of communicators of length Logging Levels <https://docs.python.org/3/library/logging.html#levels>, or None <https://docs.python.org/3/library/constants.html#None> for the default communicator Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
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>
- setFASRScale(level, vec)
- 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>
- level (int <https://docs.python.org/3/library/functions.html#int>)
- vec (Vec <#petsc4py.PETSc.Vec>)
- setFASRestriction(level, mat)
- Set the Mat <#petsc4py.PETSc.Mat> to be used to apply the
restriction from level-1 to level.
Collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:470 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L470>
- level (int <https://docs.python.org/3/library/functions.html#int>)
- mat (Mat <#petsc4py.PETSc.Mat>)
- setForceIteration(force)
- Force solve to take at least one iteration.
Collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1823 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1823>
- setFromOptions()
- Configure the solver from the options database.
Collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:255 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L255>
- setFunction(function, f=None, args=None, kargs=None)
- Set the callback to compute the nonlinear function.
Logically collective.
- function (SNESFunction <#petsc4py.typing.SNESFunction> | None <https://docs.python.org/3/library/constants.html#None>) -- The callback.
- f (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- An optional vector to store the result.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
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>
- setFunctionNorm(norm)
- 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>
- setInitialGuess(initialguess, args=None, kargs=None)
- Set the callback to compute the initial guess.
Logically collective.
- initialguess (SNESGuessFunction <#petsc4py.typing.SNESGuessFunction> | None <https://docs.python.org/3/library/constants.html#None>) -- The callback.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
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>
- setIterationNumber(its)
- 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>
- setJacobian(jacobian, J=None, P=None, args=None, kargs=None)
- Set the callback to compute the Jacobian.
Logically collective.
- jacobian (SNESJacobianFunction <#petsc4py.typing.SNESJacobianFunction> | None <https://docs.python.org/3/library/constants.html#None>) -- The Jacobian callback.
- J (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The matrix to store the Jacobian.
- P (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The matrix to construct the preconditioner.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
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>
- setKSP(ksp)
- 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>
- Parameters
- ksp (KSP <#petsc4py.PETSc.KSP>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setLineSearch(linesearch)
- Set the linesearch object to be used by this SNES.
Logically collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2632 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2632>
- Parameters
- linesearch (SNESLineSearch <#petsc4py.PETSc.SNESLineSearch>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setLineSearchPreCheck(precheck, args=None, kargs=None)
- Set the callback that will be called before applying the linesearch.
Logically collective.
- precheck (SNESLSPreFunction <#petsc4py.typing.SNESLSPreFunction> | None <https://docs.python.org/3/library/constants.html#None>) -- The callback.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
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>
- setMaxFunctionEvaluations(max_funcs)
- Set the maximum allowed number of function evaluations.
Collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1543 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1543>
- setMaxKSPFailures(max_fails)
- Set the maximum allowed number of linear solve failures.
Collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1629 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1629>
- setMaxStepFailures(max_fails)
- Set the maximum allowed number of step failures.
Collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1588 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1588>
- setMonitor(monitor, args=None, kargs=None)
- Set the callback used to monitor solver convergence.
Logically collective.
- monitor (SNESMonitorFunction <#petsc4py.typing.SNESMonitorFunction> | None <https://docs.python.org/3/library/constants.html#None>) -- The callback.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
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>
- setNGS(ngs, args=None, kargs=None)
- Set the callback to compute nonlinear Gauss-Seidel.
Logically collective.
- ngs (SNESNGSFunction <#petsc4py.typing.SNESNGSFunction> | None <https://docs.python.org/3/library/constants.html#None>) -- The nonlinear Gauss-Seidel callback.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
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>
- setNPC(snes)
- Set the nonlinear preconditioner.
Logically collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:705 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L705>
- Parameters
- snes (SNES <#petsc4py.PETSc.SNES>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setNPCSide(side)
- Set the nonlinear preconditioning side.
Collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:717 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L717>
- Parameters
- side (Side <#petsc4py.PETSc.PC.Side>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setNewtonALCorrectionType(corrtype)
- Set the correction type for SNESNEWTONAL.
Logically collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2700 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2700>
- Parameters
- corrtype (NewtonALCorrectionType <#petsc4py.PETSc.SNES.NewtonALCorrectionType>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setNewtonALFunction(function, args=None, kargs=None)
- Set the callback to compute the tangent load vector for SNESNEWTONAL.
Logically collective.
- function (SNESFunction <#petsc4py.typing.SNESFunction> | None <https://docs.python.org/3/library/constants.html#None>) -- The callback.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2654 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2654>
- setNormSchedule(normsched)
- 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>
- Parameters
- normsched (NormSchedule <#petsc4py.PETSc.SNES.NormSchedule>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setObjective(objective, args=None, kargs=None)
- Set the callback to compute the objective function.
Logically collective.
- objective (SNESObjFunction <#petsc4py.typing.SNESObjFunction> | None <https://docs.python.org/3/library/constants.html#None>) -- The Jacobian callback.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
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>
- setOptionsPrefix(prefix)
- Set the prefix used for searching for options in the database.
Logically collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:213 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L213>
- setParamsEW(version=None, rtol_0=None, rtol_max=None, gamma=None, alpha=None, alpha2=None, threshold=None)
- Set the parameters for the Eisenstat and Walker trick.
Logically collective.
- version (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- The version of the algorithm. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
- rtol_0 (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The initial relative residual norm. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
- rtol_max (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The maximum relative residual norm. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
- gamma (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- Parameter. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
- alpha (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- Parameter. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
- alpha2 (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- Parameter. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
- threshold (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- Parameter. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2002 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2002>
- setPatchCellNumbering(sec)
- Set cell patch numbering.
Source code at petsc4py/PETSc/SNES.pyx:2357 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2357>
- Parameters
- sec (Section <#petsc4py.PETSc.Section>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setPatchComputeFunction(function, args=None, kargs=None)
- Set patch compute function.
Source code at petsc4py/PETSc/SNES.pyx:2410 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2410>
- setPatchComputeOperator(operator, args=None, kargs=None)
- Set patch compute operator.
Source code at petsc4py/PETSc/SNES.pyx:2402 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2402>
- setPatchConstructType(typ, operator=None, args=None, kargs=None)
- Set patch construct type.
Source code at petsc4py/PETSc/SNES.pyx:2418 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2418>
- setPatchDiscretisationInfo(dms, bs, cellNodeMaps, subspaceOffsets, ghostBcNodes, globalBcNodes)
- Set patch discretisation information.
Source code at petsc4py/PETSc/SNES.pyx:2361 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2361>
- setPythonContext(context)
- Set the instance of the class implementing the required Python methods.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2233 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2233>
- setPythonType(py_type)
- Set the fully qualified Python name of the class to be used.
Collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2260 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2260>
- setResetCounters(reset=True)
- Set the flag to reset the counters.
Collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1445 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1445>
- setSolution(vec)
- 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>
- Parameters
- vec (Vec <#petsc4py.PETSc.Vec>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setTRTolerances(delta_min=None, delta_max=None, delta_0=None)
- Set the tolerance parameters used for the trust region.
Logically collective.
- delta_min (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The minimum allowed trust region size. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
- delta_max (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The maximum allowed trust region size. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
- delta_0 (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The initial trust region size. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
See also:
Source code at petsc4py/PETSc/SNES.pyx:324 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L324>
- setTRUpdateParameters(eta1=None, eta2=None, eta3=None, t1=None, t2=None)
- Set the update parameters used for the trust region.
Logically collective.
- eta1 (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The step acceptance tolerance. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
- eta2 (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The shrinking tolerance. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
- eta3 (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The enlarging tolerance. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
- t1 (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The shrinking factor. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
- t2 (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The enlarging factor. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
See also:
Source code at petsc4py/PETSc/SNES.pyx:375 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L375>
- setTolerances(rtol=None, atol=None, stol=None, max_it=None)
- Set the tolerance parameters used in the solver convergence tests.
Logically collective.
- rtol (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The relative norm of the residual, or DETERMINE <#petsc4py.PETSc.DETERMINE> to use the value when the object's type was set. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
- atol (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The absolute norm of the residual, or DETERMINE <#petsc4py.PETSc.DETERMINE> to use the value when the object's type was set. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
- stol (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The absolute norm of the step, or DETERMINE <#petsc4py.PETSc.DETERMINE> to use the value when the object's type was set. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
- max_it (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- The maximum allowed number of iterations, or DETERMINE <#petsc4py.PETSc.DETERMINE> to use the value when the object's type was set. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>. Use UNLIMITED <#petsc4py.PETSc.UNLIMITED> to have no maximum.
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>
- setType(snes_type)
- Set the type of the solver.
Logically collective.
- Parameters
- snes_type (Type <#petsc4py.PETSc.SNES.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of the solver.
- Return type
- 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>
- setUp()
- Set up the internal data structures for using the solver.
Collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:1679 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L1679>
- setUpMatrices()
- 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>
- setUpdate(update, args=None, kargs=None)
- Set the callback to compute update at the beginning of each step.
Logically collective.
- update (SNESUpdateFunction <#petsc4py.typing.SNESUpdateFunction> | None <https://docs.python.org/3/library/constants.html#None>) -- The callback.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
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>
- setUseEW(flag=True, *targs, **kargs)
- Tell the solver to use the Eisenstat-Walker trick.
Logically collective.
- flag (bool <https://docs.python.org/3/library/functions.html#bool>) -- Whether or not to use the Eisenstat-Walker trick.
- *targs (Any <https://docs.python.org/3/library/typing.html#typing.Any>) -- Positional arguments for setParamsEW.
- **kargs (Any <https://docs.python.org/3/library/typing.html#typing.Any>) -- Keyword arguments for setParamsEW.
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>
- setUseFD(flag=True)
- Set the boolean flag to use coloring finite-differencing for Jacobian
assembly.
Logically collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2135 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2135>
- setUseKSP(flag=True)
- Set the boolean flag indicating to use a linear solver.
Logically collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2079 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2079>
- setUseMF(flag=True)
- Set the boolean flag indicating to use matrix-free finite-differencing.
Logically collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2108 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2108>
- setVariableBounds(xl, xu)
- 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>)
- solve(b=None, x=None)
- Solve the nonlinear equations.
Collective.
- b (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- The affine right-hand side or None <https://docs.python.org/3/library/constants.html#None> to use zero.
- 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.
See also:
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(viewer=None)
- View the solver.
Collective.
- Parameters
- 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.
- Return type
- 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
- appctx
- Application context.
Source code at petsc4py/PETSc/SNES.pyx:2434 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2434>
- atol
- 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
- 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>
- history
- Convergence history.
Source code at petsc4py/PETSc/SNES.pyx:2567 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2567>
- is_converged
- 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>
- is_diverged
- 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>
- is_iterating
- 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>
- its
- 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>
- ksp
- Linear solver.
Source code at petsc4py/PETSc/SNES.pyx:2481 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2481>
- linesearch
- 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>
- max_funcs
- 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>
- max_it
- 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>
- norm
- Function norm.
Source code at petsc4py/PETSc/SNES.pyx:2559 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2559>
- npc
- 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>
- reason
- Converged reason.
Source code at petsc4py/PETSc/SNES.pyx:2574 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2574>
- rtol
- 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>
- stol
- 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_ew
- 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>
- use_fd
- 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>
- use_ksp
- 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>
- use_mf
- 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>
- vec_rhs
- 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>
- vec_sol
- Solution vector.
Source code at petsc4py/PETSc/SNES.pyx:2464 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2464>
- vec_upd
- Update vector.
Source code at petsc4py/PETSc/SNES.pyx:2469 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2469>
petsc4py.PETSc.SNESLineSearch¶
- class 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¶
- class 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(comm=None)
- Create a new linesearch object.
Collective.
- Parameters
- comm (Comm <#petsc4py.PETSc.Comm>, optional) -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
- Return type
- 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>
- destroy()
- Destroy the linesearch object.
Collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2923 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2923>
- getOrder()
- Return the order of the linesearch.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2896 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2896>
- getTolerances()
- Return the tolerance parameters used in the linesearch.
Not collective.
- minstep (float <https://docs.python.org/3/library/functions.html#float>) -- Minimum step length.
- maxstep (float <https://docs.python.org/3/library/functions.html#float>, optional) -- Maximum step length.
- rtol (float <https://docs.python.org/3/library/functions.html#float>) -- Relative tolerance.
- atol (float <https://docs.python.org/3/library/functions.html#float>) -- Absolute tolerance.
- ltol (float <https://docs.python.org/3/library/functions.html#float>) -- Lambda tolerance.
- max_its (int <https://docs.python.org/3/library/functions.html#int>) -- Maximum number of iterations for the linesearch.
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[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>, float <https://docs.python.org/3/library/functions.html#float>, int <https://docs.python.org/3/library/functions.html#int>]
See also:
Source code at petsc4py/PETSc/SNES.pyx:2829 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2829>
- getType()
- Return the type of the linesearch.
Not collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2801 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2801>
- setFromOptions()
- Configure the linesearch from the options database.
Collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2770 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2770>
- setOrder(order)
- Set the order of the linesearch.
Logically collective.
See also:
Source code at petsc4py/PETSc/SNES.pyx:2910 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/SNES.pyx#L2910>
- setTolerances(minstep=None, maxstep=None, rtol=None, atol=None, ltol=None, max_its=None)
- Set the tolerance parameters used in the linesearch.
Logically collective.
- minstep (float <https://docs.python.org/3/library/functions.html#float>) -- Minimum step length.
- maxstep (float <https://docs.python.org/3/library/functions.html#float>, optional) -- Maximum step length.
- rtol (float <https://docs.python.org/3/library/functions.html#float>, optional) -- Relative tolerance.
- atol (float <https://docs.python.org/3/library/functions.html#float>, optional) -- Absolute tolerance.
- ltol (float <https://docs.python.org/3/library/functions.html#float>, optional) -- Lambda tolerance.
- max_its (int <https://docs.python.org/3/library/functions.html#int>, optional) -- Maximum number of iterations for the linesearch.
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>
- setType(ls_type)
- 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>
- Parameters
- ls_type (Type <#petsc4py.PETSc.SNESLineSearch.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- view(viewer=None)
- View the linesearch object.
Collective.
- Parameters
- 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.
- Return type
- 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¶
- class 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:
Enumerations
| Mode <#petsc4py.PETSc.Scatter.Mode> | Scatter mode. |
| Type <#petsc4py.PETSc.Scatter.Type> | Scatter type. |
petsc4py.PETSc.Scatter.Mode¶
- class petsc4py.PETSc.Scatter.Mode
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Scatter mode.
Most commonly used scatter modes are:
See also:
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¶
- class 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(vec_from, vec_to, addv=None, mode=None)
- 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>)
- copy()
- 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>
- Return type
- Scatter <#petsc4py.PETSc.Scatter>
- create(vec_from, is_from, vec_to, is_to)
- Create a scatter object.
Collective.
- vec_from (Vec <#petsc4py.PETSc.Vec>) -- Representative vector from which to scatter the data.
- is_from (IS <#petsc4py.PETSc.IS>) -- Indices of vec_from to scatter. If None <https://docs.python.org/3/library/constants.html#None>, use all indices.
- vec_to (Vec <#petsc4py.PETSc.Vec>) -- Representative vector to which scatter the data.
- is_to (IS <#petsc4py.PETSc.IS>) -- Indices of vec_to where to receive. If None <https://docs.python.org/3/library/constants.html#None>, use all indices.
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:
Source code at petsc4py/PETSc/Scatter.pyx:90 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Scatter.pyx#L90>
- destroy()
- Destroy the scatter.
Collective.
See also:
Source code at petsc4py/PETSc/Scatter.pyx:77 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Scatter.pyx#L77>
- end(vec_from, vec_to, addv=None, mode=None)
- 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>)
- getType()
- Return the type of the scatter.
Not collective.
See also:
Source code at petsc4py/PETSc/Scatter.pyx:160 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Scatter.pyx#L160>
- scatter(vec_from, vec_to, addv=None, mode=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.
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>
- setFromOptions()
- Configure the scatter from the options database.
Collective.
See also:
Source code at petsc4py/PETSc/Scatter.pyx:174 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Scatter.pyx#L174>
- setType(scatter_type)
- 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>
- Parameters
- scatter_type (Type <#petsc4py.PETSc.Scatter.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setUp()
- 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>
- classmethod toAll(vec)
- Create a scatter that communicates a vector to all sharing processes.
Collective.
- Parameters
- vec (Vec <#petsc4py.PETSc.Vec>) -- The vector to scatter from.
- Return type
- 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>
- classmethod toZero(vec)
- Create a scatter that communicates a vector to rank zero.
Collective.
- Parameters
- vec (Vec <#petsc4py.PETSc.Vec>) -- The vector to scatter from.
- Return type
- 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(viewer=None)
- View the scatter.
Collective.
- Parameters
- 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.
- Return type
- 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¶
- class petsc4py.PETSc.ScatterMode
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Scatter mode.
Most commonly used scatter modes are:
See also:
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¶
- class 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
- addConstraintDof(point, numDof)
- Increment the number of constrained DOFs for a given point.
Not collective.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- numDof (int <https://docs.python.org/3/library/functions.html#int>) -- The number of additional DOFs which are fixed by constraints.
See also:
Source code at petsc4py/PETSc/Section.pyx:485 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L485>
- addDof(point, numDof)
- Add numDof degrees of freedom associated with a given point.
Not collective.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- numDof (int <https://docs.python.org/3/library/functions.html#int>) -- The number of additional DOFs.
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>
- addFieldConstraintDof(point, field, numDof)
- Add numDof constrained DOFs for a given field on a point.
Not collective.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- field (int <https://docs.python.org/3/library/functions.html#int>) -- The field.
- numDof (int <https://docs.python.org/3/library/functions.html#int>) -- The number of additional DOFs which are fixed by constraints.
See also:
Source code at petsc4py/PETSc/Section.pyx:557 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L557>
- addFieldDof(point, field, numDof)
- Add numDof DOFs associated with a field on a given point.
Not collective.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- field (int <https://docs.python.org/3/library/functions.html#int>) -- The field.
- numDof (int <https://docs.python.org/3/library/functions.html#int>) -- The number of additional DOFs.
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>
- clone()
- 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>
- Return type
- Section <#petsc4py.PETSc.Section>
- create(comm=None)
- 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.
- Parameters
- 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>.
- Return type
- 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>
- createGlobalSection(sf)
- 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>.
- Parameters
- sf (SF <#petsc4py.PETSc.SF>) -- The SF <#petsc4py.PETSc.SF> describing the parallel layout of the section points (leaves are unowned local points).
- Return type
- 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>
- destroy()
- Destroy a section.
Not collective.
See also:
Source code at petsc4py/PETSc/Section.pyx:29 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L29>
- getChart()
- 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>
- getConstrainedStorageSize()
- 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>
- getConstraintDof(point)
- Return the number of constrained DOFs associated with a given point.
Not collective.
- Parameters
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- Return type
- int <https://docs.python.org/3/library/functions.html#int>
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>
- getConstraintIndices(point)
- Return the point DOFs numbers which are constrained for a given point.
Not collective.
The range is in [0, DOFs).
- Parameters
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- Return type
- 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>
- getDof(point)
- 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.
- Parameters
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- Return type
- int <https://docs.python.org/3/library/functions.html#int>
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>
- getFieldComponents(field)
- Return the number of field components for the given field.
Not collective.
- Parameters
- field (int <https://docs.python.org/3/library/functions.html#int>) -- The field number.
- Return type
- int <https://docs.python.org/3/library/functions.html#int>
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>
- getFieldConstraintDof(point, field)
- Return the number of constrained DOFs for a given field on a point.
Not collective.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- field (int <https://docs.python.org/3/library/functions.html#int>) -- The field.
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>
- getFieldConstraintIndices(point, field)
- Return the field DOFs numbers, in [0, DOFs), which are constrained.
Not collective.
The constrained DOFs are sorted in ascending order.
- field (int <https://docs.python.org/3/library/functions.html#int>) -- The field number.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- Return type
- ArrayInt <#petsc4py.typing.ArrayInt>
See also:
Source code at petsc4py/PETSc/Section.pyx:634 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L634>
- getFieldDof(point, field)
- Return the number of DOFs associated with a field on a given point.
Not collective.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- field (int <https://docs.python.org/3/library/functions.html#int>) -- The field.
See also:
Source code at petsc4py/PETSc/Section.pyx:375 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L375>
- getFieldName(field)
- Return the name of a field in the section.
Not collective.
- Parameters
- field (int <https://docs.python.org/3/library/functions.html#int>) -- The field number.
- Return type
- str <https://docs.python.org/3/library/stdtypes.html#str>
See also:
Source code at petsc4py/PETSc/Section.pyx:156 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L156>
- getFieldOffset(point, field)
- 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.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- field (int <https://docs.python.org/3/library/functions.html#int>) -- The field.
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>
- getMaxDof()
- 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>
- getNumFields()
- 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>
- getOffset(point)
- 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.
- Parameters
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- Return type
- int <https://docs.python.org/3/library/functions.html#int>
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>
- getOffsetRange()
- Return the full range of offsets, [start, end), for a section.
Not collective.
See also:
Source code at petsc4py/PETSc/Section.pyx:831 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L831>
- getPermutation()
- 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>
- Return type
- IS <#petsc4py.PETSc.IS>
- getStorageSize()
- Return the size capable of holding all the DOFs defined in a section.
Not collective.
See also:
Source code at petsc4py/PETSc/Section.pyx:706 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L706>
- reset()
- Free all section data.
Not collective.
See also:
Source code at petsc4py/PETSc/Section.pyx:110 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L110>
- setChart(pStart, pEnd)
- 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.
- pStart (int <https://docs.python.org/3/library/functions.html#int>) -- The first point.
- pEnd (int <https://docs.python.org/3/library/functions.html#int>) -- 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>
- setConstraintDof(point, numDof)
- Set the number of constrained DOFs associated with a given point.
Not collective.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- numDof (int <https://docs.python.org/3/library/functions.html#int>) -- The number of DOFs which are fixed by constraints.
See also:
Source code at petsc4py/PETSc/Section.pyx:464 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L464>
- setConstraintIndices(point, indices)
- Set the point DOFs numbers, in [0, DOFs), which are constrained.
Not collective.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- indices (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- The constrained DOFs.
See also:
Source code at petsc4py/PETSc/Section.pyx:610 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L610>
- setDof(point, numDof)
- Set the number of degrees of freedom associated with a given point.
Not collective.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- numDof (int <https://docs.python.org/3/library/functions.html#int>) -- The number of DOFs.
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>
- setFieldComponents(field, numComp)
- Set the number of field components for the given field.
Not collective.
- field (int <https://docs.python.org/3/library/functions.html#int>) -- The field number.
- numComp (int <https://docs.python.org/3/library/functions.html#int>) -- The number of field components.
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>
- setFieldConstraintDof(point, field, numDof)
- Set the number of constrained DOFs for a given field on a point.
Not collective.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- field (int <https://docs.python.org/3/library/functions.html#int>) -- The field.
- numDof (int <https://docs.python.org/3/library/functions.html#int>) -- The number of DOFs which are fixed by constraints.
See also:
Source code at petsc4py/PETSc/Section.pyx:528 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L528>
- setFieldConstraintIndices(point, field, indices)
- Set the field DOFs numbers, in [0, DOFs), which are constrained.
Not collective.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- field (int <https://docs.python.org/3/library/functions.html#int>) -- The field number.
- indices (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- The constrained DOFs.
See also:
Source code at petsc4py/PETSc/Section.pyx:661 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L661>
- setFieldDof(point, field, numDof)
- Set the number of DOFs associated with a field on a given point.
Not collective.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- field (int <https://docs.python.org/3/library/functions.html#int>) -- The field.
- numDof (int <https://docs.python.org/3/library/functions.html#int>) -- The number of DOFs.
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>
- setFieldName(field, fieldName)
- Set the name of a field in the section.
Not collective.
- field (int <https://docs.python.org/3/library/functions.html#int>) -- The field number.
- fieldName (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The field name.
See also:
Source code at petsc4py/PETSc/Section.pyx:176 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L176>
- setFieldOffset(point, field, offset)
- 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.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- field (int <https://docs.python.org/3/library/functions.html#int>) -- The field.
- offset (int <https://docs.python.org/3/library/functions.html#int>) -- The offset.
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>
- setNumFields(numFields)
- Set the number of fields in a section.
Not collective.
- Parameters
- numFields (int <https://docs.python.org/3/library/functions.html#int>) -- The number of fields.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Section.pyx:138 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Section.pyx#L138>
- setOffset(point, offset)
- Set the offset for the DOFs associated with the given point.
Not collective.
The user usually does not call this function, but uses setUp.
- point (int <https://docs.python.org/3/library/functions.html#int>) -- The point.
- offset (int <https://docs.python.org/3/library/functions.html#int>) -- The offset.
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>
- setPermutation(perm)
- Set the permutation for [0, pEnd - pStart).
Not collective.
- Parameters
- perm (IS <#petsc4py.PETSc.IS>) -- The permutation of points.
- Return type
- 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>
- setUp()
- 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(viewer=None)
- View the section.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the section.
- Return type
- 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¶
- class 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¶
- class 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(comm=None)
- Create an empty Space object.
Collective.
The type can then be set with setType.
- Parameters
- 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>.
- Return type
- 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>
- destroy()
- Destroy the Space object.
Collective.
See also:
Source code at petsc4py/PETSc/Space.pyx:59 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L59>
- getDegree()
- Return the polynomial degrees that characterize this space.
Not collective.
- minDegree (int <https://docs.python.org/3/library/functions.html#int>) -- The degree of the largest polynomial space contained in the space.
- maxDegree (int <https://docs.python.org/3/library/functions.html#int>) -- The degree of the smallest polynomial space containing the space.
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>
- getDimension()
- Return the number of basis vectors.
Not collective.
See also:
Source code at petsc4py/PETSc/Space.pyx:103 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L103>
- getNumComponents()
- 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>
- getNumVariables()
- 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>
- getPTrimmedFormDegree()
- Return the form degree of the trimmed polynomials.
Not collective.
See also:
Source code at petsc4py/PETSc/Space.pyx:546 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L546>
- getPointPoints()
- 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>
- Return type
- Quad <#petsc4py.PETSc.Quad>
- getPolynomialTensor()
- 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:
Source code at petsc4py/PETSc/Space.pyx:448 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L448>
- getSumConcatenate()
- 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>
- getSumNumSubspaces()
- 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>
- getSumSubspace(s)
- Return a space in the sum.
Not collective.
- Parameters
- s (int <https://docs.python.org/3/library/functions.html#int>) -- The space number.
- Return type
- 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>
- getTensorNumSubspaces()
- Return the number of spaces in the tensor product.
Not collective.
See also:
Source code at petsc4py/PETSc/Space.pyx:376 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L376>
- getTensorSubspace(s)
- Return a space in the tensor product.
Not collective.
- Parameters
- s (int <https://docs.python.org/3/library/functions.html#int>) -- The space number.
- Return type
- 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>
- getType()
- Return the type of the space object.
Not collective.
See also:
Source code at petsc4py/PETSc/Space.pyx:227 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L227>
- setDegree(degree, maxDegree)
- 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>.
- degree (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- The degree of the largest polynomial space contained in the space.
- maxDegree (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- The degree of the largest polynomial space containing the space.
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>
- setFromOptions()
- Set parameters in Space from the options database.
Collective.
See also:
Source code at petsc4py/PETSc/Space.pyx:91 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L91>
- setNumComponents(nc)
- Set the number of components for this space.
Logically collective.
- Parameters
- nc (int <https://docs.python.org/3/library/functions.html#int>) -- The number of components.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setNumVariables(n)
- Set the number of variables for this space.
Logically collective.
- Parameters
- n (int <https://docs.python.org/3/library/functions.html#int>) -- The number of variables (x, y, z etc.).
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setPTrimmedFormDegree(formDegree)
- Set the form degree of the trimmed polynomials.
Logically collective.
- Parameters
- formDegree (int <https://docs.python.org/3/library/functions.html#int>) -- The form degree.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Space.pyx:528 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L528>
- setPointPoints(quad)
- 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.
- Parameters
- quad (Quad <#petsc4py.PETSc.Quad>) -- The Quad <#petsc4py.PETSc.Quad> defining the points.
- Return type
- 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>
- setPolynomialTensor(tensor)
- 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).
- Parameters
- tensor (bool <https://docs.python.org/3/library/functions.html#bool>) -- True <https://docs.python.org/3/library/constants.html#True> for a tensor polynomial space, False <https://docs.python.org/3/library/constants.html#False> for a polynomial space.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Space.pyx:468 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L468>
- setSumConcatenate(concatenate)
- 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.
- Parameters
- concatenate (bool <https://docs.python.org/3/library/functions.html#bool>) -- True <https://docs.python.org/3/library/constants.html#True> if subspaces are concatenated components, False <https://docs.python.org/3/library/constants.html#False> if direct summands.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setSumNumSubspaces(numSumSpaces)
- Set the number of spaces in the sum.
Logically collective.
- Parameters
- numSumSpaces (int <https://docs.python.org/3/library/functions.html#int>) -- The number of spaces.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setSumSubspace(s, subsp)
- Set a space in the sum.
Logically collective.
- s (int <https://docs.python.org/3/library/functions.html#int>) -- The space number.
- subsp (Space <#petsc4py.PETSc.Space>) -- The number of spaces.
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>
- setTensorNumSubspaces(numTensSpaces)
- Set the number of spaces in the tensor product.
Logically collective.
- Parameters
- numTensSpaces (int <https://docs.python.org/3/library/functions.html#int>) -- The number of spaces.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Space.pyx:430 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L430>
- setTensorSubspace(s, subsp)
- Set a space in the tensor product.
Logically collective.
- s (int <https://docs.python.org/3/library/functions.html#int>) -- The space number.
- subsp (Space <#petsc4py.PETSc.Space>) -- The number of spaces.
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>
- setType(space_type)
- Build a particular type of space.
Collective.
- Parameters
- space_type (Type <#petsc4py.PETSc.Space.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The kind of space.
- Return type
- 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>
- setUp()
- Construct data structures for the Space.
Collective.
See also:
Source code at petsc4py/PETSc/Space.pyx:24 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Space.pyx#L24>
- view(viewer=None)
- View a Space.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- A Viewer <#petsc4py.PETSc.Viewer> to display the Space.
- Return type
- 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¶
- class 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
- classmethod Print(*args, sep=' ', end='\n', comm=None, **kwargs)
- Print output from the first processor of a communicator.
Collective.
- *args (Any <https://docs.python.org/3/library/typing.html#typing.Any>) -- Positional arguments.
- sep (str <https://docs.python.org/3/library/stdtypes.html#str>) -- String inserted between values, by default a space.
- end (str <https://docs.python.org/3/library/stdtypes.html#str>) -- String appended after the last value, by default a newline.
- comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to getDefaultComm.
- **kwargs (Any <https://docs.python.org/3/library/typing.html#typing.Any>) -- Keyword arguments.
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>
- classmethod getDefaultComm()
- Get the default MPI communicator used to create PETSc objects.
Not collective.
See also:
Source code at petsc4py/PETSc/Sys.pyx:116 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L116>
- Return type
- Comm <#petsc4py.PETSc.Comm>
- classmethod getVersion(devel=False, date=False, author=False)
- Return PETSc version information.
Not collective.
- devel (bool <https://docs.python.org/3/library/functions.html#bool>) -- Additionally, return whether using an in-development version.
- date (bool <https://docs.python.org/3/library/functions.html#bool>) -- Additionally, return date information.
- author (bool <https://docs.python.org/3/library/functions.html#bool>) -- Additionally, return author information.
- major (int <https://docs.python.org/3/library/functions.html#int>) -- Major version number.
- minor (int <https://docs.python.org/3/library/functions.html#int>) -- Minor version number.
- micro (int <https://docs.python.org/3/library/functions.html#int>) -- Micro (or patch) version number.
See also:
Source code at petsc4py/PETSc/Sys.pyx:7 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L7>
- classmethod getVersionInfo()
- Return PETSc version information.
Not collective.
- Returns
- info -- Dictionary with version information.
- Return type
- dict <https://docs.python.org/3/library/stdtypes.html#dict>
See also:
Source code at petsc4py/PETSc/Sys.pyx:62 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L62>
- classmethod hasExternalPackage(package)
- Return whether PETSc has support for external package.
Not collective.
- Parameters
- package (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The external package name.
- Return type
- bool <https://docs.python.org/3/library/functions.html#bool>
See also:
Source code at petsc4py/PETSc/Sys.pyx:449 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L449>
- classmethod infoAllow(flag, filename=None, mode='w')
- Enables or disables PETSc info messages.
Not collective.
- flag (bool <https://docs.python.org/3/library/functions.html#bool>) -- Whether to enable info messages.
- filename (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- Name of a file where to dump output.
- mode (str <https://docs.python.org/3/library/stdtypes.html#str>) -- Write mode for file, by default "w".
See also:
Source code at petsc4py/PETSc/Sys.pyx:392 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L392>
- classmethod isFinalized()
- Return whether PETSc has been finalized.
Not collective.
See also:
Source code at petsc4py/PETSc/Sys.pyx:101 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L101>
- classmethod isInitialized()
- Return whether PETSc has been initialized.
Not collective.
See also:
Source code at petsc4py/PETSc/Sys.pyx:88 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L88>
- classmethod popErrorHandler()
- Remove the current error handler.
Logically collective.
See also:
Source code at petsc4py/PETSc/Sys.pyx:366 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L366>
- classmethod popSignalHandler()
- Remove the current signal handler.
Logically collective.
See also:
Source code at petsc4py/PETSc/Sys.pyx:379 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L379>
- classmethod pushErrorHandler(errhandler)
- Set the current error handler.
Logically collective.
- Parameters
- errhandler (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The name of the error handler.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Sys.pyx:331 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L331>
- classmethod registerCitation(citation)
- Register BibTeX citation.
Not collective.
- Parameters
- citation (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The BibTex citation entry to register.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Sys.pyx:426 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L426>
- classmethod setDefaultComm(comm)
- Set the default MPI communicator used to create PETSc objects.
Logically collective.
- Parameters
- 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>.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Sys.pyx:131 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L131>
- classmethod sleep(seconds=1.0)
- Sleep some number of seconds.
Not collective.
- Parameters
- seconds (float <https://docs.python.org/3/library/functions.html#float>) -- Time to sleep in seconds.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Sys.pyx:310 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Sys.pyx#L310>
- classmethod splitOwnership(size, bsize=None, comm=None)
- Given a global (or local) size determines a local (or global) size.
Collective.
- size (int <https://docs.python.org/3/library/functions.html#int> | 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>]) -- Global size N or 2-tuple (n, N) with local and global sizes. Either of n or N (but not both) can be None <https://docs.python.org/3/library/constants.html#None>.
- bsize (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Block size, defaults to 1.
- comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to getDefaultComm.
- n (int <https://docs.python.org/3/library/functions.html#int>) -- The local size.
- N (int <https://docs.python.org/3/library/functions.html#int>) -- The global size.
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>
- classmethod syncFlush(comm=None)
- Flush output from previous syncPrint calls.
Collective.
- Parameters
- comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to getDefaultComm.
- Return type
- 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>
- classmethod syncPrint(*args, sep=' ', end='\n', flush=False, comm=None, **kwargs)
- Print synchronized output from several processors of a communicator.
Not collective.
- *args (Any <https://docs.python.org/3/library/typing.html#typing.Any>) -- Positional arguments.
- sep (str <https://docs.python.org/3/library/stdtypes.html#str>) -- String inserted between values, by default a space.
- end (str <https://docs.python.org/3/library/stdtypes.html#str>) -- String appended after the last value, by default a newline.
- flush (bool <https://docs.python.org/3/library/functions.html#bool>) -- Whether to flush output with syncFlush.
- comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>) -- MPI communicator, defaults to getDefaultComm.
- **kwargs (Any <https://docs.python.org/3/library/typing.html#typing.Any>) -- Keyword arguments.
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¶
- class 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¶
- class petsc4py.PETSc.TAO.ALMMType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
TAO Augmented Lagrangian Multiplier method (ALMM) Type.
Attributes Summary
CLASSIC Constant CLASSIC of type int <https://docs.python.org/3/library/functions.html#int> PHR Constant PHR of type int <https://docs.python.org/3/library/functions.html#int> Attributes Documentation
petsc4py.PETSc.TAO.BNCGType¶
- class 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
Attributes Documentation
petsc4py.PETSc.TAO.ConvergedReason¶
- class 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¶
- class petsc4py.PETSc.TAO.Type
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
TAO solver type.
See also:
Attributes Summary
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
- appendOptionsPrefix(prefix)
- Append to the prefix used for searching for options in the database.
Logically collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:220 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L220>
- cancelMonitor()
- Cancel all the monitors of the solver.
Logically collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1373 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1373>
- checkConverged()
- Run convergence test and return converged reason.
Collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1700 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1700>
- Return type
- ConvergedReason <#petsc4py.PETSc.TAO.ConvergedReason>
- computeConstraints(x, c)
- 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.
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>
- computeDualVariables(xl, xu)
- 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>)
- computeGradient(x, g)
- 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.
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>
- computeHessian(x, H, P=None)
- 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.
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>
- computeJacobian(x, J, P=None)
- 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.
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>
- computeObjective(x)
- Compute the value of the objective function.
Collective.
- Parameters
- x (Vec <#petsc4py.PETSc.Vec>) -- The parameter vector.
- Return type
- 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>
- computeObjectiveGradient(x, g)
- 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.
See also:
Source code at petsc4py/PETSc/TAO.pyx:982 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L982>
- computeResidual(x, f)
- Compute the residual.
Collective.
- x (Vec <#petsc4py.PETSc.Vec>) -- The parameter vector.
- f (Vec <#petsc4py.PETSc.Vec>) -- The output vector.
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>
- computeVariableBounds(xl, xu)
- 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>)
- create(comm=None)
- Create a TAO solver.
Collective.
- Parameters
- 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>.
- Return type
- Self <https://docs.python.org/3/library/typing.html#typing.Self>
See also:
Source code at petsc4py/PETSc/TAO.pyx:152 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L152>
- createPython(context=None, comm=None)
- Create an optimization solver of Python type.
Collective.
- context (Any <https://docs.python.org/3/library/typing.html#typing.Any>) -- An instance of the Python class implementing the required methods.
- 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>.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1891 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1891>
- destroy()
- Destroy the solver.
Collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:139 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L139>
- getALMMSubsolver()
- 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>
- Return type
- TAO <#petsc4py.PETSc.TAO>
- getALMMType()
- 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>
- Return type
- ALMMType <#petsc4py.PETSc.TAO.ALMMType>
- getAppCtx()
- Return the application context.
Source code at petsc4py/PETSc/TAO.pyx:293 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L293>
- getBNCGType()
- 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>
- Return type
- BNCGType <#petsc4py.PETSc.TAO.BNCGType>
- getBRGNDampingVector()
- 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>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- getBRGNSubsolver()
- 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>
- Return type
- TAO <#petsc4py.PETSc.TAO>
- getConstraintTolerances()
- Return the constraints tolerance parameters used in the convergence tests.
Not collective.
- catol (float <https://docs.python.org/3/library/functions.html#float>) -- The absolute norm of the constraints.
- crtol (float <https://docs.python.org/3/library/functions.html#float>) -- The relative norm of the constraints.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1244 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1244>
- getConvergedReason()
- 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>
- Return type
- ConvergedReason <#petsc4py.PETSc.TAO.ConvergedReason>
- getConvergenceTest()
- Return the callback used to test for solver convergence.
Not collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1293 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1293>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[TAOConvergedFunction <#petsc4py.typing.TAOConvergedFunction>, tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...], dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>]]
- getEqualityConstraints()
- Return tuple holding vector and callback of equality constraints.
Not collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:755 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L755>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[TAOConstraintsFunction <#petsc4py.typing.TAOConstraintsFunction>, tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>, dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>]]
- getGradient()
- Return the vector used to store the gradient and the evaluation callback.
Not collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:436 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L436>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, TAOGradientFunction <#petsc4py.typing.TAOGradientFunction>]
- getGradientNorm()
- 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>
- Return type
- Mat <#petsc4py.PETSc.Mat>
- getHessian()
- 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>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>, TAOHessianFunction <#petsc4py.typing.TAOHessianFunction>]
- getInequalityConstraints()
- Return tuple holding vector and callback of inequality constraints.
Not collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:828 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L828>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[TAOConstraintsFunction <#petsc4py.typing.TAOConstraintsFunction>, tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>, dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>]]
- getIterationNumber()
- Return the current iteration number.
Not collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1596 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1596>
- getJacobianEquality()
- Return matrix, precon matrix and callback of equality constraints
Jacobian.
Not collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:792 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L792>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>, tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[TAOConstraintsJacobianFunction <#petsc4py.typing.TAOConstraintsJacobianFunction>, tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>, dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>]]
- getJacobianInequality()
- Return matrix, precon matrix and callback of ineq. constraints Jacobian.
Not collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:865 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L865>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>, tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[TAOConstraintsJacobianFunction <#petsc4py.typing.TAOConstraintsJacobianFunction>, tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>, dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>]]
- getKSP()
- 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>
- Return type
- KSP <#petsc4py.PETSc.KSP>
- getLMVMH0()
- 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>
- Return type
- Mat <#petsc4py.PETSc.Mat>
- getLMVMH0KSP()
- 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>
- Return type
- KSP <#petsc4py.PETSc.KSP>
- getLMVMMat()
- 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>
- Return type
- Mat <#petsc4py.PETSc.Mat>
- getLineSearch()
- 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>
- Return type
- TAOLineSearch <#petsc4py.PETSc.TAOLineSearch>
- getMaximumFunctionEvaluations()
- Return the maximum number of objective evaluations within the solver.
Not collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1204 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1204>
- getMaximumIterations()
- Return the maximum number of solver iterations.
Not collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1177 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1177>
- getMonitor()
- Return the callback used to monitor solver convergence.
Not collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1361 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1361>
- Return type
- list <https://docs.python.org/3/library/stdtypes.html#list>[tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[TAOMonitorFunction <#petsc4py.typing.TAOMonitorFunction>, tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...], dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>]]]
- getObjective()
- 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>
- Return type
- TAOObjectiveFunction <#petsc4py.typing.TAOObjectiveFunction>
- getObjectiveAndGradient()
- Return the vector used to store the gradient and the evaluation callback.
Not collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:482 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L482>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, TAOObjectiveGradientFunction <#petsc4py.typing.TAOObjectiveGradientFunction>]
- getObjectiveValue()
- 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>
- getOptionsPrefix()
- Return the prefix used for searching for options in the database.
Not collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:234 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L234>
- getPythonContext()
- Return the instance of the class implementing the required Python methods.
Not collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1928 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1928>
- getPythonType()
- Return the fully qualified Python name of the class used by the solver.
Not collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1958 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1958>
- getSolution()
- 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>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- getSolutionNorm()
- Return the objective function value and the norms of gradient and
constraints.
Not collective.
- f (float <https://docs.python.org/3/library/functions.html#float>) -- Current value of the objective function.
- res (float <https://docs.python.org/3/library/functions.html#float>) -- Current value of the residual norm.
- cnorm (float <https://docs.python.org/3/library/functions.html#float>) -- Current value of the constrains norm.
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>
- getSolutionStatus()
- Return the solution status.
Not collective.
- its (int <https://docs.python.org/3/library/functions.html#int>) -- Current number of iterations.
- f (float <https://docs.python.org/3/library/functions.html#float>) -- Current value of the objective function.
- res (float <https://docs.python.org/3/library/functions.html#float>) -- Current value of the residual norm.
- cnorm (float <https://docs.python.org/3/library/functions.html#float>) -- Current value of the constrains norm.
- step (float <https://docs.python.org/3/library/functions.html#float>) -- Current value of the step.
- reason (ConvergedReason <#petsc4py.PETSc.TAO.ConvergedReason>) -- Current value of converged reason.
- Return type
- 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>
- getTolerances()
- Return the tolerance parameters used in the solver convergence tests.
Not collective.
- gatol (float <https://docs.python.org/3/library/functions.html#float>) -- The absolute norm of the gradient.
- grtol (float <https://docs.python.org/3/library/functions.html#float>) -- The relative norm of the gradient.
- gttol (float <https://docs.python.org/3/library/functions.html#float>) -- The relative norm of the gradient with respect to the initial norm of the gradient.
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>
- getType()
- Return the type of the solver.
Not collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:192 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L192>
- getUpdate()
- Return the callback to compute the update.
Not collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:911 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L911>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[TAOUpdateFunction <#petsc4py.typing.TAOUpdateFunction>, tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...], dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>]]
- getVariableBounds()
- 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>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>]
- monitor(its=None, f=None, res=None, cnorm=None, step=None)
- Monitor the solver.
Collective.
This function should be called without arguments, unless users want to modify the values internally stored by the solver.
- its (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Current number of iterations or None <https://docs.python.org/3/library/constants.html#None> to use the value stored internally by the solver.
- f (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- Current value of the objective function or None <https://docs.python.org/3/library/constants.html#None> to use the value stored internally by the solver.
- res (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- Current value of the residual norm or None <https://docs.python.org/3/library/constants.html#None> to use the value stored internally by the solver.
- cnorm (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- Current value of the constrains norm or None <https://docs.python.org/3/library/constants.html#None> to use the value stored internally by the solver.
- step (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- Current value of the step or None <https://docs.python.org/3/library/constants.html#None> to use the value stored internally by the solver.
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>
- setALMMSubsolver(subsolver)
- 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>
- Parameters
- subsolver (TAO <#petsc4py.PETSc.TAO>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setALMMType(tao_almm_type)
- Set the ALMM type of the solver.
Logically collective.
- Parameters
- tao_almm_type (ALMMType <#petsc4py.PETSc.TAO.ALMMType>) -- The type of the solver.
- Return type
- 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>
- setAppCtx(appctx)
- Set the application context.
Source code at petsc4py/PETSc/TAO.pyx:289 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L289>
- setBNCGType(cg_type)
- 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>
- Parameters
- cg_type (BNCGType <#petsc4py.PETSc.TAO.BNCGType>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setBRGNDictionaryMatrix(D)
- Set the dictionary matrix.
Collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1864 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1864>
- Parameters
- D (Mat <#petsc4py.PETSc.Mat>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setBRGNRegularizerHessian(hessian, H=None, args=None, kargs=None)
- Set the callback to compute the regularizer Hessian.
Logically collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1824 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1824>
- H (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>)
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>)
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>)
- setBRGNRegularizerObjectiveGradient(objgrad, args=None, kargs=None)
- Set the callback to compute the regularizer objective and gradient.
Logically collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1808 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1808>
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>)
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>)
- setBRGNRegularizerWeight(weight)
- Set the regularizer weight.
Collective.
Source code at petsc4py/PETSc/TAO.pyx:1842 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1842>
- setBRGNSmoothL1Epsilon(epsilon)
- Set the smooth L1 epsilon.
Collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1851 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1851>
- setConstraintTolerances(catol=None, crtol=None)
- Set the constraints tolerance parameters used in the solver convergence
tests.
Collective.
- catol (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The absolute norm of the constraints, or DETERMINE <#petsc4py.PETSc.DETERMINE> to use the value when the object's type was set. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
- crtol (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The relative norm of the constraints, or DETERMINE <#petsc4py.PETSc.DETERMINE> to use the value when the object's type was set. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1218 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1218>
- setConstraints(constraints, C=None, args=None, kargs=None)
- Set the callback to compute constraints.
Logically collective.
- constraints (TAOConstraintsFunction <#petsc4py.typing.TAOConstraintsFunction>) -- The callback.
- C (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- The vector to hold the constraints.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
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>
- setConvergedReason(reason)
- 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>
- Parameters
- reason (ConvergedReason <#petsc4py.PETSc.TAO.ConvergedReason>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setConvergenceTest(converged, args=None, kargs=None)
- Set the callback used to test for solver convergence.
Logically collective.
- converged (TAOConvergedFunction <#petsc4py.typing.TAOConvergedFunction> | None <https://docs.python.org/3/library/constants.html#None>) -- The callback. If None <https://docs.python.org/3/library/constants.html#None>, reset to the default convergence test.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
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>
- setEqualityConstraints(equality_constraints, c, args=None, kargs=None)
- Set equality constraints callback.
Logically collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:737 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L737>
- c (Vec <#petsc4py.PETSc.Vec>)
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>)
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>)
- setFromOptions()
- Configure the solver from the options database.
Collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:248 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L248>
- setGradient(gradient, g=None, args=None, kargs=None)
- Set the gradient evaluation callback.
Logically collective.
- gradient (TAOGradientFunction <#petsc4py.typing.TAOGradientFunction>) -- The gradient callback.
- g (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- The vector to store the gradient.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
See also:
Source code at petsc4py/PETSc/TAO.pyx:394 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L394>
- setGradientNorm(mat)
- 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>
- Parameters
- mat (Mat <#petsc4py.PETSc.Mat>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setHessian(hessian, H=None, P=None, args=None, kargs=None)
- Set the callback to compute the Hessian matrix.
Logically collective.
- hessian (TAOHessianFunction <#petsc4py.typing.TAOHessianFunction>) -- The Hessian callback.
- H (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The matrix to store the Hessian.
- P (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The matrix to construct the preconditioner.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
See also:
Source code at petsc4py/PETSc/TAO.pyx:563 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L563>
- setInequalityConstraints(inequality_constraints, c, args=None, kargs=None)
- Set inequality constraints callback.
Logically collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:810 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L810>
- c (Vec <#petsc4py.PETSc.Vec>)
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>)
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>)
- setInitialTrustRegionRadius(radius)
- Set the initial trust region radius.
Collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:274 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L274>
- setIterationNumber(its)
- Set the current iteration number.
Collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1583 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1583>
- setJacobian(jacobian, J=None, P=None, args=None, kargs=None)
- Set the callback to compute the Jacobian.
Logically collective.
- jacobian (TAOJacobianFunction <#petsc4py.typing.TAOJacobianFunction>) -- The Jacobian callback.
- J (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The matrix to store the Jacobian.
- P (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The matrix to construct the preconditioner.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
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>
- setJacobianDesign(jacobian_design, J=None, args=None, kargs=None)
- Set Jacobian design callback.
Logically collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:689 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L689>
- J (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>)
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>)
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>)
- setJacobianEquality(jacobian_equality, J=None, P=None, args=None, kargs=None)
- Set Jacobian equality constraints callback.
Logically collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:770 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L770>
- J (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>)
- P (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>)
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>)
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>)
- setJacobianInequality(jacobian_inequality, J=None, P=None, args=None, kargs=None)
- Set Jacobian inequality constraints callback.
Logically collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:843 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L843>
- J (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>)
- P (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>)
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>)
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>)
- setJacobianResidual(jacobian, J=None, P=None, args=None, kargs=None)
- Set the callback to compute the least-squares residual Jacobian.
Logically collective.
- jacobian (TAOJacobianResidualFunction <#petsc4py.typing.TAOJacobianResidualFunction>) -- The Jacobian callback.
- J (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The matrix to store the Jacobian.
- P (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The matrix to construct the preconditioner.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
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>
- setJacobianState(jacobian_state, J=None, P=None, I=None, args=None, kargs=None)
- Set Jacobian state callback.
Logically collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:665 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L665>
- J (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>)
- P (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>)
- I (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>)
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>)
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>)
- setLMVMH0(mat)
- 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>
- Parameters
- mat (Mat <#petsc4py.PETSc.Mat>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setLMVMMat(M)
- 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>
- Parameters
- M (Mat <#petsc4py.PETSc.Mat>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setMaximumFunctionEvaluations(mit)
- Set the maximum number of objective evaluations within the solver.
Collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1191 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1191>
- setMaximumIterations(mit)
- Set the maximum number of solver iterations.
Collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1164 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1164>
- setMonitor(monitor, args=None, kargs=None)
- Set the callback used to monitor solver convergence.
Logically collective.
- monitor (TAOMonitorFunction <#petsc4py.typing.TAOMonitorFunction>) -- The callback.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1332 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1332>
- setObjective(objective, args=None, kargs=None)
- Set the objective function evaluation callback.
Logically collective.
- objective (TAOObjectiveFunction <#petsc4py.typing.TAOObjectiveFunction>) -- The objective function callback.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
See also:
Source code at petsc4py/PETSc/TAO.pyx:309 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L309>
- setObjectiveGradient(objgrad, g=None, args=None, kargs=None)
- Set the objective function and gradient evaluation callback.
Logically collective.
- objgrad (TAOObjectiveGradientFunction <#petsc4py.typing.TAOObjectiveGradientFunction>) -- The objective function and gradient callback.
- g (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- The vector to store the gradient.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
See also:
Source code at petsc4py/PETSc/TAO.pyx:452 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L452>
- setOptionsPrefix(prefix)
- Set the prefix used for searching for options in the database.
Logically collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:206 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L206>
- setPythonContext(context)
- Set the instance of the class implementing the required Python methods.
Not collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1916 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1916>
- setPythonType(py_type)
- Set the fully qualified Python name of the class to be used.
Collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:1943 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1943>
- setResidual(residual, R, args=None, kargs=None)
- Set the residual evaluation callback for least-squares applications.
Logically collective.
- residual (TAOResidualFunction <#petsc4py.typing.TAOResidualFunction>) -- The residual callback.
- R (Vec <#petsc4py.PETSc.Vec>) -- The vector to store the residual.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
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>
- setSolution(x)
- 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>
- Parameters
- x (Vec <#petsc4py.PETSc.Vec>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setStateDesignIS(state=None, design=None)
- Set the index sets indicating state and design variables.
Collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:650 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L650>
- state (IS <#petsc4py.PETSc.IS> | None <https://docs.python.org/3/library/constants.html#None>)
- design (IS <#petsc4py.PETSc.IS> | None <https://docs.python.org/3/library/constants.html#None>)
- setTolerances(gatol=None, grtol=None, gttol=None)
- Set the tolerance parameters used in the solver convergence tests.
Collective.
- gatol (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The absolute norm of the gradient, or DETERMINE <#petsc4py.PETSc.DETERMINE> to use the value when the object's type was set. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
- grtol (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The relative norm of the gradient with respect to the initial norm of the objective, or DETERMINE <#petsc4py.PETSc.DETERMINE> to use the value when the object's type was set. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
- gttol (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The relative norm of the gradient with respect to the initial norm of the gradient, or DETERMINE <#petsc4py.PETSc.DETERMINE> to use the value when the object's type was set. Defaults to CURRENT <#petsc4py.PETSc.CURRENT>.
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>
- setType(tao_type)
- Set the type of the solver.
Logically collective.
- Parameters
- tao_type (Type <#petsc4py.PETSc.TAO.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of the solver.
- Return type
- 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>
- setUp()
- Set up the internal data structures for using the solver.
Collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:260 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L260>
- setUpdate(update, args=None, kargs=None)
- Set the callback to compute update at each optimization step.
Logically collective.
- update (TAOUpdateFunction <#petsc4py.typing.TAOUpdateFunction>) -- The update callback or None <https://docs.python.org/3/library/constants.html#None> to reset it.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
See also:
Source code at petsc4py/PETSc/TAO.pyx:882 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L882>
- setVariableBounds(varbounds, args=None, kargs=None)
- Set the lower and upper bounds for the optimization problem.
Logically collective.
- varbounds (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>] | TAOVariableBoundsFunction <#petsc4py.typing.TAOVariableBoundsFunction>) -- Either a tuple of Vec <#petsc4py.PETSc.Vec> or a TAOVariableBoundsFunction <#petsc4py.typing.TAOVariableBoundsFunction> callback.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
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(x=None)
- Solve the optimization problem.
Collective.
- Parameters
- 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.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
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(viewer=None)
- View the solver.
Collective.
- Parameters
- 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.
- Return type
- 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
- appctx
- Application context.
Source code at petsc4py/PETSc/TAO.pyx:1994 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L1994>
- cnorm
- Constraints norm.
Source code at petsc4py/PETSc/TAO.pyx:2063 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2063>
- converged
- 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>
- ctol
- Broken.
Source code at petsc4py/PETSc/TAO.pyx:2038 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2038>
- diverged
- 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>
- ftol
- Broken.
Source code at petsc4py/PETSc/TAO.pyx:2012 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2012>
- function
- Objective value.
Source code at petsc4py/PETSc/TAO.pyx:2078 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2078>
- gnorm
- Gradient norm.
Source code at petsc4py/PETSc/TAO.pyx:2058 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2058>
- gradient
- Gradient vector.
Source code at petsc4py/PETSc/TAO.pyx:2083 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2083>
- gtol
- Broken.
Source code at petsc4py/PETSc/TAO.pyx:2025 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2025>
- iterating
- 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>
- its
- 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>
- ksp
- Linear solver.
Source code at petsc4py/PETSc/TAO.pyx:2004 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2004>
- objective
- Objective value.
Source code at petsc4py/PETSc/TAO.pyx:2073 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2073>
- reason
- Converged reason.
Source code at petsc4py/PETSc/TAO.pyx:2090 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2090>
- solution
- Solution vector.
Source code at petsc4py/PETSc/TAO.pyx:2068 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2068>
petsc4py.PETSc.TAOLineSearch¶
- class 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¶
- class 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¶
- class 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
- apply(x, g, s)
- Performs a line-search in a given step direction.
Collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:2391 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2391>
- x (Vec <#petsc4py.PETSc.Vec>)
- g (Vec <#petsc4py.PETSc.Vec>)
- s (Vec <#petsc4py.PETSc.Vec>)
- create(comm=None)
- Create a TAO linesearch.
Collective.
- Parameters
- comm -- MPI communicator, defaults to Sys.getDefaultComm <#petsc4py.PETSc.Sys.getDefaultComm>.
- Return type
- Self <https://docs.python.org/3/library/typing.html#typing.Self>
See also:
Source code at petsc4py/PETSc/TAO.pyx:2194 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2194>
- destroy()
- Destroy the linesearch object.
Collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:2181 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2181>
- getOptionsPrefix()
- Return the prefix used for searching for options in the database.
Not collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:2286 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2286>
- getType()
- Return the type of the linesearch.
Not collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:2234 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2234>
- setFromOptions()
- Configure the linesearch from the options database.
Collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:2248 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2248>
- setGradient(gradient, args=None, kargs=None)
- Set the gradient evaluation callback.
Logically collective.
- gradient (TAOLSGradientFunction <#petsc4py.typing.TAOLSGradientFunction>) -- The gradient callback.
- g -- The vector to store the gradient.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
See also:
Source code at petsc4py/PETSc/TAO.pyx:2325 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2325>
- setInitialStepLength(s)
- Sets the initial step length of a line search.
Logically collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:2407 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2407>
- setObjective(objective, args=None, kargs=None)
- Set the objective function evaluation callback.
Logically collective.
- objective (TAOLSObjectiveFunction <#petsc4py.typing.TAOLSObjectiveFunction>) -- The objective function callback.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
See also:
Source code at petsc4py/PETSc/TAO.pyx:2300 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2300>
- setObjectiveGradient(objgrad, args=None, kargs=None)
- Set the objective function and gradient evaluation callback.
Logically collective.
- objgrad (TAOLSObjectiveGradientFunction <#petsc4py.typing.TAOLSObjectiveGradientFunction>) -- The objective function and gradient callback.
- g -- The vector to store the gradient.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Positional arguments for the callback.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Keyword arguments for the callback.
See also:
Source code at petsc4py/PETSc/TAO.pyx:2352 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2352>
- setOptionsPrefix(prefix=None)
- Set the prefix used for searching for options in the database.
Logically collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:2272 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2272>
- setType(ls_type)
- Set the type of the linesearch.
Logically collective.
- Parameters
- ls_type (Type <#petsc4py.PETSc.TAOLineSearch.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of the solver.
- Return type
- 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>
- setUp()
- Set up the internal data structures for using the linesearch.
Collective.
See also:
Source code at petsc4py/PETSc/TAO.pyx:2260 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TAO.pyx#L2260>
- useTAORoutine(tao)
- 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>
- Parameters
- tao (TAO <#petsc4py.PETSc.TAO>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- view(viewer=None)
- View the linesearch object.
Collective.
- Parameters
- 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.
- Return type
- 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¶
- class 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¶
- class petsc4py.PETSc.TS.ARKIMEXType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The ARKIMEX subtype.
Attributes Summary
Attributes Documentation
petsc4py.PETSc.TS.ConvergedReason¶
- class 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¶
- class petsc4py.PETSc.TS.DIRKType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The DIRK subtype.
Attributes Summary
Attributes Documentation
petsc4py.PETSc.TS.EquationType¶
- class 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¶
- class petsc4py.PETSc.TS.ExactFinalTime
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The method for ending time stepping.
Attributes Summary
INTERPOLATE Constant INTERPOLATE of type int <https://docs.python.org/3/library/functions.html#int> MATCHSTEP Constant MATCHSTEP of type int <https://docs.python.org/3/library/functions.html#int> STEPOVER Constant STEPOVER 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.ProblemType¶
- class petsc4py.PETSc.TS.ProblemType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Distinguishes linear and nonlinear problems.
Attributes Summary
LINEAR Constant LINEAR of type int <https://docs.python.org/3/library/functions.html#int> NONLINEAR Constant NONLINEAR of type int <https://docs.python.org/3/library/functions.html#int> Attributes Documentation
petsc4py.PETSc.TS.RKType¶
- class petsc4py.PETSc.TS.RKType
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The RK subtype.
Attributes Summary
Attributes Documentation
petsc4py.PETSc.TS.Type¶
- class petsc4py.PETSc.TS.Type
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The time stepping method.
Attributes Summary
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
- adjointReset()
- Reset a TS, removing any allocated vectors and matrices.
Collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:2908 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2908>
- adjointSetSteps(adjoint_steps)
- Set the number of steps the adjoint solver should take backward in time.
Logically collective.
- Parameters
- adjoint_steps (int <https://docs.python.org/3/library/functions.html#int>) -- The number of steps to take.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- adjointSetUp()
- 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>
- adjointSolve()
- Solve the discrete adjoint problem for an ODE/DAE.
Collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:2884 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2884>
- adjointStep()
- Step one time step backward in the adjoint run.
Collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:2896 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2896>
- appendOptionsPrefix(prefix)
- Append to the prefix used for all the TS options.
Logically collective.
- Parameters
- prefix (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The prefix to append to the current prefix.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
Notes
A hyphen must not be given at the beginning of the prefix name.
See also:
Source code at petsc4py/PETSc/TS.pyx:540 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L540>
- clone()
- 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>
- Return type
- TS <#petsc4py.PETSc.TS>
- computeI2Function(t, x, xdot, xdotdot, f)
- 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.
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>
- computeI2Jacobian(t, x, xdot, xdotdot, v, a, J, P=None)
- 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.
- 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.
- v (float <https://docs.python.org/3/library/functions.html#float>) -- The shift to apply to the first derivative.
- a (float <https://docs.python.org/3/library/functions.html#float>) -- The shift to apply to the second derivative.
- J (Mat <#petsc4py.PETSc.Mat>) -- The matrix into which the Jacobian is computed.
- P (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The optional matrix to use for building a preconditioner.
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>
- computeIFunction(t, x, xdot, f, imex=False)
- Evaluate the DAE residual written 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.
- f (Vec <#petsc4py.PETSc.Vec>) -- The vector into which the residual is stored.
- imex (bool <https://docs.python.org/3/library/functions.html#bool>) -- A flag which indicates if the RHS should be kept separate.
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>
- computeIJacobian(t, x, xdot, a, J, P=None, imex=False)
- 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
- 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.
- a (float <https://docs.python.org/3/library/functions.html#float>) -- The shift to apply
- J (Mat <#petsc4py.PETSc.Mat>) -- The matrix into which the Jacobian is computed.
- P (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The optional matrix to use for building a preconditioner.
- imex (bool <https://docs.python.org/3/library/functions.html#bool>) -- A flag which indicates if the RHS should be kept separate.
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>
- computeIJacobianP(t, x, xdot, a, J, imex=False)
- Evaluate the Jacobian with respect to parameters.
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.
- a (float <https://docs.python.org/3/library/functions.html#float>) -- The shift to apply
- J (Mat <#petsc4py.PETSc.Mat>) -- The matrix into which the Jacobian is computed.
- imex (bool <https://docs.python.org/3/library/functions.html#bool>) -- A flag which indicates if the RHS should be kept separate.
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>
- computeRHSFunction(t, x, f)
- Evaluate the right-hand side function.
Collective.
- t (float <https://docs.python.org/3/library/functions.html#float>) -- The time at which to evaluate the RHS.
- x (Vec <#petsc4py.PETSc.Vec>) -- The state vector.
- f (Vec <#petsc4py.PETSc.Vec>) -- The Vec into which the RHS is computed.
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>
- computeRHSFunctionLinear(t, x, f)
- Evaluate the right-hand side via the user-provided Jacobian.
Collective.
- t (float <https://docs.python.org/3/library/functions.html#float>) -- The time at which to evaluate the RHS.
- x (Vec <#petsc4py.PETSc.Vec>) -- The state vector.
- f (Vec <#petsc4py.PETSc.Vec>) -- The Vec into which the RHS is computed.
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>
- computeRHSJacobian(t, x, J, P=None)
- Compute the Jacobian matrix that has been set with setRHSJacobian.
Collective.
- t (float <https://docs.python.org/3/library/functions.html#float>) -- The time at which to evaluate the Jacobian.
- x (Vec <#petsc4py.PETSc.Vec>) -- The state vector.
- J (Mat <#petsc4py.PETSc.Mat>) -- The matrix into which the Jacobian is computed.
- P (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The optional matrix to use for building a preconditioner.
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>
- computeRHSJacobianConstant(t, x, J, P=None)
- Reuse a Jacobian that is time-independent.
Collective.
- t (float <https://docs.python.org/3/library/functions.html#float>) -- The time at which to evaluate the Jacobian.
- x (Vec <#petsc4py.PETSc.Vec>) -- The state vector.
- J (Mat <#petsc4py.PETSc.Mat>) -- A pointer to the stored Jacobian.
- P (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- An optional pointer to the matrix used to construct the preconditioner.
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>
- computeRHSJacobianP(t, x, J)
- Run the user-defined JacobianP function.
Collective.
- t (float <https://docs.python.org/3/library/functions.html#float>) -- The time at which to compute the Jacobian.
- x (Vec <#petsc4py.PETSc.Vec>) -- The solution at which to compute the Jacobian.
- J (Mat <#petsc4py.PETSc.Mat>) -- The output Jacobian matrix.
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(comm=None)
- 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.
- Parameters
- 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>.
- Return type
- 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>
- createPython(context=None, comm=None)
- Create an integrator of Python type.
Collective.
- context (Any <https://docs.python.org/3/library/typing.html#typing.Any>) -- An instance of the Python class implementing the required methods.
- 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>.
See also:
Source code at petsc4py/PETSc/TS.pyx:2922 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2922>
- createQuadratureTS(forward=True)
- Create a sub TS that evaluates integrals over time.
Collective.
- Parameters
- forward (bool <https://docs.python.org/3/library/functions.html#bool>) -- Enable to evaluate forward in time.
- Return type
- 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>
- destroy()
- Destroy the TS that was created with create.
Collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:207 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L207>
- getARKIMEXType()
- 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>
- getAlphaParams()
- Return the algorithmic parameters for Type.ALPHA
<#petsc4py.PETSc.TS.Type.ALPHA>.
Not collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:3129 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3129>
- getAppCtx()
- Return the application context.
Source code at petsc4py/PETSc/TS.pyx:590 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L590>
- getConvergedReason()
- 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>
- Return type
- ConvergedReason <#petsc4py.PETSc.TS.ConvergedReason>
- getCostGradients()
- Return the cost gradients.
Not collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:2693 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2693>
- Return type
- 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>]]
- getCostIntegral()
- 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>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- getDIRKType()
- 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>
- getDM()
- 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>
- Return type
- DM <#petsc4py.PETSc.DM>
- getEquationType()
- 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>
- Return type
- EquationType <#petsc4py.PETSc.TS.EquationType>
- getEvaluationSolutions()
- Return the solutions and the times they were recorded at.
Not collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:1539 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1539>
- Return type
- 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>]]
- getEvaluationTimes()
- Return the evaluation points.
Not collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:1523 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1523>
- Return type
- ArrayReal <#petsc4py.typing.ArrayReal>
- getI2Function()
- 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>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, TSI2Function <#petsc4py.typing.TSI2Function>]
- getI2Jacobian()
- 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>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>, TSI2Jacobian <#petsc4py.typing.TSI2Jacobian>]
- getIFunction()
- 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>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, TSIFunction <#petsc4py.typing.TSIFunction>]
- getIJacobian()
- 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>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>, TSIJacobian <#petsc4py.typing.TSIJacobian>]
- getKSP()
- 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>
- Return type
- KSP <#petsc4py.PETSc.KSP>
- getKSPIterations()
- 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>
- getMaxSteps()
- Return the maximum number of steps to use.
Not collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:1885 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1885>
- getMaxTime()
- Return the maximum (final) time.
Not collective.
Defaults to 5.
See also:
Source code at petsc4py/PETSc/TS.pyx:1849 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1849>
- getMonitor()
- Return the monitor.
Not collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:2201 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2201>
- Return type
- list <https://docs.python.org/3/library/stdtypes.html#list>[tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[TSMonitorFunction <#petsc4py.typing.TSMonitorFunction>, tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...], dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>]]]
- getNumEvents()
- Return the number of events.
Logically collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:2348 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2348>
- getOptionsPrefix()
- Return the prefix used for all the TS options.
Not collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:526 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L526>
- getPostStep()
- Return the poststep function.
Source code at petsc4py/PETSc/TS.pyx:2441 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2441>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[TSPostStepFunction <#petsc4py.typing.TSPostStepFunction>, tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>, dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>]
- getPreStep()
- Return the prestep function.
Not collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:2397 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2397>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[TSPreStepFunction <#petsc4py.typing.TSPreStepFunction>, tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>, dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>]
- getPrevTime()
- 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>
- getProblemType()
- 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>
- Return type
- ProblemType <#petsc4py.PETSc.TS.ProblemType>
- getPythonContext()
- Return the instance of the class implementing the required Python methods.
Not collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:2959 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2959>
- getPythonType()
- Return the fully qualified Python name of the class used by the solver.
Not collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:2988 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2988>
- getQuadratureTS()
- Return the sub TS that evaluates integrals over time.
Not collective.
- forward (bool <https://docs.python.org/3/library/functions.html#bool>) -- True if evaluating the integral forward in time
- qts (TS) -- The sub TS
- Return type
- 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>
- getRHSFunction()
- 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>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, TSRHSFunction <#petsc4py.typing.TSRHSFunction>]
- getRHSJacobian()
- 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>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Mat <#petsc4py.PETSc.Mat>, Mat <#petsc4py.PETSc.Mat>, TSRHSJacobian <#petsc4py.typing.TSRHSJacobian>]
- getRKType()
- Return the Type.RK <#petsc4py.PETSc.TS.Type.RK> scheme.
Not collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:376 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L376>
- getSNES()
- 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>
- Return type
- SNES <#petsc4py.PETSc.SNES>
- getSNESFailures()
- 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>
- getSNESIterations()
- 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>
- getSolution()
- 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>
- Return type
- Vec <#petsc4py.PETSc.Vec>
- getSolution2()
- 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>
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Vec <#petsc4py.PETSc.Vec>, Vec <#petsc4py.PETSc.Vec>]
- getSolveTime()
- 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>
- getStepLimits()
- Return the minimum and maximum allowed time step sizes.
Not collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:2582 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2582>
- getStepNumber()
- Return the number of time steps completed.
Not collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:1813 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1813>
- getStepRejections()
- 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>
- getTheta()
- 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>
- getThetaEndpoint()
- 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>
- getTime()
- 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>
- getTimeSpanSolutions()
- Return the solutions at the times in the time span. Deprecated.
Not collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:1596 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1596>
- Return type
- list <https://docs.python.org/3/library/stdtypes.html#list>[Vec <#petsc4py.PETSc.Vec>]
- getTimeStep()
- Return the duration of the current timestep.
Not collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:1772 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1772>
- getTolerances()
- Return the tolerances for local truncation error.
Logically collective.
- rtol (float <https://docs.python.org/3/library/functions.html#float>) -- the relative tolerance
- atol (float <https://docs.python.org/3/library/functions.html#float>) -- the absolute tolerance
See also:
Source code at petsc4py/PETSc/TS.pyx:2072 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2072>
- getType()
- Return the TS type.
Not collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:362 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L362>
- interpolate(t, u)
- Interpolate the solution to a given time.
Collective.
- t (float <https://docs.python.org/3/library/functions.html#float>) -- The time to interpolate.
- u (Vec <#petsc4py.PETSc.Vec>) -- The state vector to interpolate.
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(viewer)
- Load a TS that has been stored in binary with view.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer>) -- The visualization context.
- Return type
- 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(step, time, u=None)
- Monitor the solve.
Collective.
- step (int <https://docs.python.org/3/library/functions.html#int>) -- The step number that has just completed.
- time (float <https://docs.python.org/3/library/functions.html#float>) -- The model time of the state.
- u (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- The state at the current model time.
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>
- monitorCancel()
- Clear all the monitors that have been set.
Logically collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:2213 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2213>
- removeTrajectory()
- Remove the internal TS trajectory object.
Collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:2620 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2620>
- reset()
- 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>
- restartStep()
- 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>
- rollBack()
- Roll back one time step.
Collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:2508 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2508>
- setARKIMEXFastSlowSplit(flag)
- Use ARKIMEX for solving a fast-slow system.
Logically collective.
- Parameters
- flag (bool <https://docs.python.org/3/library/functions.html#bool>) -- Set to True for fast-slow partitioned systems.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setARKIMEXFullyImplicit(flag)
- Solve both parts of the equation implicitly.
Logically collective.
- Parameters
- flag (bool <https://docs.python.org/3/library/functions.html#bool>) -- Set to True for fully implicit.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/TS.pyx:327 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L327>
- setARKIMEXType(ts_type)
- Set the type of Type.ARKIMEX
<#petsc4py.PETSc.TS.Type.ARKIMEX> scheme.
Logically collective.
- Parameters
- 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.
- Return type
- 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>
- setAlphaParams(alpha_m=None, alpha_f=None, gamma=None)
- Set the algorithmic parameters for Type.ALPHA
<#petsc4py.PETSc.TS.Type.ALPHA>.
Logically collective.
Users should call setAlphaRadius.
- alpha_m (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- Parameter, leave None <https://docs.python.org/3/library/constants.html#None> to keep current value.
- alpha_f (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- Parameter, leave None <https://docs.python.org/3/library/constants.html#None> to keep current value.
- gamma (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- Parameter, leave None <https://docs.python.org/3/library/constants.html#None> to keep current value.
See also:
Source code at petsc4py/PETSc/TS.pyx:3096 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3096>
- setAlphaRadius(radius)
- Set the spectral radius for Type.ALPHA
<#petsc4py.PETSc.TS.Type.ALPHA>.
Logically collective.
- Parameters
- radius (float <https://docs.python.org/3/library/functions.html#float>) -- the spectral radius
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setAppCtx(appctx)
- Set the application context.
Not collective.
- Parameters
- appctx (Any <https://docs.python.org/3/library/typing.html#typing.Any>) -- The application context.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
Source code at petsc4py/PETSc/TS.pyx:577 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L577>
- setConvergedReason(reason)
- 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.
- Parameters
- reason (ConvergedReason <#petsc4py.PETSc.TS.ConvergedReason>) -- The reason for convergence.
- Return type
- 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>
- setCostGradients(vl, vm=None)
- Set the cost gradients.
Logically collective.
- vl (Vec <#petsc4py.PETSc.Vec> | Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Vec <#petsc4py.PETSc.Vec>] | None <https://docs.python.org/3/library/constants.html#None>) -- gradients with respect to the initial condition variables, the dimension and parallel layout of these vectors is the same as the ODE solution vector
- vm (Vec <#petsc4py.PETSc.Vec> | Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Vec <#petsc4py.PETSc.Vec>] | None <https://docs.python.org/3/library/constants.html#None>) -- gradients with respect to the parameters, the number of entries in these vectors is the same as the number of parameters
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>
- setDIRKType(ts_type)
- Set the type of Type.DIRK <#petsc4py.PETSc.TS.Type.DIRK>
scheme.
Logically collective.
- Parameters
- 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.
- Return type
- 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>
- setDM(dm)
- Set the DM that may be used by some nonlinear solvers or preconditioners.
Logically collective.
- Parameters
- dm (DM <#petsc4py.PETSc.DM>) -- The DM <#petsc4py.PETSc.DM> object.
- Return type
- 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>
- setEquationType(eqtype)
- Set the type of the equation that TS is solving.
Logically collective.
- Parameters
- eqtype (EquationType <#petsc4py.PETSc.TS.EquationType>) -- The type of equation.
- Return type
- 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>
- setErrorIfStepFails(flag=True)
- Immediately error is no step succeeds.
Not collective.
- Parameters
- flag (bool <https://docs.python.org/3/library/functions.html#bool>) -- Enable to error if no step succeeds.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setEvaluationTimes(tspan)
- 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.
- Parameters
- 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.
- Return type
- 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>
- setEventHandler(direction, terminate, indicator, postevent=None, args=None, kargs=None)
- Set a function used for detecting events.
Logically collective.
- direction (Sequence[int <https://docs.python.org/3/library/functions.html#int>]) -- Direction of zero crossing to be detected {-1, 0, +1}.
- terminate (Sequence[bool <https://docs.python.org/3/library/functions.html#bool>]) -- Flags for each event to indicate stepping should be terminated.
- indicator (TSIndicatorFunction <#petsc4py.typing.TSIndicatorFunction> | None <https://docs.python.org/3/library/constants.html#None>) -- Function for defining the indicator-functions marking the events
- postevent (TSPostEventFunction <#petsc4py.typing.TSPostEventFunction> | None <https://docs.python.org/3/library/constants.html#None>) -- Function to execute after the event
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for indicator.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for indicator.
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>
- setEventTolerances(tol=None, vtol=None)
- Set tolerances for event zero crossings when using event handler.
Logically collective.
setEventHandler must have already been called.
- tol (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The scalar tolerance or None <https://docs.python.org/3/library/constants.html#None> to leave at the current value
- vtol (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[float <https://docs.python.org/3/library/functions.html#float>] | None <https://docs.python.org/3/library/constants.html#None>) -- A sequence of scalar tolerance for each event. Used in preference to tol if present. Set to None <https://docs.python.org/3/library/constants.html#None> to leave at the current value.
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>
- setExactFinalTime(option)
- Set method of computing the final time step.
Logically collective.
- Parameters
- option (ExactFinalTime <#petsc4py.PETSc.TS.ExactFinalTime>) -- The exact final time option
- Return type
- 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>
- setFromOptions()
- Set various TS parameters from user options.
Collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:563 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L563>
- setI2Function(function, f=None, args=None, kargs=None)
- Set the function to compute the 2nd order DAE.
Logically collective.
- function (TSI2Function <#petsc4py.typing.TSI2Function> | None <https://docs.python.org/3/library/constants.html#None>) -- The right-hand side function.
- f (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- The vector to store values or None <https://docs.python.org/3/library/constants.html#None> to be created internally.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for function.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for function.
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>
- setI2Jacobian(jacobian, J=None, P=None, args=None, kargs=None)
- Set the function to compute the Jacobian of the 2nd order DAE.
Logically collective.
- jacobian (TSI2Jacobian <#petsc4py.typing.TSI2Jacobian> | None <https://docs.python.org/3/library/constants.html#None>) -- The function which computes the Jacobian.
- J (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The matrix into which the Jacobian is computed.
- P (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The optional matrix to use for building a preconditioner.
- args -- Additional positional arguments for jacobian.
- kargs -- Additional keyword arguments for jacobian.
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>
- setIFunction(function, f=None, args=None, kargs=None)
- Set the function representing the DAE to be solved.
Logically collective.
- function (TSIFunction <#petsc4py.typing.TSIFunction> | None <https://docs.python.org/3/library/constants.html#None>) -- The right-hand side function.
- f (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- The vector to store values or None <https://docs.python.org/3/library/constants.html#None> to be created internally.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for function.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for function.
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>
- setIJacobian(jacobian, J=None, P=None, args=None, kargs=None)
- 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.
- jacobian (TSIJacobian <#petsc4py.typing.TSIJacobian> | None <https://docs.python.org/3/library/constants.html#None>) -- The function which computes the Jacobian.
- J (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The matrix into which the Jacobian is computed.
- P (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The optional matrix to use for building a preconditioner matrix.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for jacobian.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for jacobian.
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>
- setIJacobianP(jacobian, J=None, args=None, kargs=None)
- 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.
- jacobian -- The function which computes the Jacobian.
- J (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The matrix into which the Jacobian is computed.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for jacobian.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for jacobian.
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>
- setMaxSNESFailures(n)
- Set the maximum number of SNES solves failures allowed.
Not collective.
- Parameters
- n (int <https://docs.python.org/3/library/functions.html#int>) -- The maximum number of failed nonlinear solver, use -1 for unlimited.
- Return type
- 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>
- setMaxStepRejections(n)
- Set the maximum number of step rejections before a time step fails.
Not collective.
- Parameters
- n (int <https://docs.python.org/3/library/functions.html#int>) -- The maximum number of rejected steps, use -1 for unlimited.
- Return type
- 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>
- setMaxSteps(max_steps)
- Set the maximum number of steps to use.
Logically collective.
Defaults to 5000.
- Parameters
- max_steps (int <https://docs.python.org/3/library/functions.html#int>) -- The maximum number of steps to use.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setMaxTime(max_time)
- Set the maximum (final) time.
Logically collective.
- Parameters
- max_time (float <https://docs.python.org/3/library/functions.html#float>) -- the final time
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setMonitor(monitor, args=None, kargs=None)
- Set an additional monitor to the TS.
Logically collective.
- monitor (TSMonitorFunction <#petsc4py.typing.TSMonitorFunction> | None <https://docs.python.org/3/library/constants.html#None>) -- The custom monitor function.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for monitor.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for monitor.
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>
- setOptionsPrefix(prefix)
- Set the prefix used for all the TS options.
Logically collective.
- Parameters
- prefix (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The prefix to prepend to all option names.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
Notes
A hyphen must not be given at the beginning of the prefix name.
See also:
Source code at petsc4py/PETSc/TS.pyx:503 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L503>
- setPostStep(poststep, args=None, kargs=None)
- Set a function to be called at the end of each time step.
Logically collective.
- poststep (TSPostStepFunction <#petsc4py.typing.TSPostStepFunction> | None <https://docs.python.org/3/library/constants.html#None>) -- The function to be called at the end of each step.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for poststep.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for poststep.
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>
- setPreStep(prestep, args=None, kargs=None)
- Set a function to be called at the beginning of each time step.
Logically collective.
- prestep (TSPreStepFunction <#petsc4py.typing.TSPreStepFunction> | None <https://docs.python.org/3/library/constants.html#None>) -- The function to be called at the beginning of each step.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for prestep.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for prestep.
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>
- setProblemType(ptype)
- Set the type of problem to be solved.
Logically collective.
- Parameters
- ptype (ProblemType <#petsc4py.PETSc.TS.ProblemType>) -- The type of problem of the forms.
- Return type
- 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>
- setPythonContext(context)
- Set the instance of the class implementing the required Python methods.
Not collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:2947 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2947>
- setPythonType(py_type)
- Set the fully qualified Python name of the class to be used.
Collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:2974 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2974>
- setRHSFunction(function, f=None, args=None, kargs=None)
- Set the routine for evaluating the function G in U_t = G(t,
u).
Logically collective.
- function (TSRHSFunction <#petsc4py.typing.TSRHSFunction> | None <https://docs.python.org/3/library/constants.html#None>) -- The right-hand side function.
- f (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- The vector into which the right-hand side is computed.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for function.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for function.
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>
- setRHSJacobian(jacobian, J=None, P=None, args=None, kargs=None)
- Set the function to compute the Jacobian of G in U_t = G(U,
t).
Logically collective.
- jacobian (TSRHSJacobian <#petsc4py.typing.TSRHSJacobian> | None <https://docs.python.org/3/library/constants.html#None>) -- The right-hand side function.
- J (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The matrix into which the jacobian is computed.
- P (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The matrix into which the preconditioner is computed.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for jacobian.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for jacobian.
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>
- setRHSJacobianP(rhsjacobianp, A=None, args=None, kargs=None)
- Set the function that computes the Jacobian with respect to the
parameters.
Collective.
- rhsjacobianp (TSRHSJacobianP <#petsc4py.typing.TSRHSJacobianP> | None <https://docs.python.org/3/library/constants.html#None>) -- The function to compute the Jacobian
- A (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- The JacobianP matrix
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for rhsjacobianp.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for rhsjacobianp.
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>
- setRHSSplitIFunction(splitname, function, r=None, args=None, kargs=None)
- Set the split implicit functions.
Logically collective.
- splitname (str <https://docs.python.org/3/library/stdtypes.html#str>) -- Name of the split.
- function (TSIFunction <#petsc4py.typing.TSIFunction>) -- The implicit function evaluation routine.
- r (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector to hold the residual.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for function.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for function.
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>
- setRHSSplitIJacobian(splitname, jacobian, J=None, P=None, args=None, kargs=None)
- Set the Jacobian for the split implicit function.
Logically collective.
- splitname (str <https://docs.python.org/3/library/stdtypes.html#str>) -- Name of the split.
- jacobian (TSRHSJacobian <#petsc4py.typing.TSRHSJacobian>) -- The Jacobian evaluation routine.
- J (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- Matrix to store Jacobian entries computed by jacobian.
- P (Mat <#petsc4py.PETSc.Mat> | None <https://docs.python.org/3/library/constants.html#None>) -- Matrix used to compute preconditioner (usually the same as J).
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for jacobian.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for jacobian.
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>
- setRHSSplitIS(splitname, iss)
- Set the index set for the specified split.
Logically collective.
- splitname (str <https://docs.python.org/3/library/stdtypes.html#str>) -- Name of this split, if None <https://docs.python.org/3/library/constants.html#None> the number of the split is used.
- iss (IS <#petsc4py.PETSc.IS>) -- The index set for part of the solution vector.
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>
- setRHSSplitRHSFunction(splitname, function, r=None, args=None, kargs=None)
- Set the split right-hand-side functions.
Logically collective.
- splitname (str <https://docs.python.org/3/library/stdtypes.html#str>) -- Name of the split.
- function (TSRHSFunction <#petsc4py.typing.TSRHSFunction>) -- The RHS function evaluation routine.
- r (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector to hold the residual.
- args (tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Any <https://docs.python.org/3/library/typing.html#typing.Any>, ...] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional positional arguments for function.
- kargs (dict <https://docs.python.org/3/library/stdtypes.html#dict>[str <https://docs.python.org/3/library/stdtypes.html#str>, Any <https://docs.python.org/3/library/typing.html#typing.Any>] | None <https://docs.python.org/3/library/constants.html#None>) -- Additional keyword arguments for function.
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>
- setRKType(ts_type)
- Set the type of the Runge-Kutta scheme.
Logically collective.
- Parameters
- ts_type (RKType <#petsc4py.PETSc.TS.RKType> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of scheme.
- Return type
- 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>
- setSaveTrajectory()
- 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>
- setSolution(u)
- Set the initial solution vector.
Logically collective.
- Parameters
- u (Vec <#petsc4py.PETSc.Vec>) -- The solution vector.
- Return type
- 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>
- setSolution2(u, v)
- 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.
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>
- setStepLimits(hmin, hmax)
- Set the minimum and maximum allowed step sizes.
Logically collective.
- hmin (float <https://docs.python.org/3/library/functions.html#float>) -- the minimum step size
- hmax (float <https://docs.python.org/3/library/functions.html#float>) -- the maximum step size
See also:
Source code at petsc4py/PETSc/TS.pyx:2559 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2559>
- setStepNumber(step_number)
- 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.
- Parameters
- step_number (int <https://docs.python.org/3/library/functions.html#int>) -- the number of steps completed
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setTheta(theta)
- Set the abscissa of the stage in (0, 1] for Type.THETA
<#petsc4py.PETSc.TS.Type.THETA>.
Logically collective.
- Parameters
- theta (float <https://docs.python.org/3/library/functions.html#float>) -- stage abscissa
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setThetaEndpoint(flag=True)
- Set to use the endpoint variant of Type.THETA
<#petsc4py.PETSc.TS.Type.THETA>.
Logically collective.
- Parameters
- flag -- Enable to use the endpoint variant.
- Return type
- 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>
- setTime(t)
- Set the time.
Logically collective.
- Parameters
- t (float <https://docs.python.org/3/library/functions.html#float>) -- The time.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/TS.pyx:1687 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1687>
- setTimeSpan(tspan)
- 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.
- Parameters
- 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.
- Return type
- 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>
- setTimeStep(time_step)
- Set the duration of the timestep.
Logically collective.
- Parameters
- time_step (float <https://docs.python.org/3/library/functions.html#float>) -- the duration of the timestep
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/TS.pyx:1754 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L1754>
- setTolerances(rtol=None, atol=None)
- Set tolerances for local truncation error when using an adaptive
controller.
Logically collective.
- rtol (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The relative tolerance, DETERMINE <#petsc4py.PETSc.DETERMINE> to use the value when the object's type was set, or None <https://docs.python.org/3/library/constants.html#None> to leave the current value.
- atol (float <https://docs.python.org/3/library/functions.html#float> | None <https://docs.python.org/3/library/constants.html#None>) -- The absolute tolerance, DETERMINE <#petsc4py.PETSc.DETERMINE> to use the value when the object's type was set, or None <https://docs.python.org/3/library/constants.html#None> to leave the current value.
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>
- setType(ts_type)
- Set the method to be used as the TS solver.
Collective.
- Parameters
- ts_type (Type <#petsc4py.PETSc.TS.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The solver type.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setUp()
- Set up the internal data structures for the TS.
Collective.
See also:
Source code at petsc4py/PETSc/TS.pyx:2445 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2445>
- solve(u=None)
- Step the requested number of timesteps.
Collective.
- Parameters
- u (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- The solution vector. Can be None <https://docs.python.org/3/library/constants.html#None>.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/TS.pyx:2520 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L2520>
- step()
- 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>
- view(viewer=None)
- Print the TS object.
Collective.
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer> | None <https://docs.python.org/3/library/constants.html#None>) -- The visualization context.
- Return type
- 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
- appctx
- Application context.
Source code at petsc4py/PETSc/TS.pyx:3145 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3145>
- atol
- 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>
- converged
- 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>
- diverged
- 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>
- dm
- 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>
- equation_type
- The equation type.
Source code at petsc4py/PETSc/TS.pyx:3173 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3173>
- iterating
- 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>
- ksp
- 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>
- max_steps
- 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>
- max_time
- The maximum time.
Source code at petsc4py/PETSc/TS.pyx:3222 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3222>
- problem_type
- The problem type.
Source code at petsc4py/PETSc/TS.pyx:3165 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3165>
- reason
- The converged reason.
Source code at petsc4py/PETSc/TS.pyx:3256 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3256>
- rtol
- 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>
- snes
- 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>
- step_number
- The current step number.
Source code at petsc4py/PETSc/TS.pyx:3214 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3214>
- time
- The current time.
Source code at petsc4py/PETSc/TS.pyx:3198 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3198>
- time_step
- 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>
- vec_sol
- The solution vector.
Source code at petsc4py/PETSc/TS.pyx:3191 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/TS.pyx#L3191>
petsc4py.PETSc.Vec¶
- class 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¶
- class 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¶
- class petsc4py.PETSc.Vec.Type
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
The vector type.
Attributes Summary
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
- abs()
- 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>
- appendOptionsPrefix(prefix)
- Append to the prefix used for searching for options in the database.
Logically collective.
See also:
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()
- Assemble the vector.
Collective.
See also:
Source code at petsc4py/PETSc/Vec.pyx:3061 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3061>
- assemblyBegin()
- Begin an assembling stage of the vector.
Collective.
See also:
Source code at petsc4py/PETSc/Vec.pyx:3037 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3037>
- assemblyEnd()
- 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>
- attachDLPackInfo(vec=None, dltensor=None)
- Attach tensor information from another vector or DLPack tensor.
Logically collective.
This tensor information is required when converting a Vec to a DLPack object.
- vec (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector with attached tensor information. This is typically created by calling createWithDLPack.
- dltensor -- DLPack tensor. This will only be used if vec is None <https://docs.python.org/3/library/constants.html#None>.
Notes
This operation does not copy any data from vec or dltensor.
See also:
Source code at petsc4py/PETSc/Vec.pyx:643 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L643>
- axpby(alpha, beta, x)
- 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.
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>
- axpy(alpha, x)
- Compute and store y = ɑ·x + y.
Logically collective.
- alpha (Scalar <#petsc4py.typing.Scalar>) -- Scale factor.
- x (Vec <#petsc4py.PETSc.Vec>) -- Input vector.
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>
- aypx(alpha, x)
- 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.
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>
- bindToCPU(flg)
- Bind vector operations execution on the CPU.
Logically collective.
See also:
Source code at petsc4py/PETSc/Vec.pyx:1396 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1396>
- boundToCPU()
- 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>
- chop(tol)
- Set all vector entries less than some absolute tolerance to zero.
Collective.
- Parameters
- tol (float <https://docs.python.org/3/library/functions.html#float>) -- The absolute tolerance below which entries are set to zero.
- Return type
- 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>
- clearDLPackInfo()
- Clear tensor information.
Logically collective.
See also:
Source code at petsc4py/PETSc/Vec.pyx:705 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L705>
- classmethod concatenate(vecs)
- Concatenate vectors into a single vector.
Collective.
- Parameters
- vecs (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Vec <#petsc4py.PETSc.Vec>]) -- The vectors to be concatenated.
- Returns
- vector_out (Vec) -- The concatenated vector.
- indices_list (list <https://docs.python.org/3/library/stdtypes.html#list> of IS <#petsc4py.PETSc.IS>) -- A list of index sets corresponding to the concatenated components.
- Return type
- 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>
- conjugate()
- Conjugate the vector.
Logically collective.
See also:
Source code at petsc4py/PETSc/Vec.pyx:2319 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2319>
- copy(result=None)
- Return a copy of the vector.
Logically collective.
This operation copies vector entries to the new vector.
- Parameters
- 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.
- Return type
- 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(comm=None)
- Create a vector object.
Collective.
After creation the vector type can then be set with setType.
- Parameters
- 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>.
- Return type
- 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>
- createCUDAWithArrays(cpuarray=None, cudahandle=None, size=None, bsize=None, comm=None)
- Create a Type.CUDA <#petsc4py.PETSc.Vec.Type.CUDA> vector
with optional arrays.
Collective.
- cpuarray (Sequence[Scalar <#petsc4py.typing.Scalar>] | None <https://docs.python.org/3/library/constants.html#None>) -- Host array. Will be lazily allocated if not provided.
- cudahandle (Any | None <https://docs.python.org/3/library/constants.html#None>) -- Address of the array on the GPU. Will be lazily allocated if not provided.
- size (LayoutSizeSpec <#petsc4py.typing.LayoutSizeSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector size.
- bsize (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector block size. If None <https://docs.python.org/3/library/constants.html#None>, bsize = 1.
- 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>.
- Return type
- 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>
- createGhost(ghosts, size, bsize=None, comm=None)
- Create a parallel vector with ghost padding on each processor.
Collective.
- ghosts (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Global indices of ghost points.
- size (LayoutSizeSpec <#petsc4py.typing.LayoutSizeSpec>) -- Vector size.
- bsize (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector block size. If None <https://docs.python.org/3/library/constants.html#None>, bsize = 1.
- 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>.
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>
- createGhostWithArray(ghosts, array, size=None, bsize=None, comm=None)
- Create a parallel vector with ghost padding and provided arrays.
Collective.
- ghosts (Sequence[int <https://docs.python.org/3/library/functions.html#int>]) -- Global indices of ghost points.
- array (Sequence[Scalar <#petsc4py.typing.Scalar>]) -- Array to store the vector values. Must be at least as large as the local size of the vector (including ghost points).
- size (LayoutSizeSpec <#petsc4py.typing.LayoutSizeSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector size.
- bsize (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector block size. If None <https://docs.python.org/3/library/constants.html#None>, bsize = 1.
- 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>.
- Return type
- 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>
- createHIPWithArrays(cpuarray=None, hiphandle=None, size=None, bsize=None, comm=None)
- Create a Type.HIP <#petsc4py.PETSc.Vec.Type.HIP> vector with
optional arrays.
Collective.
- cpuarray (Sequence[Scalar <#petsc4py.typing.Scalar>] | None <https://docs.python.org/3/library/constants.html#None>) -- Host array. Will be lazily allocated if not provided.
- hiphandle (Any | None <https://docs.python.org/3/library/constants.html#None>) -- Address of the array on the GPU. Will be lazily allocated if not provided.
- size (LayoutSizeSpec <#petsc4py.typing.LayoutSizeSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector size.
- bsize (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector block size. If None <https://docs.python.org/3/library/constants.html#None>, bsize = 1.
- 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>.
- Return type
- 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>
- createLocalVector()
- Create a local vector.
Not collective.
- Returns
- The local vector.
- Return type
- 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>
- createMPI(size, bsize=None, comm=None)
- Create a parallel Type.MPI <#petsc4py.PETSc.Vec.Type.MPI>
vector.
Collective.
- size (LayoutSizeSpec <#petsc4py.typing.LayoutSizeSpec>) -- Vector size.
- bsize (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector block size. If None <https://docs.python.org/3/library/constants.html#None>, bsize = 1.
- 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>.
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>
- createNest(vecs, isets=None, comm=None)
- Create a Type.NEST <#petsc4py.PETSc.Vec.Type.NEST> vector
containing multiple nested subvectors.
Collective.
- vecs (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Vec <#petsc4py.PETSc.Vec>]) -- Iterable of subvectors.
- isets (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[IS <#petsc4py.PETSc.IS>] | None <https://docs.python.org/3/library/constants.html#None>) -- Iterable of index sets for each nested subvector. Defaults to contiguous ordering.
- 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>.
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>
- createSeq(size, bsize=None, comm=None)
- Create a sequential Type.SEQ <#petsc4py.PETSc.Vec.Type.SEQ>
vector.
Collective.
- size (LayoutSizeSpec <#petsc4py.typing.LayoutSizeSpec>) -- Vector size.
- bsize (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector block size. If None <https://docs.python.org/3/library/constants.html#None>, bsize = 1.
- 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>.
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.
- size (LayoutSizeSpec <#petsc4py.typing.LayoutSizeSpec>) -- Vector size.
- bsize (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector block size. If None <https://docs.python.org/3/library/constants.html#None>, bsize = 1.
- 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>.
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>
- createViennaCLWithArrays(cpuarray=None, viennaclvechandle=None, size=None, bsize=None, comm=None)
- Create a Type.VIENNACL <#petsc4py.PETSc.Vec.Type.VIENNACL>
vector with optional arrays.
Collective.
- cpuarray (Sequence[Scalar <#petsc4py.typing.Scalar>] | None <https://docs.python.org/3/library/constants.html#None>) -- Host array. Will be lazily allocated if not provided.
- viennaclvechandle (Any | None <https://docs.python.org/3/library/constants.html#None>) -- Address of the array on the GPU. Will be lazily allocated if not provided.
- size (LayoutSizeSpec <#petsc4py.typing.LayoutSizeSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector size.
- bsize (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector block size. If None <https://docs.python.org/3/library/constants.html#None>, bsize = 1.
- 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>.
- Return type
- 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>
- createWithArray(array, size=None, bsize=None, comm=None)
- 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.
- array (Sequence[Scalar <#petsc4py.typing.Scalar>]) -- Array to store the vector values. Must be at least as large as the local size of the vector.
- size (LayoutSizeSpec <#petsc4py.typing.LayoutSizeSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector size.
- bsize (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector block size. If None <https://docs.python.org/3/library/constants.html#None>, bsize = 1.
- 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>.
- Return type
- 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>
- createWithDLPack(dltensor, size=None, bsize=None, comm=None)
- 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.
- dltensor -- Either an object with a __dlpack__ method or a DLPack tensor object.
- size (LayoutSizeSpec <#petsc4py.typing.LayoutSizeSpec> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector size.
- bsize (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector block size. If None <https://docs.python.org/3/library/constants.html#None>, bsize = 1.
- 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>.
- Return type
- 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>
- destroy()
- Destroy the vector.
Collective.
See also:
Source code at petsc4py/PETSc/Vec.pyx:163 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L163>
- dot(vec)
- 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.
- Parameters
- vec (Vec <#petsc4py.PETSc.Vec>) -- Vector to compute the dot product with.
- Return type
- 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>
- dotBegin(vec)
- Begin computing the dot product.
Collective.
This should be paired with a call to dotEnd.
- Parameters
- vec (Vec <#petsc4py.PETSc.Vec>) -- Vector to compute the dot product with.
- Return type
- 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>
- dotEnd(vec)
- 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>
- Parameters
- vec (Vec <#petsc4py.PETSc.Vec>)
- Return type
- Scalar <#petsc4py.typing.Scalar>
- dotNorm2(vec)
- 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>
- Parameters
- vec (Vec <#petsc4py.PETSc.Vec>)
- Return type
- tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[Scalar <#petsc4py.typing.Scalar>, float <https://docs.python.org/3/library/functions.html#float>]
- duplicate(array=None)
- Create a new vector with the same type, optionally with data.
Collective.
- Parameters
- 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.
- Return type
- 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>
- equal(vec)
- Return whether the vector is equal to another.
Collective.
- Parameters
- vec (Vec <#petsc4py.PETSc.Vec>) -- Vector to compare with.
- Return type
- 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>
- exp()
- 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>
- getArray(readonly=False)
- Return local portion of the vector as an ndarray
<https://numpy.org/doc/stable/glossary.html#term-ndarray>.
Logically collective.
- Parameters
- readonly (bool <https://docs.python.org/3/library/functions.html#bool>) -- Request read-only access.
- Return type
- ArrayScalar <#petsc4py.typing.ArrayScalar>
See also:
Source code at petsc4py/PETSc/Vec.pyx:1313 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1313>
- getBlockSize()
- Return the block size of the vector.
Not collective.
See also:
Source code at petsc4py/PETSc/Vec.pyx:1149 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1149>
- getBuffer(readonly=False)
- Return a buffered view of the local portion of the vector.
Logically collective.
- Parameters
- readonly (bool <https://docs.python.org/3/library/functions.html#bool>) -- Request read-only access.
- Returns
- 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>.
- Return type
- 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:
Source code at petsc4py/PETSc/Vec.pyx:1270 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1270>
- getCLContextHandle()
- Return the OpenCL context associated with the vector.
Not collective.
- Returns
- Pointer to underlying CL context. This can be used with pyopencl through pyopencl.Context.from_int_ptr.
- Return type
- 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>
- getCLMemHandle(mode='rw')
- Return the OpenCL buffer associated with the vector.
Not collective.
- Returns
- Pointer to the device buffer. This can be used with pyopencl through pyopencl.Context.from_int_ptr.
- Return type
- int <https://docs.python.org/3/library/functions.html#int>
- Parameters
- 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>
- getCLQueueHandle()
- Return the OpenCL command queue associated with the vector.
Not collective.
- Returns
- Pointer to underlying CL command queue. This can be used with pyopencl through pyopencl.Context.from_int_ptr.
- Return type
- 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>
- getCUDAHandle(mode='rw')
- Return a pointer to the device buffer.
Not collective.
The returned pointer should be released using restoreCUDAHandle with the same access mode.
- Returns
- CUDA device pointer.
- Return type
- typing.Any <https://docs.python.org/3/library/typing.html#typing.Any>
- Parameters
- 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>
- getDM()
- 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>
- Return type
- DM <#petsc4py.PETSc.DM>
- getGhostIS()
- Return ghosting indices of a ghost vector.
Collective.
- Returns
- Indices of ghosts.
- Return type
- 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>
- getHIPHandle(mode='rw')
- Return a pointer to the device buffer.
Not collective.
The returned pointer should be released using restoreHIPHandle with the same access mode.
- Returns
- HIP device pointer.
- Return type
- typing.Any <https://docs.python.org/3/library/typing.html#typing.Any>
- Parameters
- 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>
- getLGMap()
- 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>
- Return type
- LGMap <#petsc4py.PETSc.LGMap>
- getLocalSize()
- Return the local size of the vector.
Not collective.
See also:
Source code at petsc4py/PETSc/Vec.pyx:1107 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1107>
- getLocalVector(lvec, readonly=False)
- Maps the local portion of the vector into a local vector.
Logically collective.
- lvec (Vec <#petsc4py.PETSc.Vec>) -- The local vector obtained from createLocalVector.
- readonly (bool <https://docs.python.org/3/library/functions.html#bool>) -- Request read-only access.
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>
- getNestSubVecs()
- 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 type
- list <https://docs.python.org/3/library/stdtypes.html#list>[Vec <#petsc4py.PETSc.Vec>]
- getOffloadMask()
- 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
- Returns
- Enum value from PetscOffloadMask <https://petsc.org/release/manualpages/Sys/PetscOffloadMask.html> describing the offloading status.
- Return type
- int <https://docs.python.org/3/library/functions.html#int>
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>
- getOptionsPrefix()
- Return the prefix used for searching for options in the database.
Not collective.
See also:
Source code at petsc4py/PETSc/Vec.pyx:1014 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1014>
- getOwnershipRange()
- Return the locally owned range of indices (start, end).
Not collective.
- start (int <https://docs.python.org/3/library/functions.html#int>) -- The first local element.
- end (int <https://docs.python.org/3/library/functions.html#int>) -- One more than the last local element.
See also:
Source code at petsc4py/PETSc/Vec.pyx:1163 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1163>
- getOwnershipRanges()
- 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>
- Return type
- ArrayInt <#petsc4py.typing.ArrayInt>
- getSize()
- 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>
- getSizes()
- 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>
- Return type
- LayoutSizeSpec <#petsc4py.typing.LayoutSizeSpec>
- getSubVector(iset, subvec=None)
- Return a subvector from given indices.
Collective.
Once finished with the subvector it should be returned with restoreSubVector.
- iset (IS <#petsc4py.PETSc.IS>) -- Index set describing which indices to extract into the subvector.
- subvec (Vec <#petsc4py.PETSc.Vec> | None <https://docs.python.org/3/library/constants.html#None>) -- Subvector to copy entries into. If None <https://docs.python.org/3/library/constants.html#None> then a new Vec will be created.
- Return type
- 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>
- getType()
- Return the type of the vector.
Not collective.
See also:
Source code at petsc4py/PETSc/Vec.pyx:1079 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1079>
- getValue(index)
- Return a single value from the vector.
Not collective.
Only values locally stored may be accessed.
- Parameters
- index (int <https://docs.python.org/3/library/functions.html#int>) -- Location of the value to read.
- Return type
- 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>
- getValues(indices, values=None)
- Return values from certain locations in the vector.
Not collective.
Only values locally stored may be accessed.
- indices (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Locations of the values to read.
- values (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>) -- Location to store the collected values. If not provided then a new array will be allocated.
- Return type
- 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>
- getValuesStagStencil(indices, values=None)
- Not implemented.
Source code at petsc4py/PETSc/Vec.pyx:2781 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2781>
- ghostUpdate(addv=None, mode=None)
- Update ghosted vector entries.
Neighborwise collective.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
- mode (ScatterModeSpec <#petsc4py.typing.ScatterModeSpec>) -- Scatter mode.
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:
Source code at petsc4py/PETSc/Vec.pyx:3345 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3345>
- ghostUpdateBegin(addv=None, mode=None)
- Begin updating ghosted vector entries.
Neighborwise collective.
See also:
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>)
- ghostUpdateEnd(addv=None, mode=None)
- Finish updating ghosted vector entries initiated with
ghostUpdateBegin.
Neighborwise collective.
See also:
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>)
- isaxpy(idx, alpha, x)
- 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.
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>
- isset(idx, alpha)
- 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.
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>
- load(viewer)
- Load a vector.
Collective.
See also:
Source code at petsc4py/PETSc/Vec.pyx:1750 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1750>
- Parameters
- viewer (Viewer <#petsc4py.PETSc.Viewer>)
- Return type
- Self <https://docs.python.org/3/library/typing.html#typing.Self>
- localForm()
- Return a context manager for viewing ghost vectors in local form.
Logically collective.
- Returns
- Context manager yielding the vector in local (ghosted) form.
- Return type
- 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:
Source code at petsc4py/PETSc/Vec.pyx:3278 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3278>
- log()
- 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>
- mDot(vecs, out=None)
- Compute Xᴴ·y with X an array of vectors.
Collective.
- vecs (Sequence[Vec <#petsc4py.PETSc.Vec>]) -- Array of vectors.
- out (ArrayScalar <#petsc4py.typing.ArrayScalar> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional placeholder for the result.
- Return type
- ArrayScalar <#petsc4py.typing.ArrayScalar>
See also:
Source code at petsc4py/PETSc/Vec.pyx:1902 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1902>
- mDotBegin(vecs, out)
- Starts a split phase multiple dot product computation.
Collective.
- vecs (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Vec <#petsc4py.PETSc.Vec>]) -- Array of vectors.
- out (ArrayScalar <#petsc4py.typing.ArrayScalar>) -- Placeholder for the result.
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>
- mDotEnd(vecs, out)
- Ends a split phase multiple dot product computation.
Collective.
- vecs (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Vec <#petsc4py.PETSc.Vec>]) -- Array of vectors.
- out (ArrayScalar <#petsc4py.typing.ArrayScalar>) -- Placeholder for the result.
- Return type
- 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>
- max()
- Return the vector entry with maximum real part and its location.
Collective.
- p (int <https://docs.python.org/3/library/functions.html#int>) -- Location of the maximum value. If multiple entries exist with the same value then the smallest index will be returned.
- val (Scalar <#petsc4py.typing.Scalar>) -- Minimum value.
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>
- maxPointwiseDivide(vec)
- 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>)
See also:
Source code at petsc4py/PETSc/Vec.pyx:2710 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2710>
- maxpy(alphas, vecs)
- Compute and store y = Σₙ(ɑₙ·Xₙ)
+ y with X an array of vectors.
Logically collective.
Equivalent to y[:] = alphas[i]*vecs[i, :] + y[:].
- alphas (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>]) -- Array of scale factors, one for each vector in vecs.
- vecs (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Vec <#petsc4py.PETSc.Vec>]) -- Array of vectors.
See also:
Source code at petsc4py/PETSc/Vec.pyx:2583 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2583>
- mean()
- 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>
- Return type
- Scalar <#petsc4py.typing.Scalar>
- min()
- Return the vector entry with minimum real part and its location.
Collective.
- p (int <https://docs.python.org/3/library/functions.html#int>) -- Location of the minimum value. If multiple entries exist with the same value then the smallest index will be returned.
- val (Scalar <#petsc4py.typing.Scalar>) -- Minimum value.
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>
- mtDot(vecs, out=None)
- Compute Xᵀ·y with X an array of vectors.
Collective.
- vecs (Sequence[Vec <#petsc4py.PETSc.Vec>]) -- Array of vectors.
- out (ArrayScalar <#petsc4py.typing.ArrayScalar> | None <https://docs.python.org/3/library/constants.html#None>) -- Optional placeholder for the result.
- Return type
- ArrayScalar <#petsc4py.typing.ArrayScalar>
See also:
Source code at petsc4py/PETSc/Vec.pyx:1996 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1996>
- mtDotBegin(vecs, out)
- Starts a split phase transpose multiple dot product computation.
Collective.
- vecs (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Vec <#petsc4py.PETSc.Vec>]) -- Array of vectors.
- out (ArrayScalar <#petsc4py.typing.ArrayScalar>) -- Placeholder for the result.
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>
- mtDotEnd(vecs, out)
- Ends a split phase transpose multiple dot product computation.
Collective.
- vecs (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Vec <#petsc4py.PETSc.Vec>]) -- Array of vectors.
- out (ArrayScalar <#petsc4py.typing.ArrayScalar>) -- Placeholder for the result.
- Return type
- 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>
- norm(norm_type=None)
- 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>
- Parameters
- norm_type (NormTypeSpec <#petsc4py.typing.NormTypeSpec>)
- Return type
- float <https://docs.python.org/3/library/functions.html#float> | tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[float <https://docs.python.org/3/library/functions.html#float>, float <https://docs.python.org/3/library/functions.html#float>]
- normBegin(norm_type=None)
- 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>
- Parameters
- norm_type (NormTypeSpec <#petsc4py.typing.NormTypeSpec>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- normEnd(norm_type=None)
- Finish computations initiated with normBegin.
Collective.
See also:
Source code at petsc4py/PETSc/Vec.pyx:2131 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2131>
- Parameters
- norm_type (NormTypeSpec <#petsc4py.typing.NormTypeSpec>)
- Return type
- float <https://docs.python.org/3/library/functions.html#float> | tuple <https://docs.python.org/3/library/stdtypes.html#tuple>[float <https://docs.python.org/3/library/functions.html#float>, float <https://docs.python.org/3/library/functions.html#float>]
- normalize()
- Normalize the vector by its 2-norm.
Collective.
- Returns
- The vector norm before normalization.
- Return type
- 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(order, invert=False)
- Permute the vector in-place with a provided ordering.
Collective.
- order (IS <#petsc4py.PETSc.IS>) -- Ordering for the permutation.
- invert (bool <https://docs.python.org/3/library/functions.html#bool>) -- Whether to invert the permutation.
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>
- placeArray(array)
- 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>
- Parameters
- array (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>])
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- pointwiseDivide(x, y)
- 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.
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>
- pointwiseMax(x, y)
- 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.
See also:
Source code at petsc4py/PETSc/Vec.pyx:2672 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2672>
- pointwiseMaxAbs(x, y)
- 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.
See also:
Source code at petsc4py/PETSc/Vec.pyx:2691 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2691>
- pointwiseMin(x, y)
- 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.
See also:
Source code at petsc4py/PETSc/Vec.pyx:2653 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2653>
- pointwiseMult(x, y)
- 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.
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>
- reciprocal()
- 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>
- resetArray(force=False)
- Reset the vector to use its default array.
Not collective.
- Parameters
- 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.
- Returns
- 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.
- Return type
- 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>
- restoreCLMemHandle()
- 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>
- restoreCUDAHandle(handle, mode='rw')
- Restore a pointer to the device buffer obtained with getCUDAHandle.
Not collective.
- handle (Any <https://docs.python.org/3/library/typing.html#typing.Any>) -- CUDA device pointer.
- mode (AccessModeSpec <#petsc4py.typing.AccessModeSpec>) -- Access mode.
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>
- restoreHIPHandle(handle, mode='rw')
- Restore a pointer to the device buffer obtained with getHIPHandle.
Not collective.
- handle (Any <https://docs.python.org/3/library/typing.html#typing.Any>) -- HIP device pointer.
- mode (AccessModeSpec <#petsc4py.typing.AccessModeSpec>) -- Access mode.
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>
- restoreLocalVector(lvec, readonly=False)
- Unmap a local access obtained with getLocalVector.
Logically collective.
- lvec (Vec <#petsc4py.PETSc.Vec>) -- The local vector.
- readonly (bool <https://docs.python.org/3/library/functions.html#bool>) -- Request read-only access.
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>
- restoreSubVector(iset, subvec)
- 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.
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(alpha)
- Scale all entries of the vector.
Collective.
This method sets each entry (xₙ) in the vector to ɑ·xₙ.
- Parameters
- alpha (Scalar <#petsc4py.typing.Scalar>) -- The scaling factor.
- Return type
- 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(alpha)
- 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>
- Parameters
- alpha (Scalar <#petsc4py.typing.Scalar>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setArray(array)
- Set values for the local portion of the vector.
Logically collective.
See also:
Source code at petsc4py/PETSc/Vec.pyx:1333 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1333>
- Parameters
- array (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>])
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setBlockSize(bsize)
- Set the block size of the vector.
Logically collective.
See also:
Source code at petsc4py/PETSc/Vec.pyx:1136 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1136>
- setDM(dm)
- 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>
- Parameters
- dm (DM <#petsc4py.PETSc.DM>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setFromOptions()
- Configure the vector from the options database.
Collective.
See also:
Source code at petsc4py/PETSc/Vec.pyx:1042 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1042>
- setLGMap(lgmap)
- Set the local-to-global mapping.
Logically collective.
This allows users to insert vector entries using a local numbering with setValuesLocal.
See also:
Source code at petsc4py/PETSc/Vec.pyx:2898 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2898>
- Parameters
- lgmap (LGMap <#petsc4py.PETSc.LGMap>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setMPIGhost(ghosts)
- Set the ghost points for a ghosted vector.
Collective.
- Parameters
- ghosts (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Global indices of ghost points.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
See also:
Source code at petsc4py/PETSc/Vec.pyx:3380 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3380>
- setNestSubVecs(sx, idxm=None)
- Set the component vectors at specified indices in the nested vector.
Not collective.
- sx (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Vec <#petsc4py.PETSc.Vec>]) -- Array of component vectors.
- idxm (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>] | None <https://docs.python.org/3/library/constants.html#None>) -- Indices of the component vectors, defaults to range(len(sx)).
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>
- setOption(option, flag)
- Set option.
Collective.
See also:
Source code at petsc4py/PETSc/Vec.pyx:1067 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1067>
- option (Option <#petsc4py.PETSc.Vec.Option>)
- flag (bool <https://docs.python.org/3/library/functions.html#bool>)
- setOptionsPrefix(prefix)
- Set the prefix used for searching for options in the database.
Logically collective.
See also:
Source code at petsc4py/PETSc/Vec.pyx:1000 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L1000>
- setRandom(random=None)
- Set all components of the vector to random numbers.
Collective.
- Parameters
- 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.
- Return type
- 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>
- setSizes(size, bsize=None)
- Set the local and global sizes of the vector.
Collective.
- size (LayoutSizeSpec <#petsc4py.typing.LayoutSizeSpec>) -- Vector size.
- bsize (int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Vector block size. If None <https://docs.python.org/3/library/constants.html#None>, bsize = 1.
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>
- setType(vec_type)
- Set the vector type.
Collective.
- Parameters
- vec_type (Type <#petsc4py.PETSc.Vec.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The vector type.
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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>
- setUp()
- 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>
- setValue(index, value, addv=None)
- 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.
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>
- setValueLocal(index, value, addv=None)
- Insert or add a single value in the vector using a local numbering.
Not collective.
- index (int <https://docs.python.org/3/library/functions.html#int>) -- Location to write to.
- value (Scalar <#petsc4py.typing.Scalar>) -- Value to insert at index.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
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>
- setValues(indices, values, addv=None)
- Insert or add multiple values in the vector.
Not collective.
- indices (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Locations to write to. Negative indices are ignored.
- values (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>]) -- Values to insert at indices.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
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>
- setValuesBlocked(indices, values, addv=None)
- 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.
- indices (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Block indices to write to. Negative indices are ignored.
- values (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>]) -- Values to insert at indices. Should have length len(indices) * vec.block_size.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
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>
- setValuesBlockedLocal(indices, values, addv=None)
- 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.
- indices (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Local block indices to write to.
- values (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>]) -- Values to insert at indices. Should have length len(indices) * vec.block_size.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
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:
Source code at petsc4py/PETSc/Vec.pyx:2999 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2999>
- setValuesLocal(indices, values, addv=None)
- Insert or add multiple values in the vector with a local numbering.
Not collective.
- indices (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[int <https://docs.python.org/3/library/functions.html#int>]) -- Locations to write to.
- values (Sequence <https://docs.python.org/3/library/typing.html#typing.Sequence>[Scalar <#petsc4py.typing.Scalar>]) -- Values to insert at indices.
- addv (InsertModeSpec <#petsc4py.typing.InsertModeSpec>) -- Insertion mode.
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>
- setValuesStagStencil(indices, values, addv=None)
- Not implemented.
Source code at petsc4py/PETSc/Vec.pyx:2894 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2894>
- shift(alpha)
- Shift all entries in the vector.
Collective.
This method sets each entry (xₙ) in the vector to xₙ + ɑ.
- Parameters
- alpha (Scalar <#petsc4py.typing.Scalar>) -- The shift to apply to the vector values.
- Return type
- 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>
- sqrtabs()
- 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>
- strideGather(field, vec, addv=None)
- 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.
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>
- strideMax(field)
- 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.
- Parameters
- field (int <https://docs.python.org/3/library/functions.html#int>) -- Component index. Must be between 0 and vec.block_size.
- Returns
- int <https://docs.python.org/3/library/functions.html#int> -- Location of maximum.
- float <https://docs.python.org/3/library/functions.html#float> -- Maximum value.
See also:
Source code at petsc4py/PETSc/Vec.pyx:3151 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3151>
- strideMin(field)
- 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.
- Parameters
- field (int <https://docs.python.org/3/library/functions.html#int>) -- Component index. Must be between 0 and vec.block_size.
- Returns
- int <https://docs.python.org/3/library/functions.html#int> -- Location of minimum.
- float <https://docs.python.org/3/library/functions.html#float> -- Minimum value.
See also:
Source code at petsc4py/PETSc/Vec.pyx:3120 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3120>
- strideNorm(field, norm_type=None)
- 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.
- field (int <https://docs.python.org/3/library/functions.html#int>) -- Component index. Must be between 0 and vec.block_size.
- norm_type (NormTypeSpec <#petsc4py.typing.NormTypeSpec>) -- The norm type.
See also:
Source code at petsc4py/PETSc/Vec.pyx:3182 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3182>
- strideScale(field, alpha)
- Scale a component of the vector.
Logically collective.
- field (int <https://docs.python.org/3/library/functions.html#int>) -- Component index. Must be between 0 and vec.block_size.
- alpha (Scalar <#petsc4py.typing.Scalar>) -- Factor to multiple the component entries by.
See also:
Source code at petsc4py/PETSc/Vec.pyx:3076 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3076>
- strideScatter(field, vec, addv=None)
- 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.
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>
- strideSum(field)
- Sum subvector entries.
Collective.
Equivalent to sum(x[field], x[field+bs], x[field+2*bs], ...) where bs is block_size.
- Parameters
- field (int <https://docs.python.org/3/library/functions.html#int>) -- Component index. Must be between 0 and vec.block_size.
- Return type
- Scalar <#petsc4py.typing.Scalar>
See also:
Source code at petsc4py/PETSc/Vec.pyx:3097 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3097>
- sum()
- 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>
- Return type
- Scalar <#petsc4py.typing.Scalar>
- swap(vec)
- Swap the content of two vectors.
Logically collective.
- Parameters
- vec (Vec <#petsc4py.PETSc.Vec>) -- The vector to swap data with.
- Return type
- 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>
- tDot(vec)
- 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.
- Parameters
- vec (Vec <#petsc4py.PETSc.Vec>) -- Vector to compute the indefinite dot product with.
- Return type
- 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>
- tDotBegin(vec)
- Begin computing the indefinite dot product.
Collective.
This should be paired with a call to tDotEnd.
- Parameters
- vec (Vec <#petsc4py.PETSc.Vec>) -- Vector to compute the indefinite dot product with.
- Return type
- 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>
- tDotEnd(vec)
- 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>
- Parameters
- vec (Vec <#petsc4py.PETSc.Vec>)
- Return type
- Scalar <#petsc4py.typing.Scalar>
- toDLPack(mode='rw')
- Return a DLPack PyCapsule
<https://docs.python.org/3/c-api/capsule.html#c.PyCapsule> wrapping
the vector data.
Collective.
- Parameters
- mode (AccessModeSpec <#petsc4py.typing.AccessModeSpec>) -- Access mode for the vector.
- Returns
- Capsule of a DLPack tensor wrapping a Vec.
- Return type
- 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:
Source code at petsc4py/PETSc/Vec.pyx:726 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L726>
- view(viewer=None)
- Display the vector.
Collective.
- Parameters
- 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.
- Return type
- 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>
- waxpy(alpha, x, y)
- 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.
See also:
Source code at petsc4py/PETSc/Vec.pyx:2561 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2561>
- zeroEntries()
- Set all entries in the vector to zero.
Logically collective.
See also:
Source code at petsc4py/PETSc/Vec.pyx:2372 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L2372>
Attributes Documentation
- array
- Alias for array_w.
Source code at petsc4py/PETSc/Vec.pyx:3658 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3658>
- array_r
- 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>
- array_w
- 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>
- block_size
- The block size.
Source code at petsc4py/PETSc/Vec.pyx:3614 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3614>
- buffer
- Alias for buffer_w.
Source code at petsc4py/PETSc/Vec.pyx:3653 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3653>
- buffer_r
- 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>
- buffer_w
- 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>
- local_size
- The local vector size.
Source code at petsc4py/PETSc/Vec.pyx:3609 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Vec.pyx#L3609>
- owner_range
- 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>
- owner_ranges
- 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>
- size
- 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>
- sizes
- 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¶
- class 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¶
- class 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¶
- class 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¶
- class petsc4py.PETSc.Viewer.Format
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Viewer format.
Attributes Summary
Attributes Documentation
petsc4py.PETSc.Viewer.Type¶
- class petsc4py.PETSc.Viewer.Type
- Bases: object
<https://docs.python.org/3/library/functions.html#object>
Viewer type.
Attributes Summary
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
- classmethod ASCII(name, comm=None)
- Return an ASCII viewer associated with the communicator.
Collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The filename.
- 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>.
- Return type
- 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>
- classmethod BINARY(comm=None)
- Return the default Type.BINARY
<#petsc4py.PETSc.Viewer.Type.BINARY> viewer associated with the
communicator.
Collective.
- Parameters
- 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>.
- Return type
- 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>
- classmethod DRAW(comm=None)
- Return the default Type.DRAW
<#petsc4py.PETSc.Viewer.Type.DRAW> viewer associated with the
communicator.
Collective.
- Parameters
- 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>.
- Return type
- 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>
- classmethod STDERR(comm=None)
- Return the standard error viewer associated with the communicator.
Collective.
- Parameters
- 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>.
- Return type
- 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>
- classmethod STDOUT(comm=None)
- Return the standard output viewer associated with the communicator.
Collective.
- Parameters
- 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>.
- Return type
- 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>
- addASCIITab(tabs)
- Increment the ASCII tab level.
Collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:690 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L690>
- clearDraw()
- Reset graphics.
Not collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:921 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L921>
- create(comm=None)
- Create a viewer.
Collective.
- Parameters
- 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>.
- Return type
- Self <https://docs.python.org/3/library/typing.html#typing.Self>
See also:
Source code at petsc4py/PETSc/Viewer.pyx:179 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L179>
- createASCII(name, mode=None, comm=None)
- Create a viewer of type Type.ASCII
<#petsc4py.PETSc.Viewer.Type.ASCII>.
Collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The filename associated with the viewer.
- mode (FileMode <#petsc4py.PETSc.Viewer.FileMode> | str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The mode type.
- 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>.
- Return type
- Self
See also:
Source code at petsc4py/PETSc/Viewer.pyx:200 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L200>
- createBinary(name, mode=None, comm=None)
- Create a viewer of type Type.BINARY
<#petsc4py.PETSc.Viewer.Type.BINARY>.
Collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The filename associated with the viewer.
- mode (FileMode <#petsc4py.PETSc.Viewer.FileMode> | str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The mode type.
- 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>.
- Return type
- Self
See also:
Source code at petsc4py/PETSc/Viewer.pyx:238 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L238>
- createDraw(display=None, title=None, position=None, size=None, comm=None)
- Create a Type.DRAW <#petsc4py.PETSc.Viewer.Type.DRAW> viewer.
Collective.
- display (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The X display to use or None <https://docs.python.org/3/library/constants.html#None> for the local machine.
- title (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The window title or None <https://docs.python.org/3/library/constants.html#None> for no title.
- position (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>] | None <https://docs.python.org/3/library/constants.html#None>) -- Screen coordinates of the upper left corner, or None <https://docs.python.org/3/library/constants.html#None> for default.
- size (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>] | int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Window size or None <https://docs.python.org/3/library/constants.html#None> for default.
- 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>.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:380 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L380>
- createHDF5(name, mode=None, comm=None)
- Create a viewer of type Type.HDF5
<#petsc4py.PETSc.Viewer.Type.HDF5>.
Collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The filename associated with the viewer.
- mode (FileMode <#petsc4py.PETSc.Viewer.FileMode> | str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The mode type.
- 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>.
- Return type
- Self
See also:
Source code at petsc4py/PETSc/Viewer.pyx:344 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L344>
- createMPIIO(name, mode=None, comm=None)
- Create a viewer of type Type.BINARY
<#petsc4py.PETSc.Viewer.Type.BINARY> supporting MPI-IO.
Collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The filename associated with the viewer.
- mode (FileMode <#petsc4py.PETSc.Viewer.FileMode> | str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The mode type.
- 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>.
- Return type
- Self
See also:
Source code at petsc4py/PETSc/Viewer.pyx:271 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L271>
- createPython(context=None, comm=None)
- Create a Type.PYTHON <#petsc4py.PETSc.Viewer.Type.PYTHON>
viewer.
Collective.
- context (Any <https://docs.python.org/3/library/typing.html#typing.Any>) -- An instance of the Python class implementing the required methods.
- 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>.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:933 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L933>
- createVTK(name, mode=None, comm=None)
- Create a viewer of type Type.VTK
<#petsc4py.PETSc.Viewer.Type.VTK>.
Collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The filename associated with the viewer.
- mode (FileMode <#petsc4py.PETSc.Viewer.FileMode> | str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The mode type.
- 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>.
- Return type
- Self
See also:
Source code at petsc4py/PETSc/Viewer.pyx:308 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L308>
- destroy()
- Destroy the viewer.
Collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:166 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L166>
- flush()
- Flush the viewer.
Collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:809 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L809>
- getASCIITab()
- Return the ASCII tab level.
Not collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:676 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L676>
- getFileMode()
- 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>
- Return type
- FileMode <#petsc4py.PETSc.Viewer.FileMode>
- getFileName()
- Return file name.
Not collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:861 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L861>
- getFormat()
- 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>
- Return type
- Format <#petsc4py.PETSc.Viewer.Format>
- getPythonContext()
- Return the instance of the class implementing the required Python methods.
Not collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:973 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L973>
- getPythonType()
- Return the fully qualified Python name of the class used by the viewer.
Not collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:1003 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L1003>
- getSubViewer(comm=None)
- Return a viewer defined on a subcommunicator.
Collective.
- Parameters
- 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>.
- Return type
- 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>
- getType()
- Return the type of the viewer.
Not collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:449 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L449>
- popASCIISynchronized()
- Disallow ASCII synchronized calls.
Collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:729 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L729>
- popASCIITab()
- 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>
- popFormat()
- Pop format from the viewer.
Collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:514 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L514>
- printfASCII(msg)
- Print a message.
Collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:779 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L779>
- printfASCIISynchronized(msg)
- Print a synchronized message.
Collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:793 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L793>
- pushASCIISynchronized()
- Allow ASCII synchronized calls.
Collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:716 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L716>
- pushASCIITab()
- Push an additional tab level.
Collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:742 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L742>
- pushFormat(format)
- 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>
- Parameters
- format (Format <#petsc4py.PETSc.Viewer.Format>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- restoreSubViewer(sub)
- Restore a viewer defined on a subcommunicator.
Collective.
- Parameters
- sub (Viewer <#petsc4py.PETSc.Viewer>) -- The subviewer obtained from getSubViewer.
- Return type
- 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>
- setASCIITab(tabs)
- Set ASCII tab level.
Collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:663 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L663>
- setDrawInfo(display=None, title=None, position=None, size=None)
- Set window information for a Type.DRAW
<#petsc4py.PETSc.Viewer.Type.DRAW> viewer.
Collective.
- display (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The X display to use or None <https://docs.python.org/3/library/constants.html#None> for the local machine.
- title (str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The window title or None <https://docs.python.org/3/library/constants.html#None> for no title.
- position (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>] | None <https://docs.python.org/3/library/constants.html#None>) -- Screen coordinates of the upper left corner, or None <https://docs.python.org/3/library/constants.html#None> for default.
- size (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>] | int <https://docs.python.org/3/library/functions.html#int> | None <https://docs.python.org/3/library/constants.html#None>) -- Window size or None <https://docs.python.org/3/library/constants.html#None> for default.
Source code at petsc4py/PETSc/Viewer.pyx:877 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L877>
- setFileMode(mode)
- Set file mode.
Collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:821 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L821>
- Parameters
- mode (FileMode <#petsc4py.PETSc.Viewer.FileMode> | str <https://docs.python.org/3/library/stdtypes.html#str>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
- setFileName(name)
- Set file name.
Collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:847 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L847>
- setFromOptions()
- Configure the object from the options database.
Collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:463 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L463>
- setPythonContext(context)
- Set the instance of the class implementing the required Python methods.
Logically collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:961 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L961>
- setPythonType(py_type)
- Set the fully qualified Python name of the class to be used.
Collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:988 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L988>
- setType(vwr_type)
- Set the type of the viewer.
Logically collective.
- Parameters
- vwr_type (Type <#petsc4py.PETSc.Viewer.Type> | str <https://docs.python.org/3/library/stdtypes.html#str>) -- The type of the viewer.
- Return type
- 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>
- setUp()
- Set up the internal data structures for using the viewer.
Collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:475 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L475>
- subtractASCIITab(tabs)
- Decrement the ASCII tab level.
Collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:703 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L703>
- useASCIITabs(flag)
- Enable/disable the use of ASCII tabs.
Collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:766 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L766>
- view(obj=None)
- View the viewer.
Collective.
- Parameters
- 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.
- Return type
- 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>
- viewObjectPython(obj)
- View a generic Object <#petsc4py.PETSc.Object>.
Collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:1018 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L1018>
- Parameters
- obj (Object <#petsc4py.PETSc.Object>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
petsc4py.PETSc.ViewerHDF5¶
- class 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:
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(name, mode=None, comm=None)
- Create a viewer of type Type.HDF5
<#petsc4py.PETSc.Viewer.Type.HDF5>.
Collective.
- name (str <https://docs.python.org/3/library/stdtypes.html#str>) -- The filename associated with the viewer.
- mode (FileMode <#petsc4py.PETSc.Viewer.FileMode> | str <https://docs.python.org/3/library/stdtypes.html#str> | None <https://docs.python.org/3/library/constants.html#None>) -- The mode type.
- 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>.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:1044 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L1044>
- getGroup()
- Return the current group.
Not collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:1171 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L1171>
- getTimestep()
- Return the current time step.
Not collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:1104 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L1104>
- incrementTimestep()
- Increment the time step.
Logically collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:1132 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L1132>
- popGroup()
- 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>
- popTimestepping()
- 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>
- pushGroup(group)
- Set the current group.
Logically collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:1145 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L1145>
- pushTimestepping()
- Activate the timestepping mode.
Logically collective.
See also:
Source code at petsc4py/PETSc/Viewer.pyx:1080 <https://gitlab.com/petsc/petsc/-/tree/release/src/binding/petsc4py/src/petsc4py/PETSc/Viewer.pyx#L1080>
- setTimestep(timestep)
- Set the current time step.
Logically collective.
See also:
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¶
- exception petsc4py.PETSc.Error
- 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¶
- petsc4py.PETSc.garbage_cleanup(comm=None)
- 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>
- Parameters
- comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
petsc4py.PETSc.garbage_view¶
- petsc4py.PETSc.garbage_view(comm=None)
- 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>
- Parameters
- comm (Comm <#petsc4py.PETSc.Comm> | None <https://docs.python.org/3/library/constants.html#None>)
- Return type
- None <https://docs.python.org/3/library/constants.html#None>
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¶
- petsc4py.PETSc.COMM_NULL: Comm <#petsc4py.PETSc.Comm> = COMM_NULL
- Object COMM_NULL of type Comm <#petsc4py.PETSc.Comm>
petsc4py.PETSc.COMM_SELF¶
- petsc4py.PETSc.COMM_SELF: Comm <#petsc4py.PETSc.Comm> = COMM_SELF
- Object COMM_SELF of type Comm <#petsc4py.PETSc.Comm>
petsc4py.PETSc.COMM_WORLD¶
- petsc4py.PETSc.COMM_WORLD: Comm <#petsc4py.PETSc.Comm> = 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 |