Changes: 3.23#
General:
Add
PetscCtxDestroyFn
as the prototype for all context destroy functions. It isPetscErrorCode ()(void **)
. Previously some context destructor setters tookPetscErrorCode ()(void *)
. But these would not work directly with PETSc objects as contexts and having two different context destructor models added unneeded complexity to the library. This change is not backward compatibleDeprecate
PetscContainerSetUserDestroy()
withPetscContainerSetCtxDestroy()
, updating will require a small change in calling codeDeprecate
PetscContainerCtxDestroyDefault
withPetscCtxDestroyDefault()
Add
PetscIntViewNumColumns()
,PetscScalarViewNumColumns()
, andPetscRealViewNumColumns()
Change
PetscGetKokkosExecutionSpace()
to return theKokkos::DefaultExecutionSpace
object instead of a reference to it
Configure/Build:
Update
--download-pastix
to use CMake build, with additional dependency on LAPACKE and CBLAS, can use for ex. MKL with--with-blaslapack-dir=${MKLROOT}
, or Netlib LAPACK with--download-netlib-lapack --with-netlib-lapack-c-bindings
Add option
--with-library-name-suffix=<suffix>
Sys:
Add
PetscCIntCast()
Add
PetscObjectHasFunction()
to query for the presence of a composed methodAdd
PetscSortedCheckDupsCount()
andPetscFindCount()
Event Logging:
PetscViewer:
PetscDraw:
AO:
IS:
Add
ISGetCompressOutput()
andISSetCompressOutput()
VecScatter / PetscSF:
PF:
Vec:
Add
PetscKDTree
, an implementation of K-d trees for efficient nearest-neighbor point searches. IncludesPetscKDTreeCreate()
,PetscKDTreeDestroy()
,PetscKDTreeView()
, and thenPetscKDTreeQueryPointsNearestNeighbor()
for actually doing the nearest-neighbor queryAdd
VecKokkosPlaceArray()
andVecKokkosResetArray()
PetscSection:
PetscPartitioner:
Mat:
Add
MatCopyHashToXAIJ()
which allows assembling an XAIJ matrix in hash table form into another XAIJ matrixAdd
MatResetHash()
which allows resetting an XAIJ matrix to use a hash tableAdd
MatCreateSeqAIJKokkosWithKokkosViews()
which allows creation of aMATSEQAIJKOKKOS
matrix with AIJ data in Kokkos viewsChange
MatCreateMPIAIJWithSeqAIJ()
so that B can be passed in with local indices and compactification skippedChange option
-mat_factor_bind_factorization <host | device>
to-pc_factor_mat_factor_on_host <bool>
forMATAIJ
device matricesAdd option
-pc_factor_mat_solve_on_host <bool>
forMATSEQAIJKOKKOS
matrices
MatCoarsen:
PC:
Add
PCHYPREGetCFMarkers()
to extract Coarse/Fine splittings created by BoomerAMG fromPCHYPRE
, similar toPCGetInterpolations()
andPCGetCoarseOperators()
KSP:
SNES:
Add
DMPlexSetSNESVariableBounds()
SNESLineSearch:
Add
SNESLINESEARCHBISECTION
as new SNES line search type, performing a bisection line search on the directional derivativeAdd
SNESLineSearchVIDirDerivFn
to compute directional derivative taking into account VI bounds, and updateSNESLineSearchGetVIFunctions()
andSNESLineSearchSetVIFunctions()
accordingly
TS:
Add
TSSetEvaluationTimes()
,TSGetEvaluationTimes()
, andTSGetEvaluationSolutions()
for evaluating solutions a given list of times. Also activatable via -ts_eval_timesDeprecate
TSGetTimeSpan()
–>TSGetEvaluationTimes()
andTSGetTimeSpanSolutions()
–>TSGetEvaluationSolutions()
TAO:
DM/DA:
Deprecate
DMGetSection()
andDMSetSection()
for existingDMGetLocalSection()
andDMSetLocalSection()
Replace the Fortran array
DMDALocalInfo
with a derived type whose entries match the C structChange the Fortran
DMDAGetNeighbors()
to return aPetscMPIInt, pointer :: n(:)
and add a FortranDMDARestoreNeighbors()
Change the Fortran
DMDAGetOwnershipRanges()
to returnPetscInt, pointer :: n(:)
and add a FortranDMDARestoreOwnershipRanges()
DMSwarm:
Change
DMSwarmVectorGetField()
and addDMSwarmVectorDefineFields()
to handle multiple fieldsAdd
DMSwarmComputeMoments()
Add
DMSwarmCellDMCreate()
,DMSwarmCellDMDestroy()
,DMSwarmCellDMView()
,DMSwarmCellDMGetDM()
,DMSwarmCellDMGetFields()
,DMSwarmCellDMGetCoordinateFields()
,DMSwarmCellDMGetCellID()
,DMSwarmCellDMGetSort()
,DMSwarmCellDMSetSort()
, andDMSwarmCellDMGetBlockSize()
Add
DMSwarmAddCellDM()
,DMSwarmSetCellDMActive()
, andDMSwarmGetCellDMActive()
Add
DMSwarmCreateGlobalVectorFromFields()
,DMSwarmDestroyGlobalVectorFromFields()
,DMSwarmCreateLocalVectorFromFields()
, andDMSwarmDestroyLocalVectorFromFields()
Add
DMSwarmSortDestroy()
Add
DMSwarmRemapType
,DMSwarmRemap()
, andDMSwarmDuplicate()
Add
DMSwarmGetType()
Add
DMSwarmGetCellDMByName()
andDMSwarmGetCellDMNames()
DMPlex:
Add
DMPlexTransformGetMatchStrata()
andDMPlexTransformSetMatchStrata()
Deprecate
DMPlexSetGlobalToNaturalSF()
andDMPlexGetGlobalToNaturalSF()
for existingDMSetNaturalSF()
andDMGetNaturalSF()
Add
-dm_plex_box_label_bd
to setup isoperiodicity when using-dm_plex_box_label_bd
Change
PetscViewerCGNSGetSolutionTime()
to no longer error if “TimeValues” array isn’t found in CGNS fileAdd
DMPlexGetInterpolatePreferTensor()
andDMPlexSetInterpolatePreferTensor()
Add
PetscCallEGADS()
Add
DMPlexTransformGetTransformTypes()
andDMPlexTransformSetTransformTypes()
Several
DMPLEX
functions includingDMPlexVecGetClosure()
now requiring a dummy argument for the length of the returned array, for examplePETSC_NULL_INTEGER
that was previously missing not in the Fortran API.
FE/FV:
Add
PetscFEGeomMode
Change
PetscFEGeomCreate()
,DMFieldCreateFEGeom()
, andDMSNESGetFEGeom()
to takePetscFEGeomMode
DMNetwork:
DMStag:
DT:
Add
PetscDSGetLowerBound()
,PetscDSSetLowerBound()
,PetscDSGetUpperBound()
,PetscDSSetUpperBound()
,PetscDSCopyBounds()
Add
PetscProbComputeKSStatisticWeighted()
andPetscProbComputeKSStatisticMagnitude()
Fortran:
Deprecate all Fortran function names with the suffix F90 with the equivalent function name without the suffix F90. Functions such as
VecGetArray()
now take a Fortran pointer as arguments and hence behave like the deprecatedVecGetArrayF90()
Add
PETSC_NULL_ENUM_XXX
to be used instead ofPETSC_NULL_INTEGER
when a pointer to an XXXenum
is expected in a PETSc function callAdd
PETSC_NULL_INTEGER_ARRAY
,PETSC_NULL_SCALAR_ARRAY
, andPETSC_NULL_REAL_ARRAY
for use instead ofPETSC_NULL_INTEGER
,PETSC_NULL_SCALAR
, andPETSC_NULL_REAL
when an input array is expected in a PETSc function call but not provided by the userAdd
PETSC_NULL_INTEGER_POINTER
for arguments that return as arrays, for example,PetscInt, pointer :: idx(:)
but not needed by the user.Add automatically generated interface definitions for most PETSc functions to detect illegal usage at compile time
Add
PetscObjectIsNull()
for users to check if a PETSc object isNULL
. All PETSc objects are now null when they are declaredChange the PETSc Fortran API so that non-array values,
v
, passed to PETSc routines expecting arrays must be cast with[v]
in the calling sequence. For example, withVecSetValues()
Use of
case(e)
wheree
is any PETSc enum variable or value must be changed toPetscEnumCase(e)
orcase(e%v)
MatInfo
and similar are now derived data types instead of arrays, use e.g.matinfo%nz_allocated
to access their components