Scroll to navigation

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

NAME

petsc4py - PETSc for Python

Lisandro Dalcin
dalcinl@gmail.com
https://gitlab.com/petsc/petsc
Nov 29, 2024

Abstract

This document describes petsc4py, a Python wrapper to the PETSc libraries.

PETSc (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 standard for all message-passing communication.

This package provides an important subset of PETSc functionalities and uses NumPy to efficiently manage input and output of array data.

A good friend of petsc4py is:

mpi4py: Python bindings for MPI, the Message Passing Interface.



Other projects depend on petsc4py:

slepc4py: Python bindings for SLEPc, the Scalable Library for Eigenvalue Problem Computations.



PETSC OVERVIEW

PETSc 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 standard for all message-passing communication.

PETSc is intended for use in large-scale application projects [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]. 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.22, 2024. http://dx.doi.org/10.2172/2205494, https://petsc.org/release/docs/manual/manual.pdf
[petsc-efficient]
Satish Balay, Victor Eijkhout, William D. Gropp, Lois Curfman McInnes and Barry F. Smith. Efficient Management of Parallelism in Object Oriented Numerical Software Libraries. Modern Software Tools in Scientific Computing. E. Arge, A. M. Bruaset and H. P. Langtangen, editors. 163--202. Birkhauser Press. 1997.

Components

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

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

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

INSTALLATION

Install from PyPI using pip

You can use pip to install petsc4py and its dependencies (mpi4py is optional but highly recommended):

$ python -m pip install mpi4py petsc petsc4py


Install from the PETSc source tree

First build PETSc. Next cd to the top of the PETSc source tree and set the PETSC_DIR and PETSC_ARCH environment variables. Run:

$ python -m pip install src/binding/petsc4py


The installation of petsc4py supports multiple PETSC_ARCH 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 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 ${PETSC_DIR/doc/requirements.txt


Then:

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


The resulting HTML files will be in _build/html.

NOTE:

Building the documentation requires Python 3.11 or later.


CONTRIBUTING

Contributions from the user community are welcome. See the PETSc developers documentation for general information on contributions.

New contributions to petsc4py must adhere with the coding standards. We use cython-lint for Cython and 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 specifications.

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

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


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

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


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

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


WARNING:

The docstrings must not cause Sphinx warnings.


CITATIONS

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

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

REFERENCE

petsc4py The PETSc for Python package.
petsc4py.typing Typing support.
petsc4py.PETSc Portable, Extensible Toolkit for Scientific Computation.

petsc4py

The PETSc for Python package.

This package is an interface to PETSc libraries.

PETSc (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 standard for all message-passing communications.

Functions

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

petsc4py.get_config

Return a dictionary with information about PETSc.
dict[str, str]


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

Initialize PETSc.
  • args (str | list[str] | None) -- Command-line arguments, usually the sys.argv list
  • arch (str | None) -- Specific configuration to use
  • comm (Intracomm | None) -- MPI commmunicator

None

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

petsc4py.typing.Scalar

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

Scalars can be either float or complex (but not both) depending on how PETSc was configured (./configure --with-scalar-type=real|complex).


petsc4py.typing.ArrayBool

Array of bool.

alias of ndarray[Any, dtype[bool]]


petsc4py.typing.ArrayInt

Array of int.

alias of ndarray[Any, dtype[int]]


petsc4py.typing.ArrayReal

Array of float.

alias of ndarray[Any, dtype[float]]


petsc4py.typing.ArrayComplex

Array of complex.

alias of ndarray[Any, dtype[complex]]


petsc4py.typing.ArrayScalar

Array of Scalar numbers.

alias of ndarray[Any, dtype[float | complex]]


petsc4py.typing.DimsSpec

Dimensions specification.

N-tuples indicates N-dimensional grid sizes.

alias of tuple[int, ...]


petsc4py.typing.AccessModeSpec

Access mode specification.
  • 'rw' Read-Write mode.
  • 'r' Read-only mode.
  • 'w' Write-only mode.
  • None as 'rw'.


alias of Literal['rw', 'r', 'w'] | None


petsc4py.typing.InsertModeSpec

petsc4py.typing.InsertModeSpec = petsc4py.PETSc.InsertMode | bool | None
Insertion mode specification.
  • InsertMode.ADD_VALUES Add new value to existing one.
  • InsertMode.INSERT_VALUES Replace existing entry with new value.
  • None as InsertMode.INSERT_VALUES.
  • False as InsertMode.INSERT_VALUES.
  • True as InsertMode.ADD_VALUES.


SEE ALSO:

InsertMode



petsc4py.typing.ScatterModeSpec

petsc4py.typing.ScatterModeSpec = petsc4py.PETSc.ScatterMode | bool | str | None
Scatter mode specification.
  • ScatterMode.FORWARD Forward mode.
  • ScatterMode.REVERSE Reverse mode.
  • None as ScatterMode.FORWARD.
  • False as ScatterMode.FORWARD.
  • True as ScatterMode.REVERSE.
  • 'forward' as ScatterMode.FORWARD.
  • 'reverse' as ScatterMode.REVERSE.


SEE ALSO:

ScatterMode



petsc4py.typing.LayoutSizeSpec

petsc4py.typing.LayoutSizeSpec = int | tuple[int, int]
int or 2-tuple of int describing the layout sizes.

A single int indicates global size. A tuple of int indicates (local_size, global_size).

SEE ALSO:

Sys.splitOwnership



petsc4py.typing.NormTypeSpec

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

Possible values include:

  • NormType.NORM_1 The 1-norm: Σₙ abs(xₙ) for vectors, maxₙ (Σᵢ abs(xₙᵢ)) for matrices.
  • NormType.NORM_2 The 2-norm: √(Σₙ xₙ²) for vectors, largest singular values for matrices.
  • NormType.NORM_INFINITY The ∞-norm: maxₙ abs(xₙ) for vectors, maxᵢ (Σₙ abs(xₙᵢ)) for matrices.
  • NormType.NORM_FROBENIUS The Frobenius norm: same as 2-norm for vectors, √(Σₙᵢ xₙᵢ²) for matrices.
  • NormType.NORM_1_AND_2 Compute both NormType.NORM_1 and NormType.NORM_2.
  • None as NormType.NORM_2 for vectors, NormType.NORM_FROBENIUS for matrices.

SEE ALSO:

PETSc.NormType, NormType



petsc4py.typing.PetscOptionsHandlerFunction

Callback for processing extra options.

alias of Callable[[Object], None]


petsc4py.typing.MatAssemblySpec

petsc4py.typing.MatAssemblySpec = petsc4py.PETSc.Mat.AssemblyType | bool | None
Matrix assembly specification.
  • Mat.AssemblyType.FINAL
  • Mat.AssemblyType.FLUSH
  • None as Mat.AssemblyType.FINAL
  • False as Mat.AssemblyType.FINAL
  • True as Mat.AssemblyType.FLUSH


SEE ALSO:

MatAssemblyType



petsc4py.typing.MatSizeSpec

petsc4py.typing.MatSizeSpec = int | tuple[int, int] | tuple[tuple[int, int], tuple[int, int]]
int or (nested) tuple of int describing the matrix sizes.

If int then rows = columns. A single tuple of int indicates (rows, columns). A nested tuple of int indicates ((local_rows, rows), (local_columns, columns)).

SEE ALSO:

Sys.splitOwnership



petsc4py.typing.MatBlockSizeSpec

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

If a single int is provided then rows and columns share the same block size.


petsc4py.typing.CSRIndicesSpec

CSR indices format specification.

A 2-tuple carrying the (row_start, col_indices) information.

alias of tuple[Sequence[int], Sequence[int]]


petsc4py.typing.CSRSpec

CSR format specification.

A 3-tuple carrying the (row_start, col_indices, values) information.

alias of tuple[Sequence[int], Sequence[int], Sequence[float | complex]]


petsc4py.typing.NNZSpec

Nonzero pattern specification.

A single int corresponds to fixed number of non-zeros per row. A Sequence of int indicates different non-zeros per row. If a 2-tuple is used, the elements of the tuple corresponds to the on-process and off-process parts of the matrix.

SEE ALSO:

MatSeqAIJSetPreallocation, MatMPIAIJSetPreallocation


alias of int | Sequence[int] | tuple[Sequence[int], Sequence[int]]


petsc4py.typing.MatNullFunction

PETSc.NullSpace callback.

alias of Callable[[NullSpace, Vec], None]


petsc4py.typing.DMCoarsenHookFunction

PETSc.DM coarsening hook callback.

alias of Callable[[DM, DM], None]


petsc4py.typing.DMRestrictHookFunction

PETSc.DM restriction hook callback.

alias of Callable[[DM, Mat, Vec, Mat, DM], None]


petsc4py.typing.KSPRHSFunction

PETSc.KSP right-hand side function callback.

alias of Callable[[KSP, Vec], None]


petsc4py.typing.KSPOperatorsFunction

PETSc.KSP operators function callback.

alias of Callable[[KSP, Mat, Mat], None]


petsc4py.typing.KSPConvergenceTestFunction

PETSc.KSP convergence test callback.

alias of Callable[[KSP, int, float], ConvergedReason]


petsc4py.typing.KSPMonitorFunction

PETSc.KSP monitor callback.

alias of Callable[[KSP, int, float], None]


petsc4py.typing.KSPPreSolveFunction

PETSc.KSP pre solve callback.

alias of Callable[[KSP, Vec, Vec], None]


petsc4py.typing.KSPPostSolveFunction

PETSc.KSP post solve callback.

alias of Callable[[KSP, Vec, Vec], None]


petsc4py.typing.SNESMonitorFunction

SNES monitor callback.

alias of Callable[[SNES, int, float], None]


petsc4py.typing.SNESObjFunction

SNES objective function callback.

alias of Callable[[SNES, Vec], None]


petsc4py.typing.SNESFunction

SNES residual function callback.

alias of Callable[[SNES, Vec, Vec], None]


petsc4py.typing.SNESJacobianFunction

SNES Jacobian callback.

alias of Callable[[SNES, Vec, Mat, Mat], None]


petsc4py.typing.SNESGuessFunction

SNES initial guess callback.

alias of Callable[[SNES, Vec], None]


petsc4py.typing.SNESUpdateFunction

SNES step update callback.

alias of Callable[[SNES, int], None]


petsc4py.typing.SNESLSPreFunction

SNES linesearch pre-check update callback.

alias of Callable[[Vec, Vec], None]


petsc4py.typing.SNESNGSFunction

SNES nonlinear Gauss-Seidel callback.

alias of Callable[[SNES, Vec, Vec], None]


petsc4py.typing.SNESConvergedFunction

SNES convergence test callback.

alias of Callable[[SNES, int, tuple[float, float, float]], ConvergedReason]


petsc4py.typing.TSRHSFunction

TS right-hand side function callback.

alias of Callable[[TS, float, Vec, Vec], None]


petsc4py.typing.TSRHSJacobian

TS right-hand side Jacobian callback.

alias of Callable[[TS, float, Vec, Mat, Mat], None]


petsc4py.typing.TSRHSJacobianP

TS right-hand side parameter Jacobian callback.

alias of Callable[[TS, float, Vec, Mat], None]


petsc4py.typing.TSIFunction

TS implicit function callback.

alias of Callable[[TS, float, Vec, Vec, Vec], None]


petsc4py.typing.TSIJacobian

TS implicit Jacobian callback.

alias of Callable[[TS, float, Vec, Vec, float, Mat, Mat], None]


petsc4py.typing.TSIJacobianP

TS implicit parameter Jacobian callback.

alias of Callable[[TS, float, Vec, Vec, float, Mat], None]


petsc4py.typing.TSI2Function

TS implicit 2nd order function callback.

alias of Callable[[TS, float, Vec, Vec, Vec, Vec], None]


petsc4py.typing.TSI2Jacobian

TS implicit 2nd order Jacobian callback.

alias of Callable[[TS, float, Vec, Vec, Vec, float, float, Mat, Mat], None]


petsc4py.typing.TSI2JacobianP

TS implicit 2nd order parameter Jacobian callback.

alias of Callable[[TS, float, Vec, Vec, Vec, float, float, Mat], None]


petsc4py.typing.TSMonitorFunction

TS monitor callback.

alias of Callable[[TS, int, float, Vec], None]


petsc4py.typing.TSPreStepFunction

TS pre-step callback.

alias of Callable[[TS], None]


petsc4py.typing.TSPostStepFunction

TS post-step callback.

alias of Callable[[TS], None]


petsc4py.typing.TSIndicatorFunction

TS event indicator callback.

alias of Callable[[TS, float, Vec, ndarray[Any, dtype[float]]], None]


petsc4py.typing.TSPostEventFunction

TS post-event callback.

alias of Callable[[TS, ndarray[Any, dtype[int]], float, Vec, bool], None]


petsc4py.typing.TAOObjectiveFunction

TAO objective function callback.

alias of Callable[[TAO, Vec], float]


petsc4py.typing.TAOGradientFunction

TAO objective gradient callback.

alias of Callable[[TAO, Vec, Vec], None]


petsc4py.typing.TAOObjectiveGradientFunction

TAO objective function and gradient callback.

alias of Callable[[TAO, Vec, Vec], float]


petsc4py.typing.TAOHessianFunction

TAO objective Hessian callback.

alias of Callable[[TAO, Vec, Mat, Mat], None]


petsc4py.typing.TAOUpdateFunction

TAO update callback.

alias of Callable[[TAO, int], None]


petsc4py.typing.TAOMonitorFunction

TAO monitor callback.

alias of Callable[[TAO], None]


petsc4py.typing.TAOConvergedFunction

TAO convergence test callback.

alias of Callable[[TAO], None]


petsc4py.typing.TAOJacobianFunction

TAO Jacobian callback.

alias of Callable[[TAO, Vec, Mat, Mat], None]


petsc4py.typing.TAOResidualFunction

TAO residual callback.

alias of Callable[[TAO, Vec, Vec], None]


petsc4py.typing.TAOJacobianResidualFunction

TAO Jacobian residual callback.

alias of Callable[[TAO, Vec, Mat, Mat], None]


petsc4py.typing.TAOVariableBoundsFunction

TAO variable bounds callback.

alias of Callable[[TAO, Vec, Vec], None]


petsc4py.typing.TAOConstraintsFunction

TAO constraints callback.

alias of Callable[[TAO, Vec, Vec], None]


petsc4py.typing.TAOLSObjectiveFunction

TAOLineSearch objective function callback.

alias of Callable[[TAOLineSearch, Vec], float]


petsc4py.typing.TAOLSGradientFunction

TAOLineSearch objective gradient callback.

alias of Callable[[TAOLineSearch, Vec, Vec], None]


petsc4py.typing.TAOLSObjectiveGradientFunction

TAOLineSearch objective function and gradient callback.

alias of Callable[[TAOLineSearch, Vec, Vec], float]


petsc4py.PETSc

Portable, Extensible Toolkit for Scientific Computation.

Basic constants:

Use a default value for an int or float parameter.
Use a default value chosen by PETSc.
Compute a default value for an int or float parameter. For tolerances this uses the default value from when the object's type was set.
Do not change the current value that is set.
For a parameter that is a bound, such as the maximum number of iterations, do not bound the value.

More constants:

Very large real value.
Very large negative real value.
Very large positive real value, same as INFINITY.

Classes

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

petsc4py.PETSc.AO

Bases: Object

Application ordering object.

Enumerations

Type The application ordering types.

petsc4py.PETSc.AO.Type

Bases: object

The application ordering types.

Attributes Summary

ADVANCED Object ADVANCED of type str
BASIC Object BASIC of type str
MAPPING Object MAPPING of type str
MEMORYSCALABLE Object MEMORYSCALABLE of type str

Attributes Documentation

Object ADVANCED of type str

Object BASIC of type str

Object MAPPING of type str

Object MEMORYSCALABLE of type str


Methods Summary

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

Methods Documentation

Map an application-defined ordering to the PETSc ordering.

Collective.

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

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

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

indices (Sequence[int] | IS) -- The indices; to be replaced with their mapped values.
Sequence[int] | IS

SEE ALSO:

petsc2app, AOApplicationToPetscIS, AOApplicationToPetsc


Source code at petsc4py/PETSc/AO.pyx:214


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[int] | IS) -- The application ordering.
  • petsc (Sequence[int] | IS | None) -- Another ordering (may be None to indicate the natural ordering, that is 0, 1, 2, 3, ...).
  • comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.

Self

SEE ALSO:

createMemoryScalable, createMapping, AOCreateBasicIS, AOCreateBasic


Source code at petsc4py/PETSc/AO.pyx:53


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[int] | IS) -- The application ordering.
  • petsc (Sequence[int] | IS | None) -- Another ordering. May be None to indicate the identity ordering.
  • comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.

Self

SEE ALSO:

createBasic, AOCreateMappingIS, AOCreateMapping


Source code at petsc4py/PETSc/AO.pyx:154


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[int] | IS) -- The application ordering.
  • petsc (Sequence[int] | IS | None) -- Another ordering (may be None to indicate the natural ordering, that is 0, 1, 2, 3, ...).
  • comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.

Self

SEE ALSO:

createBasic, createMapping, AOCreateMemoryScalableIS, AOCreateMemoryScalable


Source code at petsc4py/PETSc/AO.pyx:102


Destroy the application ordering.

Collective.

SEE ALSO:

AODestroy


Source code at petsc4py/PETSc/AO.pyx:40



Return the application ordering type.

Not collective.

SEE ALSO:

AOGetType


Source code at petsc4py/PETSc/AO.pyx:200



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.

indices (Sequence[int] | IS) -- The indices; to be replaced with their mapped values.
Sequence[int] | IS

SEE ALSO:

app2petsc, AOPetscToApplicationIS, AOPetscToApplication


Source code at petsc4py/PETSc/AO.pyx:248


Display the application ordering.

Collective.

viewer (Viewer | None) -- A Viewer to display the ordering.
None

SEE ALSO:

AOView


Source code at petsc4py/PETSc/AO.pyx:21




petsc4py.PETSc.Comm

Bases: object

Communicator object.

Predefined instances:

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

SEE ALSO:

Sys.setDefaultComm, Sys.getDefaultComm


Methods Summary

barrier() Barrier synchronization.
destroy() Destroy the communicator.
duplicate() Duplicate the communicator.
getRank() Return the rank of the calling processes in the communicator.
getSize() Return the number of processes in the communicator.
tompi4py() Convert communicator to mpi4py.

Attributes Summary

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

Methods Documentation

Barrier synchronization.

Collective.

Source code at petsc4py/PETSc/Comm.pyx:123



Destroy the communicator.

Collective.

SEE ALSO:

PetscCommDestroy


Source code at petsc4py/PETSc/Comm.pyx:61



Duplicate the communicator.

Collective.

SEE ALSO:

PetscCommDuplicate


Source code at petsc4py/PETSc/Comm.pyx:79



Return the rank of the calling processes in the communicator.

Not collective.

Source code at petsc4py/PETSc/Comm.pyx:111



Return the number of processes in the communicator.

Not collective.

Source code at petsc4py/PETSc/Comm.pyx:99



Convert communicator to mpi4py.

Not collective.

SEE ALSO:

mpi4py.MPI.Comm, mpi4py.MPI.Intracomm


Source code at petsc4py/PETSc/Comm.pyx:155

Intracomm


Attributes Documentation

Fortran handle.

Source code at petsc4py/PETSc/Comm.pyx:147


Communicator rank.

Source code at petsc4py/PETSc/Comm.pyx:140


Communicator size.

Source code at petsc4py/PETSc/Comm.pyx:135



petsc4py.PETSc.DM

Bases: Object

An object describing a computational grid or mesh.

Enumerations

BoundaryType DM Boundary types.
PolytopeType The DM cell types.
ReorderDefaultFlag The DM reordering default flags.
Type DM types.

petsc4py.PETSc.DM.BoundaryType

Bases: object

DM Boundary types.

Attributes Summary

GHOSTED Constant GHOSTED of type int
MIRROR Constant MIRROR of type int
NONE Constant NONE of type int
PERIODIC Constant PERIODIC of type int
TWIST Constant TWIST of type int

Attributes Documentation

Constant GHOSTED of type int

Constant MIRROR of type int

Constant NONE of type int

Constant PERIODIC of type int

Constant TWIST of type int


petsc4py.PETSc.DM.PolytopeType

Bases: object

The DM cell types.

Attributes Summary

FV_GHOST Constant FV_GHOST of type int
HEXAHEDRON Constant HEXAHEDRON of type int
INTERIOR_GHOST Constant INTERIOR_GHOST of type int
POINT Constant POINT of type int
POINT_PRISM_TENSOR Constant POINT_PRISM_TENSOR of type int
PYRAMID Constant PYRAMID of type int
QUADRILATERAL Constant QUADRILATERAL of type int
QUAD_PRISM_TENSOR Constant QUAD_PRISM_TENSOR of type int
SEGMENT Constant SEGMENT of type int
SEG_PRISM_TENSOR Constant SEG_PRISM_TENSOR of type int
TETRAHEDRON Constant TETRAHEDRON of type int
TRIANGLE Constant TRIANGLE of type int
TRI_PRISM Constant TRI_PRISM of type int
TRI_PRISM_TENSOR Constant TRI_PRISM_TENSOR of type int
UNKNOWN Constant UNKNOWN of type int
UNKNOWN_CELL Constant UNKNOWN_CELL of type int
UNKNOWN_FACE Constant UNKNOWN_FACE of type int

Attributes Documentation

Constant FV_GHOST of type int

Constant HEXAHEDRON of type int

Constant INTERIOR_GHOST of type int

Constant POINT of type int

Constant POINT_PRISM_TENSOR of type int

Constant PYRAMID of type int

Constant QUADRILATERAL of type int

Constant QUAD_PRISM_TENSOR of type int

Constant SEGMENT of type int

Constant SEG_PRISM_TENSOR of type int

Constant TETRAHEDRON of type int

Constant TRIANGLE of type int

Constant TRI_PRISM of type int

Constant TRI_PRISM_TENSOR of type int

Constant UNKNOWN of type int

Constant UNKNOWN_CELL of type int

Constant UNKNOWN_FACE of type int


petsc4py.PETSc.DM.ReorderDefaultFlag

Bases: object

The DM reordering default flags.

Attributes Summary

FALSE Constant FALSE of type int
NOTSET Constant NOTSET of type int
TRUE Constant TRUE of type int

Attributes Documentation

Constant FALSE of type int

Constant NOTSET of type int

Constant TRUE of type int


petsc4py.PETSc.DM.Type

Bases: object

DM types.

Attributes Summary

COMPOSITE Object COMPOSITE of type str
DA Object DA of type str
FOREST Object FOREST of type str
MOAB Object MOAB of type str
NETWORK Object NETWORK of type str
P4EST Object P4EST of type str
P8EST Object P8EST of type str
PATCH Object PATCH of type str
PLEX Object PLEX of type str
PRODUCT Object PRODUCT of type str
REDUNDANT Object REDUNDANT of type str
SHELL Object SHELL of type str
SLICED Object SLICED of type str
STAG Object STAG of type str
SWARM Object SWARM of type str

Attributes Documentation

Object COMPOSITE of type str

Object DA of type str

Object FOREST of type str

Object MOAB of type str

Object NETWORK of type str

Object P4EST of type str

Object P8EST of type str

Object PATCH of type str

Object PLEX of type str

Object PRODUCT of type str

Object REDUNDANT of type str

Object SHELL of type str

Object SLICED of type str

Object STAG of type str

Object SWARM of type str


Methods Summary

adaptLabel(label) Adapt a DM based on a 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 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 a list of IS objects.
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 encoding the parallel DOF overlap for the DM.
createSubDM(fields) Return 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.
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 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 of all values that the 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 takes.
getLabelValue(name, point) Return the value in DMLabel for the given point.
getLocalBoundingBox() Return the bounding box for the piece of the DM.
getLocalSection() Return the 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.
getPointSF() Return the SF encoding the parallel DOF overlap for the DM.
getRefineLevel() Return the refinement level.
getSectionSF() Return the 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, 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 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 with a given value.
setLocalSection(sec) Set the 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.
setPointSF(sf) Set the SF encoding the parallel DOF overlap for the DM.
setRefineLevel(level) Set the number of refinements.
setSNESFunction(function[, args, kargs]) Set SNES residual evaluation function.
setSNESJacobian(jacobian[, args, kargs]) Set the SNES Jacobian evaluation function.
setSectionSF(sf) Set the Section encoding the parallel DOF overlap for the DM.
setType(dm_type) Build a DM.
setUp() Return the data structure.
setVecType(vec_type) Set the type of vector.
view([viewer]) View the DM.

Attributes Summary

appctx Application context.
ds Discrete space.

Methods Documentation

Adapt a DM based on a DMLabel.

Collective.

label (str) -- The name of the DMLabel.
DM

SEE ALSO:

DMAdaptLabel


Source code at petsc4py/PETSc/DM.pyx:1645


Return a mesh adapted to the specified metric field.

Collective.

  • metric (Vec) -- The metric to which the mesh is adapted, defined vertex-wise.
  • bdLabel (str | None) -- Label for boundary tags.
  • rgLabel (str | None) -- Label for cell tag.

DM

SEE ALSO:

DMAdaptMetric


Source code at petsc4py/PETSc/DM.pyx:1668


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

Logically collective.

  • coarsenhook (DMCoarsenHookFunction) -- The coarsen hook function.
  • restricthook (DMRestrictHookFunction) -- The restrict hook function.
  • args (tuple[Any, ...] | None) -- Positional arguments for the hooks.
  • kargs (dict[str, Any] | None) -- Keyword arguments for the hooks.

None

SEE ALSO:

DMCoarsenHookAdd


Source code at petsc4py/PETSc/DM.pyx:2333


Add a field to a DM object.

Logically collective.

  • field (Object) -- The discretization object.
  • label (str | None) -- The name of the label indicating the support of the field, or None for the entire mesh.

None

SEE ALSO:

DMAddField


Source code at petsc4py/PETSc/DM.pyx:611


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

Logically collective.

SEE ALSO:

Working with PETSc options, setOptionsPrefix, DMAppendOptionsPrefix


Source code at petsc4py/PETSc/DM.pyx:298

prefix (str | None)
None


Remove all discrete systems from the DM.

Logically collective.

SEE ALSO:

DMClearDS


Source code at petsc4py/PETSc/DM.pyx:691



Remove all fields from the DM.

Logically collective.

SEE ALSO:

DMClearFields


Source code at petsc4py/PETSc/DM.pyx:634



Remove all points from a stratum.

Not collective.

  • name (str) -- The label name.
  • value (int) -- The stratum value.

None

SEE ALSO:

DMClearLabelStratum


Source code at petsc4py/PETSc/DM.pyx:2124


Remove a point from a DMLabel with given value.

Not collective.

  • name (str) -- The label name.
  • point (int) -- The mesh point.
  • value (int) -- The label value for the point.

None

SEE ALSO:

DMClearLabelValue


Source code at petsc4py/PETSc/DM.pyx:2010


Return the cloned DM .

Collective.

SEE ALSO:

DMClone


Source code at petsc4py/PETSc/DM.pyx:155



Return a coarsened DM object.

Collective.

comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.
DM

SEE ALSO:

DMCoarsen


Source code at petsc4py/PETSc/DM.pyx:1519


Coarsen this DM and return the coarsened DM hierarchy.

Collective.

nlevels (int) -- The number of levels of coarsening.
list

SEE ALSO:

DMCoarsenHierarchy


Source code at petsc4py/PETSc/DM.pyx:1570


Return a DM converted to another DM.

Collective.

dm_type (Type | str) -- The new DM.Type, use “same” for the same type.
DM

SEE ALSO:

DM.Type, DMConvert


Source code at petsc4py/PETSc/DM.pyx:1472


Copy the discrete systems for this DM into another DM.

Collective.

  • dm (DM) -- The DM that the discrete fields are copied into.
  • minDegree -- The minimum polynommial degree for the discretization, or None for no limit
  • maxDegree -- The maximum polynommial degree for the discretization, or None for no limit

None

SEE ALSO:

DMCopyDS


Source code at petsc4py/PETSc/DM.pyx:718


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

Collective.

dm (DM) -- The DM that the fields and discrete systems are copied into.
None

SEE ALSO:

DMCopyDisc


Source code at petsc4py/PETSc/DM.pyx:751


Copy the discretizations of this DM into another DM.

Collective.

  • dm (DM) -- The DM that the fields are copied into.
  • minDegree -- The minimum polynommial degree for the discretization, or None for no limit
  • maxDegree -- The maximum polynommial degree for the discretization, or None for no limit

None

SEE ALSO:

DMCopyFields


Source code at petsc4py/PETSc/DM.pyx:646


Return an empty DM.

Collective.

comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.
Self

SEE ALSO:

DMCreate


Source code at petsc4py/PETSc/DM.pyx:134


Create discrete systems.

Collective.

SEE ALSO:

DMCreateDS


Source code at petsc4py/PETSc/DM.pyx:679



Return a list of IS objects.

Not collective.

Notes

The user is responsible for freeing all requested arrays.

SEE ALSO:

DMCreateFieldDecomposition


Source code at petsc4py/PETSc/DM.pyx:2222

tuple[list, list, list]


Return a global vector.

Collective.

SEE ALSO:

DMCreateGlobalVector


Source code at petsc4py/PETSc/DM.pyx:798



Return the injection matrix into a finer DM.

Collective.

dm (DM) -- The second, finer DM object.
Mat

SEE ALSO:

DMCreateInjection


Source code at petsc4py/PETSc/DM.pyx:1434


Return the interpolation matrix to a finer DM.

Collective.

dm (DM) -- The second, finer DM.
tuple[Mat, Vec]

SEE ALSO:

DMCreateInterpolation


Source code at petsc4py/PETSc/DM.pyx:1413


Create a label of the given name if it does not already exist.

Not collective.

name (str) -- The label name.
None

SEE ALSO:

DMCreateLabel


Source code at petsc4py/PETSc/DM.pyx:1922


Return a local vector.

Not collective.

SEE ALSO:

DMCreateLocalVector


Source code at petsc4py/PETSc/DM.pyx:812



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

Collective.

dmf (DM) -- The second DM.
Mat

SEE ALSO:

DMCreateMassMatrix


Source code at petsc4py/PETSc/DM.pyx:1394


Return an empty matrix.

Collective.

SEE ALSO:

DMCreateMatrix


Source code at petsc4py/PETSc/DM.pyx:1380



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

Collective.

dm (DM) -- The second, finer DM object.
Mat

SEE ALSO:

DMCreateRestriction


Source code at petsc4py/PETSc/DM.pyx:1453


Create the SF encoding the parallel DOF overlap for the DM.

Collective.

  • localsec (Section) -- Describe the local data layout.
  • globalsec (Section) -- Describe the global data layout.

None

Notes

Encoding based on the Section describing the data layout.

SEE ALSO:

DM.getSectionSF, DMCreateSectionSF


Source code at petsc4py/PETSc/DM.pyx:1786


Return IS and DM encapsulating a subproblem.

Not collective.

  • iset (IS) -- The global indices for all the degrees of freedom.
  • subdm (DM) -- The DM for the subproblem.

fields (Sequence[int])
tuple[IS, DM]

SEE ALSO:

DMCreateSubDM


Source code at petsc4py/PETSc/DM.pyx:446


Destroy the object.

Collective.

SEE ALSO:

DMDestroy


Source code at petsc4py/PETSc/DM.pyx:121



Return the application context.

Source code at petsc4py/PETSc/DM.pyx:343



Return an auxiliary vector for region.

Not collective.

  • label (str | None) -- The name of the DMLabel.
  • value (int | None) -- Indicate the region.
  • part (int | None) -- The equation part, or 0 is unused.

Vec

SEE ALSO:

DM.getLabel, DMGetAuxiliaryVec


Source code at petsc4py/PETSc/DM.pyx:503


Return the flags for determining variable influence.

Not collective.

  • useCone (bool) -- Whether adjacency uses cone information.
  • useClosure (bool) -- Whether adjacency is computed using full closure information.

tuple[bool, bool]

SEE ALSO:

DMGetBasicAdjacency


Source code at petsc4py/PETSc/DM.pyx:370


Return the inherent block size associated with a DM.

Not collective.

SEE ALSO:

DMGetBlockSize


Source code at petsc4py/PETSc/DM.pyx:770



Return the dimension of embedding space for coordinates values.

Not collective.

SEE ALSO:

DMGetBoundingBox


Source code at petsc4py/PETSc/DM.pyx:1306

tuple[tuple[float, float], ...]


Return the cell coordinate DM.

Collective.

SEE ALSO:

DMGetCellCoordinateDM


Source code at petsc4py/PETSc/DM.pyx:1159



Return the cell coordinate layout over the DM.

Collective.

SEE ALSO:

DMGetCellCoordinateSection


Source code at petsc4py/PETSc/DM.pyx:1194

Section


Return a global vector with the cellwise coordinates.

Collective.

SEE ALSO:

DMGetCellCoordinates


Source code at petsc4py/PETSc/DM.pyx:1226



Return a local vector with the cellwise coordinates.

Collective.

SEE ALSO:

DMGetCellCoordinatesLocal


Source code at petsc4py/PETSc/DM.pyx:1258



Return the coarse DM.

Collective.

SEE ALSO:

DMGetCoarseDM


Source code at petsc4py/PETSc/DM.pyx:1020



Return the number of coarsenings.

Not collective.

SEE ALSO:

DMGetCoarsenLevel


Source code at petsc4py/PETSc/DM.pyx:1629



Return the coordinate DM.

Collective.

SEE ALSO:

DMGetCoordinateDM


Source code at petsc4py/PETSc/DM.pyx:1048



Return the dimension of embedding space for coordinates values.

Not collective.

SEE ALSO:

DMGetCoordinateDim


Source code at petsc4py/PETSc/DM.pyx:238



Return coordinate values layout over the mesh.

Collective.

SEE ALSO:

DMGetCoordinateSection


Source code at petsc4py/PETSc/DM.pyx:1063

Section


Return a global vector with the coordinates associated.

Collective.

SEE ALSO:

DMGetCoordinates


Source code at petsc4py/PETSc/DM.pyx:1095



Return a local vector with the coordinates associated.

Collective the first time it is called.

SEE ALSO:

DMGetCoordinatesLocal


Source code at petsc4py/PETSc/DM.pyx:1127



Check if the coordinates have been localized for cells.

Not collective.

SEE ALSO:

DMGetCoordinatesLocalized


Source code at petsc4py/PETSc/DM.pyx:1292



Return default DS.

Not collective.

SEE ALSO:

DMGetDS


Source code at petsc4py/PETSc/DM.pyx:703



Return the topological dimension of the DM.

Not collective.

SEE ALSO:

DMGetDimension


Source code at petsc4py/PETSc/DM.pyx:206



Return the discretization object for a given DM field.

Not collective.

index (int) -- The field number.
tuple[Object, None]

SEE ALSO:

DMGetField


Source code at petsc4py/PETSc/DM.pyx:586


Return the flags for determining variable influence.

Not collective.

field (int) -- The field number.
  • useCone (bool) -- Whether adjacency uses cone information.
  • useClosure (bool) -- Whether adjacency is computed using full closure information.

tuple[bool, bool]

SEE ALSO:

DMGetAdjacency


Source code at petsc4py/PETSc/DM.pyx:416


Return the Section encoding the global data layout for the DM.

Collective the first time it is called.

SEE ALSO:

DMGetGlobalSection


Source code at petsc4py/PETSc/DM.pyx:1762

Section


Return a global vector.

Collective.

name (str | None) -- The optional name to retrieve a persistent vector.
Vec

Notes

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

SEE ALSO:

restoreGlobalVec, DMGetGlobalVector, DMGetNamedGlobalVector


Source code at petsc4py/PETSc/DM.pyx:826


Return local mapping to global mapping.

Collective.

SEE ALSO:

DMGetLocalToGlobalMapping


Source code at petsc4py/PETSc/DM.pyx:1003

LGMap


Return the label of a given name.

Not collective.

SEE ALSO:

DMGetLabel


Source code at petsc4py/PETSc/DM.pyx:1704

name (str)
DMLabel


Return an IS of all values that the DMLabel takes.

Not collective.

name (str) -- The label name.
IS

SEE ALSO:

DMLabelGetValueIS, DMGetLabelIdIS


Source code at petsc4py/PETSc/DM.pyx:2055


Return the name of nth label.

Not collective.

index (int) -- The label number.
str

SEE ALSO:

DMGetLabelName


Source code at petsc4py/PETSc/DM.pyx:1881


Return the output flag for a given label.

Not collective.

name (str) -- The label name.
bool

SEE ALSO:

DMGetLabelOutput


Source code at petsc4py/PETSc/DM.pyx:2168


Return the number of values that the DMLabel takes.

Not collective.

name (str) -- The label name.
int

SEE ALSO:

DMLabelGetNumValues, DMGetLabelSize


Source code at petsc4py/PETSc/DM.pyx:2034


Return the value in DMLabel for the given point.

Not collective.

  • name (str) -- The label name.
  • point (int) -- The mesh point

int

SEE ALSO:

DMGetLabelValue


Source code at petsc4py/PETSc/DM.pyx:1963


Return the bounding box for the piece of the DM.

Not collective.

SEE ALSO:

DMGetLocalBoundingBox


Source code at petsc4py/PETSc/DM.pyx:1323

tuple[tuple[float, float], ...]


Return the Section encoding the local data layout for the DM.

Not collective.

SEE ALSO:

DMGetGlobalSection


Source code at petsc4py/PETSc/DM.pyx:1735

Section


Return a local vector.

Not collective.

name (str | None) -- The optional name to retrieve a persistent vector.
Vec

Notes

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

SEE ALSO:

restoreLocalVec, DMGetLocalVector, DMGetNamedLocalVector


Source code at petsc4py/PETSc/DM.pyx:880


Return the number of fields in the DM.

Not collective.

SEE ALSO:

DMGetNumFields


Source code at petsc4py/PETSc/DM.pyx:546



Return the number of labels defined by on the DM.

Not collective.

SEE ALSO:

DMGetNumLabels


Source code at petsc4py/PETSc/DM.pyx:1867



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

Not collective.

SEE ALSO:

Working with PETSc options, setOptionsPrefix, DMGetOptionsPrefix


Source code at petsc4py/PETSc/DM.pyx:284



Return the SF encoding the parallel DOF overlap for the DM.

Not collective.

SEE ALSO:

DMGetPointSF


Source code at petsc4py/PETSc/DM.pyx:1840



Return the refinement level.

Not collective.

SEE ALSO:

DMGetRefineLevel


Source code at petsc4py/PETSc/DM.pyx:1597



Return the Section encoding the parallel DOF overlap.

Collective the first time it is called.

SEE ALSO:

DMGetSectionSF


Source code at petsc4py/PETSc/DM.pyx:1809



Return the points in a label stratum.

Not collective.

  • name (str) -- The label name.
  • value (int) -- The stratum value.

IS

SEE ALSO:

DMGetStratumIS


Source code at petsc4py/PETSc/DM.pyx:2100


Return the number of points in a label stratum.

Not collective.

  • name (str) -- The label name.
  • value (int) -- The stratum value.

int

SEE ALSO:

DMGetStratumSize


Source code at petsc4py/PETSc/DM.pyx:2076


Return the DM type name.

Not collective.

SEE ALSO:

DMGetType


Source code at petsc4py/PETSc/DM.pyx:192



Update local vectors from global vector.

Neighborwise collective.

  • vg (Vec) -- The global vector.
  • vl (Vec) -- The local vector.
  • addv (InsertModeSpec | None) -- Insertion mode.

None

SEE ALSO:

DMGlobalToLocalBegin, DMGlobalToLocalEnd


Source code at petsc4py/PETSc/DM.pyx:934


Determine whether the DM has a label.

Not collective.

name (str) -- The label name.
bool

SEE ALSO:

DMHasLabel


Source code at petsc4py/PETSc/DM.pyx:1901


Return a DM stored in binary.

Collective.

viewer (Viewer) -- Viewer used to store the DM, like Viewer.Type.BINARY or Viewer.Type.HDF5.
Self

Notes

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

SEE ALSO:

DM.view, DM.load, Object.setName, DMLoad


Source code at petsc4py/PETSc/DM.pyx:95


Update global vectors from local vector.

Neighborwise collective.

  • vl (Vec) -- The local vector.
  • vg (Vec) -- The global vector.
  • addv (InsertModeSpec | None) -- Insertion mode.

None

SEE ALSO:

DMLocalToGlobalBegin, DMLocalToGlobalEnd


Source code at petsc4py/PETSc/DM.pyx:957


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

Neighborwise collective.

  • vl (Vec) -- The local vector.
  • vlg (Vec) -- The global vector.
  • addv (InsertModeSpec | None) -- Insertion mode.

None

SEE ALSO:

DMLocalToLocalBegin, DMLocalToLocalEnd


Source code at petsc4py/PETSc/DM.pyx:980


Create local coordinates for cells having periodic faces.

Collective.

Notes

Used if the mesh is periodic.

SEE ALSO:

DMLocalizeCoordinates


Source code at petsc4py/PETSc/DM.pyx:1340



Return a refined DM object.

Collective.

comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.
DM

SEE ALSO:

DMRefine


Source code at petsc4py/PETSc/DM.pyx:1495


Refine this DM and return the refined DM hierarchy.

Collective.

nlevels (int) -- The number of levels of refinement.
list

SEE ALSO:

DMRefineHierarchy


Source code at petsc4py/PETSc/DM.pyx:1543


Remove and destroy the label by name.

Not collective.

name (str) -- The label name.
None

SEE ALSO:

DMRemoveLabel


Source code at petsc4py/PETSc/DM.pyx:1941


Restore a global vector obtained with getGlobalVec.

Logically collective.

  • vg (Vec) -- The global vector.
  • name (str | None) -- The name used to retrieve the persistent vector, if any.

None

SEE ALSO:

getGlobalVec, DMRestoreGlobalVector, DMRestoreNamedGlobalVector


Source code at petsc4py/PETSc/DM.pyx:855


Restore a local vector obtained with getLocalVec.

Not collective.

  • vl (Vec) -- The local vector.
  • name (str | None) -- The name used to retrieve the persistent vector, if any.

None

SEE ALSO:

getLocalVec, DMRestoreLocalVector, DMRestoreNamedLocalVector


Source code at petsc4py/PETSc/DM.pyx:909


Set the application context.

Source code at petsc4py/PETSc/DM.pyx:339

appctx (Any)
None


Set an auxiliary vector for a specific region.

Not collective.

  • aux (Vec) -- The auxiliary vector.
  • label (DMLabel | None) -- The name of the DMLabel.
  • value -- Indicate the region.
  • part -- The equation part, or 0 is unused.

None

SEE ALSO:

DMGetLabel, DMSetAuxiliaryVec


Source code at petsc4py/PETSc/DM.pyx:473


Set the flags for determining variable influence.

Not collective.

  • useCone (bool) -- Whether adjacency uses cone information.
  • useClosure (bool) -- Whether adjacency is computed using full closure information.

None

SEE ALSO:

DMSetBasicAdjacency


Source code at petsc4py/PETSc/DM.pyx:349


Set the cell coordinate DM.

Collective.

dm (DM) -- The cell coordinate DM.
None

SEE ALSO:

DMSetCellCoordinateDM


Source code at petsc4py/PETSc/DM.pyx:1142


Set the cell coordinate layout over the DM.

Collective.

  • dim (int) -- The embedding dimension, or DETERMINE.
  • sec (Section) -- The cell coordinate Section.

None

SEE ALSO:

DMSetCellCoordinateSection


Source code at petsc4py/PETSc/DM.pyx:1174


Set a global vector with the cellwise coordinates.

Collective.

c (Vec) -- The global cell coordinate vector.
None

SEE ALSO:

DMSetCellCoordinates


Source code at petsc4py/PETSc/DM.pyx:1209


Set a local vector with the cellwise coordinates.

Not collective.

c (Vec) -- The local cell coordinate vector.
None

SEE ALSO:

DMSetCellCoordinatesLocal


Source code at petsc4py/PETSc/DM.pyx:1241


Set the coarse DM.

Collective.

SEE ALSO:

DMSetCoarseDM


Source code at petsc4py/PETSc/DM.pyx:1035

dm (DM)
None


Set the dimension of embedding space for coordinates values.

Not collective.

dim (int) -- The embedding dimension.
None

SEE ALSO:

DMSetCoordinateDim


Source code at petsc4py/PETSc/DM.pyx:252


Project coordinates to a different space.

Collective.

  • disc (FE) -- The new coordinates discretization.
  • project (bool)

Self

SEE ALSO:

DMSetCoordinateDisc


Source code at petsc4py/PETSc/DM.pyx:1273


Set a global vector that holds the coordinates.

Collective.

c (Vec) -- Coordinate Vector.
None

SEE ALSO:

DMSetCoordinates


Source code at petsc4py/PETSc/DM.pyx:1078


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

Not collective.

c (Vec) -- Coordinate Vector.
None

SEE ALSO:

DMSetCoordinatesLocal


Source code at petsc4py/PETSc/DM.pyx:1110


Set the topological dimension of the DM.

Collective.

dim (int) -- Topological dimension.
None

SEE ALSO:

DMSetDimension


Source code at petsc4py/PETSc/DM.pyx:220


Set the discretization object for a given DM field.

Logically collective.

  • index (int) -- The field number.
  • field (Object) -- The discretization object.
  • label (str | None) -- The name of the label indicating the support of the field, or None for the entire mesh.

None

SEE ALSO:

DMSetField


Source code at petsc4py/PETSc/DM.pyx:560


Set the flags for determining variable influence.

Not collective.

  • field (int) -- The field number.
  • useCone (bool) -- Whether adjacency uses cone information.
  • useClosure (bool) -- Whether adjacency is computed using full closure information.

None

SEE ALSO:

DMSetAdjacency


Source code at petsc4py/PETSc/DM.pyx:392


Configure the object from the options database.

Collective.

SEE ALSO:

Working with PETSc options, DMSetFromOptions


Source code at petsc4py/PETSc/DM.pyx:312



Set the Section encoding the global data layout for the DM.

Collective.

SEE ALSO:

DMSetGlobalSection


Source code at petsc4py/PETSc/DM.pyx:1750

sec (Section)
None


Matrix associated with the linear system.

Collective.

  • operator -- Callback function to compute the operators.
  • args (tuple[Any, ...] | None) -- Positional arguments for the callback.
  • kargs (dict[str, Any] | None) -- Keyword arguments for the callback.

None

SEE ALSO:

DMKSPSetComputeOperators


Source code at petsc4py/PETSc/DM.pyx:2194


Set if a given label should be saved to a view.

Not collective.

  • name (str) -- The label name.
  • output (bool) -- If True, the label is saved to the viewer.

None

SEE ALSO:

DMSetLabelOutput


Source code at petsc4py/PETSc/DM.pyx:2146


Set a point to a DMLabel with a given value.

Not collective.

  • name (str) -- The label name.
  • point (int) -- The mesh point.
  • value (int) -- The label value for the point.

None

SEE ALSO:

DMSetLabelValue


Source code at petsc4py/PETSc/DM.pyx:1986


Set the Section encoding the local data layout for the DM.

Collective.

SEE ALSO:

DMSetLocalSection


Source code at petsc4py/PETSc/DM.pyx:1723

sec (Section)
None


Set matrix type to be used by DM.createMat.

Logically collective.

mat_type (Type | str) -- The matrix type.
None

Notes

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

SEE ALSO:

Working with PETSc options, DMSetMatType


Source code at petsc4py/PETSc/DM.pyx:1357


Set the number of fields in the DM.

Logically collective.

SEE ALSO:

DMSetNumFields


Source code at petsc4py/PETSc/DM.pyx:533

numFields (int)
None


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

Logically collective.

SEE ALSO:

Working with PETSc options, getOptionsPrefix, DMSetOptionsPrefix


Source code at petsc4py/PETSc/DM.pyx:270

prefix (str | None)
None


Set the SF encoding the parallel DOF overlap for the DM.

Logically collective.

SEE ALSO:

DMSetPointSF


Source code at petsc4py/PETSc/DM.pyx:1855

sf (SF)
None


Set the number of refinements.

Not collective.

  • nlevels -- The number of refinement.
  • level (int)

None

SEE ALSO:

DMSetRefineLevel


Source code at petsc4py/PETSc/DM.pyx:1611


Set SNES residual evaluation function.

Not collective.

  • function (SNESFunction) -- The callback.
  • args (tuple[Any, ...] | None) -- Positional arguments for the callback.
  • kargs (dict[str, Any] | None) -- Keyword arguments for the callback.

None

SEE ALSO:

SNES.setFunction, DMSNESSetFunction


Source code at petsc4py/PETSc/DM.pyx:2270


Set the SNES Jacobian evaluation function.

Not collective.

  • jacobian (SNESJacobianFunction) -- The Jacobian callback.
  • args (tuple[Any, ...] | None) -- Positional arguments for the callback.
  • kargs (dict[str, Any] | None) -- Keyword arguments for the callback.

None

SEE ALSO:

SNES.setJacobian, DMSNESSetJacobian


Source code at petsc4py/PETSc/DM.pyx:2302


Set the Section encoding the parallel DOF overlap for the DM.

Logically collective.

SEE ALSO:

DMSetSectionSF


Source code at petsc4py/PETSc/DM.pyx:1824

sf (SF)
None


Build a DM.

Collective.

dm_type (Type | str) -- The type of DM.
None

Notes

DM types are available in DM.Type class.

SEE ALSO:

DM.Type, DMSetType


Source code at petsc4py/PETSc/DM.pyx:169


Return the data structure.

Collective.

SEE ALSO:

DMSetUp


Source code at petsc4py/PETSc/DM.pyx:324



Set the type of vector.

Logically collective.

SEE ALSO:

Vec.Type, DMSetVecType


Source code at petsc4py/PETSc/DM.pyx:784

vec_type (Type | str)
None


View the DM.

Collective.

viewer (Viewer | None) -- The DM viewer.
None

SEE ALSO:

DMView


Source code at petsc4py/PETSc/DM.pyx:76


Attributes Documentation

Application context.

Source code at petsc4py/PETSc/DM.pyx:2386


Discrete space.

Source code at petsc4py/PETSc/DM.pyx:2396




petsc4py.PETSc.DMComposite

Bases: DM

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

Methods Summary

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

Methods Documentation

Add a DM vector to the composite.

Collective.

  • dm (DM) -- The DM object.
  • *args (DM) -- Additional DM objects.

None

SEE ALSO:

DMCompositeAddDM


Source code at petsc4py/PETSc/DMComposite.pyx:28


Create a composite object.

Collective.

comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.
Self

SEE ALSO:

DMCompositeCreate


Source code at petsc4py/PETSc/DMComposite.pyx:6


Gather split local vectors into a coupled global vector.

Collective.

  • gvec (Vec) -- The global vector.
  • imode (InsertModeSpec) -- The insertion mode.
  • lvecs (Sequence[Vec]) -- The individual sequential vectors.

None

SEE ALSO:

scatter, DMCompositeGatherArray


Source code at petsc4py/PETSc/DMComposite.pyx:115


Get access to the individual vectors from the global vector.

Not collective.

Use via The with statement context manager (PEP 343).

  • gvec (Vec) -- The global vector.
  • locs (Sequence[int] | None) -- Indices of vectors wanted, or None to get all vectors.

Any

Source code at petsc4py/PETSc/DMComposite.pyx:219


Return sub-DMs contained in the composite.

Not collective.

SEE ALSO:

DMCompositeGetEntriesArray


Source code at petsc4py/PETSc/DMComposite.pyx:66

list[DM]


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:

DMCompositeGetGlobalISs


Source code at petsc4py/PETSc/DMComposite.pyx:143

list[IS]


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:

DMCompositeGetISLocalToGlobalMappings


Source code at petsc4py/PETSc/DMComposite.pyx:196

list[LGMap]


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:

DMCompositeGetLocalISs


Source code at petsc4py/PETSc/DMComposite.pyx:170

list[IS]


Get number of sub-DMs contained in the composite.

Not collective.

SEE ALSO:

DMCompositeGetNumberDM


Source code at petsc4py/PETSc/DMComposite.pyx:51



Scatter coupled global vector into split local vectors.

Collective.

  • gvec (Vec) -- The global vector.
  • lvecs (Sequence[Vec]) -- Array of local vectors.

None

SEE ALSO:

gather, DMCompositeScatterArray


Source code at petsc4py/PETSc/DMComposite.pyx:90



petsc4py.PETSc.DMDA

Bases: DM

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

Enumerations

ElementType Element types.
InterpolationType Interpolation types.
StencilType Stencil types.

petsc4py.PETSc.DMDA.ElementType

Bases: object

Element types.

Attributes Summary

P1 Constant P1 of type int
Q1 Constant Q1 of type int

Attributes Documentation

Constant P1 of type int

Constant Q1 of type int


petsc4py.PETSc.DMDA.InterpolationType

Bases: object

Interpolation types.

Attributes Summary

Q0 Constant Q0 of type int
Q1 Constant Q1 of type int

Attributes Documentation

Constant Q0 of type int

Constant Q1 of type int


petsc4py.PETSc.DMDA.StencilType

Bases: object

Stencil types.

Attributes Summary

BOX Constant BOX of type int
STAR Constant STAR of type int

Attributes Documentation

Constant BOX of type int

Constant STAR of type int


Methods Summary

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

Attributes Summary

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

Methods Documentation

Create a DMDA object.

Collective.

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

  • dim (int | None) -- The number of dimensions.
  • dof (int | None) -- The number of degrees of freedom.
  • sizes (DimsSpec | None) -- The number of elements in each dimension.
  • proc_sizes (DimsSpec | None) -- The number of processes in x, y, z dimensions.
  • boundary_type (tuple[DM.BoundaryType | int | str | bool, ...] | None) -- The boundary types.
  • stencil_type (StencilType | None) -- The ghost/halo stencil type.
  • stencil_width (int | None) -- The width of the ghost/halo region.
  • setup (bool) -- Whether to call the setup routine after creating the object.
  • ownership_ranges (tuple[Sequence[int], ...] | None) -- Local x, y, z element counts, of length equal to proc_sizes, summing to sizes.
  • comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.

Self

SEE ALSO:

DMDACreate, DMSetDimension, DMDASetDof, DMDASetSizes, DMDASetNumProcs, DMDASetOwnershipRanges, DMDASetBoundaryType, DMDASetStencilType, DMDASetStencilWidth, DMSetUp


Source code at petsc4py/PETSc/DMDA.pyx:32


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.

SEE ALSO:

DMDACreateNaturalVector


Source code at petsc4py/PETSc/DMDA.pyx:832



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 | None) -- The number of degrees of freedom.
  • boundary_type (tuple[DM.BoundaryType | int | str | bool, ...] | None) -- Boundary types.
  • stencil_type (StencilType | None) -- The ghost/halo stencil type.
  • stencil_width (int | None) -- The width of the ghost/halo region.

DMDA

SEE ALSO:

create, DMDAGetInfo, DMSetUp


Source code at petsc4py/PETSc/DMDA.pyx:148


Return the application ordering context for a distributed array.

Collective.

The returned 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:

DMDAGetAO


Source code at petsc4py/PETSc/DMDA.pyx:909



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

Not collective.

SEE ALSO:

setBoundaryType


Source code at petsc4py/PETSc/DMDA.pyx:407

tuple[BoundaryType, ...]


Return the name of a coordinate dimension.

Not collective.

index (int) -- The coordinate number for the DMDA (0, 1, ..., dim-1).
str

SEE ALSO:

setCoordinateName, DMDAGetCoordinateName


Source code at petsc4py/PETSc/DMDA.pyx:810


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

Not collective.

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

Excluding ghost points.

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

SEE ALSO:

getRanges, getGhostRanges, getOwnershipRanges, getGhostCorners, DMDAGetCorners


Source code at petsc4py/PETSc/DMDA.pyx:622

tuple[tuple[int, ...], tuple[int, ...]]


Return the topological dimension.

Not collective.

SEE ALSO:

setDim, DMGetDimension


Source code at petsc4py/PETSc/DMDA.pyx:234



Return the number of degrees of freedom per node.

Not collective.

SEE ALSO:

setDof, DMDAGetInfo


Source code at petsc4py/PETSc/DMDA.pyx:264



Return the element type to be returned by getElements.

Not collective.

SEE ALSO:

setElementType, DMDAGetElementType


Source code at petsc4py/PETSc/DMDA.pyx:1050

ElementType


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

Not collective.

The elements are in local coordinates.

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

elem_type (ElementType | None) -- The element type.
ArrayInt

SEE ALSO:

DMDAGetElements


Source code at petsc4py/PETSc/DMDA.pyx:1064


Return the name of an individual field component.

Not collective.

field (int) -- The field number for the DMDA (0, 1, ..., dof-1), where dof indicates the number of degrees of freedom per node within the DMDA.
str

SEE ALSO:

setFieldName, DMDAGetFieldName


Source code at petsc4py/PETSc/DMDA.pyx:699


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

Not collective.

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

SEE ALSO:

getRanges, getGhostRanges, getOwnershipRanges, getCorners, DMDAGetGhostCorners


Source code at petsc4py/PETSc/DMDA.pyx:651

tuple[tuple[int, ...], tuple[int, ...]]


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

Not collective.

SEE ALSO:

getRanges, getOwnershipRanges, getCorners, getGhostCorners, DMDAGetGhostCorners


Source code at petsc4py/PETSc/DMDA.pyx:577

tuple[tuple[int, int], ...]


Return the type of interpolation.

Not collective.

SEE ALSO:

setInterpolationType, DMDAGetInterpolationType


Source code at petsc4py/PETSc/DMDA.pyx:1020

InterpolationType


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

Not collective.

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

SEE ALSO:

getRanges, getGhostRanges, getCorners, getGhostCorners, DMDAGetOwnershipRanges


Source code at petsc4py/PETSc/DMDA.pyx:597

tuple[ArrayInt, ...]


Return the number of processes in each dimension.

Not collective.

SEE ALSO:

setProcSizes, DMDAGetInfo


Source code at petsc4py/PETSc/DMDA.pyx:361

tuple[int, ...]


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

Not collective.

Excluding ghost nodes.

SEE ALSO:

getGhostRanges, getOwnershipRanges, getCorners, getGhostCorners, DMDAGetCorners


Source code at petsc4py/PETSc/DMDA.pyx:555

tuple[tuple[int, int], ...]


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

Not collective.

SEE ALSO:

setRefinementFactor, DMDAGetRefinementFactor


Source code at petsc4py/PETSc/DMDA.pyx:981

tuple[int, ...]


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

Collective.

SEE ALSO:

DMDAGetScatter


Source code at petsc4py/PETSc/DMDA.pyx:930

tuple[Scatter, Scatter]


Return the number of grid points in each dimension.

Not collective.

SEE ALSO:

setSizes, DMDAGetInfo


Source code at petsc4py/PETSc/DMDA.pyx:311

tuple[int, ...]


Return the stencil type and width.

Not collective.

SEE ALSO:

getStencilType, getStencilWidth


Source code at petsc4py/PETSc/DMDA.pyx:532

tuple[StencilType, int]


Return the stencil type.

Not collective.

SEE ALSO:

setStencilType, DMDAGetInfo


Source code at petsc4py/PETSc/DMDA.pyx:448

StencilType


Return the stencil width.

Not collective.

SEE ALSO:

setStencilWidth


Source code at petsc4py/PETSc/DMDA.pyx:486



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

Logically collective.

  • vec (Vec) -- The vector to which access is being requested.
  • readonly (bool) -- Request read-only access.

Any

SEE ALSO:

Vec.getArray, DMDAVecGetArray, DMDAVecGetArrayDOF


Source code at petsc4py/PETSc/DMDA.pyx:723


Map values to the "natural" grid ordering.

Neighborwise collective.

You must call createNaturalVec before using this routine.

  • vg (Vec) -- The global vector in a grid ordering.
  • vn (Vec) -- The global vector in a "natural" ordering.
  • addv (InsertMode | None) -- The insertion mode.

None

SEE ALSO:

naturalToGlobal, DMDAGlobalToNaturalBegin, DMDAGlobalToNaturalEnd


Source code at petsc4py/PETSc/DMDA.pyx:849


Map values the to grid ordering.

Neighborwise collective.

  • vn (Vec) -- The global vector in a natural ordering.
  • vg (Vec) -- the global vector in a grid ordering.
  • addv (InsertMode | None) -- The insertion mode.

None

SEE ALSO:

globalToNatural, DMDANaturalToGlobalBegin, DMDANaturalToGlobalEnd


Source code at petsc4py/PETSc/DMDA.pyx:879


Set the type of ghost nodes on domain boundaries.

Not collective.

boundary_type (tuple[BoundaryType | int | str | bool, ...]) -- The boundary type in (x), (x, y), or (x, y, z) dimensions.
None

SEE ALSO:

getBoundaryType, DMDASetBoundaryType


Source code at petsc4py/PETSc/DMDA.pyx:384


Set the name of the coordinate dimension.

Logically collective.

  • index (int) -- The coordinate number for the DMDA (0, 1, ..., dim-1).
  • name (str) -- The name of the coordinate.

None

SEE ALSO:

getCoordinateName, DMDASetCoordinateName


Source code at petsc4py/PETSc/DMDA.pyx:788


Set the topological dimension.

Collective.

dim (int) -- Topological dimension.
None

SEE ALSO:

getDim, DMSetDimension


Source code at petsc4py/PETSc/DMDA.pyx:217


Set the number of degrees of freedom per vertex.

Not collective.

dof (int) -- The number of degrees of freedom.
None

SEE ALSO:

getDof, DMDASetDof


Source code at petsc4py/PETSc/DMDA.pyx:246


Set the element type to be returned by getElements.

Not collective.

SEE ALSO:

getElementType, DMDASetElementType


Source code at petsc4py/PETSc/DMDA.pyx:1036

elem_type (ElementType | str)
None


Set the name of individual field components.

Logically collective.

  • field (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) -- The name of the field (component).

None

SEE ALSO:

getFieldName, DMDASetFieldName


Source code at petsc4py/PETSc/DMDA.pyx:675


Set the type of interpolation.

Logically collective.

You should call this on the coarser of the two DMDAs you pass to DM.createInterpolation.

interp_type (InterpolationType) -- The interpolation type.
None

SEE ALSO:

getInterpolationType, DMDASetInterpolationType


Source code at petsc4py/PETSc/DMDA.pyx:999


Set the number of processes in each dimension.

Logically collective.

proc_sizes (DimsSpec) -- The number of processes in (x,), (x, y), or (x, y, z) dimensions.
None

SEE ALSO:

getProcSizes, DMDASetNumProcs


Source code at petsc4py/PETSc/DMDA.pyx:334


Set the ratios for the DMDA grid refinement.

Logically collective.

  • refine_x (int) -- Ratio of fine grid to coarse in x dimension.
  • refine_y (int) -- Ratio of fine grid to coarse in y dimension.
  • refine_z (int) -- Ratio of fine grid to coarse in z dimension.

None

SEE ALSO:

getRefinementFactor, DMDASetRefinementFactor


Source code at petsc4py/PETSc/DMDA.pyx:949


Set the number of grid points in each dimension.

Logically collective.

sizes (DimsSpec) -- The global (x,), (x, y), or (x, y, z) size.
None

SEE ALSO:

getSizes, DMDASetSizes


Source code at petsc4py/PETSc/DMDA.pyx:284


Set the stencil type and width.

Not collective.

  • stencil_type (StencilType) -- The stencil type.
  • stencil_width (int) -- The stencil width.

None

SEE ALSO:

setStencilWidth, setStencilType, DMDASetStencilType, DMDASetStencilWidth


Source code at petsc4py/PETSc/DMDA.pyx:506


Set the stencil type.

Logically collective.

  • stype -- The stencil type.
  • stencil_type (StencilType)

None

SEE ALSO:

getStencilType, setStencil, DMDASetStencilType


Source code at petsc4py/PETSc/DMDA.pyx:430


Set the stencil width.

Logically collective.

stencil_width (int) -- The stencil width.
None

SEE ALSO:

getStencilWidth, setStencil, DMDASetStencilWidth


Source code at petsc4py/PETSc/DMDA.pyx:468


Set the DMDA coordinates to be a uniform grid.

Collective.

  • xmin (float) -- The minimum in the x dimension.
  • xmax (float) -- The maximum in the x dimension.
  • ymin (float) -- The minimum in the y dimension (value ignored for 1 dimensional problems).
  • ymax (float) -- The maximum in the y dimension (value ignored for 1 dimensional problems).
  • zmin (float) -- The minimum in the z dimension (value ignored for 1 or 2 dimensional problems).
  • zmax (float) -- The maximum in the z dimension (value ignored for 1 or 2 dimensional problems).

None

SEE ALSO:

DMDASetUniformCoordinates


Source code at petsc4py/PETSc/DMDA.pyx:744


Attributes Documentation

Boundary types in each dimension.

Source code at petsc4py/PETSc/DMDA.pyx:1123


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

Source code at petsc4py/PETSc/DMDA.pyx:1153


The grid dimension.

Source code at petsc4py/PETSc/DMDA.pyx:1103


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

Source code at petsc4py/PETSc/DMDA.pyx:1108


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

Source code at petsc4py/PETSc/DMDA.pyx:1158


Ranges of local region, including ghost nodes.

Source code at petsc4py/PETSc/DMDA.pyx:1148


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

Source code at petsc4py/PETSc/DMDA.pyx:1118


Ranges of the local region in each dimension.

Source code at petsc4py/PETSc/DMDA.pyx:1143


The global dimension.

Source code at petsc4py/PETSc/DMDA.pyx:1113


Stencil type and width.

Source code at petsc4py/PETSc/DMDA.pyx:1128


Stencil type.

Source code at petsc4py/PETSc/DMDA.pyx:1133


Elementwise stencil width.

Source code at petsc4py/PETSc/DMDA.pyx:1138




petsc4py.PETSc.DMInterpolation

Bases: 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 which can hold all the interpolated field values.
restoreVector(vec) Restore a Vec which can hold all the interpolated field values.
setDim(dim) Set the spatial dimension for the interpolation context.
setDof(dof) Set the number of fields interpolated at a point.
setUp(dm[, redundantPoints, ignoreOutsideDomain]) Compute spatial indices for point location during interpolation.

Methods Documentation

Create a DMInterpolation context.

Collective.

comm (Comm | None) -- MPI communicator, defaults to COMM_SELF.
Self

SEE ALSO:

destroy, DMInterpolationCreate


Source code at petsc4py/PETSc/DMUtils.pyx:13


Destroy the DMInterpolation context.

Collective.

SEE ALSO:

create, DMInterpolationDestroy


Source code at petsc4py/PETSc/DMUtils.pyx:35



Calculate interpolated field values at the interpolation points.

Collective.

  • dm (DM) -- The DM.
  • x (Vec) -- The local vector containing the field to be interpolated.
  • v (Vec | None) -- A vector capable of holding the interpolated field values.

Vec

SEE ALSO:

DMInterpolationEvaluate


Source code at petsc4py/PETSc/DMUtils.pyx:48


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:

DMInterpolationGetCoordinates


Source code at petsc4py/PETSc/DMUtils.pyx:74



Return the spatial dimension of the interpolation context.

Not collective.

SEE ALSO:

setDim, DMInterpolationGetDim


Source code at petsc4py/PETSc/DMUtils.pyx:92



Return the number of fields interpolated at a point.

Not collective.

SEE ALSO:

setDof, DMInterpolationGetDof


Source code at petsc4py/PETSc/DMUtils.pyx:106



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

Collective.

This vector should be returned using restoreVector.

SEE ALSO:

restoreVector, DMInterpolationGetVector


Source code at petsc4py/PETSc/DMUtils.pyx:185



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

Collective.

vec (Vec) -- A vector capable of holding the interpolated field values.
None

SEE ALSO:

getVector, DMInterpolationRestoreVector


Source code at petsc4py/PETSc/DMUtils.pyx:201


Set the spatial dimension for the interpolation context.

Not collective.

dim (int) -- The spatial dimension.
None

SEE ALSO:

getDim, DMInterpolationSetDim


Source code at petsc4py/PETSc/DMUtils.pyx:120


Set the number of fields interpolated at a point.

Not collective.

dof (int) -- The number of fields.
None

SEE ALSO:

getDof, DMInterpolationSetDof


Source code at petsc4py/PETSc/DMUtils.pyx:138


Compute spatial indices for point location during interpolation.

Collective.

  • dm (DM) -- The DM for the function space used for interpolation.
  • redundantPoints (bool) -- If True, all processes are passing in the same array of points. Otherwise, points need to be communicated among processes.
  • ignoreOutsideDomain (bool) -- Ignore points outside of the domain if True; otherwise, return an error.

None

SEE ALSO:

DMInterpolationSetUp


Source code at petsc4py/PETSc/DMUtils.pyx:156



petsc4py.PETSc.DMLabel

Bases: Object

An object representing a subset of mesh entities from a 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 and 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.
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 of all values that the DMLabel takes.
getNumValues() Return the number of values that the DMLabel takes.
getStratumIS(stratum) Return an 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 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 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.
setValue(point, value) Set the value a label assigns to a point.
stratumHasPoint(value, point) Return whether the stratum contains a point.
view([viewer]) View the label.

Methods Documentation

Add new stratum values in a DMLabel.

Not collective.

strata (Sequence[int]) -- The stratum values.
None

SEE ALSO:

addStrataIS, addStratum, DMLabelAddStrata


Source code at petsc4py/PETSc/DMLabel.pyx:238


Add new stratum values in a DMLabel.

Not collective.

iset (IS) -- Index set with stratum values.
None

SEE ALSO:

addStrata, addStratum, DMLabelAddStrataIS


Source code at petsc4py/PETSc/DMLabel.pyx:258


Add a new stratum value in a DMLabel.

Not collective.

value (int) -- The stratum value.
None

SEE ALSO:

addStrata, addStrataIS, DMLabelAddStratum


Source code at petsc4py/PETSc/DMLabel.pyx:220


Remove a stratum.

Not collective.

stratum (int) -- The stratum value.
None

SEE ALSO:

DMLabelClearStratum


Source code at petsc4py/PETSc/DMLabel.pyx:406


Clear the value a label assigns to a point.

Not collective.

  • point (int) -- The point.
  • value (int) -- The point value.

None

SEE ALSO:

DMLabelClearValue


Source code at petsc4py/PETSc/DMLabel.pyx:199


Create an index structure for membership determination.

Not collective.

Automatically determines the bounds.

SEE ALSO:

DMLabelComputeIndex


Source code at petsc4py/PETSc/DMLabel.pyx:424



Return a Section and IS that encode the label.

Not collective.

SEE ALSO:

DMLabelConvertToSection


Source code at petsc4py/PETSc/DMLabel.pyx:607

tuple[Section, IS]


Create a DMLabel object, which is a multimap.

Collective.

  • name (str) -- The label name.
  • comm (Comm | None) -- MPI communicator, defaults to COMM_SELF.

Self

SEE ALSO:

DMLabelCreate


Source code at petsc4py/PETSc/DMLabel.pyx:40


Create an index structure for membership determination.

Not collective.

  • pStart (int) -- The smallest point.
  • pEnd (int) -- The largest point + 1.

None

SEE ALSO:

destroyIndex, DMLabelCreateIndex


Source code at petsc4py/PETSc/DMLabel.pyx:438


Destroy the label.

Collective.

SEE ALSO:

DMLabelDestroy


Source code at petsc4py/PETSc/DMLabel.pyx:8



Destroy the index structure.

Not collective.

SEE ALSO:

createIndex, DMLabelDestroyIndex


Source code at petsc4py/PETSc/DMLabel.pyx:458



Create a new label pushed forward over the SF.

Collective.

sf (SF) -- The map from old to new distribution.
DMLabel

SEE ALSO:

gather, DMLabelDistribute


Source code at petsc4py/PETSc/DMLabel.pyx:567


Duplicate the DMLabel.

Collective.

SEE ALSO:

DMLabelDuplicate


Source code at petsc4py/PETSc/DMLabel.pyx:65

DMLabel


Remove all points outside of [start, end).

Not collective.

  • start (int) -- The first point kept.
  • end (int) -- One more than the last point kept.

None

SEE ALSO:

DMLabelFilter


Source code at petsc4py/PETSc/DMLabel.pyx:528


Gather all label values from leaves into roots.

Collective.

This is the inverse operation to distribute.

sf (SF) -- The SF communication map.
DMLabel

SEE ALSO:

distribute, DMLabelGather


Source code at petsc4py/PETSc/DMLabel.pyx:586


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:

DMLabelGetBounds


Source code at petsc4py/PETSc/DMLabel.pyx:512

tuple[int, int]


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:

setDefaultValue, DMLabelGetDefaultValue


Source code at petsc4py/PETSc/DMLabel.pyx:161



Return an IS of all values that the DMLabel takes.

Not collective.

SEE ALSO:

DMLabelGetNonEmptyStratumValuesIS


Source code at petsc4py/PETSc/DMLabel.pyx:622



Return the number of values that the DMLabel takes.

Not collective.

SEE ALSO:

DMLabelGetNumValues


Source code at petsc4py/PETSc/DMLabel.pyx:275



Return an IS with the stratum points.

Not collective.

stratum (int) -- The stratum value.
IS

SEE ALSO:

setStratumIS, DMLabelGetStratumIS


Source code at petsc4py/PETSc/DMLabel.pyx:366


Return the size of a stratum.

Not collective.

stratum (int) -- The stratum value.
int

SEE ALSO:

DMLabelGetStratumSize


Source code at petsc4py/PETSc/DMLabel.pyx:346


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.

point (int) -- The point.
int

SEE ALSO:

setValue, setDefaultValue, DMLabelGetValue


Source code at petsc4py/PETSc/DMLabel.pyx:137


Return an IS of all values that the DMLabel takes.

Not collective.

SEE ALSO:

DMLabelGetValueIS


Source code at petsc4py/PETSc/DMLabel.pyx:289



Determine whether the label contains a point.

Not collective.

The user must call createIndex before this function.

point (int) -- The point.
bool

SEE ALSO:

hasValue, DMLabelHasPoint


Source code at petsc4py/PETSc/DMLabel.pyx:490


Determine whether points exist with the given value.

Not collective.

value (int) -- The stratum value.
bool

SEE ALSO:

DMLabelHasStratum


Source code at petsc4py/PETSc/DMLabel.pyx:326


Determine whether a label assigns the value to any point.

Not collective.

value (int) -- The value.
bool

SEE ALSO:

hasPoint, DMLabelHasValue


Source code at petsc4py/PETSc/DMLabel.pyx:470


Set all points in the IS to a value.

Not collective.

  • iset (IS) -- The point IS.
  • value (int) -- The point value.

Self

SEE ALSO:

DMLabelInsertIS


Source code at petsc4py/PETSc/DMLabel.pyx:91


Create a new label with permuted points.

Not collective.

permutation (IS) -- The point permutation.
DMLabel

SEE ALSO:

DMLabelPermute


Source code at petsc4py/PETSc/DMLabel.pyx:548


Destroy internal data structures in the DMLabel.

Not collective.

SEE ALSO:

DMLabelReset


Source code at petsc4py/PETSc/DMLabel.pyx:79



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.

value (int) -- The default value.
None

SEE ALSO:

getDefaultValue, DMLabelSetDefaultValue


Source code at petsc4py/PETSc/DMLabel.pyx:178


Set the stratum points using an IS.

Not collective.

  • stratum (int) -- The stratum value.
  • iset (IS) -- The stratum points.

None

SEE ALSO:

getStratumIS, DMLabelSetStratumIS


Source code at petsc4py/PETSc/DMLabel.pyx:386


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) -- The point.
  • value (int) -- The point value.

None

SEE ALSO:

getValue, setDefaultValue, DMLabelSetValue


Source code at petsc4py/PETSc/DMLabel.pyx:112


Return whether the stratum contains a point.

Not collective.

  • value (int) -- The stratum value.
  • point (int) -- The point.

bool

SEE ALSO:

DMLabelStratumHasPoint


Source code at petsc4py/PETSc/DMLabel.pyx:303


View the label.

Collective.

viewer (Viewer | None) -- A Viewer to display the graph.
None

SEE ALSO:

DMLabelView


Source code at petsc4py/PETSc/DMLabel.pyx:21



petsc4py.PETSc.DMPlex

Bases: 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 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.
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 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.
distributeGetDefault() Return a flag indicating whether the 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 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.
getPointGlobalField(point, field) Return location of point field data in global Vec.
getPointHeight(point) Return the height of a given point.
getPointLocal(point) Return location of point data in local Vec.
getPointLocalField(point, field) Return location of point field data in local Vec.
getRefinementLimit() Retrieve the maximum cell volume for refinement.
getRefinementUniform() Retrieve the flag for uniform refinement.
getSubpointIS() Return an IS covering the entire subdm chart.
getSubpointMap() Return a 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.
sectionView(viewer, sectiondm) Save a section associated with a DMPlex.
setAdjacencyUseAnchors([useAnchors]) Define adjacency in the mesh using the point-to-point constraints.
setCellType(p, ctype) Set the polytope type of a given cell.
setChart(pStart, pEnd) Set the interval for all mesh points [pStart, pEnd).
setCone(p, cone[, orientation]) Set the points on the in-edges for this point in the DAG.
setConeOrientation(p, orientation) Set the orientations on the in-edges for this point in the DAG.
setConeSize(p, size) Set the number of in-edges for this point in the DAG.
setMatClosure(sec, gsec, mat, point, values) Set an array of the values on the closure of point.
setPartitioner(part) Set the mesh partitioner.
setRefinementLimit(refinementLimit) Set the maximum cell volume for refinement.
setRefinementUniform([refinementUniform]) Set the flag for uniform refinement.
setSupport(p, supp) Set the points on the out-edges for this point in the DAG.
setSupportSize(p, size) Set the number of out-edges for this point in the DAG.
setTetGenOptions(opts) Set the options used for the Tetgen mesh generator.
setTriangleOptions(opts) Set the options used for the Triangle mesh generator.
setVecClosure(sec, vec, point, values[, addv]) Set an array of the values on the closure of point.
stratify() Calculate the strata of DAG.
symmetrize() Create support (out-edge) information from cone (in-edge) information.
topologyLoad(viewer) Load a topology into this DMPlex object.
topologyView(viewer) Save a DMPlex topology into a file.
uninterpolate() Convert to a mesh with only cells and vertices.
vecGetClosure(sec, vec, p) Return an array of values on the closure of p.

Methods Documentation

Compute the volume for a given cell.

Not collective.

cell (int) -- The cell.
  • volume (float) -- The cell volume.
  • centroid (ArrayReal) -- The cell centroid.
  • normal (ArrayReal) -- The cell normal, if appropriate.

tuple[float, ArrayReal, ArrayReal]

SEE ALSO:

DMPlex, DM.getCoordinateSection, DM.getCoordinates, DMPlexComputeCellGeometryFVM


Source code at petsc4py/PETSc/DMPlex.pyx:2217


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

Collective.

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

Vec

SEE ALSO:

DM, DMPlex, DMPlexComputeGradientClementInterpolant


Source code at petsc4py/PETSc/DMPlex.pyx:3151


Construct ghost cells which connect to every boundary face.

Collective.

labelName (str | None) -- The name of the label specifying the boundary faces. Defaults to "Face Sets".
numGhostCells -- The number of ghost cells added to the DMPlex.
int

SEE ALSO:

DM, DMPlex, DM.create, DMPlexConstructGhostCells


Source code at petsc4py/PETSc/DMPlex.pyx:2249


Load coordinates into this DMPlex object.

Collective.

  • viewer (Viewer) -- The Viewer for the saved coordinates.
  • sfxc (SF) -- The SF returned by topologyLoad.

None

SEE ALSO:

DM, DMPlex, DM.load, DMPlex.topologyLoad, DMPlex.labelsLoad, DM.view, SF, Viewer, DMPlexCoordinatesLoad


Source code at petsc4py/PETSc/DMPlex.pyx:3324


Save DMPlex coordinates into a file.

Collective.

viewer (Viewer) -- The Viewer for saving.
None

SEE ALSO:

DM, DMPlex, DM.view, DMPlex.topologyView, DMPlex.labelsView, DMPlex.coordinatesLoad, Viewer, DMPlexCoordinatesView


Source code at petsc4py/PETSc/DMPlex.pyx:3191


Create a DMPlex object, which encapsulates an unstructured mesh.

Collective.

comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.
Self

SEE ALSO:

DM, DMPlex, DM.create, DM.setType, DMPlexCreate


Source code at petsc4py/PETSc/DMPlex.pyx:14


Create a mesh on the tensor product of intervals.

Collective.

  • faces (Sequence[int]) -- Number of faces per dimension, or None for the default.
  • lower (Sequence[float] | None) -- The lower left corner.
  • upper (Sequence[float] | None) -- The upper right corner.
  • simplex (bool | None) -- True for simplices, False for tensor cells.
  • periodic (Sequence | str | int | bool | None) -- The boundary type for the X, Y, Z direction, or None for DM.BoundaryType.NONE.
  • interpolate (bool | None) -- Flag to create intermediate mesh entities (edges, faces).
  • localizationHeight (int | None) -- Flag to localize edges and faces in addition to cells; only significant for periodic meshes.
  • sparseLocalize (bool | None) -- Flag to localize coordinates only for cells near the periodic boundary; only significant for periodic meshes.
  • comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.

Self

SEE ALSO:

DM, DMPlex, DM.setFromOptions, DMPlex.createFromFile, DM.setType, DM.create, DMPlexCreateBoxMesh


Source code at petsc4py/PETSc/DMPlex.pyx:90


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

Collective.

  • faces (Sequence[int]) -- Number of faces per dimension, or None for the default.
  • lower (Sequence[float] | None) -- The lower left corner.
  • upper (Sequence[float] | None) -- The upper right corner.
  • interpolate (bool | None) -- Flag to create intermediate mesh pieces (edges, faces).
  • comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.

Self

SEE ALSO:

DM, DMPlex, DM.setFromOptions, DMPlex.createBoxMesh, DMPlex.createFromFile, DM.setType, DM.create, DMPlexCreateBoxSurfaceMesh


Source code at petsc4py/PETSc/DMPlex.pyx:149


Create a DMPlex mesh from a CGNS file.

Collective.

  • cgid (int) -- The CG id associated with a file and obtained using cg_open.
  • interpolate (bool | None) -- Create faces and edges in the mesh.
  • comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.

Self

SEE ALSO:

DM, DMPlex, DMPlex.create, DMPlex.createCGNSFromFile, DMPlex.createExodus, DMPlexCreateCGNS


Source code at petsc4py/PETSc/DMPlex.pyx:226


"Create a DMPlex mesh from a CGNS file.

Collective.

  • filename (str) -- The name of the CGNS file.
  • interpolate (bool | None) -- Create faces and edges in the mesh.
  • comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.

Self

SEE ALSO:

DM, DMPlex, DMPlex.create, DMPlex.createCGNS, DMPlex.createExodus, DMPlexCreateCGNS


Source code at petsc4py/PETSc/DMPlex.pyx:254


Calculate an index for sec for the closure operation.

Not collective.

sec (Section) -- The Section describing the layout in the local vector, or None to use the default section.
None

SEE ALSO:

DM, DMPlex, Section, DMPlex.vecGetClosure, DMPlexCreateClosureIndex


Source code at petsc4py/PETSc/DMPlex.pyx:2031


Create an IS covering the coarse DMPlex chart with the fine points as data.

Collective.

fpointIS -- The IS of all the fine points which exist in the original coarse mesh.
IS

SEE ALSO:

DM, DMPlex, IS, DM.refine, DMPlex.setRefinementUniform, DMPlexCreateCoarsePointIS


Source code at petsc4py/PETSc/DMPlex.pyx:1817


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

Collective.

  • hasLagrange (bool) -- Flag indicating whether the mesh has Lagrange dofs in the cohesive cells.
  • value (int) -- A label value.

DMPlex

SEE ALSO:

DM, DMPlex, DMPlexCreateCohesiveSubmesh


Source code at petsc4py/PETSc/DMPlex.pyx:377


Create a DMPlex mesh from an ExodusII file ID.

Collective.

  • exoid (int) -- The ExodusII id associated with a file obtained using ex_open.
  • interpolate (bool | None) -- Create faces and edges in the mesh,
  • comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.

Self

SEE ALSO:

DM, DMPlex, DM.create, DMPlexCreateExodus


Source code at petsc4py/PETSc/DMPlex.pyx:312


Create a DMPlex mesh from an ExodusII file.

Collective.

  • filename (str) -- The name of the ExodusII file.
  • interpolate (bool | None) -- Create faces and edges in the mesh.
  • comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.

Self

SEE ALSO:

DM, DMPlex, DM.create, DMPlex.createExodus, DMPlexCreateExodusFromFile


Source code at petsc4py/PETSc/DMPlex.pyx:283


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

Collective.

  • dim (int) -- The topological dimension of the mesh.
  • cells (Sequence[int]) -- An array of number of cells times number of vertices on each cell.
  • coords (Sequence[float]) -- An array of number of vertices times spatial dimension for coordinates.
  • interpolate (bool | None) -- Flag to interpolate the mesh.
  • comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.

Self

SEE ALSO:

DM, DMPlex, DMPlex.create, DMPlex.interpolate, DMPlexCreateFromCellListPetsc


Source code at petsc4py/PETSc/DMPlex.pyx:35


Create DMPlex from a file.

Collective.

  • filename (str) -- A file name.
  • plexname (str | None) -- The name of the resulting DMPlex, also used for intra-datafile lookup by some formats.
  • interpolate (bool | None) -- Flag to create intermediate mesh pieces (edges, faces).
  • comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.

Self

SEE ALSO:

DM, DMPlex, DMPlex.createFromCellList, DMPlex.create, Object.setName, DM.view, DM.load, Working with PETSc options, DMPlexCreateFromFile


Source code at petsc4py/PETSc/DMPlex.pyx:192


Create a DMPlex mesh from a Gmsh file viewer.

Collective.

  • viewer (Viewer) -- The Viewer associated with a Gmsh file.
  • interpolate (bool | None) -- Create faces and edges in the mesh.
  • comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.

Self

Notes

-dm_plex_gmsh_hybrid forces triangular prisms to use tensor order.

-dm_plex_gmsh_periodic allows for reading Gmsh periodic section.

-dm_plex_gmsh_highorder allows for generating high-order coordinates.

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

-dm_plex_gmsh_use_regions generates labels with region names.

-dm_plex_gmsh_mark_vertices adds vertices to generated labels.

-dm_plex_gmsh_multiple_tags allows multiple tags for default labels.

-dm_plex_gmsh_spacedim <d> embedding space dimension.

SEE ALSO:

DM, DMPlex, DM.create, Working with PETSc options, DMPlexCreateGmsh


Source code at petsc4py/PETSc/DMPlex.pyx:339


Create a global numbering for all points.

Collective.

SEE ALSO:

DM, DMPlex, DMPlex.getCellNumbering, DMPlexCreatePointNumbering


Source code at petsc4py/PETSc/DMPlex.pyx:915



Create a Section based upon the DOF layout specification provided.

Not collective.

  • numComp (Sequence[int]) -- An array of size numFields holding the number of components per field.
  • numDof (Sequence[int]) -- An array of size numFields*(dim+1) holding the number of DOFs per field on a mesh piece of dimension dim.
  • bcField (Sequence[int] | None) -- An array of size numBC giving the field number for each boundary condition, where numBC is the number of boundary conditions.
  • bcComps (Sequence[IS] | None) -- An array of size numBC giving an IS holding the field components to which each boundary condition applies.
  • bcPoints (Sequence[IS] | None) -- An array of size numBC giving an IS holding the DMPlex points to which each boundary condition applies.
  • perm (IS | None) -- Permutation of the chart.

Section

SEE ALSO:

DM, DMPlex, DMPlex.create, Section.create, Section.setPermutation, DMPlexCreateSection


Source code at petsc4py/PETSc/DMPlex.pyx:1837


Distribute the mesh and any associated sections.

Collective.

overlap (int | None) -- The overlap of partitions.
sf -- The SF used for point distribution, or None if not distributed.
SF or None

SEE ALSO:

DM, DMPlex, DMPlex.create, DMPlexDistribute


Source code at petsc4py/PETSc/DMPlex.pyx:1561


Distribute field data with a with a given SF.

Collective.

  • sf (SF) -- The SF describing the communication pattern.
  • sec (Section) -- The Section for existing data layout.
  • vec (Vec) -- The existing data in a local vector.
  • newsec (Section | None) -- The SF describing the new data layout.
  • newvec (Vec | None) -- The new data in a local vector.

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

tuple[Section, Vec]

SEE ALSO:

DMPlex, DMPlex.distribute, DMPlexDistributeField


Source code at petsc4py/PETSc/DMPlex.pyx:1758


Return a flag indicating whether the DM should be distributed by default.

Not collective.

dist -- Flag indicating whether the DMPlex should be distributed by default.
bool

SEE ALSO:

DM, DMPlex, DMPlex.distributeSetDefault, DMPlex.distribute, DMPlexDistributeGetDefault


Source code at petsc4py/PETSc/DMPlex.pyx:1647


Add partition overlap to a distributed non-overlapping DMPlex.

Collective.

overlap (int | None) -- The overlap of partitions (the same on all ranks).
sf -- The SF used for point distribution.
SF

SEE ALSO:

DM, DMPlex, SF, DMPlex.create, DMPlex.distribute, DMPlexDistributeOverlap


Source code at petsc4py/PETSc/DMPlex.pyx:1589


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

Logically collective.

flag (bool) -- Flag indicating whether the DMPlex should be distributed by default.
None

SEE ALSO:

DMPlex, DMPlex.distributeGetDefault, DMPlex.distribute, DMPlexDistributeSetDefault


Source code at petsc4py/PETSc/DMPlex.pyx:1667


Retrieve the name of the specific parallel distribution.

Not collective.

name -- The name of the specific parallel distribution.
str

SEE ALSO:

DMPlex, DMPlex.distributionSetName, DMPlex.topologyView, DMPlex.topologyLoad, DMPlexDistributionGetName


Source code at petsc4py/PETSc/DMPlex.pyx:1708


Set the name of the specific parallel distribution.

Logically collective.

name (str) -- The name of the specific parallel distribution.
None

SEE ALSO:

DMPlex, DMPlex.distributionGetName, DMPlex.topologyView, DMPlex.topologyLoad, DMPlexDistributionSetName


Source code at petsc4py/PETSc/DMPlex.pyx:1687


Generate a mesh.

Not collective.

  • boundary (DMPlex) -- The DMPlex boundary object.
  • name (str | None) -- The mesh generation package name.
  • interpolate (bool | None) -- Flag to create intermediate mesh elements.

Self

SEE ALSO:

DM, DMPlex, DMPlex.create, DM.refine, Working with PETSc options, DMPlexGenerate


Source code at petsc4py/PETSc/DMPlex.pyx:1284


Return all points adjacent to the given point.

Not collective.

p (int) -- The point.
ArrayInt

SEE ALSO:

DMPlex, DMPlex.distribute, DMPlexGetAdjacency


Source code at petsc4py/PETSc/DMPlex.pyx:1467


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

Not collective.

SEE ALSO:

DMPlex, DMPlex.getAdjacency, DMPlex.distribute, DMPlexGetAdjacencyUseAnchors


Source code at petsc4py/PETSc/DMPlex.pyx:1452



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

Collective the first time it is called.

SEE ALSO:

DM, DMPlex, DMPlex.getVertexNumbering, DMPlexGetCellNumbering


Source code at petsc4py/PETSc/DMPlex.pyx:885



Return the polytope type of a given cell.

Not collective.

p (int) -- The cell.
PolytopeType

SEE ALSO:

DM, DMPlex, DM.PolytopeType, DMPlex.getCellTypeLabel, DMPlex.getDepth, DMPlexGetCellType


Source code at petsc4py/PETSc/DMPlex.pyx:685


Return the DMLabel recording the polytope type of each cell.

Not collective.

SEE ALSO:

DM, DMPlex, DMPlex.getCellType, DM.createLabel, DMPlexGetCellTypeLabel


Source code at petsc4py/PETSc/DMPlex.pyx:706

DMLabel


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

Not collective.

  • pStart (int) -- The first mesh point.
  • pEnd (int) -- The upper bound for mesh points.

tuple[int, int]

SEE ALSO:

DM, DMPlex, DMPlex.create, DMPlex.setChart, DMPlexGetChart


Source code at petsc4py/PETSc/DMPlex.pyx:400


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

Not collective.

p (int) -- The point, which must lie in the chart set with DMPlex.setChart.
ArrayInt

SEE ALSO:

DM, DMPlex, DMPlex.getConeSize, DMPlex.setCone, DMPlex.setChart, DMPlexGetCone


Source code at petsc4py/PETSc/DMPlex.pyx:491


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

Not collective.

p (int) -- The point, which must lie in the chart set with DMPlex.setChart.
ArrayInt

SEE ALSO:

DM, DMPlex, DMPlex.create, DMPlex.getCone, DMPlex.setCone, DMPlex.setChart, DMPlexGetConeOrientation


Source code at petsc4py/PETSc/DMPlex.pyx:606


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

Not collective.

p (int) -- The point, which must lie in the chart set with DMPlex.setChart.
int

SEE ALSO:

DM, DMPlex, DMPlex.create, DMPlex.setConeSize, DMPlex.setChart, DMPlexGetConeSize


Source code at petsc4py/PETSc/DMPlex.pyx:442


Return the depth of the DAG representing this mesh.

Not collective.

SEE ALSO:

DM, DMPlex, DMPlex.getDepthStratum, DMPlex.symmetrize, DMPlexGetDepth


Source code at petsc4py/PETSc/DMPlex.pyx:929



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

Not collective.

svalue (int) -- The requested depth.
  • pStart (int) -- The first stratum point.
  • pEnd (int) -- The upper bound for stratum points.

tuple[int, int]

SEE ALSO:

DM, DMPlex, DMPlex.getHeightStratum, DMPlex.getDepth, DMPlex.symmetrize, DMPlex.interpolate, DMPlexGetDepthStratum


Source code at petsc4py/PETSc/DMPlex.pyx:944


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

Not collective.

points (Sequence[int]) -- The input points.
ArrayInt

SEE ALSO:

DM, DMPlex, DMPlex.getJoin, DMPlex.getMeet, DMPlexGetFullJoin


Source code at petsc4py/PETSc/DMPlex.pyx:1092


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

Not collective.

svalue (int) -- The requested height.
  • pStart (int) -- The first stratum point.
  • pEnd (int) -- The upper bound for stratum points.

tuple[int, int]

SEE ALSO:

DM, DMPlex, DMPlex.getDepthStratum, DMPlex.getDepth, DMPlexGetHeightStratum


Source code at petsc4py/PETSc/DMPlex.pyx:971


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

Not collective.

points (Sequence[int]) -- The input points.
ArrayInt

SEE ALSO:

DM, DMPlex, DMPlex.getMeet, DMPlexGetJoin


Source code at petsc4py/PETSc/DMPlex.pyx:1066


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

Not collective.

  • maxConeSize (int) -- The maximum number of in-edges.
  • maxSupportSize (int) -- The maximum number of out-edges.

tuple[int, int]

SEE ALSO:

DM, DMPlex, DMPlex.create, DMPlex.setConeSize, DMPlex.setChart, DMPlexGetMaxSizes


Source code at petsc4py/PETSc/DMPlex.pyx:826


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

Not collective.

points (Sequence[int]) -- The input points.
ArrayInt

SEE ALSO:

DM, DMPlex, DMPlex.getJoin, DMPlexGetMeet


Source code at petsc4py/PETSc/DMPlex.pyx:1040


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

Not collective.

SEE ALSO:

DMPlex, DM.getCoordinates, DMPlexGetMinRadius


Source code at petsc4py/PETSc/DMPlex.pyx:1803

float


Calculate a reordering of the mesh.

Collective.

otype (OrderingType) -- Type of reordering, see Mat.OrderingType.
perm -- The point permutation.
IS

SEE ALSO:

DMPlex, DMPlex.permute, Mat.OrderingType, Mat.getOrdering, DMPlexGetOrdering


Source code at petsc4py/PETSc/DMPlex.pyx:2130


Return the mesh partitioner.

Not collective.

SEE ALSO:

DM, DMPlex, Partitioner, Section, DMPlex.distribute, DMPlex.setPartitioner, Partitioner.create, PetscPartitionerDMPlexPartition, DMPlexGetPartitioner


Source code at petsc4py/PETSc/DMPlex.pyx:1510

Partitioner


Return the depth of a given point.

Not collective.

point (int) -- The point.
int

SEE ALSO:

DM, DMPlex, DMPlex.getDepthStratum, DMPlex.getDepth, DMPlexGetPointDepth


Source code at petsc4py/PETSc/DMPlex.pyx:998


Return location of point data in global Vec.

Not collective.

point (int) -- The topological point.
  • start (int) -- Start of point data; returns -(globalStart+1) if point is not owned.
  • end (int) -- End of point data; returns -(globalEnd+1) if point is not owned.

tuple[int, int]

SEE ALSO:

DM, DMPlex, DMPlex.getPointGlobalField, Section.getOffset, Section.getDof, DMPlex.getPointLocal, DMPlexGetPointGlobal


Source code at petsc4py/PETSc/DMPlex.pyx:1972


Return location of point field data in global Vec.

Not collective.

  • point (int) -- The topological point.
  • field (int) -- The field number.

  • start (int) -- Start of point data; returns -(globalStart+1) if point is not owned.
  • end (int) -- End of point data; returns -(globalEnd+1) if point is not owned.

tuple[int, int]

SEE ALSO:

DM, DMPlex, DMPlex.getPointGlobal, Section.getOffset, Section.getDof, DMPlex.getPointLocal, DMPlexGetPointGlobalField


Source code at petsc4py/PETSc/DMPlex.pyx:2000


Return the height of a given point.

Not collective.

point (int) -- The point.
int

SEE ALSO:

DM, DMPlex, DMPlex.getHeightStratum, DMPlexGetPointHeight


Source code at petsc4py/PETSc/DMPlex.pyx:1019


Return location of point data in local Vec.

Not collective.

point (int) -- The topological point.
  • start (int) -- Start of point data.
  • end (int) -- End of point data.

tuple[int, int]

SEE ALSO:

DM, DMPlex, DMPlex.getPointLocalField, Section.getOffset, Section.getDof, DMPlexGetPointLocal


Source code at petsc4py/PETSc/DMPlex.pyx:1913


Return location of point field data in local Vec.

Not collective.

  • point (int) -- The topological point.
  • field (int) -- The field number.

  • start (int) -- Start of point data.
  • end (int) -- End of point data.

tuple[int, int]

SEE ALSO:

DM, DMPlex, DMPlex.getPointLocal, Section.getOffset, DMPlexGetPointLocalField


Source code at petsc4py/PETSc/DMPlex.pyx:1941


Retrieve the maximum cell volume for refinement.

Not collective.

SEE ALSO:

DM, DMPlex, DM.refine, DMPlex.setRefinementLimit, DMPlex.getRefinementUniform, DMPlex.setRefinementUniform, DMPlexGetRefinementLimit


Source code at petsc4py/PETSc/DMPlex.pyx:2114

float


Retrieve the flag for uniform refinement.

Not collective.

refinementUniform -- The flag for uniform refinement.
bool

SEE ALSO:

DM, DMPlex, DM.refine, DMPlex.setRefinementUniform, DMPlex.getRefinementLimit, DMPlex.setRefinementLimit, DMPlexGetRefinementUniform


Source code at petsc4py/PETSc/DMPlex.pyx:2073


Return an IS covering the entire subdm chart.

Not collective.

iset -- The IS containing subdm's parent's points.
IS

SEE ALSO:

DM, DMPlex, DMPlexGetSubpointIS


Source code at petsc4py/PETSc/DMPlex.pyx:2278


Return a DMLabel with point dimension as values.

Not collective.

label -- The DMLabel whose values are subdm's point dimensions.
DMLabel

SEE ALSO:

DM, DMPlex, DMPlexGetSubpointMap


Source code at petsc4py/PETSc/DMPlex.pyx:2298


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

Not collective.

p (int) -- The point, which must lie in the chart set with DMPlex.setChart.
ArrayInt

SEE ALSO:

DM, DMPlex, DMPlex.getSupportSize, DMPlex.setSupport, DMPlex.getCone, DMPlex.setChart, DMPlexGetSupport


Source code at petsc4py/PETSc/DMPlex.pyx:771


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

Not collective.

p (int) -- The point, which must lie in the chart set with DMPlex.setChart.
int

SEE ALSO:

DM, DMPlex, DMPlex.create, DMPlex.setConeSize, DMPlex.setChart, DMPlex.getConeSize, DMPlexGetSupportSize


Source code at petsc4py/PETSc/DMPlex.pyx:722


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

Not collective.

  • p (int) -- The mesh point.
  • useCone (bool | None) -- True for the closure, otherwise return the star.

  • points (ArrayInt) -- The points.
  • orientations (ArrayInt) -- The orientations.

tuple[ArrayInt, ArrayInt]

SEE ALSO:

DM, DMPlex, DMPlex.create, DMPlex.setCone, DMPlex.setChart, DMPlex.getCone, DMPlexGetTransitiveClosure


Source code at petsc4py/PETSc/DMPlex.pyx:1118


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

Not collective.

  • sec (Section) -- The Section describing the layout in vec or None to use the default section.
  • vec (Vec) -- The local vector.
  • point (int) -- The point in the DMPlex.

ArrayScalar

SEE ALSO:

DM, DMPlex, DMPlexVecRestoreClosure


Source code at petsc4py/PETSc/DMPlex.pyx:1185


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

Collective the first time it is called.

SEE ALSO:

DM, DMPlex, DMPlex.getCellNumbering, DMPlexGetVertexNumbering


Source code at petsc4py/PETSc/DMPlex.pyx:900



Load on-disk vector data into a global vector.

Collective.

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

None

SEE ALSO:

DM, DMPlex, DMPlex.topologyLoad, DMPlex.sectionLoad, DMPlex.localVectorLoad, DMPlex.globalVectorView, DMPlex.localVectorView, SF, Viewer, DMPlexGlobalVectorLoad


Source code at petsc4py/PETSc/DMPlex.pyx:3401


Save a global vector.

Collective.

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

None

SEE ALSO:

DM, DMPlex, DMPlex.topologyView, DMPlex.sectionView, DMPlex.localVectorView, DMPlex.globalVectorLoad, DMPlex.localVectorLoad, DMPlexGlobalVectorView


Source code at petsc4py/PETSc/DMPlex.pyx:3248


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

Not collective.

  • p (int) -- The point, which must lie in the chart set with DMPlex.setChart.
  • conePos (int) -- The local index in the cone where the point should be put.
  • conePoint (int) -- The mesh point to insert.

None

SEE ALSO:

DM, DMPlex, DMPlex.create, DMPlex.getCone, DMPlex.setChart, DMPlex.setConeSize, DM.setUp, DMPlexInsertCone


Source code at petsc4py/PETSc/DMPlex.pyx:556


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

Not collective.

  • p (int) -- The point, which must lie in the chart set with DMPlex.setChart
  • conePos (int) -- The local index in the cone where the point should be put.
  • coneOrientation (int) -- The point orientation to insert.

None

SEE ALSO:

DM, DMPlex, DMPlex.create, DMPlex.getCone, DMPlex.setChart, DMPlex.setConeSize, DM.setUp, DMPlexInsertConeOrientation


Source code at petsc4py/PETSc/DMPlex.pyx:581


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

Collective.

SEE ALSO:

DMPlex, DMPlex.uninterpolate, DMPlex.createFromCellList, DMPlexInterpolate


Source code at petsc4py/PETSc/DMPlex.pyx:1728



Return the flag indicating if the mesh is distributed.

Collective.

SEE ALSO:

DM, DMPlex, DMPlex.distribute, DMPlexIsDistributed


Source code at petsc4py/PETSc/DMPlex.pyx:1618



Return the flag indicating if the first cell is a simplex.

Not collective.

SEE ALSO:

DM, DMPlex, DMPlex.getCellType, DMPlex.getHeightStratum, DMPlexIsSimplex


Source code at petsc4py/PETSc/DMPlex.pyx:1632



Add all other mesh pieces to complete the surface.

Not collective.

  • label (DMLabel) -- A DMLabel marking the surface.
  • bdlabel (DMLabel) -- A DMLabel marking the vertices on the boundary which will not be duplicated.
  • bdvalue (int) -- Value of DMLabel marking the vertices on the boundary.
  • flip (bool) -- Flag to flip the submesh normal and replace points on the other side.
  • split (bool) -- Flag to split faces incident on the surface boundary, rather than clamping those faces to the boundary
  • subdm (DMPlex) -- The DMPlex associated with the label.

None

SEE ALSO:

DM, DMPlex, DMPlex.labelComplete, DMPlexLabelCohesiveComplete


Source code at petsc4py/PETSc/DMPlex.pyx:1396


Add the transitive closure to the surface.

Not collective.

label (DMLabel) -- A DMLabel marking the surface points.
None

SEE ALSO:

DM, DMPlex, DMPlex.labelCohesiveComplete, DMPlexLabelComplete


Source code at petsc4py/PETSc/DMPlex.pyx:1379


Load labels into this DMPlex object.

Collective.

  • viewer (Viewer) -- The Viewer for the saved labels.
  • sfxc (SF) -- The SF returned by topologyLoad.

None

SEE ALSO:

DM, DMPlex, DM.load, DMPlex.topologyLoad, DMPlex.coordinatesLoad, DM.view, SF, Viewer, DMPlexLabelsLoad


Source code at petsc4py/PETSc/DMPlex.pyx:3344


Save DMPlex labels into a file.

Collective.

viewer (Viewer) -- The Viewer for saving.
None

SEE ALSO:

DM, DMPlex, DM.view, DMPlex.topologyView, DMPlex.coordinatesView, DMPlex.labelsLoad, Viewer, DMPlexLabelsView


Source code at petsc4py/PETSc/DMPlex.pyx:3209


Load on-disk vector data into a local vector.

Collective.

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

None

SEE ALSO:

DM, DMPlex, DMPlex.topologyLoad, DMPlex.sectionLoad, DMPlex.globalVectorLoad, DMPlex.globalVectorView, DMPlex.localVectorView, SF, Viewer, DMPlexLocalVectorLoad


Source code at petsc4py/PETSc/DMPlex.pyx:3426


Save a local vector.

Collective.

  • viewer (Viewer) -- The Viewer to save data with.
  • sectiondm (DM) -- The DM that contains the local section on which vec is defined; may be the same as this DMPlex object.
  • vec (Vec) -- The local vector to be saved.

None

SEE ALSO:

DM, DMPlex, DMPlex.topologyView, DMPlex.sectionView, DMPlex.globalVectorView, DMPlex.globalVectorLoad, DMPlex.localVectorLoad, DMPlexLocalVectorView


Source code at petsc4py/PETSc/DMPlex.pyx:3272


Mark all faces on the boundary.

Not collective.

  • value (int | None) -- The marker value, or DETERMINE or None to use some value in the closure (or 1 if none are found).
  • label (str)

DMLabel

SEE ALSO:

DM, DMPlex, DMLabel.create, DM.createLabel, DMPlexMarkBoundaryFaces


Source code at petsc4py/PETSc/DMPlex.pyx:1352


Compute and return the unweighted average of two metrics.

Collective.

  • metric1 (Vec) -- The first metric to be averaged.
  • metric2 (Vec) -- The second metric to be averaged.
  • metricAvg (Vec) -- The output averaged metric.

Vec

SEE ALSO:

DMPlex.metricAverage3, DMPlexMetricAverage2


Source code at petsc4py/PETSc/DMPlex.pyx:3059


Compute and return the unweighted average of three metrics.

Collective.

  • metric1 (Vec) -- The first metric to be averaged.
  • metric2 (Vec) -- The second metric to be averaged.
  • metric3 (Vec) -- The third metric to be averaged.
  • metricAvg (Vec) -- The output averaged metric.

Vec

SEE ALSO:

DMPlex.metricAverage2, DMPlexMetricAverage3


Source code at petsc4py/PETSc/DMPlex.pyx:3081


Create a Riemannian metric field.

Collective.

field (int | None) -- The field number to use.
Vec

SEE ALSO:

DMPlex.metricCreateUniform, DMPlex.metricCreateIsotropic, Working with PETSc options, DMPlexMetricCreate


Source code at petsc4py/PETSc/DMPlex.pyx:2890


Construct an isotropic metric from an error indicator.

Collective.

  • indicator (Vec) -- The error indicator.
  • field (int | None) -- The field number to use.

Vec

SEE ALSO:

DMPlex.metricCreate, DMPlex.metricCreateUniform, DMPlexMetricCreateIsotropic


Source code at petsc4py/PETSc/DMPlex.pyx:2935


Construct a uniform isotropic metric.

Collective.

  • alpha (float) -- Scaling parameter for the diagonal.
  • field (int | None) -- The field number to use.

Vec

SEE ALSO:

DMPlex.metricCreate, DMPlex.metricCreateIsotropic, DMPlexMetricCreateUniform


Source code at petsc4py/PETSc/DMPlex.pyx:2911


Create the determinant field for a Riemannian metric.

Collective.

field (int | None) -- The field number to use.
  • determinant (Vec) -- The determinant field.
  • dmDet (DM) -- The corresponding DM

tuple[Vec, DM]

SEE ALSO:

DMPlex.metricCreateUniform, DMPlex.metricCreateIsotropic, DMPlex.metricCreate, DMPlexMetricDeterminantCreate


Source code at petsc4py/PETSc/DMPlex.pyx:2958


Enforce symmetric positive-definiteness of a metric.

Collective.

  • metric (Vec) -- The metric.
  • ometric (Vec) -- The output metric.
  • determinant (Vec) -- The output determinant.
  • restrictSizes (bool | None) -- Flag indicating whether maximum/minimum magnitudes should be enforced.
  • restrictAnisotropy (bool | None) -- Flag indicating whether maximum anisotropy should be enforced.

  • ometric (Vec) -- The output metric.
  • determinant (Vec) -- The output determinant.

tuple[Vec, Vec]

SEE ALSO:

DMPlex.metricNormalize, DMPlex.metricIntersection2, DMPlex.metricIntersection3, Working with PETSc options, DMPlexMetricEnforceSPD


Source code at petsc4py/PETSc/DMPlex.pyx:2987


Return the metric gradation factor.

Not collective.

SEE ALSO:

DMPlex.metricSetGradationFactor, DMPlex.metricGetHausdorffNumber, DMPlexMetricGetGradationFactor


Source code at petsc4py/PETSc/DMPlex.pyx:2841

float


Return the metric Hausdorff number.

Not collective.

SEE ALSO:

DMPlex.metricGetGradationFactor, DMPlex.metricSetHausdorffNumber, DMPlexMetricGetHausdorffNumber


Source code at petsc4py/PETSc/DMPlex.pyx:2875

float


Return the maximum tolerated metric anisotropy.

Not collective.

SEE ALSO:

DMPlex.metricSetMaximumAnisotropy, DMPlex.metricGetMaximumMagnitude, DMPlexMetricGetMaximumAnisotropy


Source code at petsc4py/PETSc/DMPlex.pyx:2739

float


Return the maximum tolerated metric magnitude.

Not collective.

SEE ALSO:

DMPlex.metricSetMaximumMagnitude, DMPlex.metricGetMinimumMagnitude, DMPlexMetricGetMaximumMagnitude


Source code at petsc4py/PETSc/DMPlex.pyx:2705

float


Return the minimum tolerated metric magnitude.

Not collective.

SEE ALSO:

DMPlex.metricSetMinimumMagnitude, DMPlex.metricGetMaximumMagnitude, DMPlexMetricGetMinimumMagnitude


Source code at petsc4py/PETSc/DMPlex.pyx:2671

float


Return the order p for L-p normalization.

Not collective.

SEE ALSO:

DMPlex.metricSetNormalizationOrder, DMPlex.metricGetTargetComplexity, DMPlexMetricGetNormalizationOrder


Source code at petsc4py/PETSc/DMPlex.pyx:2807

float


Return the number of parallel adaptation iterations.

Not collective.

SEE ALSO:

DMPlex.metricSetNumIterations, DMPlex.metricGetVerbosity, DMPlexMetricGetNumIterations


Source code at petsc4py/PETSc/DMPlex.pyx:2637



Return the target metric complexity.

Not collective.

SEE ALSO:

DMPlex.metricSetTargetComplexity, DMPlex.metricGetNormalizationOrder, DMPlexMetricGetTargetComplexity


Source code at petsc4py/PETSc/DMPlex.pyx:2773

float


Return the verbosity of the mesh adaptation package.

Not collective.

verbosity -- The verbosity, where -1 is silent and 10 is maximum.
int

SEE ALSO:

DMPlex.metricSetVerbosity, DMPlex.metricGetNumIterations, DMPlexMetricGetVerbosity


Source code at petsc4py/PETSc/DMPlex.pyx:2598


Compute and return the intersection of two metrics.

Collective.

  • metric1 (Vec) -- The first metric to be intersected.
  • metric2 (Vec) -- The second metric to be intersected.
  • metricInt (Vec) -- The output intersected metric.

Vec

SEE ALSO:

DMPlex.metricIntersection3, DMPlexMetricIntersection2


Source code at petsc4py/PETSc/DMPlex.pyx:3105


Compute the intersection of three metrics.

Collective.

  • metric1 (Vec) -- The first metric to be intersected.
  • metric2 (Vec) -- The second metric to be intersected.
  • metric3 (Vec) -- The third metric to be intersected.
  • metricInt (Vec) -- The output intersected metric.

Vec

SEE ALSO:

DMPlex.metricIntersection2, DMPlexMetricIntersection3


Source code at petsc4py/PETSc/DMPlex.pyx:3127


Return the flag indicating whether the metric is isotropic or not.

Not collective.

SEE ALSO:

DMPlex.metricSetIsotropic, DMPlex.metricIsUniform, DMPlex.metricRestrictAnisotropyFirst, DMPlexMetricIsIsotropic


Source code at petsc4py/PETSc/DMPlex.pyx:2386



Return the flag indicating whether the metric is uniform or not.

Not collective.

SEE ALSO:

DMPlex.metricSetUniform, DMPlex.metricRestrictAnisotropyFirst, DMPlexMetricIsUniform


Source code at petsc4py/PETSc/DMPlex.pyx:2352



Return the flag indicating whether node insertion and deletion are turned off.

Not collective.

SEE ALSO:

DMPlex.metricSetNoInsertion, DMPlex.metricNoSwapping, DMPlex.metricNoMovement, DMPlex.metricNoSurf, DMPlexMetricNoInsertion


Source code at petsc4py/PETSc/DMPlex.pyx:2455



Return the flag indicating whether node movement is turned off.

Not collective.

SEE ALSO:

DMPlex.metricSetNoMovement, DMPlex.metricNoInsertion, DMPlex.metricNoSwapping, DMPlex.metricNoSurf, DMPlexMetricNoMovement


Source code at petsc4py/PETSc/DMPlex.pyx:2527



Return the flag indicating whether surface modification is turned off.

Not collective.

SEE ALSO:

DMPlex.metricSetNoSurf, DMPlex.metricNoMovement, DMPlex.metricNoInsertion, DMPlex.metricNoSwapping, DMPlexMetricNoSurf


Source code at petsc4py/PETSc/DMPlex.pyx:2563



Return the flag indicating whether facet swapping is turned off.

Not collective.

SEE ALSO:

DMPlex.metricSetNoSwapping, DMPlex.metricNoInsertion, DMPlex.metricNoMovement, DMPlex.metricNoSurf, DMPlexMetricNoSwapping


Source code at petsc4py/PETSc/DMPlex.pyx:2491



Apply L-p normalization to a metric.

Collective.

  • metric (Vec) -- The metric.
  • ometric (Vec) -- The output metric.
  • determinant (Vec) -- The output determinant.
  • restrictSizes (bool | None) -- Flag indicating whether maximum/minimum magnitudes should be enforced.
  • restrictAnisotropy (bool | None) -- Flag indicating whether maximum anisotropy should be enforced.

  • ometric (Vec) -- The output normalized metric.
  • determinant (Vec) -- The output determinant.

tuple[Vec, Vec]

SEE ALSO:

DMPlex.metricEnforceSPD, DMPlex.metricIntersection2, DMPlex.metricIntersection3, Working with PETSc options, DMPlexMetricNormalize


Source code at petsc4py/PETSc/DMPlex.pyx:3023


Return true if anisotropy is restricted before normalization.

Not collective.

SEE ALSO:

DMPlex.metricIsIsotropic, DMPlex.metricSetRestrictAnisotropyFirst, DMPlexMetricRestrictAnisotropyFirst


Source code at petsc4py/PETSc/DMPlex.pyx:2420



Configure the object from the options database.

Collective.

SEE ALSO:

Working with PETSc options


Source code at petsc4py/PETSc/DMPlex.pyx:2320



Set the metric gradation factor.

Logically collective.

beta (float) -- The metric gradation factor.
None

SEE ALSO:

DMPlex.metricGetGradationFactor, DMPlex.metricSetHausdorffNumber, DMPlexMetricSetGradationFactor


Source code at petsc4py/PETSc/DMPlex.pyx:2822


Set the metric Hausdorff number.

Logically collective.

hausd (float) -- The metric Hausdorff number.
None

SEE ALSO:

DMPlex.metricSetGradationFactor, DMPlex.metricGetHausdorffNumber, DMPlexMetricSetHausdorffNumber


Source code at petsc4py/PETSc/DMPlex.pyx:2856


Record whether the metric is isotropic or not.

Logically collective.

isotropic (bool) -- Flag indicating whether the metric is isotropic or not.
None

SEE ALSO:

DMPlex.metricIsIsotropic, DMPlex.metricSetUniform, DMPlex.metricSetRestrictAnisotropyFirst, DMPlexMetricSetIsotropic


Source code at petsc4py/PETSc/DMPlex.pyx:2367


Set the maximum tolerated metric anisotropy.

Logically collective.

a_max (float) -- The maximum tolerated metric anisotropy.
None

SEE ALSO:

DMPlex.metricGetMaximumAnisotropy, DMPlex.metricSetMaximumMagnitude, DMPlexMetricSetMaximumAnisotropy


Source code at petsc4py/PETSc/DMPlex.pyx:2720


Set the maximum tolerated metric magnitude.

Logically collective.

h_max (float) -- The maximum tolerated metric magnitude.
None

SEE ALSO:

DMPlex.metricGetMaximumMagnitude, DMPlex.metricSetMinimumMagnitude, DMPlexMetricSetMaximumMagnitude


Source code at petsc4py/PETSc/DMPlex.pyx:2686


Set the minimum tolerated metric magnitude.

Logically collective.

h_min (float) -- The minimum tolerated metric magnitude.
None

SEE ALSO:

DMPlex.metricGetMinimumMagnitude, DMPlex.metricSetMaximumMagnitude, DMPlexMetricSetMinimumMagnitude


Source code at petsc4py/PETSc/DMPlex.pyx:2652


Set the flag indicating whether node insertion should be turned off.

Logically collective.

noInsert (bool) -- Flag indicating whether node insertion and deletion should be turned off.
None

SEE ALSO:

DMPlex.metricNoInsertion, DMPlex.metricSetNoSwapping, DMPlex.metricSetNoMovement, DMPlex.metricSetNoSurf, DMPlexMetricSetNoInsertion


Source code at petsc4py/PETSc/DMPlex.pyx:2435


Set the flag indicating whether node movement should be turned off.

Logically collective.

noMove (bool) -- Flag indicating whether node movement should be turned off.
None

SEE ALSO:

DMPlex.metricNoMovement, DMPlex.metricSetNoInsertion, DMPlex.metricSetNoSwapping, DMPlex.metricSetNoSurf, DMPlexMetricSetNoMovement


Source code at petsc4py/PETSc/DMPlex.pyx:2507


Set the flag indicating whether surface modification should be turned off.

Logically collective.

noSurf (bool) -- Flag indicating whether surface modification should be turned off.
None

SEE ALSO:

DMPlex.metricNoSurf, DMPlex.metricSetNoMovement, DMPlex.metricSetNoInsertion, DMPlex.metricSetNoSwapping, DMPlexMetricSetNoSurf


Source code at petsc4py/PETSc/DMPlex.pyx:2543


Set the flag indicating whether facet swapping should be turned off.

Logically collective.

noSwap (bool) -- Flag indicating whether facet swapping should be turned off.
None

SEE ALSO:

DMPlex.metricNoSwapping, DMPlex.metricSetNoInsertion, DMPlex.metricSetNoMovement, DMPlex.metricSetNoSurf, DMPlexMetricSetNoSwapping


Source code at petsc4py/PETSc/DMPlex.pyx:2471


Set the order p for L-p normalization.

Logically collective.

p (float) -- The normalization order.
None

SEE ALSO:

DMPlex.metricGetNormalizationOrder, DMPlex.metricSetTargetComplexity, DMPlexMetricSetNormalizationOrder


Source code at petsc4py/PETSc/DMPlex.pyx:2788


Set the number of parallel adaptation iterations.

Logically collective.

numIter (int) -- The number of parallel adaptation iterations.
None

SEE ALSO:

DMPlex.metricSetVerbosity, DMPlex.metricGetNumIterations, DMPlexMetricSetNumIterations


Source code at petsc4py/PETSc/DMPlex.pyx:2618


Record whether anisotropy is be restricted before normalization or after.

Logically collective.

restrictAnisotropyFirst (bool) -- Flag indicating if anisotropy is restricted before normalization or after.
None

SEE ALSO:

DMPlex.metricSetIsotropic, DMPlex.metricRestrictAnisotropyFirst, DMPlexMetricSetRestrictAnisotropyFirst


Source code at petsc4py/PETSc/DMPlex.pyx:2401


Set the target metric complexity.

Logically collective.

targetComplexity (float) -- The target metric complexity.
None

SEE ALSO:

DMPlex.metricGetTargetComplexity, DMPlex.metricSetNormalizationOrder, DMPlexMetricSetTargetComplexity


Source code at petsc4py/PETSc/DMPlex.pyx:2754


Record whether the metric is uniform or not.

Logically collective.

uniform (bool) -- Flag indicating whether the metric is uniform or not.
None

SEE ALSO:

DMPlex.metricIsUniform, DMPlex.metricSetIsotropic, DMPlex.metricSetRestrictAnisotropyFirst, DMPlexMetricSetUniform


Source code at petsc4py/PETSc/DMPlex.pyx:2333


Set the verbosity of the mesh adaptation package.

Logically collective.

verbosity (int) -- The verbosity, where -1 is silent and 10 is maximum.
None

SEE ALSO:

DMPlex.metricGetVerbosity, DMPlex.metricSetNumIterations, DMPlexMetricSetVerbosity


Source code at petsc4py/PETSc/DMPlex.pyx:2579


Give a consistent orientation to the input mesh.

Collective.

SEE ALSO:

DM, DMPlex, DM.create, DMPlexOrient


Source code at petsc4py/PETSc/DMPlex.pyx:873



Reorder the mesh according to the input permutation.

Collective.

perm (IS) -- The point permutation, perm[old point number] = new point number.
pdm -- The permuted DMPlex.
DMPlex

SEE ALSO:

DMPlex, Mat.permute, DMPlexPermute


Source code at petsc4py/PETSc/DMPlex.pyx:2158


Redistribute shared points in order to achieve better balancing.

Collective.

  • entityDepth (int | None) -- Depth of the entity to balance (e.g., 0 -> balance vertices).
  • useInitialGuess (bool | None) -- Whether to use the current distribution as initial guess.
  • parallel (bool | None) -- Whether to use ParMETIS and do the partition in parallel or gather the graph onto a single process.

success -- Whether the graph partitioning was successful or not. Unsuccessful simply means no change to the partitioning.
bool

SEE ALSO:

DM, DMPlex, DMPlex.distribute, Working with PETSc options, DMPlexRebalanceSharedPoints


Source code at petsc4py/PETSc/DMPlex.pyx:1527


Return flag indicating whether the DMPlex should be reordered by default.

Not collective.

SEE ALSO:

None, DMPlexReorderGetDefault


Source code at petsc4py/PETSc/DMPlex.pyx:2182

ReorderDefaultFlag


Set flag indicating whether the DM should be reordered by default.

Logically collective.

  • reorder -- Flag for reordering.
  • flag (ReorderDefaultFlag)

None

SEE ALSO:

DMPlex.reorderGetDefault, DMPlexReorderSetDefault


Source code at petsc4py/PETSc/DMPlex.pyx:2196


Load section into a DM.

Collective.

  • viewer (Viewer) -- The Viewer that represents the on-disk section (sectionA).
  • sectiondm (DM) -- The DM into which the on-disk section (sectionA) is migrated.
  • sfxc (SF) -- The SF returned by topologyLoad.

  • gsf (SF) -- The SF that migrates any on-disk Vec data associated with sectionA into a global Vec associated with the sectiondm's global section (None if not needed).
  • lsf (SF) -- The SF that migrates any on-disk Vec data associated with sectionA into a local Vec associated with the sectiondm's local section (None if not needed).

tuple[SF, SF]

SEE ALSO:

DM, DMPlex, DM.load, DMPlex.topologyLoad, DMPlex.coordinatesLoad, DMPlex.labelsLoad, DMPlex.globalVectorLoad, DMPlex.localVectorLoad, DMPlex.sectionView, SF, Viewer, DMPlexSectionLoad


Source code at petsc4py/PETSc/DMPlex.pyx:3364


Save a section associated with a DMPlex.

Collective.

  • viewer (Viewer) -- The Viewer for saving.
  • sectiondm (DM) -- The DM that contains the section to be saved.

None

SEE ALSO:

DM, DMPlex, DM.view, DMPlex.topologyView, DMPlex.coordinatesView, DMPlex.labelsView, DMPlex.globalVectorView, DMPlex.localVectorView, DMPlex.sectionLoad, Viewer, DMPlexSectionView


Source code at petsc4py/PETSc/DMPlex.pyx:3227


Define adjacency in the mesh using the point-to-point constraints.

Logically collective.

useAnchors (bool) -- Flag to use the constraints. If True, then constrained points are omitted from DMPlex.getAdjacency, and their anchor points appear in their place.
None

SEE ALSO:

DMPlex, DMPlex.getAdjacency, DMPlex.distribute, DMPlexSetAdjacencyUseAnchors


Source code at petsc4py/PETSc/DMPlex.pyx:1431


Set the polytope type of a given cell.

Not collective.

  • p (int) -- The cell.
  • ctype (PolytopeType) -- The polytope type of the cell.

None

SEE ALSO:

DM, DMPlex, DMPlex.getCellTypeLabel, DMPlex.getDepth, DM.createLabel, DMPlexSetCellType


Source code at petsc4py/PETSc/DMPlex.pyx:663


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

Not collective.

  • pStart (int) -- The first mesh point.
  • pEnd (int) -- The upper bound for mesh points.

None

SEE ALSO:

DM, DMPlex, DMPlex.create, DMPlex.getChart, DMPlexSetChart


Source code at petsc4py/PETSc/DMPlex.pyx:421


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

Not collective.

  • p (int) -- The point, which must lie in the chart set with DMPlex.setChart.
  • cone (Sequence[int]) -- An array of points which are on the in-edges for point p.
  • orientation (Sequence[int] | None) -- An array of orientations, defaults to None.

None

SEE ALSO:

DM, DMPlex, DMPlex.create, DMPlex.getCone, DMPlex.setChart, DMPlex.setConeSize, DM.setUp, DMPlex.setSupport, DMPlex.setSupportSize, DMPlexSetCone


Source code at petsc4py/PETSc/DMPlex.pyx:517


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

Not collective.

  • p (int) -- The point, which must lie in the chart set with DMPlex.setChart.
  • orientation (Sequence[int]) -- An array of orientations.

None

SEE ALSO:

DM, DMPlex, DMPlex.create, DMPlex.getConeOrientation, DMPlex.setCone, DMPlex.setChart, DMPlex.setConeSize, DM.setUp, DMPlexSetConeOrientation


Source code at petsc4py/PETSc/DMPlex.pyx:632


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

Not collective.

  • p (int) -- The point, which must lie in the chart set with DMPlex.setChart.
  • size (int) -- The cone size for point p.

None

SEE ALSO:

DM, DMPlex, DMPlex.create, DMPlex.getConeSize, DMPlex.setChart, DMPlexSetConeSize


Source code at petsc4py/PETSc/DMPlex.pyx:466


Set an array of the values on the closure of point.

Not collective.

  • sec (Section) -- The section describing the layout in mat, or None to use the default section.
  • gsec (Section) -- The section describing the layout in mat, or None to use the default global section.
  • mat (Mat) -- The matrix.
  • point (int) -- The point in the DMPlex.
  • values (Sequence[Scalar]) -- The array of values.
  • mode -- The insertion mode.
  • addv (InsertModeSpec | None)

None

SEE ALSO:

DM, DMPlex, DMPlexMatSetClosure


Source code at petsc4py/PETSc/DMPlex.pyx:1247


Set the mesh partitioner.

Logically collective.

part (Partitioner) -- The partitioner.
None

SEE ALSO:

DM, DMPlex, Partitioner, DMPlex.distribute, DMPlex.getPartitioner, Partitioner.create, DMPlexSetPartitioner


Source code at petsc4py/PETSc/DMPlex.pyx:1492


Set the maximum cell volume for refinement.

Logically collective.

refinementLimit (float) -- The maximum cell volume in the refined mesh.
None

SEE ALSO:

DM, DMPlex, DM.refine, DMPlex.getRefinementLimit, DMPlex.getRefinementUniform, DMPlex.setRefinementUniform, DMPlexSetRefinementLimit


Source code at petsc4py/PETSc/DMPlex.pyx:2094


Set the flag for uniform refinement.

Logically collective.

refinementUniform (bool | None) -- The flag for uniform refinement.
None

SEE ALSO:

DM, DMPlex, DM.refine, DMPlex.getRefinementUniform, DMPlex.getRefinementLimit, DMPlex.setRefinementLimit, DMPlexSetRefinementUniform


Source code at petsc4py/PETSc/DMPlex.pyx:2053


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

Not collective.

  • p (int) -- The point, which must lie in the chart set with DMPlex.setChart.
  • supp (Sequence[int]) -- An array of points which are on the out-edges for point p.

None

SEE ALSO:

DM, DMPlex, DMPlex.setCone, DMPlex.setConeSize, DMPlex.create, DMPlex.getSupport, DMPlex.setChart, DMPlex.setSupportSize, DM.setUp, DMPlexSetSupport


Source code at petsc4py/PETSc/DMPlex.pyx:797


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

Not collective.

  • p (int) -- The point, which must lie in the chart set with DMPlex.setChart.
  • size (int) -- The support size for point p.

None

SEE ALSO:

DM, DMPlex, DMPlex.create, DMPlex.getSupportSize, DMPlex.setChart, DMPlexSetSupportSize


Source code at petsc4py/PETSc/DMPlex.pyx:746


Set the options used for the Tetgen mesh generator.

Not collective.

opts (str) -- The command line options.
None

SEE ALSO:

Working with PETSc options, DM, DMPlex, DMPlex.setTriangleOptions, DMPlex.generate, DMPlexTetgenSetOptions


Source code at petsc4py/PETSc/DMPlex.pyx:1332


Set the options used for the Triangle mesh generator.

Not collective.

opts (str) -- The command line options.
None

SEE ALSO:

Working with PETSc options, DM, DMPlex, DMPlex.setTetGenOptions, DMPlex.generate, DMPlexTriangleSetOptions


Source code at petsc4py/PETSc/DMPlex.pyx:1312


Set an array of the values on the closure of point.

Not collective.

  • sec (Section) -- The section describing the layout in vec, or None to use the default section.
  • vec (Vec) -- The local vector.
  • point (int) -- The point in the DMPlex.
  • values (Sequence[Scalar]) -- The array of values.
  • mode -- The insertion mode.
  • addv (InsertModeSpec | None)

None

SEE ALSO:

DM, DMPlex, DMPlexVecSetClosure


Source code at petsc4py/PETSc/DMPlex.pyx:1215


Calculate the strata of DAG.

Collective.

SEE ALSO:

DM, DMPlex, DMPlex.create, DMPlex.symmetrize, DMPlexStratify


Source code at petsc4py/PETSc/DMPlex.pyx:861



Create support (out-edge) information from cone (in-edge) information.

Not collective.

SEE ALSO:

DM, DMPlex, DMPlex.create, DMPlex.setChart, DMPlex.setConeSize, DMPlex.setCone, DMPlexSymmetrize


Source code at petsc4py/PETSc/DMPlex.pyx:848



Load a topology into this DMPlex object.

Collective.

viewer (Viewer) -- The Viewer for the saved topology
sfxc -- The SF that pushes points in [0, N) to the associated points in the loaded DMPlex, where N is the global number of points.
SF

SEE ALSO:

DM, DMPlex, DM.load, DMPlex.coordinatesLoad, DMPlex.labelsLoad, DM.view, SF, Viewer, DMPlexTopologyLoad


Source code at petsc4py/PETSc/DMPlex.pyx:3298


Save a DMPlex topology into a file.

Collective.

viewer (Viewer) -- The Viewer for saving.
None

SEE ALSO:

DM, DMPlex, DM.view, DMPlex.coordinatesView, DMPlex.labelsView, DMPlex.topologyLoad, Viewer, DMPlexTopologyView


Source code at petsc4py/PETSc/DMPlex.pyx:3173


Convert to a mesh with only cells and vertices.

Collective.

SEE ALSO:

DMPlex, DMPlex.interpolate, DMPlex.createFromCellList, DMPlexUninterpolate


Source code at petsc4py/PETSc/DMPlex.pyx:1743



Return an array of values on the closure of p.

Not collective.

  • sec (Section) -- The section describing the layout in vec.
  • vec (Vec) -- The local vector.
  • p (int) -- The point in the DMPlex.

ArrayScalar

SEE ALSO:

DM, DMPlex, DMPlexVecRestoreClosure


Source code at petsc4py/PETSc/DMPlex.pyx:1157



petsc4py.PETSc.DMPlexTransform

Bases: 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 for the transformation.
setFromOptions() Configure the transformation from the options database.
setType(tr_type) Set the transformation type.
setUp() Setup a mesh transformation.
view([viewer]) View the mesh transformation.

Methods Documentation

Apply a mesh transformation.

Collective.

Source code at petsc4py/PETSc/DMPlex.pyx:3475

dm (DM)
DM


Create a mesh transformation.

Collective.

SEE ALSO:

DMPlexTransformCreate


Source code at petsc4py/PETSc/DMPlex.pyx:3486

comm (Comm | None)
Self


Destroy a mesh transformation.

Collective.

SEE ALSO:

DMPlexTransformDestroy


Source code at petsc4py/PETSc/DMPlex.pyx:3503



Return the transformation type name.

Not collective.

SEE ALSO:

DMPlexTransformGetType


Source code at petsc4py/PETSc/DMPlex.pyx:3516



Set the DM for the transformation.

Logically collective.

Source code at petsc4py/PETSc/DMPlex.pyx:3554

dm (DM)
None


Configure the transformation from the options database.

Collective.

SEE ALSO:

Working with PETSc options, DMPlexTransformSetFromOptions


Source code at petsc4py/PETSc/DMPlex.pyx:3563



Set the transformation type.

Collective.

SEE ALSO:

DMPlexTransformSetType


Source code at petsc4py/PETSc/DMPlex.pyx:3540

tr_type (DMPlexTransformType | str)
None


Setup a mesh transformation.

Collective.

Source code at petsc4py/PETSc/DMPlex.pyx:3530



View the mesh transformation.

Collective.

viewer (Viewer | None) -- A Viewer instance or None for the default viewer.
None

SEE ALSO:

Viewer, DMPlexTransformView


Source code at petsc4py/PETSc/DMPlex.pyx:3575



petsc4py.PETSc.DMPlexTransformType

Bases: object

Transformation types.

Attributes Summary

EXTRUDE Object EXTRUDE of type str
REFINE1D Object REFINE1D of type str
REFINEALFELD Object REFINEALFELD of type str
REFINEBOUNDARYLAYER Object REFINEBOUNDARYLAYER of type str
REFINEPOWELLSABIN Object REFINEPOWELLSABIN of type str
REFINEREGULAR Object REFINEREGULAR of type str
REFINESBR Object REFINESBR of type str
REFINETOBOX Object REFINETOBOX of type str
REFINETOSIMPLEX Object REFINETOSIMPLEX of type str
TRANSFORMFILTER Object TRANSFORMFILTER of type str

Attributes Documentation

Object EXTRUDE of type str

Object REFINE1D of type str

Object REFINEALFELD of type str

Object REFINEBOUNDARYLAYER of type str

Object REFINEPOWELLSABIN of type str

Object REFINEREGULAR of type str

Object REFINESBR of type str

Object REFINETOBOX of type str

Object REFINETOSIMPLEX of type str

Object TRANSFORMFILTER of type str


petsc4py.PETSc.DMShell

Bases: 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 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 context for local to global communication.
setLocalToLocal(begin, end[, begin_args, ...]) Set the routines used to perform a local to local scatter.
setLocalToLocalVecScatter(ltol) Set a Scatter context for local to local communication.
setLocalVector(lv) Set a template local vector.
setMatrix(mat) Set a template matrix.
setRefine(refine[, args, kargs]) Set the routine used to refine the DMShell.

Methods Documentation

Creates a shell DM object.

Collective.

comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.
Self

SEE ALSO:

DMShellCreate


Source code at petsc4py/PETSc/DMShell.pyx:4


Set the routine used to coarsen the DMShell.

Logically collective.

  • coarsen (Callable[[DM, Comm], DM] | None) -- The routine which coarsens the DM.
  • args (tuple[Any, ...] | None) -- Additional positional arguments for coarsen.
  • kargs (dict[str, Any] | None) -- Additional keyword arguments for coarsen.

None

SEE ALSO:

setRefine, DMShellSetCoarsen


Source code at petsc4py/PETSc/DMShell.pyx:368


Set the routine used to create a domain decomposition.

Logically collective.

  • decomp (Callable[[DM], tuple[list[str] | None, list[IS] | None, list[IS] | None, list[DM] | None]] | None) -- The routine to create the decomposition.
  • args (tuple[Any, ...] | None) -- Additional positional arguments for decomp.
  • kargs (dict[str, Any] | None) -- Additional keyword arguments for decomp.

None

SEE ALSO:

DMShellSetCreateDomainDecomposition


Source code at petsc4py/PETSc/DMShell.pyx:560


Set the routine used to create the scatter contexts for domain decomposition.

Logically collective.

  • scatter (Callable[[DM, list[DM]], tuple[list[Scatter], list[Scatter], list[Scatter]]] | None) -- The routine to create the scatters.
  • args (tuple[Any, ...] | None) -- Additional positional arguments for scatter.
  • kargs (dict[str, Any] | None) -- Additional keyword arguments for scatter.

None

SEE ALSO:

DMShellSetCreateDomainDecompositionScatters


Source code at petsc4py/PETSc/DMShell.pyx:592


Set the routine used to create a field decomposition.

Logically collective.

  • decomp (Callable[[DM], tuple[list[str] | None, list[IS] | None, list[DM] | None]] | None) -- The routine to create the decomposition.
  • args (tuple[Any, ...] | None) -- Additional positional arguments for decomp.
  • kargs (dict[str, Any] | None) -- Additional keyword arguments for decomp.

None

SEE ALSO:

DMShellSetCreateFieldDecomposition


Source code at petsc4py/PETSc/DMShell.pyx:528


Set the routine to create a global vector.

Logically collective.

  • create_gvec (Callable[[DM], Vec] | None) -- The creation routine.
  • args (tuple[Any, ...] | None) -- Additional positional arguments for create_gvec.
  • kargs (dict[str, Any] | None) -- Additional keyword arguments for create_gvec.

None

SEE ALSO:

setCreateLocalVector, DMShellSetCreateGlobalVector


Source code at petsc4py/PETSc/DMShell.pyx:76


Set the routine used to create the injection operator.

Logically collective.

  • create_injection (Callable[[DM, DM], Mat] | None) -- The routine to create the injection.
  • args (tuple[Any, ...] | None) -- Additional positional arguments for create_injection.
  • kargs (dict[str, Any] | None) -- Additional keyword arguments for create_injection.

None

SEE ALSO:

DMShellSetCreateInjection


Source code at petsc4py/PETSc/DMShell.pyx:464


Set the routine used to create the interpolation operator.

Logically collective.

  • create_interpolation (Callable[[DM, DM], tuple[Mat, Vec]] | None) -- The routine to create the interpolation.
  • args (tuple[Any, ...] | None) -- Additional positional arguments for create_interpolation.
  • kargs (dict[str, Any] | None) -- Additional keyword arguments for create_interpolation.

None

SEE ALSO:

DMShellSetCreateInterpolation


Source code at petsc4py/PETSc/DMShell.pyx:432


Set the routine to create a local vector.

Logically collective.

  • create_lvec (Callable[[DM], Vec] | None) -- The creation routine.
  • args (tuple[Any, ...] | None) -- Additional positional arguments for create_lvec.
  • kargs (dict[str, Any] | None) -- Additional keyword arguments for create_lvec.

None

SEE ALSO:

setCreateGlobalVector, DMShellSetCreateLocalVector


Source code at petsc4py/PETSc/DMShell.pyx:108


Set the routine to create a matrix.

Logically collective.

  • create_matrix (Callable[[DM], Mat] | None) -- The function to create a matrix.
  • args (tuple[Any, ...] | None) -- Additional positional arguments for create_matrix.
  • kargs (dict[str, Any] | None) -- Additional keyword arguments for create_matrix.

None

SEE ALSO:

DMShellSetCreateMatrix


Source code at petsc4py/PETSc/DMShell.pyx:336


Set the routine used to create the restriction operator.

Logically collective.

  • create_restriction (Callable[[DM, DM], Mat] | None) -- The routine to create the restriction
  • args (tuple[Any, ...] | None) -- Additional positional arguments for create_restriction.
  • kargs (dict[str, Any] | None) -- Additional keyword arguments for create_restriction.

None

SEE ALSO:

DMShellSetCreateRestriction


Source code at petsc4py/PETSc/DMShell.pyx:496


Set the routine used to create a sub DM from the DMShell.

Logically collective.

  • subdm -- The routine to create the decomposition.
  • args (tuple[Any, ...] | None) -- Additional positional arguments for subdm.
  • kargs (dict[str, Any] | None) -- Additional keyword arguments for subdm.
  • create_subdm (Callable[[DM, Sequence[int]], tuple[IS, DM]] | None)

None

SEE ALSO:

DMShellSetCreateSubDM


Source code at petsc4py/PETSc/DMShell.pyx:624


Set the routines used to perform a global to local scatter.

Logically collective.

  • dm -- The DMShell.
  • begin (Callable[[DM, Vec, InsertMode, Vec], None] | None) -- The routine which begins the global to local scatter.
  • end (Callable[[DM, Vec, InsertMode, Vec], None] | None) -- The routine which ends the global to local scatter.
  • begin_args (tuple[Any, ...] | None) -- Additional positional arguments for begin.
  • begin_kargs (dict[str, Any] | None) -- Additional keyword arguments for begin.
  • end_args (tuple[Any, ...] | None) -- Additional positional arguments for end.
  • end_kargs (dict[str, Any] | None) -- Additional keyword arguments for end.

None

SEE ALSO:

DMShellSetGlobalToLocal


Source code at petsc4py/PETSc/DMShell.pyx:140


Set a Scatter context for global to local communication.

Logically collective.

gtol (Scatter) -- The global to local Scatter context.
None

SEE ALSO:

DMShellSetGlobalToLocalVecScatter


Source code at petsc4py/PETSc/DMShell.pyx:189


Set a template global vector.

Logically collective.

gv (Vec) -- Template vector.
None

SEE ALSO:

setLocalVector, DMShellSetGlobalVector


Source code at petsc4py/PETSc/DMShell.pyx:42


Set the routines used to perform a local to global scatter.

Logically collective.

  • begin (Callable[[DM, Vec, InsertMode, Vec], None] | None) -- The routine which begins the local to global scatter.
  • end (Callable[[DM, Vec, InsertMode, Vec], None] | None) -- The routine which ends the local to global scatter.
  • begin_args (tuple[Any, ...] | None) -- Additional positional arguments for begin.
  • begin_kargs (dict[str, Any] | None) -- Additional keyword arguments for begin.
  • end_args (tuple[Any, ...] | None) -- Additional positional arguments for end.
  • end_kargs (dict[str, Any] | None) -- Additional keyword arguments for end.

None

SEE ALSO:

DMShellSetLocalToGlobal


Source code at petsc4py/PETSc/DMShell.pyx:206


Set a Scatter context for local to global communication.

Logically collective.

ltog (Scatter) -- The local to global Scatter context.
None

SEE ALSO:

DMShellSetLocalToGlobalVecScatter


Source code at petsc4py/PETSc/DMShell.pyx:253


Set the routines used to perform a local to local scatter.

Logically collective.

  • begin (Callable[[DM, Vec, InsertMode, Vec], None] | None) -- The routine which begins the local to local scatter.
  • end (Callable[[DM, Vec, InsertMode, Vec], None] | None) -- The routine which ends the local to local scatter.
  • begin_args (tuple[Any, ...] | None) -- Additional positional arguments for begin.
  • begin_kargs (dict[str, Any] | None) -- Additional keyword arguments for begin.
  • end_args (tuple[Any, ...] | None) -- Additional positional arguments for end.
  • end_kargs (dict[str, Any] | None) -- Additional keyword arguments for end.

None

SEE ALSO:

DMShellSetLocalToLocal


Source code at petsc4py/PETSc/DMShell.pyx:270


Set a Scatter context for local to local communication.

Logically collective.

ltol (Scatter) -- The local to local Scatter context.
None

SEE ALSO:

DMShellSetLocalToLocalVecScatter


Source code at petsc4py/PETSc/DMShell.pyx:319


Set a template local vector.

Logically collective.

lv (Vec) -- Template vector.
None

SEE ALSO:

setGlobalVector, DMShellSetLocalVector


Source code at petsc4py/PETSc/DMShell.pyx:59


Set a template matrix.

Collective.

mat (Mat) -- The template matrix.
None

SEE ALSO:

DMShellSetMatrix


Source code at petsc4py/PETSc/DMShell.pyx:25


Set the routine used to refine the DMShell.

Logically collective.

  • refine (Callable[[DM, Comm], DM] | None) -- The routine which refines the DM.
  • args (tuple[Any, ...] | None) -- Additional positional arguments for refine.
  • kargs (dict[str, Any] | None) -- Additional keyword arguments for refine.

None

SEE ALSO:

setCoarsen, DMShellSetRefine


Source code at petsc4py/PETSc/DMShell.pyx:400



petsc4py.PETSc.DMStag

Bases: DM

A DM object representing a "staggered grid" or a structured cell complex.

Enumerations

StencilLocation Stencil location types.
StencilType Stencil types.

petsc4py.PETSc.DMStag.StencilLocation

Bases: object

Stencil location types.

Attributes Summary

BACK Constant BACK of type int
BACK_DOWN Constant BACK_DOWN of type int
BACK_DOWN_LEFT Constant BACK_DOWN_LEFT of type int
BACK_DOWN_RIGHT Constant BACK_DOWN_RIGHT of type int
BACK_LEFT Constant BACK_LEFT of type int
BACK_RIGHT Constant BACK_RIGHT of type int
BACK_UP Constant BACK_UP of type int
BACK_UP_LEFT Constant BACK_UP_LEFT of type int
BACK_UP_RIGHT Constant BACK_UP_RIGHT of type int
DOWN Constant DOWN of type int
DOWN_LEFT Constant DOWN_LEFT of type int
DOWN_RIGHT Constant DOWN_RIGHT of type int
ELEMENT Constant ELEMENT of type int
FRONT Constant FRONT of type int
FRONT_DOWN Constant FRONT_DOWN of type int
FRONT_DOWN_LEFT Constant FRONT_DOWN_LEFT of type int
FRONT_DOWN_RIGHT Constant FRONT_DOWN_RIGHT of type int
FRONT_LEFT Constant FRONT_LEFT of type int
FRONT_RIGHT Constant FRONT_RIGHT of type int
FRONT_UP Constant FRONT_UP of type int
FRONT_UP_LEFT Constant FRONT_UP_LEFT of type int
FRONT_UP_RIGHT Constant FRONT_UP_RIGHT of type int
LEFT Constant LEFT of type int
NULLLOC Constant NULLLOC of type int
RIGHT Constant RIGHT of type int
UP Constant UP of type int
UP_LEFT Constant UP_LEFT of type int
UP_RIGHT Constant UP_RIGHT of type int

Attributes Documentation

Constant BACK of type int

Constant BACK_DOWN of type int

Constant BACK_DOWN_LEFT of type int

Constant BACK_DOWN_RIGHT of type int

Constant BACK_LEFT of type int

Constant BACK_RIGHT of type int

Constant BACK_UP of type int

Constant BACK_UP_LEFT of type int

Constant BACK_UP_RIGHT of type int

Constant DOWN of type int

Constant DOWN_LEFT of type int

Constant DOWN_RIGHT of type int

Constant ELEMENT of type int

Constant FRONT of type int

Constant FRONT_DOWN of type int

Constant FRONT_DOWN_LEFT of type int

Constant FRONT_DOWN_RIGHT of type int

Constant FRONT_LEFT of type int

Constant FRONT_RIGHT of type int

Constant FRONT_UP of type int

Constant FRONT_UP_LEFT of type int

Constant FRONT_UP_RIGHT of type int

Constant LEFT of type int

Constant NULLLOC of type int

Constant RIGHT of type int

Constant UP of type int

Constant UP_LEFT of type int

Constant UP_RIGHT of type int


petsc4py.PETSc.DMStag.StencilType

Bases: object

Stencil types.

Attributes Summary

BOX Constant BOX of type int
NONE Constant NONE of type int
STAR Constant STAR of type int

Attributes Documentation

Constant BOX of type int

Constant NONE of type int

Constant STAR of type int


Methods Summary

VecSplitToDMDA(vec, loc, c) Return DMDA, Vec from a subgrid of a DMStag, its Vec.
create(dim[, dofs, sizes, boundary_types, ...]) Create a DMDA object.
createCompatibleDMStag(dofs) Create a compatible DMStag with different DOFs/stratum.
get1dCoordinatecArrays() Not implemented.
getBoundaryTypes() Return boundary types in each dimension.
getCorners() Return starting element index, width and number of partial elements.
getDim() Return the number of dimensions.
getDof() Get number of DOFs associated with each stratum of the grid.
getEntriesPerElement() Return the number of entries per element in the local representation.
getGhostCorners() Return starting element index and width of local region.
getGlobalSizes() Return global element counts in each dimension.
getIsFirstRank() Return whether this process is first in each dimension in the process grid.
getIsLastRank() Return whether this process is last in each dimension in the process grid.
getLocalSizes() Return local elementwise sizes in each dimension.
getLocationDof(loc) Return number of DOFs associated with a given point on the grid.
getLocationSlot(loc, c) Return index to use in accessing raw local arrays.
getOwnershipRanges() Return elements per process in each dimension.
getProcSizes() Return number of processes in each dimension.
getProductCoordinateLocationSlot(loc) Return slot for use with local product coordinate arrays.
getStencilType() Return elementwise ghost/halo stencil type.
getStencilWidth() Return elementwise stencil width.
getVecArray(vec) Not implemented.
migrateVec(vec, dmTo, vecTo) Transfer a vector between two DMStag objects.
setBoundaryTypes(boundary_types) Set the boundary types.
setCoordinateDMType(dmtype) Set the type to store coordinates.
setDof(dofs) Set DOFs/stratum.
setGlobalSizes(sizes) Set global element counts in each dimension.
setOwnershipRanges(ranges) Set elements per process in each dimension.
setProcSizes(sizes) Set the number of processes in each dimension in the global process grid.
setStencilType(stenciltype) Set elementwise ghost/halo stencil type.
setStencilWidth(swidth) Set elementwise stencil width.
setUniformCoordinates([xmin, xmax, ymin, ...]) Set the coordinates to be a uniform grid..
setUniformCoordinatesExplicit([xmin, xmax, ...]) Set coordinates to be a uniform grid, storing all values.
setUniformCoordinatesProduct([xmin, xmax, ...]) Create uniform coordinates, as a product of 1D arrays.

Attributes Summary

boundary_types Boundary types in each dimension.
corners The lower left corner and size of local region in each dimension.
dim The dimension.
dofs The number of DOFs associated with each stratum of the grid.
entries_per_element The number of entries per element in the local representation.
ghost_corners The lower left corner and size of local region in each dimension.
global_sizes Global element counts in each dimension.
local_sizes Local elementwise sizes in each dimension.
proc_sizes The number of processes in each dimension in the global decomposition.
stencil_type Stencil type.
stencil_width Elementwise stencil width.

Methods Documentation

Return DMDA, Vec from a subgrid of a DMStag, its Vec.

Collective.

If a c value of -k is provided, the first k DOFs for that position are extracted, padding with zero values if needed. If a non-negative value is provided, a single DOF is extracted.

  • vec (Vec) -- The Vec object.
  • loc (StencilLocation) -- Which subgrid to extract.
  • c (int) -- Which component to extract.

tuple[DMDA, Vec]

SEE ALSO:

DMStagVecSplitToDMDA


Source code at petsc4py/PETSc/DMStag.pyx:790


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) -- The number of dimensions.
  • dofs (tuple[int, ...] | None) -- The number of degrees of freedom per vertex, element (1D); vertex, face, element (2D); or vertex, edge, face, element (3D).
  • sizes (tuple[int, ...] | None) -- The number of elements in each dimension.
  • boundary_types (tuple[DM.BoundaryType | int | str | bool, ...] | None) -- The boundary types.
  • stencil_type (StencilType | None) -- The ghost/halo stencil type.
  • stencil_width (int | None) -- The width of the ghost/halo region.
  • proc_sizes (tuple[int, ...] | None) -- The number of processes in x, y, z dimensions.
  • ownership_ranges (tuple[Sequence[int], ...] | None) -- Local x, y, z element counts, of length equal to proc_sizes, summing to sizes.
  • comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.
  • setUp (bool | None) -- Whether to call the setup routine after creating the object.

Self

SEE ALSO:

DMStagCreate1d, DMStagCreate2d, DMStagCreate3d, DMSetUp


Source code at petsc4py/PETSc/DMStag.pyx:50


Create a compatible DMStag with different DOFs/stratum.

Collective.

dofs (tuple[int, ...]) -- The number of DOFs on the strata in the new DMStag.
DM

SEE ALSO:

DMStagCreateCompatibleDMStag


Source code at petsc4py/PETSc/DMStag.pyx:766


Not implemented.

Source code at petsc4py/PETSc/DMStag.pyx:832



Return boundary types in each dimension.

Not collective.

SEE ALSO:

setBoundaryTypes, DMStagGetBoundaryTypes


Source code at petsc4py/PETSc/DMStag.pyx:478

tuple[str, ...]


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:

getGhostCorners, DMStagGetCorners, DMGetDimension


Source code at petsc4py/PETSc/DMStag.pyx:363

tuple[tuple[int, ...], tuple[int, ...], tuple[int, ...]]


Return the number of dimensions.

Not collective.

Source code at petsc4py/PETSc/DMStag.pyx:310



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

Not collective.

SEE ALSO:

DMStagGetDOF


Source code at petsc4py/PETSc/DMStag.pyx:348

tuple[int, ...]


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:

DMStagGetEntriesPerElement


Source code at petsc4py/PETSc/DMStag.pyx:318



Return starting element index and width of local region.

Not collective.

SEE ALSO:

getCorners, DMStagGetGhostCorners


Source code at petsc4py/PETSc/DMStag.pyx:385

tuple[tuple[int, ...], tuple[int, ...]]


Return global element counts in each dimension.

Not collective.

SEE ALSO:

getLocalSizes, DMStagGetGlobalSizes


Source code at petsc4py/PETSc/DMStag.pyx:417

tuple[int, ...]


Return whether this process is first in each dimension in the process grid.

Not collective.

SEE ALSO:

DMStagGetIsFirstRank


Source code at petsc4py/PETSc/DMStag.pyx:496

tuple[int, ...]


Return whether this process is last in each dimension in the process grid.

Not collective.

SEE ALSO:

DMStagGetIsLastRank


Source code at petsc4py/PETSc/DMStag.pyx:512

tuple[int, ...]


Return local elementwise sizes in each dimension.

Not collective.

The returned value is calculated excluding ghost points.

SEE ALSO:

getGlobalSizes, DMStagGetLocalSizes


Source code at petsc4py/PETSc/DMStag.pyx:400

tuple[int, ...]


Return number of DOFs associated with a given point on the grid.

Not collective.

loc (StencilLocation) -- The grid point.
int

SEE ALSO:

DMStagGetLocationDOF


Source code at petsc4py/PETSc/DMStag.pyx:721


Return index to use in accessing raw local arrays.

Not collective.

  • loc (StencilLocation) -- Location relative to an element.
  • c (int) -- Component.

int

SEE ALSO:

DMStagGetLocationSlot


Source code at petsc4py/PETSc/DMStag.pyx:678


Return elements per process in each dimension.

Not collective.

SEE ALSO:

setOwnershipRanges, DMStagGetOwnershipRanges


Source code at petsc4py/PETSc/DMStag.pyx:461

tuple[Sequence[int], ...]


Return number of processes in each dimension.

Not collective.

SEE ALSO:

DMStagGetNumRanks


Source code at petsc4py/PETSc/DMStag.pyx:432

tuple[int, ...]


Return slot for use with local product coordinate arrays.

Not collective.

loc (StencilLocation) -- The grid location.
None

SEE ALSO:

DMStagGetProductCoordinateLocationSlot


Source code at petsc4py/PETSc/DMStag.pyx:701


Return elementwise ghost/halo stencil type.

Not collective.

SEE ALSO:

setStencilType, DMStagGetStencilType


Source code at petsc4py/PETSc/DMStag.pyx:447



Return elementwise stencil width.

Not collective.

SEE ALSO:

DMStagGetStencilWidth


Source code at petsc4py/PETSc/DMStag.pyx:334



Not implemented.

Source code at petsc4py/PETSc/DMStag.pyx:828

vec (Vec)
None


Transfer a vector between two DMStag objects.

Collective.

Currently only implemented to migrate global vectors to global vectors.

  • vec (Vec) -- The source vector.
  • dmTo (DM) -- The compatible destination object.
  • vecTo (Vec) -- The destination vector.

None

SEE ALSO:

DMStagMigrateVec


Source code at petsc4py/PETSc/DMStag.pyx:743


Set the boundary types.

Logically collective.

boundary_types (tuple[BoundaryType | int | str | bool, ...]) -- Boundary types for one/two/three dimensions.
None

SEE ALSO:

getBoundaryTypes, DMStagSetBoundaryTypes


Source code at petsc4py/PETSc/DMStag.pyx:201


Set the type to store coordinates.

Logically collective.

dmtype (Type) -- The type to store coordinates.
None

SEE ALSO:

DMStagSetCoordinateDMType


Source code at petsc4py/PETSc/DMStag.pyx:657


Set DOFs/stratum.

Logically collective.

dofs (tuple[int, ...]) -- The number of points per 0-cell (vertex/node), 1-cell (element in 1D, edge in 2D and 3D), 2-cell (element in 2D, face in 3D), or 3-cell (element in 3D).
None

SEE ALSO:

DMStagSetDOF


Source code at petsc4py/PETSc/DMStag.pyx:224


Set global element counts in each dimension.

Logically collective.

sizes (tuple[int, ...]) -- Global elementwise size in the one/two/three dimensions.
None

SEE ALSO:

DMStagSetGlobalSizes


Source code at petsc4py/PETSc/DMStag.pyx:246


Set elements per process in each dimension.

Logically collective.

ranges (tuple[Sequence[int], ...]) -- Element counts for each process in one/two/three dimensions.
None

SEE ALSO:

getOwnershipRanges, DMStagSetOwnershipRanges


Source code at petsc4py/PETSc/DMStag.pyx:286


Set the number of processes in each dimension in the global process grid.

Logically collective.

sizes (tuple[int, ...]) -- Number of processes in one/two/three dimensions.
None

SEE ALSO:

DMStagSetNumRanks


Source code at petsc4py/PETSc/DMStag.pyx:266


Set elementwise ghost/halo stencil type.

Logically collective.

stenciltype (StencilType | str) -- The elementwise ghost stencil type.
None

SEE ALSO:

getStencilType, DMStagSetStencilType


Source code at petsc4py/PETSc/DMStag.pyx:183


Set elementwise stencil width.

Logically collective.

The width value is not used when StencilType.NONE is specified.

swidth (int) -- Stencil/halo/ghost width in elements.
None

SEE ALSO:

DMStagSetStencilWidth


Source code at petsc4py/PETSc/DMStag.pyx:163


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) -- The minimum global coordinate value in the x dimension.
  • xmax (float) -- The maximum global coordinate value in the x dimension.
  • ymin (float) -- The minimum global coordinate value in the y dimension.
  • ymax (float) -- The maximum global coordinate value in the y dimension.
  • zmin (float) -- The minimum global coordinate value in the z dimension.
  • zmax (float) -- The maximum global coordinate value in the z dimension.

None

SEE ALSO:

setUniformCoordinatesExplicit, setUniformCoordinatesProduct, DMStagSetUniformCoordinates


Source code at petsc4py/PETSc/DMStag.pyx:610


Set coordinates to be a uniform grid, storing all values.

Collective.

  • xmin (float) -- The minimum global coordinate value in the x dimension.
  • xmax (float) -- The maximum global coordinate value in the x dimension.
  • ymin (float) -- The minimum global coordinate value in the y dimension.
  • ymax (float) -- The maximum global coordinate value in the y dimension.
  • zmin (float) -- The minimum global coordinate value in the z dimension.
  • zmax (float) -- The maximum global coordinate value in the z dimension.

None

SEE ALSO:

setUniformCoordinatesProduct, setUniformCoordinates, DMStagSetUniformCoordinatesExplicit


Source code at petsc4py/PETSc/DMStag.pyx:530


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) -- The minimum global coordinate value in the x dimension.
  • xmax (float) -- The maximum global coordinate value in the x dimension.
  • ymin (float) -- The minimum global coordinate value in the y dimension.
  • ymax (float) -- The maximum global coordinate value in the y dimension.
  • zmin (float) -- The minimum global coordinate value in the z dimension.
  • zmax (float) -- The maximum global coordinate value in the z dimension.

None

SEE ALSO:

setUniformCoordinatesExplicit, setUniformCoordinates, DMStagSetUniformCoordinatesProduct


Source code at petsc4py/PETSc/DMStag.pyx:568


Attributes Documentation

Boundary types in each dimension.

Source code at petsc4py/PETSc/DMStag.pyx:866


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

Source code at petsc4py/PETSc/DMStag.pyx:881


The dimension.

Source code at petsc4py/PETSc/DMStag.pyx:836


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

Source code at petsc4py/PETSc/DMStag.pyx:841


The number of entries per element in the local representation.

Source code at petsc4py/PETSc/DMStag.pyx:846


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

Source code at petsc4py/PETSc/DMStag.pyx:886


Global element counts in each dimension.

Source code at petsc4py/PETSc/DMStag.pyx:851


Local elementwise sizes in each dimension.

Source code at petsc4py/PETSc/DMStag.pyx:856


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

Source code at petsc4py/PETSc/DMStag.pyx:861


Stencil type.

Source code at petsc4py/PETSc/DMStag.pyx:871


Elementwise stencil width.

Source code at petsc4py/PETSc/DMStag.pyx:876




petsc4py.PETSc.DMSwarm

Bases: DM

A DM object used to represent arrays of data (fields) of arbitrary type.

Enumerations

CollectType Swarm collection types.
MigrateType Swarm migration types.
PICLayoutType Swarm PIC layout types.
Type Swarm types.

petsc4py.PETSc.DMSwarm.CollectType

Bases: object

Swarm collection types.

Attributes Summary

COLLECT_BASIC Constant COLLECT_BASIC of type int
COLLECT_DMDABOUNDINGBOX Constant COLLECT_DMDABOUNDINGBOX of type int
COLLECT_GENERAL Constant COLLECT_GENERAL of type int
COLLECT_USER Constant COLLECT_USER of type int

Attributes Documentation

Constant COLLECT_BASIC of type int

Constant COLLECT_DMDABOUNDINGBOX of type int

Constant COLLECT_GENERAL of type int

Constant COLLECT_USER of type int


petsc4py.PETSc.DMSwarm.MigrateType

Bases: object

Swarm migration types.

Attributes Summary

MIGRATE_BASIC Constant MIGRATE_BASIC of type int
MIGRATE_DMCELLEXACT Constant MIGRATE_DMCELLEXACT of type int
MIGRATE_DMCELLNSCATTER Constant MIGRATE_DMCELLNSCATTER of type int
MIGRATE_USER Constant MIGRATE_USER of type int

Attributes Documentation

Constant MIGRATE_BASIC of type int

Constant MIGRATE_DMCELLEXACT of type int

Constant MIGRATE_DMCELLNSCATTER of type int

Constant MIGRATE_USER of type int


petsc4py.PETSc.DMSwarm.PICLayoutType

Bases: object

Swarm PIC layout types.

Attributes Summary

LAYOUT_GAUSS Constant LAYOUT_GAUSS of type int
LAYOUT_REGULAR Constant LAYOUT_REGULAR of type int
LAYOUT_SUBDIVISION Constant LAYOUT_SUBDIVISION of type int

Attributes Documentation

Constant LAYOUT_GAUSS of type int

Constant LAYOUT_REGULAR of type int

Constant LAYOUT_SUBDIVISION of type int


petsc4py.PETSc.DMSwarm.Type

Bases: object

Swarm types.

Attributes Summary

BASIC Constant BASIC of type int
PIC Constant PIC of type int

Attributes Documentation

Constant BASIC of type int

Constant PIC of type int


Methods Summary

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.
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.
createGlobalVectorFromField(fieldname) Create a global Vec object associated with a given field.
createLocalVectorFromField(fieldname) Create a local Vec object associated with a given field.
destroyGlobalVectorFromField(fieldname) Destroy the global Vec object associated with a given field.
destroyLocalVectorFromField(fieldname) Destroy the local Vec object associated with a given field.
finalizeFieldRegister() Finalize the registration of fields to a DMSwarm.
getCellDM() Return DM cell attached to 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.
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 to a 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 field from which to define a Vec object.
viewFieldsXDMF(filename, fieldnames) Write a selection of DMSwarm fields to an XDMF3 file.
viewXDMF(filename) Write this DMSwarm fields to an XDMF3 file.

Methods Documentation

Add space for a number of new points in the DMSwarm.

Not collective.

npoints (int) -- The number of new points to add.
None

SEE ALSO:

DMSwarmAddNPoints


Source code at petsc4py/PETSc/DMSwarm.pyx:329


Add space for one new point in the DMSwarm.

Not collective.

SEE ALSO:

DMSwarmAddPoint


Source code at petsc4py/PETSc/DMSwarm.pyx:317



Apply a collection method and gather points in neighbor ranks.

Collective.

SEE ALSO:

collectViewDestroy, DMSwarmCollectViewCreate


Source code at petsc4py/PETSc/DMSwarm.pyx:445



Reset the DMSwarm to the size prior to calling collectViewCreate.

Collective.

SEE ALSO:

collectViewCreate, DMSwarmCollectViewDestroy


Source code at petsc4py/PETSc/DMSwarm.pyx:457



Copy point pi to point pj in the DMSwarm.

Not collective.

  • pi (int) -- The index of the point to copy (source).
  • pj (int) -- The point index where the copy should be located (destination).

None

SEE ALSO:

DMSwarmCopyPoint


Source code at petsc4py/PETSc/DMSwarm.pyx:377


Create an empty DM object and set its type to DM.Type.SWARM.

Collective.

DMs are the abstract objects in PETSc that mediate between meshes and discretizations and the algebraic solvers, time integrators, and optimization algorithms.

comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.
Self

SEE ALSO:

DMCreate, DMSetType


Source code at petsc4py/PETSc/DMSwarm.pyx:39


Create a global Vec object associated with a given field.

Collective.

The vector must be returned to the DMSwarm using a matching call to destroyGlobalVectorFromField.

fieldname (str) -- The textual name given to a registered field.
Vec

SEE ALSO:

destroyGlobalVectorFromField, DMSwarmCreateGlobalVectorFromField


Source code at petsc4py/PETSc/DMSwarm.pyx:65


Create a local Vec object associated with a given field.

Collective.

The vector must be returned to the DMSwarm using a matching call to destroyLocalVectorFromField.

fieldname (str) -- The textual name given to a registered field.
Vec

SEE ALSO:

destroyLocalVectorFromField, DMSwarmCreateLocalVectorFromField


Source code at petsc4py/PETSc/DMSwarm.pyx:109


Destroy the global Vec object associated with a given field.

Collective.

fieldname (str) -- The textual name given to a registered field.
None

SEE ALSO:

createGlobalVectorFromField, DMSwarmDestroyGlobalVectorFromField


Source code at petsc4py/PETSc/DMSwarm.pyx:89


Destroy the local Vec object associated with a given field.

Collective.

fieldname (str) -- The textual name given to a registered field.
None

SEE ALSO:

createLocalVectorFromField, DMSwarmDestroyLocalVectorFromField


Source code at petsc4py/PETSc/DMSwarm.pyx:133


Finalize the registration of fields to a DMSwarm.

Collective.

SEE ALSO:

initializeFieldRegister, DMSwarmFinalizeFieldRegister


Source code at petsc4py/PETSc/DMSwarm.pyx:167



Return DM cell attached to DMSwarm.

Collective.

SEE ALSO:

setCellDM, DMSwarmGetCellDM


Source code at petsc4py/PETSc/DMSwarm.pyx:486



Return arrays storing all entries associated with a field.

Not collective.

The returned array contains underlying values of the field.

The array must be returned to the DMSwarm using a matching call to restoreField.

fieldname (str) -- The textual name to identify this field.
The type of the entries in the array will match the type of the field.
numpy.ndarray

SEE ALSO:

restoreField, DMSwarmGetField


Source code at petsc4py/PETSc/DMSwarm.pyx:231


Return the local length of fields registered.

Not collective.

SEE ALSO:

DMSwarmGetLocalSize


Source code at petsc4py/PETSc/DMSwarm.pyx:398



Return the total length of fields registered.

Collective.

SEE ALSO:

DMSwarmGetSize


Source code at petsc4py/PETSc/DMSwarm.pyx:412



Initiate the registration of fields to a DMSwarm.

Collective.

After all fields have been registered, you must call finalizeFieldRegister.

SEE ALSO:

finalizeFieldRegister, DMSwarmInitializeFieldRegister


Source code at petsc4py/PETSc/DMSwarm.pyx:153



Insert point coordinates within each cell.

Not collective.

  • layout_type -- Method used to fill each cell with the cell DM.
  • fill_param (int) -- Parameter controlling how many points per cell are added (the meaning of this parameter is dependent on the layout type).
  • layoutType (PICLayoutType)

None

SEE ALSO:

DMSwarmInsertPointsUsingCellDM


Source code at petsc4py/PETSc/DMSwarm.pyx:601


Relocate points defined in the DMSwarm to other MPI ranks.

Collective.

remove_sent_points (bool) -- Flag indicating if sent points should be removed from the current MPI rank.
None

SEE ALSO:

DMSwarmMigrate


Source code at petsc4py/PETSc/DMSwarm.pyx:426


Project a set of DMSwarm fields onto the cell DM.

Collective.

  • dm (DM) -- The continuum DM.
  • fieldnames (Sequence[str]) -- The textual names of the swarm fields to project.
  • vecs (Sequence[Vec])
  • mode (ScatterModeSpec)

None

SEE ALSO:

DMSwarmProjectFields


Source code at petsc4py/PETSc/DMSwarm.pyx:810


Register a field to a DMSwarm with a native PETSc data type.

Collective.

  • fieldname (str) -- The textual name to identify this field.
  • blocksize (int) -- The number of each data type.
  • dtype (dtype) -- A valid PETSc data type.

None

SEE ALSO:

DMSwarmRegisterPetscDatatypeField


Source code at petsc4py/PETSc/DMSwarm.pyx:201


Remove the last point from the DMSwarm.

Not collective.

SEE ALSO:

DMSwarmRemovePoint


Source code at petsc4py/PETSc/DMSwarm.pyx:347



Remove a specific point from the DMSwarm.

Not collective.

index (int) -- Index of point to remove
None

SEE ALSO:

DMSwarmRemovePointAtIndex


Source code at petsc4py/PETSc/DMSwarm.pyx:359


Restore accesses associated with a registered field.

Not collective.

fieldname (str) -- The textual name to identify this field.
None

SEE ALSO:

getField, DMSwarmRestoreField


Source code at petsc4py/PETSc/DMSwarm.pyx:274


Attach a DM to a DMSwarm.

Collective.

dm (DM) -- The DM to attach to the DMSwarm.
None

SEE ALSO:

getCellDM, DMSwarmSetCellDM


Source code at petsc4py/PETSc/DMSwarm.pyx:469


Set the length of all registered fields on the DMSwarm.

Not collective.

  • nlocal (int) -- The length of each registered field.
  • buffer (int) -- The length of the buffer used for efficient dynamic resizing.

Self

SEE ALSO:

DMSwarmSetLocalSizes


Source code at petsc4py/PETSc/DMSwarm.pyx:179


Set point coordinates in a DMSwarm from a user-defined list.

Collective.

  • coordinates (Sequence[float]) -- The coordinate values.
  • redundant (bool) -- If set to True, it is assumed that coordinates are only valid on rank 0 and should be broadcast to other ranks.
  • mode (InsertMode | None) -- Indicates whether to append points to the swarm (InsertMode.ADD), or override existing points (InsertMode.INSERT).

None

SEE ALSO:

DMSwarmSetPointCoordinates


Source code at petsc4py/PETSc/DMSwarm.pyx:565


Insert point coordinates within each cell.

Not collective.

Point coordinates are defined over the reference cell.

coordinates (Sequence[float]) -- The coordinates (defined in the local coordinate system for each cell) to insert.
None

SEE ALSO:

DMSwarmSetPointCoordinatesCellwise


Source code at petsc4py/PETSc/DMSwarm.pyx:623


Set point coordinates in a DMSwarm on a regular (ijk) grid.

Collective.

  • min (Sequence[float]) -- Minimum coordinate values in the x, y, z directions (array of length dim).
  • max (Sequence[float]) -- Maximum coordinate values in the x, y, z directions (array of length dim).
  • npoints (Sequence[int]) -- Number of points in each spatial direction (array of length dim).
  • mode (InsertMode | None) -- Indicates whether to append points to the swarm (InsertMode.ADD), or override existing points (InsertMode.INSERT).

Self

SEE ALSO:

DMSwarmSetPointsUniformCoordinates


Source code at petsc4py/PETSc/DMSwarm.pyx:521


Set particular flavor of DMSwarm.

Collective.

dmswarm_type (Type | str) -- The DMSwarm type.
None

SEE ALSO:

DMSwarmSetType


Source code at petsc4py/PETSc/DMSwarm.pyx:503


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:

sortRestoreAccess, DMSwarmSortGetAccess


Source code at petsc4py/PETSc/DMSwarm.pyx:698



Return whether the sort context is up-to-date.

Not collective.

Returns the flag associated with a DMSwarm point sorting context.

SEE ALSO:

DMSwarmSortGetIsValid


Source code at petsc4py/PETSc/DMSwarm.pyx:772



Return the number of points in a cell.

Not collective.

e (int) -- The index of the cell.
int

SEE ALSO:

DMSwarmSortGetNumberOfPointsPerCell


Source code at petsc4py/PETSc/DMSwarm.pyx:752


Create an array of point indices for all points in a cell.

Not collective.

e (int) -- The index of the cell.
list[int]

SEE ALSO:

DMSwarmSortGetPointsPerCell


Source code at petsc4py/PETSc/DMSwarm.pyx:728


Return the sizes associated with a DMSwarm point sorting context.

Not collective.

  • ncells (int) -- Number of cells within the sort context.
  • npoints (int) -- Number of points used to create the sort context.

tuple[int, int]

SEE ALSO:

DMSwarmSortGetSizes


Source code at petsc4py/PETSc/DMSwarm.pyx:788


Invalidate the DMSwarm point sorting context.

Not collective.

SEE ALSO:

sortGetAccess, DMSwarmSortRestoreAccess


Source code at petsc4py/PETSc/DMSwarm.pyx:716



Set the field from which to define a Vec object.

Collective.

The field will be used when DM.createLocalVec, or DM.createGlobalVec is called.

fieldname (str) -- The textual name given to a registered field.
None

SEE ALSO:

DMSwarmVectorDefineField


Source code at petsc4py/PETSc/DMSwarm.pyx:295


Write a selection of DMSwarm fields to an XDMF3 file.

Collective.

  • filename (str) -- The file name of the XDMF file (must have the extension .xmf).
  • fieldnames (Sequence[str]) -- Array containing the textual names of fields to write.

None

SEE ALSO:

DMSwarmViewFieldsXDMF


Source code at petsc4py/PETSc/DMSwarm.pyx:650


Write this DMSwarm fields to an XDMF3 file.

Collective.

filename (str) -- The file name of the XDMF file (must have the extension .xmf).
None

SEE ALSO:

DMSwarmViewXDMF


Source code at petsc4py/PETSc/DMSwarm.pyx:679




petsc4py.PETSc.DS

Bases: Object

Discrete System object.

Enumerations

Type The Discrete System types.

petsc4py.PETSc.DS.Type

Bases: object

The Discrete System types.

Attributes Summary

BASIC Object BASIC of type str

Attributes Documentation

Object BASIC of type str


Methods Summary

create([comm]) Create an empty DS.
destroy() Destroy the discrete system.
getComponents() Return the number of components for each field on an evaluation point.
getCoordinateDimension() Return the coordinate dimension of the DS.
getDimensions() Return the size of the space for each field on an evaluation point.
getFieldIndex(disc) Return the index of the given field.
getNumFields() Return the number of fields in the DS.
getSpatialDimension() Return the spatial dimension of the DS.
getTotalComponents() Return the total number of components in this system.
getTotalDimensions() Return the total size of the approximation space for this system.
getType() Return the type of the discrete system.
setDiscretisation(f, disc) Set the discretization object for the given field.
setFromOptions() Set parameters in a DS from the options database.
setType(ds_type) Build a particular type of a discrete system.
setUp() Construct data structures for the discrete system.
view([viewer]) View a discrete system.

Methods Documentation

Create an empty DS.

Collective.

The type can then be set with setType.

comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.
Self

SEE ALSO:

setType, destroy, PetscDSCreate


Source code at petsc4py/PETSc/DS.pyx:53


Destroy the discrete system.

Collective.

SEE ALSO:

create, PetscDSDestroy


Source code at petsc4py/PETSc/DS.pyx:40



Return the number of components for each field on an evaluation point.

Not collective.

SEE ALSO:

PetscDSGetComponents


Source code at petsc4py/PETSc/DS.pyx:246

ArrayInt


Return the coordinate dimension of the DS.

Not collective.

The coordinate dimension of the DS is the dimension of the space into which the discretiaztions are embedded.

SEE ALSO:

PetscDSGetCoordinateDimension


Source code at petsc4py/PETSc/DS.pyx:153



Return the size of the space for each field on an evaluation point.

Not collective.

SEE ALSO:

PetscDSGetDimensions


Source code at petsc4py/PETSc/DS.pyx:231

ArrayInt


Return the index of the given field.

Not collective.

disc (Object) -- The discretization object.
int

SEE ALSO:

PetscDSGetFieldIndex


Source code at petsc4py/PETSc/DS.pyx:184


Return the number of fields in the DS.

Not collective.

SEE ALSO:

PetscDSGetNumFields


Source code at petsc4py/PETSc/DS.pyx:170



Return the spatial dimension of the DS.

Not collective.

The spatial dimension of the DS is the topological dimension of the discretizations.

SEE ALSO:

PetscDSGetSpatialDimension


Source code at petsc4py/PETSc/DS.pyx:136



Return the total number of components in this system.

Not collective.

SEE ALSO:

PetscDSGetTotalComponents


Source code at petsc4py/PETSc/DS.pyx:217



Return the total size of the approximation space for this system.

Not collective.

SEE ALSO:

PetscDSGetTotalDimension


Source code at petsc4py/PETSc/DS.pyx:203



Return the type of the discrete system.

Not collective.

SEE ALSO:

setType, PetscDSGetType


Source code at petsc4py/PETSc/DS.pyx:95



Set the discretization object for the given field.

Not collective.

  • f (int) -- The field number.
  • disc (Object) -- The discretization object.

None

SEE ALSO:

PetscDSSetDiscretization


Source code at petsc4py/PETSc/DS.pyx:261


Set parameters in a DS from the options database.

Collective.

SEE ALSO:

Working with PETSc options, PetscDSSetFromOptions


Source code at petsc4py/PETSc/DS.pyx:109



Build a particular type of a discrete system.

Collective.

ds_type (Type | str) -- The type of the discrete system.
None

SEE ALSO:

getType, PetscDSSetType


Source code at petsc4py/PETSc/DS.pyx:76


Construct data structures for the discrete system.

Collective.

SEE ALSO:

PetscDSSetUp


Source code at petsc4py/PETSc/DS.pyx:121



View a discrete system.

Collective.

viewer (Viewer | None) -- A Viewer to display the system.
None

SEE ALSO:

PetscDSView


Source code at petsc4py/PETSc/DS.pyx:21




petsc4py.PETSc.Device

Bases: object

The device object.

Represents a handle to an accelerator (which may be the host).

SEE ALSO:

DeviceContext, PetscDevice


Enumerations

Type The type of device.

petsc4py.PETSc.Device.Type

Bases: object

The type of device.

SEE ALSO:

Device, Device.create, Device.getDeviceType, Device.type, PetscDeviceType


Attributes Summary

CUDA Constant CUDA of type int
DEFAULT Constant DEFAULT of type int
HIP Constant HIP of type int
HOST Constant HOST of type int
SYCL Constant SYCL of type int

Attributes Documentation

Constant CUDA of type int

Constant DEFAULT of type int

Constant HIP of type int

Constant HOST of type int

Constant SYCL of type int


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 and setup a device object.

Not collective.

SEE ALSO:

create, PetscDeviceConfigure


Source code at petsc4py/PETSc/Device.pyx:132



Create a device object.

Not collective.

  • dtype (Type | None) -- The type of device to create (or None for the default).
  • device_id (int) -- The numeric id of the device to create.

Device

SEE ALSO:

destroy, PetscDeviceCreate


Source code at petsc4py/PETSc/Device.pyx:94


Destroy a device object.

Not collective.

SEE ALSO:

create, PetscDeviceDestroy


Source code at petsc4py/PETSc/Device.pyx:120



Return the device id.

Not collective.

SEE ALSO:

create, PetscDeviceGetDeviceId


Source code at petsc4py/PETSc/Device.pyx:180



Return the type of the device.

Not collective.

SEE ALSO:

type, PetscDeviceGetType


Source code at petsc4py/PETSc/Device.pyx:165



Set the device type to be used as the default in subsequent calls to create.

Not collective.

SEE ALSO:

create, PetscDeviceSetDefaultDeviceType


Source code at petsc4py/PETSc/Device.pyx:195

device_type (Type | str)
None


View a device object.

Collective.

viewer (Viewer | None) -- A Viewer instance or None for the default viewer.
None

SEE ALSO:

PetscDeviceView


Source code at petsc4py/PETSc/Device.pyx:144


Attributes Documentation

The device id.

Source code at petsc4py/PETSc/Device.pyx:215


The device type.

Source code at petsc4py/PETSc/Device.pyx:210




petsc4py.PETSc.DeviceContext

Bases: Object

DeviceContext object.

Represents an abstract handle to a device context.

SEE ALSO:

Device, PetscDeviceContext


Enumerations

DeviceJoinMode The type of join to perform.
StreamType The type of stream.

petsc4py.PETSc.DeviceContext.DeviceJoinMode

Bases: object

The type of join to perform.

SEE ALSO:

DeviceContext, DeviceContext.join, DeviceContext.fork, PetscDeviceContextJoinMode


Attributes Summary

DESTROY Constant DESTROY of type int
NO_SYNC Constant NO_SYNC of type int
SYNC Constant SYNC of type int

Attributes Documentation

Constant DESTROY of type int

Constant NO_SYNC of type int

Constant SYNC of type int


petsc4py.PETSc.DeviceContext.StreamType

Bases: object

The type of stream.

SEE ALSO:

DeviceContext, DeviceContext.getStreamType, DeviceContext.setStreamType, PetscStreamType


Attributes Summary

DEFAULT Constant DEFAULT of type int
DEFAULT_WITH_BARRIER Constant DEFAULT_WITH_BARRIER of type int
NONBLOCKING Constant NONBLOCKING of type int
NONBLOCKING_WITH_BARRIER Constant NONBLOCKING_WITH_BARRIER of type int

Attributes Documentation

Constant DEFAULT of type int

Constant DEFAULT_WITH_BARRIER of type int

Constant NONBLOCKING of type int

Constant NONBLOCKING_WITH_BARRIER of type int


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 which this instance is attached to.
getStreamType() Return the 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 which this DeviceContext is attached to.
setFromOptions([comm]) Configure the DeviceContext from the options database.
setStreamType(stream_type) Set the StreamType.
setUp() Set up the internal data structures for using the device context.
synchronize() Synchronize a device context.
waitFor(other) Make this instance wait for other.

Attributes Summary

current The current global device context.
device The device associated to the device context.
stream_type The stream type.

Methods Documentation

Create an empty DeviceContext.

Not collective.

SEE ALSO:

destroy, Device, PetscDeviceContextCreate


Source code at petsc4py/PETSc/Device.pyx:240



Destroy a device context.

Not collective.

SEE ALSO:

create, PetscDeviceContextDestroy


Source code at petsc4py/PETSc/Device.pyx:255



Duplicate a the device context.

Not collective.

SEE ALSO:

create, PetscDeviceContextDuplicate


Source code at petsc4py/PETSc/Device.pyx:348

DeviceContext


Create multiple device contexts which are all logically dependent on this one.

Not collective.

  • n (int) -- The number of device contexts to create.
  • stream_type (StreamType | str | None) -- The type of stream of the forked device context.

list[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:

join, waitFor, PetscDeviceContextFork


Source code at petsc4py/PETSc/Device.pyx:399


Return the current device context.

Not collective.

SEE ALSO:

current, setCurrent, PetscDeviceContextGetCurrentContext


Source code at petsc4py/PETSc/Device.pyx:519

DeviceContext


Get the Device which this instance is attached to.

Not collective.

SEE ALSO:

setDevice, device, Device, PetscDeviceContextGetDevice


Source code at petsc4py/PETSc/Device.pyx:302

Device


Return the StreamType.

Not collective.

SEE ALSO:

stream_type, setStreamType, PetscDeviceContextGetStreamType


Source code at petsc4py/PETSc/Device.pyx:268



Return whether the underlying stream for the device context is idle.

Not collective.

SEE ALSO:

synchronize, PetscDeviceContextQueryIdle


Source code at petsc4py/PETSc/Device.pyx:363



Join a set of device contexts on this one.

Not collective.

  • join_mode (DeviceJoinMode | str) -- The type of join to perform.
  • py_sub_ctxs (list[DeviceContext]) -- The list of device contexts to join.

None

SEE ALSO:

fork, waitFor, PetscDeviceContextJoin


Source code at petsc4py/PETSc/Device.pyx:448


Set the current device context.

Not collective.

dctx (DeviceContext | None) -- The DeviceContext to set as current (or None to use the default context).
None

SEE ALSO:

current, getCurrent, PetscDeviceContextSetCurrentContext


Source code at petsc4py/PETSc/Device.pyx:535


Set the Device which this DeviceContext is attached to.

Collective.

device (Device) -- The Device to which this instance is attached to.
None

SEE ALSO:

getDevice, device, Device, PetscDeviceContextSetDevice


Source code at petsc4py/PETSc/Device.pyx:317


Configure the DeviceContext from the options database.

Collective.

comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.
None

SEE ALSO:

Sys.getDefaultComm, PetscDeviceContextSetFromOptions


Source code at petsc4py/PETSc/Device.pyx:500


Set the StreamType.

Not collective.

stream_type (StreamType | str) -- The type of stream to set
None

SEE ALSO:

stream_type, getStreamType, PetscDeviceContextSetStreamType


Source code at petsc4py/PETSc/Device.pyx:283


Set up the internal data structures for using the device context.

Not collective.

SEE ALSO:

create, PetscDeviceContextSetUp


Source code at petsc4py/PETSc/Device.pyx:336



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:

idle, PetscDeviceContextSynchronize


Source code at petsc4py/PETSc/Device.pyx:483



Make this instance wait for other.

Not collective.

other (DeviceContext | None) -- The other DeviceContext to wait for
None

SEE ALSO:

fork, join, PetscDeviceContextWaitForContext


Source code at petsc4py/PETSc/Device.pyx:378


Attributes Documentation

The current global device context.

Source code at petsc4py/PETSc/Device.pyx:574


The device associated to the device context.

Source code at petsc4py/PETSc/Device.pyx:566


The stream type.

Source code at petsc4py/PETSc/Device.pyx:558




petsc4py.PETSc.DualSpace

Bases: Object

Dual space to a linear space.

Enumerations

Type The dual space types.

petsc4py.PETSc.DualSpace.Type

Bases: object

The dual space types.

Attributes Summary

BDM Object BDM of type str
LAGRANGE Object LAGRANGE of type str
REFINED Object REFINED of type str
SIMPLE Object SIMPLE of type str

Attributes Documentation

Object BDM of type str

Object LAGRANGE of type str

Object REFINED of type str

Object SIMPLE of type str


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 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 representing the reference cell.
setLagrangeContinuity(continuous) Indicate whether the element is continuous.
setLagrangeTensor(tensor) Set the tensor nature of the dual space.
setLagrangeTrimmed(trimmed) Set the trimmed nature of the dual space.
setNumComponents(nc) Set the number of components for this space.
setOrder(order) Set the order of the dual space.
setSimpleDimension(dim) Set the number of functionals in the dual space basis.
setSimpleFunctional(func, functional) Set the given basis element for this dual space.
setType(dualspace_type) Build a particular type of dual space.
setUp() Construct a basis for a DualSpace.
view([viewer]) View a DualSpace.

Methods Documentation

Create an empty DualSpace object.

Collective.

The type can then be set with setType.

comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.
Self

SEE ALSO:

PetscDualSpaceCreate


Source code at petsc4py/PETSc/Space.pyx:593


Destroy the DualSpace object.

Collective.

SEE ALSO:

PetscDualSpaceDestroy


Source code at petsc4py/PETSc/Space.pyx:635



Create a duplicate DualSpace object that is not set up.

Collective.

SEE ALSO:

PetscDualSpaceDuplicate


Source code at petsc4py/PETSc/Space.pyx:648

DualSpace


Return the DM representing the reference cell of a DualSpace.

Not collective.

SEE ALSO:

setDM, PetscDualSpaceGetDM


Source code at petsc4py/PETSc/Space.pyx:661



Return the dimension of the dual space.

Not collective.

The dimension of the dual space, i.e. the number of basis functionals.

SEE ALSO:

PetscDualSpaceGetDimension


Source code at petsc4py/PETSc/Space.pyx:692



Return the i-th basis functional in the dual space.

Not collective.

i (int) -- The basis number.
Quad

SEE ALSO:

PetscDualSpaceGetFunctional


Source code at petsc4py/PETSc/Space.pyx:822


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:

PetscDualSpaceGetInteriorDimension


Source code at petsc4py/PETSc/Space.pyx:842



Return whether the element is continuous.

Not collective.

SEE ALSO:

setLagrangeContinuity, PetscDualSpaceLagrangeGetContinuity


Source code at petsc4py/PETSc/Space.pyx:859



Return the tensor nature of the dual space.

Not collective.

SEE ALSO:

setLagrangeTensor, PetscDualSpaceLagrangeGetTensor


Source code at petsc4py/PETSc/Space.pyx:891



Return the trimmed nature of the dual space.

Not collective.

SEE ALSO:

setLagrangeTrimmed, PetscDualSpaceLagrangeGetTrimmed


Source code at petsc4py/PETSc/Space.pyx:923



Return the number of components for this space.

Not collective.

SEE ALSO:

setNumComponents, PetscDualSpaceGetNumComponents


Source code at petsc4py/PETSc/Space.pyx:708



Return the number of degrees of freedom for each spatial dimension.

Not collective.

SEE ALSO:

PetscDualSpaceGetNumDof


Source code at petsc4py/PETSc/Space.pyx:806

ArrayInt


Return the order of the dual space.

Not collective.

SEE ALSO:

setOrder, PetscDualSpaceGetOrder


Source code at petsc4py/PETSc/Space.pyx:774



Return the type of the dual space object.

Not collective.

SEE ALSO:

setType, PetscDualSpaceGetType


Source code at petsc4py/PETSc/Space.pyx:740



Set the DM representing the reference cell.

Not collective.

dm (DM) -- The reference cell.
None

SEE ALSO:

getDM, PetscDualSpaceSetDM


Source code at petsc4py/PETSc/Space.pyx:675


Indicate whether the element is continuous.

Not collective.

continuous (bool) -- The flag for element continuity.
None

SEE ALSO:

getLagrangeContinuity, PetscDualSpaceLagrangeSetContinuity


Source code at petsc4py/PETSc/Space.pyx:873


Set the tensor nature of the dual space.

Not collective.

tensor (bool) -- Whether the dual space has tensor layout (vs. simplicial).
None

SEE ALSO:

getLagrangeTensor, PetscDualSpaceLagrangeSetTensor


Source code at petsc4py/PETSc/Space.pyx:905


Set the trimmed nature of the dual space.

Not collective.

trimmed (bool) -- Whether the dual space represents to dual basis of a trimmed polynomial space (e.g. Raviart-Thomas and higher order / other form degree variants).
None

SEE ALSO:

getLagrangeTrimmed, PetscDualSpaceLagrangeSetTrimmed


Source code at petsc4py/PETSc/Space.pyx:937


Set the number of components for this space.

Logically collective.

nc (int) -- The number of components
None

SEE ALSO:

getNumComponents, PetscDualSpaceSetNumComponents


Source code at petsc4py/PETSc/Space.pyx:722


Set the order of the dual space.

Not collective.

order (int) -- The order.
None

SEE ALSO:

getOrder, PetscDualSpaceSetOrder


Source code at petsc4py/PETSc/Space.pyx:788


Set the number of functionals in the dual space basis.

Logically collective.

dim (int) -- The basis dimension.
None

SEE ALSO:

PetscDualSpaceSimpleSetDimension


Source code at petsc4py/PETSc/Space.pyx:957


Set the given basis element for this dual space.

Not collective.

  • func (int) -- The basis index.
  • functional (Quad) -- The basis functional.

None

SEE ALSO:

PetscDualSpaceSimpleSetFunctional


Source code at petsc4py/PETSc/Space.pyx:975


Build a particular type of dual space.

Collective.

dualspace_type (Type | str) -- The kind of space.
Self

SEE ALSO:

getType, PetscDualSpaceSetType


Source code at petsc4py/PETSc/Space.pyx:754


Construct a basis for a DualSpace.

Collective.

SEE ALSO:

PetscDualSpaceSetUp


Source code at petsc4py/PETSc/Space.pyx:581



View a DualSpace.

Collective.

viewer (Viewer | None) -- A Viewer to display the DualSpace.
None

SEE ALSO:

PetscDualSpaceView


Source code at petsc4py/PETSc/Space.pyx:616




petsc4py.PETSc.FE

Bases: Object

A PETSc object that manages a finite element space.

Enumerations

Type The finite element types.

petsc4py.PETSc.FE.Type

Bases: object

The finite element types.

Attributes Summary

BASIC Object BASIC of type str
COMPOSITE Object COMPOSITE of type str
OPENCL Object OPENCL of type str

Attributes Documentation

Object BASIC of type str

Object COMPOSITE of type str

Object OPENCL of type str


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 used for the approximation of the FE solution.
getDimension() Return the dimension of the finite element space on a cell.
getDualSpace() Return the DualSpace used to define the inner product for the FE.
getFaceQuadrature() Return the 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 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 used for the approximation of the solution.
setDualSpace(dspace) Set the DualSpace used to define the inner product.
setFaceQuadrature(quad) Set the 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 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 has been set.
view([viewer]) View a FE object.

Methods Documentation

Create an empty FE object.

Collective.

The type can then be set with setType.

comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.
Self

SEE ALSO:

setType, PetscFECreate


Source code at petsc4py/PETSc/FE.pyx:53


Create a FE for basic FEM computation.

Collective.

  • dim (int) -- The spatial dimension.
  • nc (int) -- The number of components.
  • isSimplex (bool) -- Flag for simplex reference cell, otherwise it's a tensor product.
  • qorder (int) -- The quadrature order or DETERMINE to use Space polynomial degree.
  • prefix (str) -- The options prefix, or None.
  • comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.

Self

SEE ALSO:

PetscFECreateDefault


Source code at petsc4py/PETSc/FE.pyx:76


Create a FE for the basic Lagrange space of degree k.

Collective.

  • dim (int) -- The spatial dimension.
  • nc (int) -- The number of components.
  • isSimplex (bool) -- Flag for simplex reference cell, otherwise it's a tensor product.
  • k (int) -- The degree of the space.
  • qorder (int) -- The quadrature order or DETERMINE to use Space polynomial degree.
  • comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.

Self

SEE ALSO:

PetscFECreateLagrange


Source code at petsc4py/PETSc/FE.pyx:122


Destroy the FE object.

Collective.

SEE ALSO:

PetscFEDestroy


Source code at petsc4py/PETSc/FE.pyx:40



Return the Space used for the approximation of the FE solution.

Not collective.

SEE ALSO:

setBasisSpace, PetscFEGetBasisSpace


Source code at petsc4py/PETSc/FE.pyx:385

Space


Return the dimension of the finite element space on a cell.

Not collective.

SEE ALSO:

PetscFEGetDimension


Source code at petsc4py/PETSc/FE.pyx:180



Return the DualSpace used to define the inner product for the FE.

Not collective.

SEE ALSO:

setDualSpace, DualSpace, PetscFEGetDualSpace


Source code at petsc4py/PETSc/FE.pyx:440

DualSpace


Return the Quad used to calculate inner products on faces.

Not collective.

SEE ALSO:

setFaceQuadrature, PetscFEGetFaceQuadrature


Source code at petsc4py/PETSc/FE.pyx:315



Return the number of components in the element.

Not collective.

SEE ALSO:

setNumComponents, PetscFEGetNumComponents


Source code at petsc4py/PETSc/FE.pyx:208



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:

PetscFEGetNumDof


Source code at petsc4py/PETSc/FE.pyx:240

ndarray


Return the Quad used to calculate inner products.

Not collective.

SEE ALSO:

setQuadrature, PetscFEGetQuadrature


Source code at petsc4py/PETSc/FE.pyx:166



Return the spatial dimension of the element.

Not collective.

SEE ALSO:

PetscFEGetSpatialDimension


Source code at petsc4py/PETSc/FE.pyx:194



Return the tile sizes for evaluation.

Not collective.

  • blockSize (int) -- The number of elements in a block.
  • numBlocks (int) -- The number of blocks in a batch.
  • batchSize (int) -- The number of elements in a batch.
  • numBatches (int) -- The number of batches in a chunk.

tuple(int, int, int, int)

SEE ALSO:

setTileSizes, PetscFEGetTileSizes


Source code at petsc4py/PETSc/FE.pyx:259


Set the Space used for the approximation of the solution.

Not collective.

sp (Space) -- The Space object.
None

SEE ALSO:

getBasisSpace, PetscFESetBasisSpace


Source code at petsc4py/PETSc/FE.pyx:399


Set the DualSpace used to define the inner product.

Not collective.

dspace (DualSpace) -- The DualSpace object.
None

SEE ALSO:

getDualSpace, DualSpace, PetscFESetDualSpace


Source code at petsc4py/PETSc/FE.pyx:454


Set the Quad used to calculate inner products on faces.

Not collective.

quad (Quad) -- The Quad object.
Quad

SEE ALSO:

getFaceQuadrature, PetscFESetFaceQuadrature


Source code at petsc4py/PETSc/FE.pyx:347


Set parameters in a FE from the options database.

Collective.

SEE ALSO:

Working with PETSc options, PetscFESetFromOptions


Source code at petsc4py/PETSc/FE.pyx:416



Set the number of field components in the element.

Not collective.

comp (int) -- The number of field components.
None

SEE ALSO:

getNumComponents, PetscFESetNumComponents


Source code at petsc4py/PETSc/FE.pyx:222


Set the Quad used to calculate inner products.

Not collective.

quad (Quad) -- The Quad object.
Self

SEE ALSO:

getQuadrature, PetscFESetQuadrature


Source code at petsc4py/PETSc/FE.pyx:329


Set the tile sizes for evaluation.

Not collective.

  • blockSize (int) -- The number of elements in a block.
  • numBlocks (int) -- The number of blocks in a batch.
  • batchSize (int) -- The number of elements in a batch.
  • numBatches (int) -- The number of batches in a chunk.

None

SEE ALSO:

getTileSizes, PetscFESetTileSizes


Source code at petsc4py/PETSc/FE.pyx:285


Build a particular FE.

Collective.

fe_type (Type | str) -- The kind of FEM space.
Self

SEE ALSO:

PetscFESetType


Source code at petsc4py/PETSc/FE.pyx:365


Construct data structures for the FE after the Type has been set.

Collective.

SEE ALSO:

PetscFESetUp


Source code at petsc4py/PETSc/FE.pyx:428



View a FE object.

Collective.

viewer (Viewer | None) -- A Viewer to display the graph.
None

SEE ALSO:

PetscFEView


Source code at petsc4py/PETSc/FE.pyx:21




petsc4py.PETSc.IS

Bases: Object

A collection of indices.

IS objects are used to index into vectors and matrices and to set up vector scatters.

SEE ALSO:

IS


Enumerations

Type The index set types.

petsc4py.PETSc.IS.Type

Bases: object

The index set types.

Attributes Summary

BLOCK Object BLOCK of type str
GENERAL Object GENERAL of type str
STRIDE Object STRIDE of type str

Attributes Documentation

Object BLOCK of type str

Object GENERAL of type str

Object STRIDE of type str


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.
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.
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.
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.
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.
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.
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 if index set is an identity, False otherwise.
indices The indices of the index set.
local_size The local size of the index set.
permutation True if index set is a permutation, False otherwise.
size The global size of the index set.
sizes The local and global sizes of the index set.
sorted True if index set is sorted, False otherwise.

Methods Documentation

Concatenate index sets stored across processors.

Collective.

The returned index set will be the same on every processor.

SEE ALSO:

ISAllGather


Source code at petsc4py/PETSc/IS.pyx:304



Create an index set describing a global mapping.

Collective.

This function generates an index set that contains new numbers from remote or local on the index set.

toindx (IS | None) -- Index set describing which indices to send, default is to send natural numbering.
New index set containing the new numbers from remote or local.
IS

SEE ALSO:

ISBuildTwoSided


Source code at petsc4py/PETSc/IS.pyx:333


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) -- Minimum index that can be found in the local part of the complement index set.
  • nmax (int) -- One greater than the maximum index that can be found in the local part of the complement index set.

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:

IS.allGather, ISComplement


Source code at petsc4py/PETSc/IS.pyx:674


Copy the contents of the index set into another.

Collective.

result (IS | None) -- The target index set. If None then IS.duplicate is called first.
The copied index set. If result is not None then this is returned here.
IS

SEE ALSO:

IS.duplicate, ISCopy


Source code at petsc4py/PETSc/IS.pyx:253


Create an IS.

Collective.

comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.
Self

SEE ALSO:

ISCreate


Source code at petsc4py/PETSc/IS.pyx:88


Create a blocked index set.

Collective.

  • bsize (int) -- Block size.
  • indices (Sequence[int]) -- Integer array of indices.
  • comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.

Self

SEE ALSO:

ISCreateBlock


Source code at petsc4py/PETSc/IS.pyx:171


Create an IS with indices.

Collective.

  • indices (Sequence[int]) -- Integer array.
  • comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.

Self

SEE ALSO:

ISCreateGeneral


Source code at petsc4py/PETSc/IS.pyx:142


Create an index set consisting of evenly spaced values.

Collective.

  • size (int) -- The length of the locally owned portion of the index set.
  • first (int) -- The first element of the index set.
  • step (int) -- The difference between adjacent indices.
  • comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.

Self

SEE ALSO:

ISCreateStride


Source code at petsc4py/PETSc/IS.pyx:204


Destroy the index set.

Collective.

SEE ALSO:

ISDestroy


Source code at petsc4py/PETSc/IS.pyx:75



Return the difference between two index sets.

Collective.

iset (IS) -- Index set to compute the difference with.
Index set representing the difference between self and iset.
IS

SEE ALSO:

ISDifference


Source code at petsc4py/PETSc/IS.pyx:650


Create a copy of the index set.

Collective.

SEE ALSO:

IS.copy, ISDuplicate


Source code at petsc4py/PETSc/IS.pyx:239



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) -- The index set to embed into.
  • drop (bool) -- Flag indicating whether to drop indices from self that are not in iset.

The embedded index set.
IS

SEE ALSO:

ISEmbed


Source code at petsc4py/PETSc/IS.pyx:710


Return whether the index sets have the same set of indices or not.

Collective.

iset (IS) -- The index set to compare indices with.
bool

SEE ALSO:

ISEqual


Source code at petsc4py/PETSc/IS.pyx:550


Return the union of two (possibly unsorted) index sets.

Collective.

To compute the union, expand concatenates the two index sets and removes any duplicates.

iset (IS) -- Index set to compute the union with.
The new, combined, index set.
IS

SEE ALSO:

ISExpand


Source code at petsc4py/PETSc/IS.pyx:588


Return the indices of an index set with type IS.Type.BLOCK.

Not collective.

SEE ALSO:

ISBlockGetIndices


Source code at petsc4py/PETSc/IS.pyx:833

ArrayInt


Return the number of elements in a block.

Not collective.

SEE ALSO:

ISGetBlockSize


Source code at petsc4py/PETSc/IS.pyx:437



Return the indices of the index set.

Not collective.

SEE ALSO:

ISGetIndices


Source code at petsc4py/PETSc/IS.pyx:789

ArrayInt


Return stride information for an index set with type IS.Type.STRIDE.

Not collective.

  • first (int) -- First element of the index set.
  • step (int) -- Difference between adjacent indices.

tuple[int, int]

SEE ALSO:

IS.getStride, ISStrideGetInfo


Source code at petsc4py/PETSc/IS.pyx:903


Return the process-local length of the index set.

Not collective.

SEE ALSO:

ISGetLocalSize


Source code at petsc4py/PETSc/IS.pyx:401



Return the global length of an index set.

Not collective.

SEE ALSO:

ISGetSize


Source code at petsc4py/PETSc/IS.pyx:387



Return the local and global sizes of the index set.

Not collective.

  • local_size (int) -- The local size.
  • global_size (int) -- The global size.

tuple[int, int]

SEE ALSO:

IS.getLocalSize, IS.getSize


Source code at petsc4py/PETSc/IS.pyx:415


Return size and stride information.

Not collective.

  • size (int) -- Length of the locally owned portion of the index set.
  • first (int) -- First element of the index set.
  • step (int) -- Difference between adjacent indices.

tuple[int, int, int]

SEE ALSO:

ISGetLocalSize, ISStrideGetInfo


Source code at petsc4py/PETSc/IS.pyx:879


Return the index set type associated with the IS.

Not collective.

SEE ALSO:

ISGetType


Source code at petsc4py/PETSc/IS.pyx:128



Invert the index set.

Collective.

For this to be correct the index set must be a permutation.

nlocal (int | None) -- The number of indices on this processor in the resulting index set, defaults to PETSC_DECIDE.
IS

SEE ALSO:

ISInvertPermutation


Source code at petsc4py/PETSc/IS.pyx:363


Return whether the index set has been declared as an identity.

Collective.

SEE ALSO:

ISIdentity


Source code at petsc4py/PETSc/IS.pyx:536



Return whether an index set has been declared to be a permutation.

Logically collective.

SEE ALSO:

ISPermutation


Source code at petsc4py/PETSc/IS.pyx:509



Return whether the indices have been sorted.

Collective.

SEE ALSO:

ISSorted


Source code at petsc4py/PETSc/IS.pyx:482



Load a stored index set.

Collective.

viewer (Viewer) -- Binary file viewer, either Viewer.Type.BINARY or Viewer.Type.HDF5.
Self

SEE ALSO:

ISLoad


Source code at petsc4py/PETSc/IS.pyx:281


Renumber the non-negative entries of an index set, starting from 0.

Collective.

mult (IS | None) -- The multiplicity of each entry in self, default implies a multiplicity of 1.
  • int -- One past the largest entry of the new index set.
  • IS -- The renumbered index set.

tuple[int, IS]

SEE ALSO:

ISRenumber


Source code at petsc4py/PETSc/IS.pyx:741


Set the indices for an index set with type IS.Type.BLOCK.

Collective.

  • bsize (int) -- Number of elements in each block.
  • indices (Sequence[int]) -- List of integers.

None

SEE ALSO:

ISBlockSetIndices


Source code at petsc4py/PETSc/IS.pyx:810


Set the block size of the index set.

Logically collective.

bs (int) -- Block size.
None

SEE ALSO:

ISSetBlockSize


Source code at petsc4py/PETSc/IS.pyx:451


Mark the index set as being an identity.

Logically collective.

SEE ALSO:

ISSetIdentity


Source code at petsc4py/PETSc/IS.pyx:523



Set the indices of an index set.

Logically collective.

The index set is assumed to be of type IS.Type.GENERAL.

SEE ALSO:

ISGeneralSetIndices


Source code at petsc4py/PETSc/IS.pyx:772

indices (Sequence[int])
None


Mark the index set as being a permutation.

Logically collective.

SEE ALSO:

ISSetPermutation


Source code at petsc4py/PETSc/IS.pyx:496



Set the stride information for an index set with type IS.Type.STRIDE.

Logically collective.

  • size (int) -- Length of the locally owned portion of the index set.
  • first (int) -- First element of the index set.
  • step (int) -- Difference between adjacent indices.

None

SEE ALSO:

ISStrideSetStride


Source code at petsc4py/PETSc/IS.pyx:855


Set the type of the index set.

Collective.

is_type (Type | str) -- The index set type.
None

SEE ALSO:

ISSetType


Source code at petsc4py/PETSc/IS.pyx:109


Sort the indices of an index set.

Collective.

SEE ALSO:

ISSort


Source code at petsc4py/PETSc/IS.pyx:469



Return the union of two (sorted) index sets.

Collective.

iset (IS) -- The index set to compute the union with.
IS

SEE ALSO:

ISSum


Source code at petsc4py/PETSc/IS.pyx:569


Convert the index set type to IS.Type.GENERAL.

Collective.

SEE ALSO:

ISToGeneral, ISType


Source code at petsc4py/PETSc/IS.pyx:320



Return the union of two (possibly unsorted) index sets.

Collective.

This function will call either ISSum or ISExpand depending on whether or not the input sets are already sorted.

Sequential only (as ISSum is sequential only).

iset (IS) -- Index set to compute the union with.
The new, combined, index set.
IS

SEE ALSO:

IS.expand, IS.sum


Source code at petsc4py/PETSc/IS.pyx:615


Display the index set.

Collective.

viewer (Viewer | None) -- Viewer used to display the IS.
None

SEE ALSO:

ISView


Source code at petsc4py/PETSc/IS.pyx:56


Attributes Documentation

View of the index set as an array of integers.

Not collective.

Source code at petsc4py/PETSc/IS.pyx:1032


The number of elements in a block.

Not collective.

SEE ALSO:

IS.getBlockSize


Source code at petsc4py/PETSc/IS.pyx:1006


True if index set is an identity, False otherwise.

Collective.

SEE ALSO:

IS.isIdentity


Source code at petsc4py/PETSc/IS.pyx:939


The indices of the index set.

Not collective.

SEE ALSO:

IS.getIndices


Source code at petsc4py/PETSc/IS.pyx:1019


The local size of the index set.

Not collective.

SEE ALSO:

IS.getLocalSize


Source code at petsc4py/PETSc/IS.pyx:993


True if index set is a permutation, False otherwise.

Logically collective.

SEE ALSO:

IS.isPermutation


Source code at petsc4py/PETSc/IS.pyx:926


The global size of the index set.

Not collective.

SEE ALSO:

IS.getSize


Source code at petsc4py/PETSc/IS.pyx:980


The local and global sizes of the index set.

Not collective.

SEE ALSO:

IS.getSizes


Source code at petsc4py/PETSc/IS.pyx:967


True if index set is sorted, False otherwise.

Collective.

SEE ALSO:

IS.isSorted


Source code at petsc4py/PETSc/IS.pyx:952




petsc4py.PETSc.InsertMode

Bases: object

Insertion mode.

Most commonly used insertion modes are:

Insert provided value/s discarding previous value/s.
Add provided value/s to current value/s.
Insert the maximum of provided value/s and current value/s.

SEE ALSO:

InsertMode


Attributes Summary

ADD Constant ADD of type int
ADD_ALL Constant ADD_ALL of type int
ADD_ALL_VALUES Constant ADD_ALL_VALUES of type int
ADD_BC Constant ADD_BC of type int
ADD_BC_VALUES Constant ADD_BC_VALUES of type int
ADD_VALUES Constant ADD_VALUES of type int
INSERT Constant INSERT of type int
INSERT_ALL Constant INSERT_ALL of type int
INSERT_ALL_VALUES Constant INSERT_ALL_VALUES of type int
INSERT_BC Constant INSERT_BC of type int
INSERT_BC_VALUES Constant INSERT_BC_VALUES of type int
INSERT_VALUES Constant INSERT_VALUES of type int
MAX Constant MAX of type int
MAX_VALUES Constant MAX_VALUES of type int
NOT_SET_VALUES Constant NOT_SET_VALUES of type int

Attributes Documentation

Constant ADD of type int

Constant ADD_ALL of type int

Constant ADD_ALL_VALUES of type int

Constant ADD_BC of type int

Constant ADD_BC_VALUES of type int

Constant ADD_VALUES of type int

Constant INSERT of type int

Constant INSERT_ALL of type int

Constant INSERT_ALL_VALUES of type int

Constant INSERT_BC of type int

Constant INSERT_BC_VALUES of type int

Constant INSERT_VALUES of type int

Constant MAX of type int

Constant MAX_VALUES of type int

Constant NOT_SET_VALUES of type int


petsc4py.PETSc.KSP

Bases: 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, meaning that only application of the preconditioner is used as the linear solver.

SEE ALSO:

create, setType, SNES, TS, PC, Type.CG, Type.GMRES, KSP


Enumerations

ConvergedReason KSP Converged Reason.
HPDDMType The HPDDM Krylov solver type.
NormType KSP norm type.
Type KSP Type.

petsc4py.PETSc.KSP.ConvergedReason

Bases: object

KSP Converged Reason.

Still iterating
Still iterating
Undocumented.
Undocumented.
∥r∥ <= rtolnorm(b) or rtolnorm(b - Ax₀)
∥r∥ <= atol
Used by the Type.PREONLY solver after the single iteration of the preconditioner is applied. Also used when the KSPConvergedSkip convergence test routine is set in KSP.
Undocumented.
Undocumented.
Undocumented.
Undocumented.
Ran out of iterations before any convergence criteria was reached.
norm(r) >= dtol*norm(b)
A breakdown in the Krylov method was detected so the method could not continue to enlarge the Krylov space. Could be due to a singular matrix or preconditioner. In KSPHPDDM, this is also returned when some search directions within a block are colinear.
A breakdown in the KSPBICG method was detected so the method could not continue to enlarge the Krylov space.
It appears the operator or preconditioner is not symmetric and this Krylov method (Type.CG, Type.MINRES, Type.CR) requires symmetry.
It appears the preconditioner is indefinite (has both positive and negative eigenvalues) and this Krylov method (Type.CG) requires it to be positive definite.
Undocumented.
Undocumented.
It was not possible to build or use the requested preconditioner. This is usually due to a zero pivot in a factorization. It can also result from a failure in a subpreconditioner inside a nested preconditioner such as PC.Type.FIELDSPLIT.

SEE ALSO:

None


Attributes Summary

CONVERGED_ATOL Constant CONVERGED_ATOL of type int
CONVERGED_ATOL_NORMAL Constant CONVERGED_ATOL_NORMAL of type int
CONVERGED_HAPPY_BREAKDOWN Constant CONVERGED_HAPPY_BREAKDOWN of type int
CONVERGED_ITERATING Constant CONVERGED_ITERATING of type int
CONVERGED_ITS Constant CONVERGED_ITS of type int
CONVERGED_NEG_CURVE Constant CONVERGED_NEG_CURVE of type int
CONVERGED_RTOL Constant CONVERGED_RTOL of type int
CONVERGED_RTOL_NORMAL Constant CONVERGED_RTOL_NORMAL of type int
CONVERGED_STEP_LENGTH Constant CONVERGED_STEP_LENGTH of type int
DIVERGED_BREAKDOWN Constant DIVERGED_BREAKDOWN of type int
DIVERGED_BREAKDOWN_BICG Constant DIVERGED_BREAKDOWN_BICG of type int
DIVERGED_DTOL Constant DIVERGED_DTOL of type int
DIVERGED_INDEFINITE_MAT Constant DIVERGED_INDEFINITE_MAT of type int
DIVERGED_INDEFINITE_PC Constant DIVERGED_INDEFINITE_PC of type int
DIVERGED_MAX_IT Constant DIVERGED_MAX_IT of type int
DIVERGED_NANORINF Constant DIVERGED_NANORINF of type int
DIVERGED_NONSYMMETRIC Constant DIVERGED_NONSYMMETRIC of type int
DIVERGED_NULL Constant DIVERGED_NULL of type int
DIVERGED_PCSETUP_FAILED Constant DIVERGED_PCSETUP_FAILED of type int
ITERATING Constant ITERATING of type int

Attributes Documentation

Constant CONVERGED_ATOL of type int

Constant CONVERGED_ATOL_NORMAL of type int

Constant CONVERGED_HAPPY_BREAKDOWN of type int

Constant CONVERGED_ITERATING of type int

Constant CONVERGED_ITS of type int

Constant CONVERGED_NEG_CURVE of type int

Constant CONVERGED_RTOL of type int

Constant CONVERGED_RTOL_NORMAL of type int

Constant CONVERGED_STEP_LENGTH of type int

Constant DIVERGED_BREAKDOWN of type int

Constant DIVERGED_BREAKDOWN_BICG of type int

Constant DIVERGED_DTOL of type int

Constant DIVERGED_INDEFINITE_MAT of type int

Constant DIVERGED_INDEFINITE_PC of type int

Constant DIVERGED_MAX_IT of type int

Constant DIVERGED_NANORINF of type int

Constant DIVERGED_NONSYMMETRIC of type int

Constant DIVERGED_NULL of type int

Constant DIVERGED_PCSETUP_FAILED of type int

Constant ITERATING of type int


petsc4py.PETSc.KSP.HPDDMType

Bases: object

The HPDDM Krylov solver type.

Attributes Summary

BCG Constant BCG of type int
BFBCG Constant BFBCG of type int
BGCRODR Constant BGCRODR of type int
BGMRES Constant BGMRES of type int
CG Constant CG of type int
GCRODR Constant GCRODR of type int
GMRES Constant GMRES of type int
PREONLY Constant PREONLY of type int

Attributes Documentation

Constant BCG of type int

Constant BFBCG of type int

Constant BGCRODR of type int

Constant BGMRES of type int

Constant CG of type int

Constant GCRODR of type int

Constant GMRES of type int

Constant PREONLY of type int


petsc4py.PETSc.KSP.NormType

Bases: object

KSP norm type.

The available norm types are:

Skips computing the norm, this should generally only be used if you are using the Krylov method as a smoother with a fixed small number of iterations. Implicitly sets KSPConvergedSkip as KSP convergence test. Note that certain algorithms such as Type.GMRES ALWAYS require the norm calculation, for these methods the norms are still computed, they are just not used in the convergence test.
The default for left preconditioned solves, uses the l₂ norm of the preconditioned residual P⁻¹(b - Ax).
Uses the l₂ norm of the true b - Ax residual.
Supported by Type.CG, Type.CR, Type.CGNE, Type.CGS.

Attributes Summary

DEFAULT Constant DEFAULT of type int
NATURAL Constant NATURAL of type int
NO Constant NO of type int
NONE Constant NONE of type int
NORM_DEFAULT Constant NORM_DEFAULT of type int
NORM_NATURAL Constant NORM_NATURAL of type int
NORM_NONE Constant NORM_NONE of type int
NORM_PRECONDITIONED Constant NORM_PRECONDITIONED of type int
NORM_UNPRECONDITIONED Constant NORM_UNPRECONDITIONED of type int
PRECONDITIONED Constant PRECONDITIONED of type int
UNPRECONDITIONED Constant UNPRECONDITIONED of type int

Attributes Documentation

Constant DEFAULT of type int

Constant NATURAL of type int

Constant NO of type int

Constant NONE of type int

Constant NORM_DEFAULT of type int

Constant NORM_NATURAL of type int

Constant NORM_NONE of type int

Constant NORM_PRECONDITIONED of type int

Constant NORM_UNPRECONDITIONED of type int

Constant PRECONDITIONED of type int

Constant UNPRECONDITIONED of type int


petsc4py.PETSc.KSP.Type

Bases: object

KSP Type.

The available types are:

The preconditioned Richardson iterative method KSPRICHARDSON.
The preconditioned Chebyshev iterative method. KSPCHEBYSHEV.
The Preconditioned Conjugate Gradient (PCG) iterative method. KSPCG
A pipelined conjugate gradient method (Gropp). KSPGROPPCG
A pipelined conjugate gradient method. KSPPIPECG
Pipelined Conjugate Gradients with Residual Replacement. KSPPIPECGRR
Deep pipelined (length l) Conjugate Gradient method. KSPPIPELCG
Pipelined predict-and-recompute conjugate gradient method. KSPPIPEPRCG
Pipelined conjugate gradient method with a single non-blocking reduction per two iterations. KSPPIPECG2
Applies the preconditioned conjugate gradient method to the normal equations without explicitly forming AᵀA. KSPCGNE
Conjugate gradient method subject to a constraint on the solution norm. KSPNASH
Conjugate gradient method subject to a constraint on the solution norm. KSPSTCG
Conjugate gradient method subject to a constraint on the solution norm. KSPGLTR
Flexible Conjugate Gradient method (FCG). Unlike most KSP methods this allows the preconditioner to be nonlinear. KSPFCG
Pipelined, Flexible Conjugate Gradient method. KSPPIPEFCG
Generalized Minimal Residual method with restart. KSPGMRES
Pipelined (1-stage) Flexible Generalized Minimal Residual method. KSPPIPEFGMRES
Implements the Flexible Generalized Minimal Residual method. KSPFGMRES
Augments the standard Generalized Minimal Residual method approximation space with approximations to the error from previous restart cycles. KSPLGMRES
Deflated Generalized Minimal Residual method. In this implementation, the adaptive strategy allows to switch to the deflated GMRES when the stagnation occurs. KSPDGMRES
Pipelined Generalized Minimal Residual method. KSPPGMRES
A variant of Quasi Minimal Residual (QMR). KSPTCQMR
Stabilized version of Biconjugate Gradient (BiCGStab) method. KSPBCGS
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
Quasi- Minimal Residual variant of the Bi-CGStab algorithm (QMRCGStab) method. KSPQMRCGS
Flexible Stabilized version of BiConjugate Gradient (BiCGStab) method. KSPFBCGS
A mathematically equivalent variant of flexible stabilized BiConjugate Gradient (BiCGStab). KSPFBCGSR
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
Pipelined stabilized BiConjugate Gradient (BiCGStab) method. KSPPIPEBCGS
Conjugate Gradient Squared method. KSPCGS
A Transpose Tree Quasi- Minimal Residual (QMR). KSPCR
(Preconditioned) Conjugate Residuals (CR) method. KSPCR
Pipelined Conjugate Residual (CR) method. KSPPIPECR
Least squares solver. KSPLSQR
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
No solver KSPNONE
Conjugate Gradient (CG) method subject to a constraint on the solution norm. KSPQCG
Implements the Biconjugate gradient method (BiCG). Similar to running the conjugate gradient on the normal equations. KSPBICG
Minimum Residual (MINRES) method. KSPMINRES
Symmetric LQ method (SymmLQ). Uses LQ decomposition (lower trapezoidal). KSPSYMMLQ
Left Conjugate Direction (LCD) method. KSPLCD
Python shell solver. Call Python function to implement solver. KSPPYTHON
Preconditioned flexible Generalized Conjugate Residual (GCR) method. KSPGCR
Pipelined Generalized Conjugate Residual method. KSPPIPEGCR
Two-Stage Iteration with least-squares Residual Minimization method. KSPTSIRM
Conjugate Gradient method for Least-Squares problems. Supports non-square (rectangular) matrices. KSPCGLS
Dual-Primal (DP) Finite Element Tearing and Interconnect (FETI) method. KSPFETIDP
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

SEE ALSO:

Working with PETSc options, KSPType


Attributes Summary

BCGS Object BCGS of type str
BCGSL Object BCGSL of type str
BICG Object BICG of type str
CG Object CG of type str
CGLS Object CGLS of type str
CGNE Object CGNE of type str
CGS Object CGS of type str
CHEBYSHEV Object CHEBYSHEV of type str
CR Object CR of type str
DGMRES Object DGMRES of type str
FBCGS Object FBCGS of type str
FBCGSR Object FBCGSR of type str
FCG Object FCG of type str
FETIDP Object FETIDP of type str
FGMRES Object FGMRES of type str
GCR Object GCR of type str
GLTR Object GLTR of type str
GMRES Object GMRES of type str
GROPPCG Object GROPPCG of type str
HPDDM Object HPDDM of type str
IBCGS Object IBCGS of type str
LCD Object LCD of type str
LGMRES Object LGMRES of type str
LSQR Object LSQR of type str
MINRES Object MINRES of type str
NASH Object NASH of type str
NONE Object NONE of type str
PGMRES Object PGMRES of type str
PIPEBCGS Object PIPEBCGS of type str
PIPECG Object PIPECG of type str
PIPECG2 Object PIPECG2 of type str
PIPECGRR Object PIPECGRR of type str
PIPECR Object PIPECR of type str
PIPEFCG Object PIPEFCG of type str
PIPEFGMRES Object PIPEFGMRES of type str
PIPEGCR Object PIPEGCR of type str
PIPELCG Object PIPELCG of type str
PIPEPRCG Object PIPEPRCG of type str
PREONLY Object PREONLY of type str
PYTHON Object PYTHON of type str
QCG Object QCG of type str
QMRCGS Object QMRCGS of type str
RICHARDSON Object RICHARDSON of type str
STCG Object STCG of type str
SYMMLQ Object SYMMLQ of type str
TCQMR Object TCQMR of type str
TFQMR Object TFQMR of type str
TSIRM Object TSIRM of type str

Attributes Documentation

Object BCGS of type str

Object BCGSL of type str

Object BICG of type str

Object CG of type str

Object CGLS of type str

Object CGNE of type str

Object CGS of type str

Object CHEBYSHEV of type str

Object CR of type str

Object DGMRES of type str

Object FBCGS of type str

Object FBCGSR of type str

Object FCG of type str

Object FETIDP of type str

Object FGMRES of type str

Object GCR of type str

Object GLTR of type str

Object GMRES of type str

Object GROPPCG of type str

Object HPDDM of type str

Object IBCGS of type str

Object LCD of type str

Object LGMRES of type str

Object LSQR of type str

Object MINRES of type str

Object NASH of type str

Object NONE of type str

Object PGMRES of type str

Object PIPEBCGS of type str

Object PIPECG of type str

Object PIPECG2 of type str

Object PIPECGRR of type str

Object PIPECR of type str

Object PIPEFCG of type str

Object PIPEFGMRES of type str

Object PIPEGCR of type str

Object PIPELCG of type str

Object PIPEPRCG of type str

Object PREONLY of type str

Object PYTHON of type str

Object QCG of type str

Object QMRCGS of type str

Object RICHARDSON of type str

Object STCG of type str

Object SYMMLQ of type str

Object TCQMR of type str

Object TFQMR of type str

Object TSIRM of type str


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 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 that may be used by some preconditioners.
setDMActive(flag) 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 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.
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.
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 of the solver.
pc_side The side on which preconditioning is performed.
reason The converged reason.
rtol The relative tolerance of the solver.
vec_rhs The right-hand side vector.
vec_sol The solution vector.

Methods Documentation

Add the function to be used to determine convergence.

Logically collective.

  • converged (KSPConvergenceTestFunction) -- Callback which computes the convergence.
  • args (tuple[Any, ...] | None) -- Positional arguments for callback function.
  • kargs (dict[str, Any] | None) -- Keyword arguments for callback function.
  • prepend (bool) -- Whether to prepend this call before the default convergence test or call it after.

None

Notes

Cannot be mixed with a call to setConvergenceTest. It can only be called once. If called multiple times, it will generate an error.

SEE ALSO:

setTolerances, getConvergenceTest, setConvergenceTest, KSPSetConvergenceTest, KSPConvergedDefault


Source code at petsc4py/PETSc/KSP.pyx:1065


Append to prefix used for all KSP options in the database.

Logically collective.

prefix (str | None) -- The options prefix to append.
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:

KSPAppendOptionsPrefix


Source code at petsc4py/PETSc/KSP.pyx:575


Return the residual of the linear system.

Collective.

r (Vec | None) -- Optional vector to use for the result.
Vec

SEE ALSO:

buildSolution, KSPBuildResidual


Source code at petsc4py/PETSc/KSP.pyx:2063


Return the solution vector.

Collective.

x (Vec | None) -- Optional vector to store the solution.
Vec

SEE ALSO:

buildResidual, KSPBuildSolution


Source code at petsc4py/PETSc/KSP.pyx:2041


Call the convergence test callback.

Collective.

  • its (int) -- Number of iterations.
  • rnorm (float) -- The residual norm.

None

Notes

This functionality is implemented in petsc4py.

Source code at petsc4py/PETSc/KSP.pyx:1121


Compute the extreme eigenvalues for the preconditioned operator.

Not collective.

SEE ALSO:

KSPComputeEigenvalues


Source code at petsc4py/PETSc/KSP.pyx:2085

ArrayComplex


Compute the extreme singular values for the preconditioned operator.

Collective.

  • smax (float) -- The maximum singular value.
  • smin (float) -- The minimum singular value.

tuple[float, float]

SEE ALSO:

KSPComputeExtremeSingularValues


Source code at petsc4py/PETSc/KSP.pyx:2108


Create the KSP context.

Collective.

SEE ALSO:

KSPCreate


Source code at petsc4py/PETSc/KSP.pyx:457

comm (Comm | None)
Self


Create a linear solver of Python type.

Collective.

  • context (Any) -- An instance of the Python class implementing the required methods.
  • comm (Comm | None) -- MPI communicator, defaults to Sys.getDefaultComm.

Self

SEE ALSO:

PETSc Python linear solver type, setType, setPythonContext, Type.PYTHON


Source code at petsc4py/PETSc/KSP.pyx:2154


Destroy KSP context.

Collective.

SEE ALSO:

KSPDestroy


Source code at petsc4py/PETSc/KSP.pyx:444



Return the user-defined context for the linear solver.

Not collective.

SEE ALSO:

setAppCtx


Source code at petsc4py/PETSc/KSP.pyx:640



Return the CG objective function value.

Not collective.

SEE ALSO:

KSPCGGetObjFcn


Source code at petsc4py/PETSc/KSP.pyx:1882

float


Return flag indicating whether eigenvalues will be calculated.

Not collective.

Return the flag indicating that the extreme eigenvalues values will be calculated via a Lanczos or Arnoldi process as the linear system is solved.

SEE ALSO:

setComputeEigenvalues, KSPSetComputeEigenvalues


Source code at petsc4py/PETSc/KSP.pyx:1430



Return flag indicating whether singular values will be calculated.

Not collective.

Return the flag indicating whether the extreme singular values will be calculated via a Lanczos or Arnoldi process as the linear system is solved.

SEE ALSO:

setComputeSingularValues, KSPGetComputeSingularValues


Source code at petsc4py/PETSc/KSP.pyx:1474



Use reason property.

Source code at petsc4py/PETSc/KSP.pyx:1876

ConvergedReason


Return array containing the residual history.

Not collective.

SEE ALSO:

setConvergenceHistory, KSPGetResidualHistory


Source code at petsc4py/PETSc/KSP.pyx:1188

ArrayReal


Return the function to be used to determine convergence.

Logically collective.

SEE ALSO:

setTolerances, setConvergenceTest, KSPGetConvergenceTest, KSPConvergedDefault


Source code at petsc4py/PETSc/KSP.pyx:1108

KSPConvergenceTestFunction


Return the DM that may be used by some preconditioners.

Not collective.

SEE ALSO:

PETSc.KSP, DM, KSPGetDM


Source code at petsc4py/PETSc/KSP.pyx:654



Return the flag indicating the solver will error if divergent.

Not collective.

SEE ALSO:

KSPGetErrorIfNotConverged


Source code at petsc4py/PETSc/KSP.pyx:1946



Return the Krylov solver type.

Not collective.

SEE ALSO:

KSPHPDDMGetType


Source code at petsc4py/PETSc/KSP.pyx:1914

HPDDMType


Determine whether the KSP solver is using the Knoll trick.

Not collective.

This uses the Knoll trick; using PC.apply to compute the initial guess.

SEE ALSO:

KSPGetInitialGuessKnoll


Source code at petsc4py/PETSc/KSP.pyx:1550



Determine whether the KSP solver uses a zero initial guess.

Not collective.

SEE ALSO:

KSPGetInitialGuessNonzero


Source code at petsc4py/PETSc/KSP.pyx:1516



Use its property.

Source code at petsc4py/PETSc/KSP.pyx:1854



Return function used to monitor the residual.

Not collective.

SEE ALSO:

Working with PETSc options, setMonitor, monitor, monitorCancel, KSPGetMonitorContext


Source code at petsc4py/PETSc/KSP.pyx:1266

KSPMonitorFunction


Return the norm that is used for convergence testing.

Not collective.

SEE ALSO:

NormType, setNormType, KSPGetNormType, KSPConvergedSkip


Source code at petsc4py/PETSc/KSP.pyx:1390

NormType


Return the matrix associated with the linear system.

Collective.

Return the matrix associated with the linear system and a (possibly) different one used to construct the preconditioner.

  • A (Mat) -- Matrix that defines the linear system.
  • P (Mat) -- Matrix to be used in constructing the preconditioner, usually the same as A.

tuple[Mat, Mat]

SEE ALSO:

PETSc.KSP, solve, setOperators, KSPGetOperators


Source code at petsc4py/PETSc/KSP.pyx:850


Return the prefix used for all KSP options in the database.

Not collective.

SEE ALSO:

KSPGetOptionsPrefix


Source code at petsc4py/PETSc/KSP.pyx:561



Return the preconditioner.

Not collective.

SEE ALSO:

PETSc.KSP, setPC, KSPGetPC


Source code at petsc4py/PETSc/KSP.pyx:897



Return the preconditioning side.

Not collective.

SEE ALSO:

Working with PETSc options, setPCSide, setNormType, getNormType, KSPGetPCSide


Source code at petsc4py/PETSc/KSP.pyx:1349



Return the instance of the class implementing Python methods.

Not collective.

SEE ALSO:

PETSc Python linear solver type, setPythonContext


Source code at petsc4py/PETSc/KSP.pyx:2195



Return the fully qualified Python name of the class used by the solver.

Not collective.

SEE ALSO:

PETSc Python linear solver type, setPythonContext, setPythonType, KSPPythonGetType


Source code at petsc4py/PETSc/KSP.pyx:2225



Use norm property.

Source code at petsc4py/PETSc/KSP.pyx:1865

float


Return the right-hand side vector for the linear system.

Not collective.

SEE ALSO:

KSPGetRhs


Source code at petsc4py/PETSc/KSP.pyx:1960



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:

KSPGetSolution


Source code at petsc4py/PETSc/KSP.pyx:1975



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) -- The relative convergence tolerance
  • atol (float) -- The absolute convergence tolerance
  • dtol (float) -- The divergence tolerance
  • maxits (int) -- Maximum number of iterations

tuple[float, float, float, int]

SEE ALSO:

setTolerances, KSPGetTolerances


Source code at petsc4py/PETSc/KSP.pyx:971


Return the KSP type as a string from the KSP object.

Not collective.

SEE ALSO:

KSPGetType


Source code at petsc4py/PETSc/KSP.pyx:509



Create working vectors.

Collective.

  • right (int | None) -- Number of right hand vectors to allocate.
  • left (int | None) -- Number of left hand vectors to allocate.

  • R (list of Vec) -- List of correctly allocated right hand vectors.
  • L (list of Vec) -- List of correctly allocated left hand vectors.

tuple[list[Vec], list[Vec]] | list[Vec] | None

Source code at petsc4py/PETSc/KSP.pyx:1993


Add residual to convergence history.

Logically collective.

rnorm (float) -- Residual norm to be added to convergence history.
None

Source code at petsc4py/PETSc/KSP.pyx:1203


Solve a linear system with multiple right-hand sides.

Collective.

These are stored as a Mat.Type.DENSE. Unlike solve, B and X must be different matrices.

  • B (Mat) -- Block of right-hand sides.
  • X (Mat) -- Block of solutions.

None

SEE ALSO:

solve, KSPMatSolve


Source code at petsc4py/PETSc/KSP.pyx:1808


Solve the transpose of a linear system with multiple RHS.

Collective.

  • B (Mat) -- Block of right-hand sides.
  • X (Mat) -- Block of solutions.

None

SEE ALSO:

solveTranspose, KSPMatSolve


Source code at petsc4py/PETSc/KSP.pyx:1830


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:

setMonitor, KSPMonitor


Source code at petsc4py/PETSc/KSP.pyx:1294

  • its (int)
  • rnorm (float)

None


Clear all monitors for a KSP object.

Logically collective.

SEE ALSO:

Working with PETSc options, getMonitor, setMonitor, monitor, KSPMonitorCancel


Source code at petsc4py/PETSc/KSP.pyx:1279



Resets a KSP context.

Collective.

Resets a KSP context to the kspsetupcalled = 0 state and removes any allocated Vecs and Mats.

SEE ALSO:

KSPReset


Source code at petsc4py/PETSc/KSP.pyx:1607



Set the optional user-defined context for the linear solver.

Not collective.

appctx (Any) -- The user defined context
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:

getAppCtx


Source code at petsc4py/PETSc/KSP.pyx:617


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.

flag (bool) -- Boolean whether to compute eigenvalues (or not).
None

Notes

Currently this option is not valid for all iterative methods.

SEE ALSO:

getComputeEigenvalues, KSPSetComputeEigenvalues


Source code at petsc4py/PETSc/KSP.pyx:1404


Set routine to compute the linear operators.

Logically collective.

  • operators (KSPOperatorsFunction) -- Function which computes the operators.
  • args (tuple[Any, ...] | None) -- Positional arguments for callback function operators.
  • kargs (dict[str, Any] | None) -- Keyword arguments for callback function operators.

None

Notes

The user provided function 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.

SEE ALSO:

PETSc.KSP, solve, setOperators, KSPSetComputeOperators, KSPSetReusePreconditioner


Source code at petsc4py/PETSc/KSP.pyx:764


Set routine to compute the right-hand side of the linear system.

Logically collective.

  • rhs (KSPRHSFunction) -- Function which computes the right-hand side.
  • args (tuple[Any, ...] | None) -- Positional arguments for callback function rhs.
  • kargs (dict[str, Any] | None) -- Keyword arguments for callback function rhs.

None

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:

PETSc.KSP, solve, KSPSetComputeRHS


Source code at petsc4py/PETSc/KSP.pyx:730


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.

flag (bool) -- Boolean whether to compute singular values (or not).
None

Notes

Currently this option is not valid for all iterative methods.

SEE ALSO:

getComputeSingularValues, KSPSetComputeSingularValues


Source code at petsc4py/PETSc/KSP.pyx:1448


Use reason property.

Source code at petsc4py/PETSc/KSP.pyx:1871

reason (ConvergedReason)
None


Set the array used to hold the residual history.

Not collective.

If set, this array will contain the residual norms computed at each iteration of the solver.

  • length (int | None) -- Length of array to store history in.
  • reset (bool) -- True indicates the history counter is reset to zero for each new linear solve.

None

Notes

If length is not provided or None then a default array of length 10000 is allocated.

If the array is not long enough then once the iterations is longer than the array length solve stops recording the history.

SEE ALSO:

getConvergenceHistory, KSPSetResidualHistory


Source code at petsc4py/PETSc/KSP.pyx:1144


Set the function to be used to determine convergence.

Logically collective.

  • converged (KSPConvergenceTestFunction) -- Callback which computes the convergence.
  • args (tuple[Any, ...] | None) -- Positional arguments for callback function.
  • kargs (dict[str, Any] | None) -- Keyword arguments for callback function.

None

Notes

Must be called after the KSP type has been set so put this after a call to setType, or setFromOptions.

The default is a combination of relative and absolute tolerances. The residual value that is tested may be an approximation; routines that need exact values should compute them.

SEE ALSO:

addConvergenceTest, ConvergedReason, setTolerances, getConvergenceTest, buildResidual, KSPSetConvergenceTest, KSPConvergedDefault


Source code at petsc4py/PETSc/KSP.pyx:1000


Set the DM that may be used by some preconditioners.

Logically collective.

dm (DM) -- The DM object, cannot be None.
None

Notes

If this is used then the KSP will attempt to use the DM to create the matrix and use the routine set with DM.setKSPComputeOperators. Use setDMActive(False) to instead use the matrix you have provided with setOperators.

A DM can only be used for solving one problem at a time because information about the problem is stored on the DM, even when not using interfaces like DM.setKSPComputeOperators. Use DM.clone to get a distinct DM when solving different problems using the same function space.

SEE ALSO:

PETSc.KSP, DM, DM.setKSPComputeOperators, setOperators, DM.clone, KSPSetDM


Source code at petsc4py/PETSc/KSP.pyx:671


DM should be used to generate system matrix & RHS vector.

Logically collective.

flag (bool) -- Whether to use the DM.
None

Notes

By default setDM sets the DM as active, call setDMActive(False) after setDM(dm) to not have the KSP object use the DM to generate the matrices.

SEE ALSO:

PETSc.KSP, DM, setDM, KSPSetDMActive


Source code at petsc4py/PETSc/KSP.pyx:704


Cause solve to generate an error if not converged.

Logically collective.

flag (bool) -- True enables this behavior.
None

SEE ALSO:

KSPSetErrorIfNotConverged


Source code at petsc4py/PETSc/KSP.pyx:1928


Set KSP options from the options database.

Collective.

This routine must be called before setUp if the user is to be allowed to set the Krylov type.

SEE ALSO:

Working with PETSc options, KSPSetFromOptions


Source code at petsc4py/PETSc/KSP.pyx:600



Set number of iterations at which KSP restarts.

Logically collective.

Suitable KSPs are: KSPGMRES, KSPFGMRES and KSPLGMRES.

restart (int) -- Integer restart value.
None

SEE ALSO:

KSPGMRESSetRestart


Source code at petsc4py/PETSc/KSP.pyx:2132


Set the Krylov solver type.

Collective.

hpddm_type (HPDDMType) -- The type of Krylov solver to use.
None

SEE ALSO:

KSPHPDDMSetType


Source code at petsc4py/PETSc/KSP.pyx:1896


Tell solver to use PC.apply to compute the initial guess.

Logically collective.

This is the Knoll trick.

flag (bool) -- True uses Knoll trick.
None

SEE ALSO:

KSPSetInitialGuessKnoll


Source code at petsc4py/PETSc/KSP.pyx:1530


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).

flag (bool) -- True indicates the guess is non-zero, False indicates the guess is zero.
None

SEE ALSO:

KSPSetInitialGuessNonzero


Source code at petsc4py/PETSc/KSP.pyx:1494


Use its property.

Source code at petsc4py/PETSc/KSP.pyx:1849

its (int)
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) -- Callback which monitors the convergence.
  • args (tuple[Any, ...] | None) -- Positional arguments for callback function.
  • kargs (dict[str, Any] | None) -- Keyword arguments for callback function.

None

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 as the context.

Several different monitoring routines may be set by calling setMonitor multiple times; all will be called in the order in which they were set.

SEE ALSO:

Working with PETSc options, getMonitor, monitor, monitorCancel, KSPMonitorSet


Source code at petsc4py/PETSc/KSP.pyx:1219


Set the norm that is used for convergence testing.

Logically collective.

normtype (NormType) -- The norm type to use (see NormType).
None

Notes

Not all combinations of preconditioner side (see setPCSide) and norm type are supported by all Krylov methods. If only one is set, PETSc tries to automatically change the other to find a compatible pair. If no such combination is supported, PETSc will generate an error.

SEE ALSO:

NormType, Working with PETSc options, setUp, solve, destroy, setPCSide, getPCSide, NormType, KSPSetNormType, KSPConvergedSkip, KSPSetCheckNormIteration


Source code at petsc4py/PETSc/KSP.pyx:1363


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 | None) -- Matrix that defines the linear system.
  • P (Mat | None) -- Matrix to be used in constructing the preconditioner, usually the same as A.

None

Notes

If you know the operator A has a null space you can use Mat.setNullSpace and 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 for A or P removes the matrix that is currently used.

SEE ALSO:

PETSc.KSP, solve, setComputeOperators, KSPSetOperators


Source code at petsc4py/PETSc/KSP.pyx:809


Set the prefix used for all KSP options in the database.

Logically collective.

prefix (str | None) -- The options prefix.
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:

Working with PETSc options, KSPSetOptionsPrefix


Source code at petsc4py/PETSc/KSP.pyx:523


Set the preconditioner.

Collective.

Set the preconditioner to be use