LCOV - code coverage report
Current view: top level - home/gitlab-runner/builds/q8svuz_Y/0/slepc/petsc/include - petscvec.h (source / functions) Hit Total Coverage
Test: SLEPc Lines: 8 13 61.5 %
Date: 2024-05-08 00:46:20 Functions: 1 1 100.0 %
Legend: Lines: hit not hit

          Line data    Source code
       1             : /*
       2             :     Defines the vector component of PETSc. Vectors generally represent
       3             :   degrees of freedom for finite element/finite difference functions
       4             :   on a grid. They have more mathematical structure then simple arrays.
       5             : */
       6             : #pragma once
       7             : 
       8             : #include <petscsys.h>
       9             : #include <petscsftypes.h> /* for VecScatter, VecScatterType */
      10             : #include <petscis.h>
      11             : #include <petscdevicetypes.h>
      12             : #include <petscviewer.h>
      13             : 
      14             : /* SUBMANSEC = Vec */
      15             : 
      16             : /*S
      17             :    Vec - Abstract PETSc vector object. Used for holding solutions and right-hand sides for (non) linear systems and integrators
      18             : 
      19             :    Level: beginner
      20             : 
      21             :    Note:
      22             :    Internally the actual vector representation is generally a simple array but most PETSc code can work on other representations through this abstraction
      23             : 
      24             : .seealso: [](doc_vector), [](ch_vectors), `VecCreate()`, `VecType`, `VecSetType()`
      25             : S*/
      26             : typedef struct _p_Vec *Vec;
      27             : 
      28             : /*E
      29             :   ScatterMode - Determines the direction of a scatter
      30             : 
      31             :   Values:
      32             : +  `SCATTER_FORWARD`       - Scatters the values as dictated by the `VecScatterCreate()` call
      33             : .  `SCATTER_REVERSE`       - Moves the values in the opposite direction than the directions indicated in the `VecScatterCreate()` call
      34             : .  `SCATTER_FORWARD_LOCAL` - Scatters the values as dictated by the `VecScatterCreate()` call except NO MPI communication is done
      35             : -  `SCATTER_REVERSE_LOCAL` - Moves the values in the opposite direction than the directions indicated in the `VecScatterCreate()` call
      36             :                              except NO MPI communication is done
      37             : 
      38             :   Level: beginner
      39             : 
      40             : .seealso: [](ch_vectors), `VecScatter`, `VecScatterBegin()`, `VecScatterEnd()`, `SCATTER_FORWARD`, `SCATTER_REVERSE`, `SCATTER_FORWARD_LOCAL`, `SCATTER_REVERSE_LOCAL`
      41             : E*/
      42             : typedef enum {
      43             :   SCATTER_FORWARD       = 0,
      44             :   SCATTER_REVERSE       = 1,
      45             :   SCATTER_FORWARD_LOCAL = 2,
      46             :   SCATTER_REVERSE_LOCAL = 3
      47             : } ScatterMode;
      48             : 
      49             : /*MC
      50             :     SCATTER_FORWARD - Scatters the values as dictated by the `VecScatterCreate()` call
      51             : 
      52             :     Level: beginner
      53             : 
      54             : .seealso: [](ch_vectors), `VecScatter`, `ScatterMode`, `VecScatterCreate()`, `VecScatterBegin()`, `VecScatterEnd()`, `SCATTER_REVERSE`, `SCATTER_FORWARD_LOCAL`,
      55             :           `SCATTER_REVERSE_LOCAL`
      56             : M*/
      57             : 
      58             : /*MC
      59             :     SCATTER_REVERSE - Moves the values in the opposite direction then the directions indicated in
      60             :                       in the `VecScatterCreate()`
      61             : 
      62             :     Level: beginner
      63             : 
      64             : .seealso: [](ch_vectors), `VecScatter`, `ScatterMode`, `VecScatterCreate()`, `VecScatterBegin()`, `VecScatterEnd()`, `SCATTER_FORWARD`, `SCATTER_FORWARD_LOCAL`,
      65             :           `SCATTER_REVERSE_LOCAL`
      66             : M*/
      67             : 
      68             : /*MC
      69             :     SCATTER_FORWARD_LOCAL - Scatters the values as dictated by the `VecScatterCreate()` call except NO parallel communication
      70             :                             is done. Any variables that have be moved between processes are ignored
      71             : 
      72             :     Level: developer
      73             : 
      74             : .seealso: [](ch_vectors), `VecScatter`, `ScatterMode`, `VecScatterCreate()`, `VecScatterBegin()`, `VecScatterEnd()`, `SCATTER_REVERSE`, `SCATTER_FORWARD`,
      75             :           `SCATTER_REVERSE_LOCAL`
      76             : M*/
      77             : 
      78             : /*MC
      79             :     SCATTER_REVERSE_LOCAL - Moves the values in the opposite direction then the directions indicated in
      80             :                            in the `VecScatterCreate()`  except NO parallel communication
      81             :                            is done. Any variables that have be moved between processes are ignored
      82             : 
      83             :     Level: developer
      84             : 
      85             : .seealso: [](ch_vectors), `VecScatter`, `ScatterMode`, `VecScatterCreate()`, `VecScatterBegin()`, `VecScatterEnd()`, `SCATTER_FORWARD`, `SCATTER_FORWARD_LOCAL`,
      86             :           `SCATTER_REVERSE`
      87             : M*/
      88             : 
      89             : /*J
      90             :    VecType - String with the name of a PETSc vector type
      91             : 
      92             :    Level: beginner
      93             : 
      94             : .seealso: [](doc_vector), [](ch_vectors), `VecSetType()`, `Vec`, `VecCreate()`, `VecDestroy()`
      95             : J*/
      96             : typedef const char *VecType;
      97             : #define VECSEQ         "seq"
      98             : #define VECMPI         "mpi"
      99             : #define VECSTANDARD    "standard" /* seq on one process and mpi on multiple */
     100             : #define VECSHARED      "shared"
     101             : #define VECSEQVIENNACL "seqviennacl"
     102             : #define VECMPIVIENNACL "mpiviennacl"
     103             : #define VECVIENNACL    "viennacl" /* seqviennacl on one process and mpiviennacl on multiple */
     104             : #define VECSEQCUDA     "seqcuda"
     105             : #define VECMPICUDA     "mpicuda"
     106             : #define VECCUDA        "cuda" /* seqcuda on one process and mpicuda on multiple */
     107             : #define VECSEQHIP      "seqhip"
     108             : #define VECMPIHIP      "mpihip"
     109             : #define VECHIP         "hip" /* seqhip on one process and mpihip on multiple */
     110             : #define VECNEST        "nest"
     111             : #define VECSEQKOKKOS   "seqkokkos"
     112             : #define VECMPIKOKKOS   "mpikokkos"
     113             : #define VECKOKKOS      "kokkos" /* seqkokkos on one process and mpikokkos on multiple */
     114             : 
     115             : /* Dynamic creation and loading functions */
     116             : PETSC_EXTERN PetscErrorCode VecScatterSetType(VecScatter, VecScatterType);
     117             : PETSC_EXTERN PetscErrorCode VecScatterGetType(VecScatter, VecScatterType *);
     118             : PETSC_EXTERN PetscErrorCode VecScatterSetFromOptions(VecScatter);
     119             : PETSC_EXTERN PetscErrorCode VecScatterRegister(const char[], PetscErrorCode (*)(VecScatter));
     120             : PETSC_EXTERN PetscErrorCode VecScatterCreate(Vec, IS, Vec, IS, VecScatter *);
     121             : 
     122             : /* Logging support */
     123             : #define REAL_FILE_CLASSID 1211213
     124             : #define VEC_FILE_CLASSID  1211214
     125             : PETSC_EXTERN PetscClassId VEC_CLASSID;
     126             : PETSC_EXTERN PetscClassId PETSCSF_CLASSID;
     127             : 
     128             : PETSC_EXTERN PetscErrorCode VecInitializePackage(void);
     129             : PETSC_EXTERN PetscErrorCode VecFinalizePackage(void);
     130             : 
     131             : PETSC_EXTERN PetscErrorCode VecCreate(MPI_Comm, Vec *);
     132             : PETSC_EXTERN PetscErrorCode VecCreateFromOptions(MPI_Comm, const char *, PetscInt, PetscInt, PetscInt, Vec *);
     133             : PETSC_EXTERN PetscErrorCode VecCreateSeq(MPI_Comm, PetscInt, Vec *);
     134             : PETSC_EXTERN PetscErrorCode VecCreateMPI(MPI_Comm, PetscInt, PetscInt, Vec *);
     135             : PETSC_EXTERN PetscErrorCode VecCreateSeqWithArray(MPI_Comm, PetscInt, PetscInt, const PetscScalar[], Vec *);
     136             : PETSC_EXTERN PetscErrorCode VecCreateMPIWithArray(MPI_Comm, PetscInt, PetscInt, PetscInt, const PetscScalar[], Vec *);
     137             : PETSC_EXTERN PetscErrorCode VecCreateShared(MPI_Comm, PetscInt, PetscInt, Vec *);
     138             : 
     139             : PETSC_EXTERN PetscErrorCode VecSetFromOptions(Vec);
     140             : PETSC_EXTERN PetscErrorCode VecViewFromOptions(Vec, PetscObject, const char[]);
     141             : 
     142             : PETSC_EXTERN PetscErrorCode VecSetUp(Vec);
     143             : PETSC_EXTERN PetscErrorCode VecDestroy(Vec *);
     144             : PETSC_EXTERN PetscErrorCode VecZeroEntries(Vec);
     145             : PETSC_EXTERN PetscErrorCode VecSetOptionsPrefix(Vec, const char[]);
     146             : PETSC_EXTERN PetscErrorCode VecAppendOptionsPrefix(Vec, const char[]);
     147             : PETSC_EXTERN PetscErrorCode VecGetOptionsPrefix(Vec, const char *[]);
     148             : PETSC_EXTERN PetscErrorCode VecGetState(Vec, PetscObjectState *);
     149             : 
     150             : PETSC_EXTERN PetscErrorCode VecSetSizes(Vec, PetscInt, PetscInt);
     151             : 
     152             : PETSC_EXTERN PetscErrorCode VecDotNorm2(Vec, Vec, PetscScalar *, PetscReal *);
     153             : PETSC_EXTERN PetscErrorCode VecDot(Vec, Vec, PetscScalar *);
     154             : PETSC_EXTERN PetscErrorCode VecDotRealPart(Vec, Vec, PetscReal *);
     155             : PETSC_EXTERN PetscErrorCode VecTDot(Vec, Vec, PetscScalar *);
     156             : PETSC_EXTERN PetscErrorCode VecMDot(Vec, PetscInt, const Vec[], PetscScalar[]);
     157             : PETSC_EXTERN PetscErrorCode VecMTDot(Vec, PetscInt, const Vec[], PetscScalar[]);
     158             : PETSC_EXTERN PetscErrorCode VecGetSubVector(Vec, IS, Vec *);
     159             : PETSC_EXTERN PetscErrorCode VecRestoreSubVector(Vec, IS, Vec *);
     160             : PETSC_EXTERN PetscErrorCode VecConcatenate(PetscInt, const Vec[], Vec *, IS *[]);
     161             : 
     162             : /*E
     163             :     NormType - determines what type of norm to compute
     164             : 
     165             :     Values:
     166             : +    `NORM_1`         - the one norm, $||v|| = \sum_i | v_i |$. $||A|| = \max_j || v_*j ||$, maximum column sum
     167             : .    `NORM_2`         - the two norm, $||v|| = sqrt(\sum_i |v_i|^2)$ (vectors only)
     168             : .    `NORM_FROBENIUS` - $||A|| = sqrt(\sum_ij |A_ij|^2)$, same as `NORM_2` for vectors
     169             : .    `NORM_INFINITY`  - $||v|| = \max_i |v_i|$. $||A|| = \max_i || v_i* ||$, maximum row sum
     170             : -    `NORM_1_AND_2`   - computes both the 1 and 2 norm of a vector. The values are stored in two adjacent `PetscReal` memory locations
     171             : 
     172             :     Level: beginner
     173             : 
     174             :     Note:
     175             :     The `v` above represents a `Vec` while the `A` represents a `Mat`
     176             : 
     177             : .seealso: [](ch_vectors), `Vec`, `Mat`, `VecNorm()`, `VecNormBegin()`, `VecNormEnd()`, `MatNorm()`, `NORM_1`,
     178             :           `NORM_2`, `NORM_FROBENIUS`, `NORM_INFINITY`, `NORM_1_AND_2`
     179             : E*/
     180             : typedef enum {
     181             :   NORM_1         = 0,
     182             :   NORM_2         = 1,
     183             :   NORM_FROBENIUS = 2,
     184             :   NORM_INFINITY  = 3,
     185             :   NORM_1_AND_2   = 4
     186             : } NormType;
     187             : PETSC_EXTERN const char *const NormTypes[];
     188             : #define NORM_MAX NORM_INFINITY
     189             : 
     190             : /*MC
     191             :    NORM_1 - the one norm, $||v|| = \sum_i | v_i |$. $||A|| = \max_j || v_{*,j} ||$, maximum column sum
     192             : 
     193             :    Level: beginner
     194             : 
     195             : .seealso: [](ch_vectors), `NormType`, `MatNorm()`, `VecNorm()`, `VecNormBegin()`, `VecNormEnd()`, `NORM_2`, `NORM_FROBENIUS`,
     196             :           `NORM_INFINITY`, `NORM_1_AND_2`
     197             : M*/
     198             : 
     199             : /*MC
     200             :    NORM_2 - the two norm, $||v|| = \sqrt{\sum_i |v_i|^2}$ (vectors only)
     201             : 
     202             :    Level: beginner
     203             : 
     204             : .seealso: [](ch_vectors), `NormType`, `MatNorm()`, `VecNorm()`, `VecNormBegin()`, `VecNormEnd()`, `NORM_1`, `NORM_FROBENIUS`,
     205             :           `NORM_INFINITY`, `NORM_1_AND_2`
     206             : M*/
     207             : 
     208             : /*MC
     209             :    NORM_FROBENIUS - $||A|| = \sqrt{\sum_{i,j} |A_{i,j}|^2}$, same as `NORM_2` for vectors
     210             : 
     211             :    Level: beginner
     212             : 
     213             : .seealso: [](ch_vectors), `NormType`, `MatNorm()`, `VecNorm()`, `VecNormBegin()`, `VecNormEnd()`, `NORM_1`, `NORM_2`,
     214             :           `NORM_INFINITY`, `NORM_1_AND_2`
     215             : M*/
     216             : 
     217             : /*MC
     218             :    NORM_INFINITY - $||v|| = \max_i |v_i|$. $||A|| = \max_i || v_{i,*} ||$, maximum row sum
     219             : 
     220             :    Level: beginner
     221             : 
     222             : .seealso: [](ch_vectors), `NormType`, `MatNorm()`, `VecNorm()`, `VecNormBegin()`, `VecNormEnd()`, `NORM_1`, `NORM_2`,
     223             :           `NORM_FROBENIUS`, `NORM_1_AND_2`
     224             : M*/
     225             : 
     226             : /*MC
     227             :    NORM_1_AND_2 - computes both the 1 and 2 norm of a vector. The values are stored in two adjacent `PetscReal` memory locations
     228             : 
     229             :    Level: beginner
     230             : 
     231             : .seealso: [](ch_vectors), `NormType`, `MatNorm()`, `VecNorm()`, `VecNormBegin()`, `VecNormEnd()`, `NORM_1`, `NORM_2`,
     232             :           `NORM_FROBENIUS`, `NORM_INFINITY`
     233             : M*/
     234             : 
     235             : /*MC
     236             :    NORM_MAX - see `NORM_INFINITY`
     237             : 
     238             :    Level: beginner
     239             : M*/
     240             : 
     241             : /*E
     242             :     ReductionType - determines what type of column reduction (one that is not a type of norm defined in `NormType`) to compute
     243             : 
     244             :     Values:
     245             : +  `REDUCTION_SUM_REALPART`       - sum of real part of each matrix column
     246             : .  `REDUCTION_SUM_IMAGINARYPART`  - sum of imaginary part of each matrix column
     247             : .  `REDUCTION_MEAN_REALPART`      - arithmetic mean of real part of each matrix column
     248             : -  `REDUCTION_MEAN_IMAGINARYPART` - arithmetic mean of imaginary part of each matrix column
     249             : 
     250             :     Level: beginner
     251             : 
     252             :     Developer Note:
     253             :     The constants defined in `ReductionType` MUST BE DISTINCT from those defined in `NormType`.
     254             :    This is because `MatGetColumnReductions()` is used to compute both norms and other types of reductions,
     255             :    and the constants defined in both `NormType` and `ReductionType` are used to designate the desired operation.
     256             : 
     257             : .seealso: [](ch_vectors), `MatGetColumnReductions()`, `MatGetColumnNorms()`, `NormType`, `REDUCTION_SUM_REALPART`,
     258             :           `REDUCTION_SUM_IMAGINARYPART`, `REDUCTION_MEAN_REALPART`, `REDUCTION_NORM_1`, `REDUCTION_NORM_2`, `REDUCTION_NORM_FROBENIUS`, `REDUCTION_NORM_INFINITY`
     259             : E*/
     260             : typedef enum {
     261             :   REDUCTION_SUM_REALPART       = 10,
     262             :   REDUCTION_MEAN_REALPART      = 11,
     263             :   REDUCTION_SUM_IMAGINARYPART  = 12,
     264             :   REDUCTION_MEAN_IMAGINARYPART = 13
     265             : } ReductionType;
     266             : 
     267             : /*MC
     268             :    REDUCTION_SUM_REALPART - sum of real part of matrix column
     269             : 
     270             :    Level: beginner
     271             : 
     272             : .seealso: [](ch_vectors), `ReductionType`, `MatGetColumnReductions()`, `REDUCTION_SUM_IMAGINARYPART`, `REDUCTION_MEAN_REALPART`, `REDUCTION_NORM_1`,
     273             :           `REDUCTION_NORM_2`, `REDUCTION_NORM_FROBENIUS`, `REDUCTION_NORM_INFINITY`
     274             : M*/
     275             : 
     276             : /*MC
     277             :    REDUCTION_SUM_IMAGINARYPART - sum of imaginary part of matrix column
     278             : 
     279             :    Level: beginner
     280             : 
     281             : .seealso: [](ch_vectors), `ReductionType`, `MatGetColumnReductions()`, `REDUCTION_SUM_REALPART`, `REDUCTION_MEAN_IMAGINARYPART`, `REDUCTION_NORM_1`,
     282             :           `REDUCTION_NORM_2`, `REDUCTION_NORM_FROBENIUS`, `REDUCTION_NORM_INFINITY`
     283             : M*/
     284             : 
     285             : /*MC
     286             :    REDUCTION_MEAN_REALPART - arithmetic mean of real part of matrix column
     287             : 
     288             :    Level: beginner
     289             : 
     290             : .seealso: [](ch_vectors), `ReductionType`, `MatGetColumnReductions()`, `REDUCTION_MEAN_IMAGINARYPART`, `REDUCTION_SUM_REALPART`, `REDUCTION_NORM_1`,
     291             :           `REDUCTION_NORM_2`, `REDUCTION_NORM_FROBENIUS`, `REDUCTION_NORM_INFINITY`
     292             : M*/
     293             : 
     294             : /*MC
     295             :    REDUCTION_MEAN_IMAGINARYPART - arithmetic mean of imaginary part of matrix column
     296             : 
     297             :    Level: beginner
     298             : 
     299             : .seealso: [](ch_vectors), `ReductionType`, `MatGetColumnReductions()`, `REDUCTION_MEAN_REALPART`, `REDUCTION_SUM_IMAGINARYPART`, `REDUCTION_NORM_1`,
     300             :           `REDUCTION_NORM_2`, `REDUCTION_NORM_FROBENIUS`, `REDUCTION_NORM_INFINITY`
     301             : M*/
     302             : 
     303             : PETSC_EXTERN PetscErrorCode VecNorm(Vec, NormType, PetscReal *);
     304             : PETSC_EXTERN PetscErrorCode VecNormAvailable(Vec, NormType, PetscBool *, PetscReal *);
     305             : PETSC_EXTERN PetscErrorCode VecNormalize(Vec, PetscReal *);
     306             : PETSC_EXTERN PetscErrorCode VecSum(Vec, PetscScalar *);
     307             : PETSC_EXTERN PetscErrorCode VecMean(Vec, PetscScalar *);
     308             : PETSC_EXTERN PetscErrorCode VecMax(Vec, PetscInt *, PetscReal *);
     309             : PETSC_EXTERN PetscErrorCode VecMin(Vec, PetscInt *, PetscReal *);
     310             : PETSC_EXTERN PetscErrorCode VecScale(Vec, PetscScalar);
     311             : PETSC_EXTERN PetscErrorCode VecCopy(Vec, Vec);
     312             : PETSC_EXTERN PetscErrorCode VecSetRandom(Vec, PetscRandom);
     313             : PETSC_EXTERN PetscErrorCode VecSet(Vec, PetscScalar);
     314             : PETSC_EXTERN PetscErrorCode VecSetInf(Vec);
     315             : PETSC_EXTERN PetscErrorCode VecSwap(Vec, Vec);
     316             : PETSC_EXTERN PetscErrorCode VecAXPY(Vec, PetscScalar, Vec);
     317             : PETSC_EXTERN PetscErrorCode VecAXPBY(Vec, PetscScalar, PetscScalar, Vec);
     318             : PETSC_EXTERN PetscErrorCode VecMAXPY(Vec, PetscInt, const PetscScalar[], Vec[]);
     319             : PETSC_EXTERN PetscErrorCode VecMAXPBY(Vec, PetscInt, const PetscScalar[], PetscScalar, Vec[]);
     320             : PETSC_EXTERN PetscErrorCode VecAYPX(Vec, PetscScalar, Vec);
     321             : PETSC_EXTERN PetscErrorCode VecWAXPY(Vec, PetscScalar, Vec, Vec);
     322             : PETSC_EXTERN PetscErrorCode VecAXPBYPCZ(Vec, PetscScalar, PetscScalar, PetscScalar, Vec, Vec);
     323             : PETSC_EXTERN PetscErrorCode VecPointwiseMax(Vec, Vec, Vec);
     324             : PETSC_EXTERN PetscErrorCode VecPointwiseMaxAbs(Vec, Vec, Vec);
     325             : PETSC_EXTERN PetscErrorCode VecPointwiseMin(Vec, Vec, Vec);
     326             : PETSC_EXTERN PetscErrorCode VecPointwiseMult(Vec, Vec, Vec);
     327             : PETSC_EXTERN PetscErrorCode VecPointwiseDivide(Vec, Vec, Vec);
     328             : PETSC_EXTERN PetscErrorCode VecMaxPointwiseDivide(Vec, Vec, PetscReal *);
     329             : PETSC_EXTERN PetscErrorCode VecShift(Vec, PetscScalar);
     330             : PETSC_EXTERN PetscErrorCode VecReciprocal(Vec);
     331             : PETSC_EXTERN PetscErrorCode VecPermute(Vec, IS, PetscBool);
     332             : PETSC_EXTERN PetscErrorCode VecSqrtAbs(Vec);
     333             : PETSC_EXTERN PetscErrorCode VecLog(Vec);
     334             : PETSC_EXTERN PetscErrorCode VecExp(Vec);
     335             : PETSC_EXTERN PetscErrorCode VecAbs(Vec);
     336             : PETSC_EXTERN PetscErrorCode VecDuplicate(Vec, Vec *);
     337             : PETSC_EXTERN PetscErrorCode VecDuplicateVecs(Vec, PetscInt, Vec *[]);
     338             : PETSC_EXTERN PetscErrorCode VecDestroyVecs(PetscInt, Vec *[]);
     339             : PETSC_EXTERN PetscErrorCode VecStrideNormAll(Vec, NormType, PetscReal[]);
     340             : PETSC_EXTERN PetscErrorCode VecStrideMaxAll(Vec, PetscInt[], PetscReal[]);
     341             : PETSC_EXTERN PetscErrorCode VecStrideMinAll(Vec, PetscInt[], PetscReal[]);
     342             : PETSC_EXTERN PetscErrorCode VecStrideScaleAll(Vec, const PetscScalar[]);
     343             : PETSC_EXTERN PetscErrorCode VecStrideSumAll(Vec, PetscScalar *);
     344             : PETSC_EXTERN PetscErrorCode VecUniqueEntries(Vec, PetscInt *, PetscScalar **);
     345             : 
     346             : PETSC_EXTERN PetscErrorCode VecStrideNorm(Vec, PetscInt, NormType, PetscReal *);
     347             : PETSC_EXTERN PetscErrorCode VecStrideMax(Vec, PetscInt, PetscInt *, PetscReal *);
     348             : PETSC_EXTERN PetscErrorCode VecStrideMin(Vec, PetscInt, PetscInt *, PetscReal *);
     349             : PETSC_EXTERN PetscErrorCode VecStrideScale(Vec, PetscInt, PetscScalar);
     350             : PETSC_EXTERN PetscErrorCode VecStrideSum(Vec, PetscInt, PetscScalar *);
     351             : PETSC_EXTERN PetscErrorCode VecStrideSet(Vec, PetscInt, PetscScalar);
     352             : 
     353             : PETSC_EXTERN PetscErrorCode VecStrideGather(Vec, PetscInt, Vec, InsertMode);
     354             : PETSC_EXTERN PetscErrorCode VecStrideScatter(Vec, PetscInt, Vec, InsertMode);
     355             : PETSC_EXTERN PetscErrorCode VecStrideGatherAll(Vec, Vec[], InsertMode);
     356             : PETSC_EXTERN PetscErrorCode VecStrideScatterAll(Vec[], Vec, InsertMode);
     357             : 
     358             : PETSC_EXTERN PetscErrorCode VecStrideSubSetScatter(Vec, PetscInt, const PetscInt[], const PetscInt[], Vec, InsertMode);
     359             : PETSC_EXTERN PetscErrorCode VecStrideSubSetGather(Vec, PetscInt, const PetscInt[], const PetscInt[], Vec, InsertMode);
     360             : 
     361             : PETSC_EXTERN PetscErrorCode VecSetValues(Vec, PetscInt, const PetscInt[], const PetscScalar[], InsertMode);
     362             : PETSC_EXTERN PetscErrorCode VecGetValues(Vec, PetscInt, const PetscInt[], PetscScalar[]);
     363             : PETSC_EXTERN PetscErrorCode VecAssemblyBegin(Vec);
     364             : PETSC_EXTERN PetscErrorCode VecAssemblyEnd(Vec);
     365             : PETSC_EXTERN PetscErrorCode VecStashSetInitialSize(Vec, PetscInt, PetscInt);
     366             : PETSC_EXTERN PetscErrorCode VecStashView(Vec, PetscViewer);
     367             : PETSC_EXTERN PetscErrorCode VecStashViewFromOptions(Vec, PetscObject, const char[]);
     368             : PETSC_EXTERN PetscErrorCode VecStashGetInfo(Vec, PetscInt *, PetscInt *, PetscInt *, PetscInt *);
     369             : 
     370             : PETSC_EXTERN PetscErrorCode VecSetPreallocationCOO(Vec, PetscCount, const PetscInt[]);
     371             : PETSC_EXTERN PetscErrorCode VecSetPreallocationCOOLocal(Vec, PetscCount, PetscInt[]);
     372             : PETSC_EXTERN PetscErrorCode VecSetValuesCOO(Vec, const PetscScalar[], InsertMode);
     373             : 
     374             : /*MC
     375             :    VecSetValue - Set a single entry into a vector.
     376             : 
     377             :    Synopsis:
     378             :    #include <petscvec.h>
     379             :    PetscErrorCode VecSetValue(Vec v,PetscInt row,PetscScalar value, InsertMode mode);
     380             : 
     381             :    Not Collective
     382             : 
     383             :    Input Parameters:
     384             : +  v     - the vector
     385             : .  row   - the row location of the entry
     386             : .  value - the value to insert
     387             : -  mode  - either `INSERT_VALUES` or `ADD_VALUES`
     388             : 
     389             :    Level: beginner
     390             : 
     391             :    Notes:
     392             :    For efficiency one should use `VecSetValues()` and set several or
     393             :    many values simultaneously if possible.
     394             : 
     395             :    These values may be cached, so `VecAssemblyBegin()` and `VecAssemblyEnd()`
     396             :    MUST be called after all calls to `VecSetValue()` have been completed.
     397             : 
     398             :    `VecSetValue()` uses 0-based indices in Fortran as well as in C.
     399             : 
     400             : .seealso: [](ch_vectors), `VecSetValues()`, `VecAssemblyBegin()`, `VecAssemblyEnd()`, `VecSetValuesBlockedLocal()`, `VecSetValueLocal()`
     401             : M*/
     402      266571 : static inline PetscErrorCode VecSetValue(Vec v, PetscInt i, PetscScalar va, InsertMode mode)
     403             : {
     404      266571 :   return VecSetValues(v, 1, &i, &va, mode);
     405             : }
     406             : 
     407             : PETSC_EXTERN PetscErrorCode VecSetBlockSize(Vec, PetscInt);
     408             : PETSC_EXTERN PetscErrorCode VecGetBlockSize(Vec, PetscInt *);
     409             : PETSC_EXTERN PetscErrorCode VecSetValuesBlocked(Vec, PetscInt, const PetscInt[], const PetscScalar[], InsertMode);
     410             : 
     411             : /* Dynamic creation and loading functions */
     412             : PETSC_EXTERN PetscFunctionList VecList;
     413             : PETSC_EXTERN PetscErrorCode    VecSetType(Vec, VecType);
     414             : PETSC_EXTERN PetscErrorCode    VecGetType(Vec, VecType *);
     415             : PETSC_EXTERN PetscErrorCode    VecRegister(const char[], PetscErrorCode (*)(Vec));
     416             : PETSC_EXTERN PetscErrorCode    VecRegisterAll(void);
     417             : 
     418             : PETSC_EXTERN PetscErrorCode VecScatterBegin(VecScatter, Vec, Vec, InsertMode, ScatterMode);
     419             : PETSC_EXTERN PetscErrorCode VecScatterEnd(VecScatter, Vec, Vec, InsertMode, ScatterMode);
     420             : PETSC_EXTERN PetscErrorCode VecScatterDestroy(VecScatter *);
     421             : PETSC_EXTERN PetscErrorCode VecScatterSetUp(VecScatter);
     422             : PETSC_EXTERN PetscErrorCode VecScatterCopy(VecScatter, VecScatter *);
     423             : PETSC_EXTERN PetscErrorCode VecScatterView(VecScatter, PetscViewer);
     424             : PETSC_EXTERN PetscErrorCode VecScatterViewFromOptions(VecScatter, PetscObject, const char[]);
     425             : PETSC_EXTERN PetscErrorCode VecScatterRemap(VecScatter, PetscInt[], PetscInt[]);
     426             : PETSC_EXTERN PetscErrorCode VecScatterGetMerged(VecScatter, PetscBool *);
     427             : 
     428             : PETSC_EXTERN PetscErrorCode VecGetArray4d(Vec, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscScalar ****[]);
     429             : PETSC_EXTERN PetscErrorCode VecRestoreArray4d(Vec, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscScalar ****[]);
     430             : PETSC_EXTERN PetscErrorCode VecGetArray3d(Vec, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscScalar ***[]);
     431             : PETSC_EXTERN PetscErrorCode VecRestoreArray3d(Vec, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscScalar ***[]);
     432             : PETSC_EXTERN PetscErrorCode VecGetArray2d(Vec, PetscInt, PetscInt, PetscInt, PetscInt, PetscScalar **[]);
     433             : PETSC_EXTERN PetscErrorCode VecRestoreArray2d(Vec, PetscInt, PetscInt, PetscInt, PetscInt, PetscScalar **[]);
     434             : PETSC_EXTERN PetscErrorCode VecGetArray1d(Vec, PetscInt, PetscInt, PetscScalar *[]);
     435             : PETSC_EXTERN PetscErrorCode VecRestoreArray1d(Vec, PetscInt, PetscInt, PetscScalar *[]);
     436             : 
     437             : PETSC_EXTERN PetscErrorCode VecGetArray4dWrite(Vec, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscScalar ****[]);
     438             : PETSC_EXTERN PetscErrorCode VecGetArray4dWrite(Vec, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscScalar ****[]);
     439             : PETSC_EXTERN PetscErrorCode VecRestoreArray4dWrite(Vec, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscScalar ****[]);
     440             : PETSC_EXTERN PetscErrorCode VecGetArray3dWrite(Vec, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscScalar ***[]);
     441             : PETSC_EXTERN PetscErrorCode VecRestoreArray3dWrite(Vec, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscScalar ***[]);
     442             : PETSC_EXTERN PetscErrorCode VecGetArray2dWrite(Vec, PetscInt, PetscInt, PetscInt, PetscInt, PetscScalar **[]);
     443             : PETSC_EXTERN PetscErrorCode VecRestoreArray2dWrite(Vec, PetscInt, PetscInt, PetscInt, PetscInt, PetscScalar **[]);
     444             : PETSC_EXTERN PetscErrorCode VecGetArray1dWrite(Vec, PetscInt, PetscInt, PetscScalar *[]);
     445             : PETSC_EXTERN PetscErrorCode VecRestoreArray1dWrite(Vec, PetscInt, PetscInt, PetscScalar *[]);
     446             : 
     447             : PETSC_EXTERN PetscErrorCode VecGetArray4dRead(Vec, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscScalar ****[]);
     448             : PETSC_EXTERN PetscErrorCode VecRestoreArray4dRead(Vec, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscScalar ****[]);
     449             : PETSC_EXTERN PetscErrorCode VecGetArray3dRead(Vec, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscScalar ***[]);
     450             : PETSC_EXTERN PetscErrorCode VecRestoreArray3dRead(Vec, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscInt, PetscScalar ***[]);
     451             : PETSC_EXTERN PetscErrorCode VecGetArray2dRead(Vec, PetscInt, PetscInt, PetscInt, PetscInt, PetscScalar **[]);
     452             : PETSC_EXTERN PetscErrorCode VecRestoreArray2dRead(Vec, PetscInt, PetscInt, PetscInt, PetscInt, PetscScalar **[]);
     453             : PETSC_EXTERN PetscErrorCode VecGetArray1dRead(Vec, PetscInt, PetscInt, PetscScalar *[]);
     454             : PETSC_EXTERN PetscErrorCode VecRestoreArray1dRead(Vec, PetscInt, PetscInt, PetscScalar *[]);
     455             : 
     456             : PETSC_EXTERN PetscErrorCode VecPlaceArray(Vec, const PetscScalar[]);
     457             : PETSC_EXTERN PetscErrorCode VecResetArray(Vec);
     458             : PETSC_EXTERN PetscErrorCode VecReplaceArray(Vec, const PetscScalar[]);
     459             : 
     460             : PETSC_EXTERN PetscErrorCode VecGetArrays(const Vec[], PetscInt, PetscScalar **[]);
     461             : PETSC_EXTERN PetscErrorCode VecRestoreArrays(const Vec[], PetscInt, PetscScalar **[]);
     462             : 
     463             : PETSC_EXTERN PetscErrorCode VecView(Vec, PetscViewer);
     464             : PETSC_EXTERN PetscErrorCode VecViewNative(Vec, PetscViewer);
     465             : PETSC_EXTERN PetscErrorCode VecEqual(Vec, Vec, PetscBool *);
     466             : PETSC_EXTERN PetscErrorCode VecLoad(Vec, PetscViewer);
     467             : 
     468             : PETSC_EXTERN PetscErrorCode VecGetSize(Vec, PetscInt *);
     469             : PETSC_EXTERN PetscErrorCode VecGetLocalSize(Vec, PetscInt *);
     470             : PETSC_EXTERN PetscErrorCode VecGetOwnershipRange(Vec, PetscInt *, PetscInt *);
     471             : PETSC_EXTERN PetscErrorCode VecGetOwnershipRanges(Vec, const PetscInt *[]);
     472             : 
     473             : PETSC_EXTERN PetscErrorCode VecSetLocalToGlobalMapping(Vec, ISLocalToGlobalMapping);
     474             : PETSC_EXTERN PetscErrorCode VecSetValuesLocal(Vec, PetscInt, const PetscInt[], const PetscScalar[], InsertMode);
     475             : 
     476             : PETSC_EXTERN PetscErrorCode VecViennaCLGetCLContext(Vec, PETSC_UINTPTR_T *);
     477             : PETSC_EXTERN PetscErrorCode VecViennaCLGetCLQueue(Vec, PETSC_UINTPTR_T *);
     478             : PETSC_EXTERN PetscErrorCode VecViennaCLGetCLMemRead(Vec, PETSC_UINTPTR_T *);
     479             : PETSC_EXTERN PetscErrorCode VecViennaCLGetCLMemWrite(Vec, PETSC_UINTPTR_T *);
     480             : PETSC_EXTERN PetscErrorCode VecViennaCLRestoreCLMemWrite(Vec);
     481             : PETSC_EXTERN PetscErrorCode VecViennaCLGetCLMem(Vec, PETSC_UINTPTR_T *);
     482             : PETSC_EXTERN PetscErrorCode VecViennaCLRestoreCLMem(Vec);
     483             : 
     484             : /*MC
     485             :    VecSetValueLocal - Set a single entry into a vector using the local numbering, see `VecSetValuesLocal()`
     486             : 
     487             :    Synopsis:
     488             :    #include <petscvec.h>
     489             :    PetscErrorCode VecSetValueLocal(Vec v,PetscInt row,PetscScalar value, InsertMode mode);
     490             : 
     491             :    Not Collective
     492             : 
     493             :    Input Parameters:
     494             : +  v     - the vector
     495             : .  row   - the row location of the entry
     496             : .  value - the value to insert
     497             : -  mode  - either `INSERT_VALUES` or `ADD_VALUES`
     498             : 
     499             :    Level: beginner
     500             : 
     501             :    Notes:
     502             :    For efficiency one should use `VecSetValuesLocal()` and set several or
     503             :    many values simultaneously if possible.
     504             : 
     505             :    These values may be cached, so `VecAssemblyBegin()` and `VecAssemblyEnd()`
     506             :    MUST be called after all calls to `VecSetValueLocal()` have been completed.
     507             : 
     508             :    `VecSetValues()` uses 0-based indices in Fortran as well as in C.
     509             : 
     510             : .seealso: [](ch_vectors), `VecSetValuesLocal()`, `VecSetValues()`, `VecAssemblyBegin()`, `VecAssemblyEnd()`, `VecSetValuesBlockedLocal()`, `VecSetValue()`
     511             : M*/
     512             : static inline PetscErrorCode VecSetValueLocal(Vec v, PetscInt i, PetscScalar va, InsertMode mode)
     513             : {
     514             :   return VecSetValuesLocal(v, 1, &i, &va, mode);
     515             : }
     516             : 
     517             : /*MC
     518             :    VecCheckAssembled - checks if values have been changed in the vector, by `VecSetValues()` or related routines,  but it has not been assembled
     519             : 
     520             :    Synopsis:
     521             :    #include <petscvec.h>
     522             :    VecCheckAssembled(Vec v);
     523             : 
     524             :    Not Collective
     525             : 
     526             :    Input Parameter:
     527             : .  v - the vector to check
     528             : 
     529             :    Level: developer
     530             : 
     531             :    Note:
     532             :    After calls to `VecSetValues()` and related routines on must call ``VecAssemblyBegin()` and `VecAssemblyEnd()` before using the vector
     533             : 
     534             : .seealso: [](ch_vectors), `Vec`, `VecSetValues()`, `VecAssemblyBegin()`, `VecAssemblyEnd()`, `MatAssemblyBegin()`, `MatAssemblyEnd()`
     535             : M*/
     536             : #define VecCheckAssembled(v) PetscCheck(v->stash.insertmode == NOT_SET_VALUES, PETSC_COMM_SELF, PETSC_ERR_ARG_WRONGSTATE, "Not for unassembled vector, did you call VecAssemblyBegin()/VecAssemblyEnd()?")
     537             : 
     538             : PETSC_EXTERN PetscErrorCode VecSetValuesBlockedLocal(Vec, PetscInt, const PetscInt[], const PetscScalar[], InsertMode);
     539             : PETSC_EXTERN PetscErrorCode VecGetLocalToGlobalMapping(Vec, ISLocalToGlobalMapping *);
     540             : 
     541             : PETSC_EXTERN PetscErrorCode VecDotBegin(Vec, Vec, PetscScalar *);
     542             : PETSC_EXTERN PetscErrorCode VecDotEnd(Vec, Vec, PetscScalar *);
     543             : PETSC_EXTERN PetscErrorCode VecTDotBegin(Vec, Vec, PetscScalar *);
     544             : PETSC_EXTERN PetscErrorCode VecTDotEnd(Vec, Vec, PetscScalar *);
     545             : PETSC_EXTERN PetscErrorCode VecNormBegin(Vec, NormType, PetscReal *);
     546             : PETSC_EXTERN PetscErrorCode VecNormEnd(Vec, NormType, PetscReal *);
     547             : PETSC_EXTERN PetscErrorCode VecErrorWeightedNorms(Vec, Vec, Vec, NormType, PetscReal, Vec, PetscReal, Vec, PetscReal, PetscReal *, PetscInt *, PetscReal *, PetscInt *, PetscReal *, PetscInt *);
     548             : 
     549             : PETSC_EXTERN PetscErrorCode VecMDotBegin(Vec, PetscInt, const Vec[], PetscScalar[]);
     550             : PETSC_EXTERN PetscErrorCode VecMDotEnd(Vec, PetscInt, const Vec[], PetscScalar[]);
     551             : PETSC_EXTERN PetscErrorCode VecMTDotBegin(Vec, PetscInt, const Vec[], PetscScalar[]);
     552             : PETSC_EXTERN PetscErrorCode VecMTDotEnd(Vec, PetscInt, const Vec[], PetscScalar[]);
     553             : PETSC_EXTERN PetscErrorCode PetscCommSplitReductionBegin(MPI_Comm);
     554             : 
     555             : PETSC_EXTERN PetscErrorCode VecBindToCPU(Vec, PetscBool);
     556             : PETSC_DEPRECATED_FUNCTION(3, 13, 0, "VecBindToCPU()", ) static inline PetscErrorCode VecPinToCPU(Vec v, PetscBool flg)
     557             : {
     558             :   return VecBindToCPU(v, flg);
     559             : }
     560             : PETSC_EXTERN PetscErrorCode VecBoundToCPU(Vec, PetscBool *);
     561             : PETSC_EXTERN PetscErrorCode VecSetBindingPropagates(Vec, PetscBool);
     562             : PETSC_EXTERN PetscErrorCode VecGetBindingPropagates(Vec, PetscBool *);
     563             : PETSC_EXTERN PetscErrorCode VecSetPinnedMemoryMin(Vec, size_t);
     564             : PETSC_EXTERN PetscErrorCode VecGetPinnedMemoryMin(Vec, size_t *);
     565             : 
     566             : PETSC_EXTERN PetscErrorCode VecGetOffloadMask(Vec, PetscOffloadMask *);
     567             : 
     568             : typedef enum {
     569             :   VEC_IGNORE_OFF_PROC_ENTRIES,
     570             :   VEC_IGNORE_NEGATIVE_INDICES,
     571             :   VEC_SUBSET_OFF_PROC_ENTRIES
     572             : } VecOption;
     573             : PETSC_EXTERN PetscErrorCode VecSetOption(Vec, VecOption, PetscBool);
     574             : 
     575             : PETSC_EXTERN PetscErrorCode VecGetArray(Vec, PetscScalar **);
     576             : PETSC_EXTERN PetscErrorCode VecGetArrayWrite(Vec, PetscScalar **);
     577             : PETSC_EXTERN PetscErrorCode VecGetArrayRead(Vec, const PetscScalar **);
     578             : PETSC_EXTERN PetscErrorCode VecRestoreArray(Vec, PetscScalar **);
     579             : PETSC_EXTERN PetscErrorCode VecRestoreArrayWrite(Vec, PetscScalar **);
     580             : PETSC_EXTERN PetscErrorCode VecRestoreArrayRead(Vec, const PetscScalar **);
     581             : PETSC_EXTERN PetscErrorCode VecCreateLocalVector(Vec, Vec *);
     582             : PETSC_EXTERN PetscErrorCode VecGetLocalVector(Vec, Vec);
     583             : PETSC_EXTERN PetscErrorCode VecRestoreLocalVector(Vec, Vec);
     584             : PETSC_EXTERN PetscErrorCode VecGetLocalVectorRead(Vec, Vec);
     585             : PETSC_EXTERN PetscErrorCode VecRestoreLocalVectorRead(Vec, Vec);
     586             : PETSC_EXTERN PetscErrorCode VecGetArrayAndMemType(Vec, PetscScalar **, PetscMemType *);
     587             : PETSC_EXTERN PetscErrorCode VecRestoreArrayAndMemType(Vec, PetscScalar **);
     588             : PETSC_EXTERN PetscErrorCode VecGetArrayReadAndMemType(Vec, const PetscScalar **, PetscMemType *);
     589             : PETSC_EXTERN PetscErrorCode VecRestoreArrayReadAndMemType(Vec, const PetscScalar **);
     590             : PETSC_EXTERN PetscErrorCode VecGetArrayWriteAndMemType(Vec, PetscScalar **, PetscMemType *);
     591             : PETSC_EXTERN PetscErrorCode VecRestoreArrayWriteAndMemType(Vec, PetscScalar **);
     592             : 
     593             : /*@C
     594             :    VecGetArrayPair - Accesses a pair of pointers for two vectors that may be common. When the vectors are not the same the first pointer is read only
     595             : 
     596             :    Logically Collective; No Fortran Support
     597             : 
     598             :    Input Parameters:
     599             : +  x - the vector
     600             : -  y - the second vector
     601             : 
     602             :    Output Parameters:
     603             : +  xv - location to put pointer to the first array
     604             : -  yv - location to put pointer to the second array
     605             : 
     606             :    Level: developer
     607             : 
     608             : .seealso: [](ch_vectors), `VecGetArray()`, `VecGetArrayRead()`, `VecRestoreArrayPair()`
     609             : @*/
     610             : static inline PetscErrorCode VecGetArrayPair(Vec x, Vec y, PetscScalar **xv, PetscScalar **yv)
     611             : {
     612             :   PetscFunctionBegin;
     613             :   PetscCall(VecGetArray(y, yv));
     614             :   if (x == y) *xv = *yv;
     615             :   else PetscCall(VecGetArrayRead(x, (const PetscScalar **)xv));
     616             :   PetscFunctionReturn(PETSC_SUCCESS);
     617             : }
     618             : 
     619             : /*@C
     620             :    VecRestoreArrayPair - Returns a pair of pointers for two vectors that may be common obtained with `VecGetArrayPair()`
     621             : 
     622             :    Logically Collective; No Fortran Support
     623             : 
     624             :    Input Parameters:
     625             : +  x  - the vector
     626             : .  y  - the second vector
     627             : .  xv - location to put pointer to the first array
     628             : -  yv - location to put pointer to the second array
     629             : 
     630             :    Level: developer
     631             : 
     632             : .seealso: [](ch_vectors), `VecGetArray()`, `VecGetArrayRead()`, `VecGetArrayPair()`
     633             : @*/
     634             : static inline PetscErrorCode VecRestoreArrayPair(Vec x, Vec y, PetscScalar **xv, PetscScalar **yv)
     635             : {
     636             :   PetscFunctionBegin;
     637             :   PetscCall(VecRestoreArray(y, yv));
     638             :   if (x != y) PetscCall(VecRestoreArrayRead(x, (const PetscScalar **)xv));
     639             :   PetscFunctionReturn(PETSC_SUCCESS);
     640             : }
     641             : 
     642             : #if PetscDefined(USE_DEBUG)
     643             : PETSC_EXTERN PetscErrorCode  VecLockReadPush(Vec);
     644             : PETSC_EXTERN PetscErrorCode  VecLockReadPop(Vec);
     645             : PETSC_EXTERN PetscErrorCode  VecLockWriteSet(Vec, PetscBool);
     646             : PETSC_EXTERN PetscErrorCode  VecLockGet(Vec, PetscInt *);
     647             : PETSC_EXTERN PetscErrorCode  VecLockGetLocation(Vec, const char *[], const char *[], int *);
     648      230238 : static inline PetscErrorCode VecSetErrorIfLocked(Vec x, PetscInt arg)
     649             : {
     650      230238 :   PetscInt state;
     651             : 
     652      230238 :   PetscFunctionBegin;
     653      230238 :   PetscCall(VecLockGet(x, &state));
     654      230238 :   if (PetscUnlikely(state != 0)) {
     655           0 :     const char *file, *func, *name;
     656           0 :     int         line;
     657             : 
     658           0 :     PetscCall(VecLockGetLocation(x, &file, &func, &line));
     659           0 :     PetscCall(PetscObjectGetName((PetscObject)x, &name));
     660           0 :     SETERRQ(PETSC_COMM_SELF, PETSC_ERR_ARG_WRONGSTATE, "Vector '%s' (argument #%" PetscInt_FMT ") was locked for %s access in %s() at %s:%d (line numbers only accurate to function begin)", name, arg, state > 0 ? "read-only" : "write-only", func ? func : "unknown_function", file ? file : "unknown file", line);
     661             :   }
     662      230238 :   PetscFunctionReturn(PETSC_SUCCESS);
     663             : }
     664             : /* The three are deprecated */
     665             : PETSC_EXTERN PETSC_DEPRECATED_FUNCTION(3, 11, 0, "VecLockReadPush()", ) PetscErrorCode VecLockPush(Vec);
     666             : PETSC_EXTERN PETSC_DEPRECATED_FUNCTION(3, 11, 0, "VecLockReadPop()", ) PetscErrorCode VecLockPop(Vec);
     667             :   #define VecLocked(x, arg) VecSetErrorIfLocked(x, arg) PETSC_DEPRECATED_MACRO(3, 11, 0, "VecSetErrorIfLocked()", )
     668             : #else
     669             :   #define VecLockReadPush(x)          PETSC_SUCCESS
     670             :   #define VecLockReadPop(x)           PETSC_SUCCESS
     671             :   #define VecLockGet(x, s)            (*(s) = 0, PETSC_SUCCESS)
     672             :   #define VecSetErrorIfLocked(x, arg) PETSC_SUCCESS
     673             :   #define VecLockWriteSet(x, flg)     PETSC_SUCCESS
     674             :   /* The three are deprecated */
     675             :   #define VecLockPush(x)              PETSC_SUCCESS
     676             :   #define VecLockPop(x)               PETSC_SUCCESS
     677             :   #define VecLocked(x, arg)           PETSC_SUCCESS
     678             : #endif
     679             : 
     680             : /*E
     681             :   VecOperation - Enumeration of overide-able methods in the `Vec` implementation function-table.
     682             : 
     683             :   Values:
     684             : + `VECOP_DUPLICATE`  - `VecDuplicate()`
     685             : . `VECOP_SET`        - `VecSet()`
     686             : . `VECOP_VIEW`       - `VecView()`
     687             : . `VECOP_LOAD`       - `VecLoad()`
     688             : . `VECOP_VIEWNATIVE` - `VecViewNative()`
     689             : - `VECOP_LOADNATIVE` - `VecLoadNative()`
     690             : 
     691             :   Level: advanced
     692             : 
     693             :   Notes:
     694             :   Some operations may serve as the implementation for other routines not listed above. For
     695             :   example `VECOP_SET` can be used to simultaneously overriding the implementation used in
     696             :   `VecSet()`, `VecSetInf()`, and `VecZeroEntries()`.
     697             : 
     698             :   Entries to `VecOperation` are added as needed so if you do not see the operation listed which
     699             :   you'd like to replace, please send mail to `petsc-maint@mcs.anl.gov`!
     700             : 
     701             : .seealso: [](ch_vectors), `Vec`, `VecSetOperation()`
     702             : E*/
     703             : typedef enum {
     704             :   VECOP_DUPLICATE  = 0,
     705             :   VECOP_SET        = 10,
     706             :   VECOP_VIEW       = 33,
     707             :   VECOP_LOAD       = 41,
     708             :   VECOP_VIEWNATIVE = 69,
     709             :   VECOP_LOADNATIVE = 70
     710             : } VecOperation;
     711             : PETSC_EXTERN PetscErrorCode VecSetOperation(Vec, VecOperation, void (*)(void));
     712             : 
     713             : /*
     714             :      Routines for dealing with ghosted vectors:
     715             :   vectors with ghost elements at the end of the array.
     716             : */
     717             : PETSC_EXTERN PetscErrorCode VecMPISetGhost(Vec, PetscInt, const PetscInt[]);
     718             : PETSC_EXTERN PetscErrorCode VecCreateGhost(MPI_Comm, PetscInt, PetscInt, PetscInt, const PetscInt[], Vec *);
     719             : PETSC_EXTERN PetscErrorCode VecCreateGhostWithArray(MPI_Comm, PetscInt, PetscInt, PetscInt, const PetscInt[], const PetscScalar[], Vec *);
     720             : PETSC_EXTERN PetscErrorCode VecCreateGhostBlock(MPI_Comm, PetscInt, PetscInt, PetscInt, PetscInt, const PetscInt[], Vec *);
     721             : PETSC_EXTERN PetscErrorCode VecCreateGhostBlockWithArray(MPI_Comm, PetscInt, PetscInt, PetscInt, PetscInt, const PetscInt[], const PetscScalar[], Vec *);
     722             : PETSC_EXTERN PetscErrorCode VecGhostGetGhostIS(Vec, IS *);
     723             : PETSC_EXTERN PetscErrorCode VecGhostGetLocalForm(Vec, Vec *);
     724             : PETSC_EXTERN PetscErrorCode VecGhostRestoreLocalForm(Vec, Vec *);
     725             : PETSC_EXTERN PetscErrorCode VecGhostIsLocalForm(Vec, Vec, PetscBool *);
     726             : PETSC_EXTERN PetscErrorCode VecGhostUpdateBegin(Vec, InsertMode, ScatterMode);
     727             : PETSC_EXTERN PetscErrorCode VecGhostUpdateEnd(Vec, InsertMode, ScatterMode);
     728             : 
     729             : PETSC_EXTERN PetscErrorCode VecConjugate(Vec);
     730             : PETSC_EXTERN PetscErrorCode VecImaginaryPart(Vec);
     731             : PETSC_EXTERN PetscErrorCode VecRealPart(Vec);
     732             : 
     733             : PETSC_EXTERN PetscErrorCode VecScatterCreateToAll(Vec, VecScatter *, Vec *);
     734             : PETSC_EXTERN PetscErrorCode VecScatterCreateToZero(Vec, VecScatter *, Vec *);
     735             : 
     736             : /* These vector calls were included from TAO. They miss vtable entries and GPU implementation */
     737             : PETSC_EXTERN PetscErrorCode ISComplementVec(IS, Vec, IS *);
     738             : PETSC_EXTERN PetscErrorCode VecPow(Vec, PetscScalar);
     739             : PETSC_EXTERN PetscErrorCode VecMedian(Vec, Vec, Vec, Vec);
     740             : PETSC_EXTERN PetscErrorCode VecWhichInactive(Vec, Vec, Vec, Vec, PetscBool, IS *);
     741             : PETSC_EXTERN PetscErrorCode VecWhichBetween(Vec, Vec, Vec, IS *);
     742             : PETSC_EXTERN PetscErrorCode VecWhichBetweenOrEqual(Vec, Vec, Vec, IS *);
     743             : PETSC_EXTERN PetscErrorCode VecWhichGreaterThan(Vec, Vec, IS *);
     744             : PETSC_EXTERN PetscErrorCode VecWhichLessThan(Vec, Vec, IS *);
     745             : PETSC_EXTERN PetscErrorCode VecWhichEqual(Vec, Vec, IS *);
     746             : PETSC_EXTERN PetscErrorCode VecISAXPY(Vec, IS, PetscScalar, Vec);
     747             : PETSC_EXTERN PetscErrorCode VecISCopy(Vec, IS, ScatterMode, Vec);
     748             : PETSC_EXTERN PetscErrorCode VecISSet(Vec, IS, PetscScalar);
     749             : PETSC_EXTERN PetscErrorCode VecISShift(Vec, IS, PetscScalar);
     750             : PETSC_EXTERN PetscErrorCode VecBoundGradientProjection(Vec, Vec, Vec, Vec, Vec);
     751             : PETSC_EXTERN PetscErrorCode VecStepBoundInfo(Vec, Vec, Vec, Vec, PetscReal *, PetscReal *, PetscReal *);
     752             : PETSC_EXTERN PetscErrorCode VecStepMax(Vec, Vec, PetscReal *);
     753             : PETSC_EXTERN PetscErrorCode VecStepMaxBounded(Vec, Vec, Vec, Vec, PetscReal *);
     754             : 
     755             : PETSC_EXTERN PetscErrorCode PetscViewerMathematicaGetVector(PetscViewer, Vec);
     756             : PETSC_EXTERN PetscErrorCode PetscViewerMathematicaPutVector(PetscViewer, Vec);
     757             : 
     758             : /*S
     759             :    Vecs - Collection of vectors where the data for the vectors is stored in
     760             :           one contiguous memory
     761             : 
     762             :    Level: advanced
     763             : 
     764             :    Notes:
     765             :    Temporary construct for handling multiply right-hand side solves
     766             : 
     767             :    This is faked by storing a single vector that has enough array space for
     768             :    n vectors
     769             : 
     770             : S*/
     771             : struct _n_Vecs {
     772             :   PetscInt n;
     773             :   Vec      v;
     774             : };
     775             : typedef struct _n_Vecs     *Vecs;
     776             : PETSC_EXTERN PetscErrorCode VecsDestroy(Vecs);
     777             : PETSC_EXTERN PetscErrorCode VecsCreateSeq(MPI_Comm, PetscInt, PetscInt, Vecs *);
     778             : PETSC_EXTERN PetscErrorCode VecsCreateSeqWithArray(MPI_Comm, PetscInt, PetscInt, PetscScalar *, Vecs *);
     779             : PETSC_EXTERN PetscErrorCode VecsDuplicate(Vecs, Vecs *);
     780             : 
     781             : #if PetscDefined(HAVE_VIENNACL)
     782             : typedef struct _p_PetscViennaCLIndices *PetscViennaCLIndices;
     783             : PETSC_EXTERN PetscErrorCode             VecViennaCLCopyToGPUSome_Public(Vec, PetscViennaCLIndices);
     784             : PETSC_EXTERN PetscErrorCode             VecViennaCLCopyFromGPUSome_Public(Vec, PetscViennaCLIndices);
     785             : PETSC_EXTERN PetscErrorCode             VecCreateSeqViennaCL(MPI_Comm, PetscInt, Vec *);
     786             : PETSC_EXTERN PetscErrorCode             VecCreateMPIViennaCL(MPI_Comm, PetscInt, PetscInt, Vec *);
     787             : #endif
     788             : #if PetscDefined(HAVE_CUDA) || PetscDefined(HAVE_HIP)
     789             : PETSC_EXTERN PetscErrorCode VecScatterInitializeForGPU(VecScatter, Vec);
     790             : PETSC_EXTERN PetscErrorCode VecScatterFinalizeForGPU(VecScatter);
     791             : #endif
     792             : #if PetscDefined(HAVE_KOKKOS_KERNELS)
     793             : PETSC_EXTERN PetscErrorCode VecCreateSeqKokkos(MPI_Comm, PetscInt, Vec *);
     794             : PETSC_EXTERN PetscErrorCode VecCreateSeqKokkosWithArray(MPI_Comm, PetscInt, PetscInt, const PetscScalar *, Vec *);
     795             : PETSC_EXTERN PetscErrorCode VecCreateMPIKokkos(MPI_Comm, PetscInt, PetscInt, Vec *);
     796             : PETSC_EXTERN PetscErrorCode VecCreateMPIKokkosWithArray(MPI_Comm, PetscInt, PetscInt, PetscInt, const PetscScalar *, Vec *);
     797             : #endif
     798             : 
     799             : PETSC_EXTERN PetscErrorCode VecNestGetSubVecs(Vec, PetscInt *, Vec **);
     800             : PETSC_EXTERN PetscErrorCode VecNestGetSubVec(Vec, PetscInt, Vec *);
     801             : PETSC_EXTERN PetscErrorCode VecNestSetSubVecs(Vec, PetscInt, PetscInt *, Vec *);
     802             : PETSC_EXTERN PetscErrorCode VecNestSetSubVec(Vec, PetscInt, Vec);
     803             : PETSC_EXTERN PetscErrorCode VecCreateNest(MPI_Comm, PetscInt, IS *, Vec *, Vec *);
     804             : PETSC_EXTERN PetscErrorCode VecNestGetSize(Vec, PetscInt *);
     805             : 
     806             : PETSC_EXTERN PetscErrorCode PetscOptionsGetVec(PetscOptions, const char[], const char[], Vec, PetscBool *);
     807             : PETSC_EXTERN PetscErrorCode VecFilter(Vec, PetscReal);
     808             : PETSC_DEPRECATED_FUNCTION(3, 20, 0, "VecFilter()", ) static inline PetscErrorCode VecChop(Vec v, PetscReal tol)
     809             : {
     810             :   return VecFilter(v, tol);
     811             : }
     812             : 
     813             : PETSC_EXTERN PetscErrorCode VecGetLayout(Vec, PetscLayout *);
     814             : PETSC_EXTERN PetscErrorCode VecSetLayout(Vec, PetscLayout);
     815             : 
     816             : PETSC_EXTERN PetscErrorCode PetscSectionVecView(PetscSection, Vec, PetscViewer);
     817             : PETSC_EXTERN PetscErrorCode VecGetValuesSection(Vec, PetscSection, PetscInt, PetscScalar **);
     818             : PETSC_EXTERN PetscErrorCode VecSetValuesSection(Vec, PetscSection, PetscInt, const PetscScalar[], InsertMode);
     819             : PETSC_EXTERN PetscErrorCode PetscSectionVecNorm(PetscSection, PetscSection, Vec, NormType, PetscReal[]);
     820             : 
     821             : /*S
     822             :   VecTagger - Object used to manage the tagging of a subset of indices based on the values of a vector.  The
     823             :               motivating application is the selection of cells for refinement or coarsening based on vector containing
     824             :               the values in an error indicator metric.
     825             : 
     826             :   Values:
     827             : +  `VECTAGGERABSOLUTE` - "absolute" values are in a interval (box for complex values) of explicitly defined values
     828             : .  `VECTAGGERRELATIVE` - "relative" values are in a interval (box for complex values) of values relative to the set of all values in the vector
     829             : .  `VECTAGGERCDF`      - "cdf" values are in a relative range of the *cumulative distribution* of values in the vector
     830             : .  `VECTAGGEROR`       - "or" values are in the union of other tags
     831             : -  `VECTAGGERAND`      - "and" values are in the intersection of other tags
     832             : 
     833             :   Level: advanced
     834             : 
     835             :   Developer Note:
     836             :   Why not use a `DMLabel` or similar object
     837             : 
     838             : .seealso: [](ch_vectors), `Vec`, `VecTaggerType`, `VecTaggerCreate()`
     839             : S*/
     840             : typedef struct _p_VecTagger *VecTagger;
     841             : 
     842             : /*J
     843             :   VecTaggerType - String with the name of a `VecTagger` type
     844             : 
     845             :   Level: advanced
     846             : 
     847             : .seealso: [](ch_vectors), `Vec`, `VecTagger`, `VecTaggerCreate()`
     848             : J*/
     849             : typedef const char *VecTaggerType;
     850             : #define VECTAGGERABSOLUTE "absolute"
     851             : #define VECTAGGERRELATIVE "relative"
     852             : #define VECTAGGERCDF      "cdf"
     853             : #define VECTAGGEROR       "or"
     854             : #define VECTAGGERAND      "and"
     855             : 
     856             : PETSC_EXTERN PetscClassId      VEC_TAGGER_CLASSID;
     857             : PETSC_EXTERN PetscFunctionList VecTaggerList;
     858             : PETSC_EXTERN PetscErrorCode    VecTaggerRegister(const char[], PetscErrorCode (*)(VecTagger));
     859             : PETSC_EXTERN PetscErrorCode    VecTaggerRegisterAll(void);
     860             : 
     861             : PETSC_EXTERN PetscErrorCode VecTaggerCreate(MPI_Comm, VecTagger *);
     862             : PETSC_EXTERN PetscErrorCode VecTaggerSetBlockSize(VecTagger, PetscInt);
     863             : PETSC_EXTERN PetscErrorCode VecTaggerGetBlockSize(VecTagger, PetscInt *);
     864             : PETSC_EXTERN PetscErrorCode VecTaggerSetType(VecTagger, VecTaggerType);
     865             : PETSC_EXTERN PetscErrorCode VecTaggerGetType(VecTagger, VecTaggerType *);
     866             : PETSC_EXTERN PetscErrorCode VecTaggerSetInvert(VecTagger, PetscBool);
     867             : PETSC_EXTERN PetscErrorCode VecTaggerGetInvert(VecTagger, PetscBool *);
     868             : PETSC_EXTERN PetscErrorCode VecTaggerSetFromOptions(VecTagger);
     869             : PETSC_EXTERN PetscErrorCode VecTaggerSetUp(VecTagger);
     870             : PETSC_EXTERN PetscErrorCode VecTaggerView(VecTagger, PetscViewer);
     871             : PETSC_EXTERN PetscErrorCode VecTaggerComputeIS(VecTagger, Vec, IS *, PetscBool *);
     872             : PETSC_EXTERN PetscErrorCode VecTaggerDestroy(VecTagger *);
     873             : 
     874             : /*S
     875             :    VecTaggerBox - A interval (box for complex numbers) range used to tag values.  For real scalars, this is just a closed interval; for complex scalars,
     876             :    the box is the closed region in the complex plane such that real(min) <= real(z) <= real(max) and imag(min) <= imag(z) <= imag(max).  `INF` is an acceptable endpoint.
     877             : 
     878             :    Level: beginner
     879             : 
     880             : .seealso: [](ch_vectors), `Vec`, `VecTagger`, `VecTaggerType`, `VecTaggerCreate()`, `VecTaggerComputeIntervals()`
     881             : S*/
     882             : typedef struct {
     883             :   PetscScalar min;
     884             :   PetscScalar max;
     885             : } VecTaggerBox;
     886             : PETSC_EXTERN PetscErrorCode VecTaggerComputeBoxes(VecTagger, Vec, PetscInt *, VecTaggerBox **, PetscBool *);
     887             : 
     888             : PETSC_EXTERN PetscErrorCode VecTaggerAbsoluteSetBox(VecTagger, VecTaggerBox *);
     889             : PETSC_EXTERN PetscErrorCode VecTaggerAbsoluteGetBox(VecTagger, const VecTaggerBox **);
     890             : 
     891             : PETSC_EXTERN PetscErrorCode VecTaggerRelativeSetBox(VecTagger, VecTaggerBox *);
     892             : PETSC_EXTERN PetscErrorCode VecTaggerRelativeGetBox(VecTagger, const VecTaggerBox **);
     893             : 
     894             : PETSC_EXTERN PetscErrorCode VecTaggerCDFSetBox(VecTagger, VecTaggerBox *);
     895             : PETSC_EXTERN PetscErrorCode VecTaggerCDFGetBox(VecTagger, const VecTaggerBox **);
     896             : 
     897             : /*E
     898             :   VecTaggerCDFMethod - Determines what method is used to compute absolute values from cumulative distribution values (e.g., what value is the preimage of .95 in the cdf).
     899             : 
     900             :    Values:
     901             : +  `VECTAGGER_CDF_GATHER`    - gather results to MPI rank 0, perform the computation and broadcast the result
     902             : -  `VECTAGGER_CDF_ITERATIVE` - compute the results on all ranks iteratively using `MPI_Allreduce()`
     903             : 
     904             :   Level: advanced
     905             : 
     906             :   Note:
     907             :   Relevant only in parallel: in serial it is directly computed.
     908             : 
     909             : .seealso: [](ch_vectors), `Vec`, `VecTagger`, `VecTaggerType`, `VecTaggerCreate()`, `VecTaggerCDFSetMethod()`, `VecTaggerCDFMethods`
     910             : E*/
     911             : typedef enum {
     912             :   VECTAGGER_CDF_GATHER,
     913             :   VECTAGGER_CDF_ITERATIVE,
     914             :   VECTAGGER_CDF_NUM_METHODS
     915             : } VecTaggerCDFMethod;
     916             : PETSC_EXTERN const char *const VecTaggerCDFMethods[];
     917             : 
     918             : PETSC_EXTERN PetscErrorCode VecTaggerCDFSetMethod(VecTagger, VecTaggerCDFMethod);
     919             : PETSC_EXTERN PetscErrorCode VecTaggerCDFGetMethod(VecTagger, VecTaggerCDFMethod *);
     920             : PETSC_EXTERN PetscErrorCode VecTaggerCDFIterativeSetTolerances(VecTagger, PetscInt, PetscReal, PetscReal);
     921             : PETSC_EXTERN PetscErrorCode VecTaggerCDFIterativeGetTolerances(VecTagger, PetscInt *, PetscReal *, PetscReal *);
     922             : 
     923             : PETSC_EXTERN PetscErrorCode VecTaggerOrSetSubs(VecTagger, PetscInt, VecTagger *, PetscCopyMode);
     924             : PETSC_EXTERN PetscErrorCode VecTaggerOrGetSubs(VecTagger, PetscInt *, VecTagger **);
     925             : 
     926             : PETSC_EXTERN PetscErrorCode VecTaggerAndSetSubs(VecTagger, PetscInt, VecTagger *, PetscCopyMode);
     927             : PETSC_EXTERN PetscErrorCode VecTaggerAndGetSubs(VecTagger, PetscInt *, VecTagger **);
     928             : 
     929             : PETSC_EXTERN PetscErrorCode VecTaggerInitializePackage(void);
     930             : PETSC_EXTERN PetscErrorCode VecTaggerFinalizePackage(void);
     931             : 
     932             : #if PetscDefined(USE_DEBUG)
     933             : /* This is an internal debug-only routine that should not be used by users */
     934             : PETSC_SINGLE_LIBRARY_INTERN PetscErrorCode VecValidValues_Internal(Vec, PetscInt, PetscBool);
     935             : #else
     936             :   #define VecValidValues_Internal(...) PETSC_SUCCESS
     937             : #endif /* PETSC_USE_DEBUG */
     938             : 
     939             : #define VEC_CUPM_NOT_CONFIGURED(impl) SETERRQ(PETSC_COMM_SELF, PETSC_ERR_SUP_SYS, "Must configure PETSc with " PetscStringize(impl) " support to use %s", PETSC_FUNCTION_NAME)
     940             : 
     941             : #if PetscDefined(HAVE_CUDA)
     942             :   #define VEC_CUDA_DECL_OR_STUB(__decl__, ...) PETSC_EXTERN __decl__;
     943             : #else
     944             :   #define VEC_CUDA_DECL_OR_STUB(__decl__, ...) \
     945             :     static inline __decl__ \
     946             :     { \
     947             :       __VA_ARGS__; \
     948             :       VEC_CUPM_NOT_CONFIGURED(cuda); \
     949             :     }
     950             : #endif /* PETSC_HAVE_CUDA */
     951             : 
     952             : /* extra underscore here to make it line up with the cuda versions */
     953             : #if PetscDefined(HAVE_HIP)
     954             :   #define VEC_HIP__DECL_OR_STUB(__decl__, ...) PETSC_EXTERN __decl__;
     955             : #else
     956             :   #define VEC_HIP__DECL_OR_STUB(__decl__, ...) \
     957             :     static inline __decl__ \
     958             :     { \
     959             :       __VA_ARGS__; \
     960             :       VEC_CUPM_NOT_CONFIGURED(hip); \
     961             :     }
     962             : #endif /* PETSC_HAVE_HIP */
     963             : 
     964             : VEC_CUDA_DECL_OR_STUB(PetscErrorCode VecCreateSeqCUDA(MPI_Comm a, PetscInt b, Vec *c), (void)a, (void)b, (void)c)
     965             : VEC_HIP__DECL_OR_STUB(PetscErrorCode VecCreateSeqHIP(MPI_Comm a, PetscInt b, Vec *c), (void)a, (void)b, (void)c)
     966             : 
     967             : VEC_CUDA_DECL_OR_STUB(PetscErrorCode VecCreateSeqCUDAWithArray(MPI_Comm a, PetscInt b, PetscInt c, const PetscScalar *d, Vec *e), (void)a, (void)b, (void)c, (void)d, (void)e)
     968             : VEC_HIP__DECL_OR_STUB(PetscErrorCode VecCreateSeqHIPWithArray(MPI_Comm a, PetscInt b, PetscInt c, const PetscScalar *d, Vec *e), (void)a, (void)b, (void)c, (void)d, (void)e)
     969             : 
     970             : VEC_CUDA_DECL_OR_STUB(PetscErrorCode VecCreateSeqCUDAWithArrays(MPI_Comm a, PetscInt b, PetscInt c, const PetscScalar *d, const PetscScalar *e, Vec *f), (void)a, (void)b, (void)c, (void)d, (void)e, (void)f)
     971             : VEC_HIP__DECL_OR_STUB(PetscErrorCode VecCreateSeqHIPWithArrays(MPI_Comm a, PetscInt b, PetscInt c, const PetscScalar *d, const PetscScalar *e, Vec *f), (void)a, (void)b, (void)c, (void)d, (void)e, (void)f)
     972             : 
     973             : VEC_CUDA_DECL_OR_STUB(PetscErrorCode VecCreateMPICUDA(MPI_Comm a, PetscInt b, PetscInt c, Vec *d), (void)a, (void)b, (void)c, (void)d)
     974             : VEC_HIP__DECL_OR_STUB(PetscErrorCode VecCreateMPIHIP(MPI_Comm a, PetscInt b, PetscInt c, Vec *d), (void)a, (void)b, (void)c, (void)d)
     975             : 
     976             : VEC_CUDA_DECL_OR_STUB(PetscErrorCode VecCreateMPICUDAWithArray(MPI_Comm a, PetscInt b, PetscInt c, PetscInt d, const PetscScalar *e, Vec *f), (void)a, (void)b, (void)c, (void)d, (void)e, (void)f)
     977             : VEC_HIP__DECL_OR_STUB(PetscErrorCode VecCreateMPIHIPWithArray(MPI_Comm a, PetscInt b, PetscInt c, PetscInt d, const PetscScalar *e, Vec *f), (void)a, (void)b, (void)c, (void)d, (void)e, (void)f)
     978             : 
     979             : VEC_CUDA_DECL_OR_STUB(PetscErrorCode VecCreateMPICUDAWithArrays(MPI_Comm a, PetscInt b, PetscInt c, PetscInt d, const PetscScalar *e, const PetscScalar *f, Vec *g), (void)a, (void)b, (void)c, (void)d, (void)e, (void)f, (void)g)
     980             : VEC_HIP__DECL_OR_STUB(PetscErrorCode VecCreateMPIHIPWithArrays(MPI_Comm a, PetscInt b, PetscInt c, PetscInt d, const PetscScalar *e, const PetscScalar *f, Vec *g), (void)a, (void)b, (void)c, (void)d, (void)e, (void)f, (void)g)
     981             : 
     982             : VEC_CUDA_DECL_OR_STUB(PetscErrorCode VecCUDAGetArray(Vec a, PetscScalar **b), (void)a, (void)b)
     983             : VEC_HIP__DECL_OR_STUB(PetscErrorCode VecHIPGetArray(Vec a, PetscScalar **b), (void)a, (void)b)
     984             : 
     985             : VEC_CUDA_DECL_OR_STUB(PetscErrorCode VecCUDARestoreArray(Vec a, PetscScalar **b), (void)a, (void)b)
     986             : VEC_HIP__DECL_OR_STUB(PetscErrorCode VecHIPRestoreArray(Vec a, PetscScalar **b), (void)a, (void)b)
     987             : 
     988             : VEC_CUDA_DECL_OR_STUB(PetscErrorCode VecCUDAGetArrayRead(Vec a, const PetscScalar **b), (void)a, (void)b)
     989             : VEC_HIP__DECL_OR_STUB(PetscErrorCode VecHIPGetArrayRead(Vec a, const PetscScalar **b), (void)a, (void)b)
     990             : 
     991             : VEC_CUDA_DECL_OR_STUB(PetscErrorCode VecCUDARestoreArrayRead(Vec a, const PetscScalar **b), (void)a, (void)b)
     992             : VEC_HIP__DECL_OR_STUB(PetscErrorCode VecHIPRestoreArrayRead(Vec a, const PetscScalar **b), (void)a, (void)b)
     993             : 
     994             : VEC_CUDA_DECL_OR_STUB(PetscErrorCode VecCUDAGetArrayWrite(Vec a, PetscScalar **b), (void)a, (void)b)
     995             : VEC_HIP__DECL_OR_STUB(PetscErrorCode VecHIPGetArrayWrite(Vec a, PetscScalar **b), (void)a, (void)b)
     996             : 
     997             : VEC_CUDA_DECL_OR_STUB(PetscErrorCode VecCUDARestoreArrayWrite(Vec a, PetscScalar **b), (void)a, (void)b)
     998             : VEC_HIP__DECL_OR_STUB(PetscErrorCode VecHIPRestoreArrayWrite(Vec a, PetscScalar **b), (void)a, (void)b)
     999             : 
    1000             : VEC_CUDA_DECL_OR_STUB(PetscErrorCode VecCUDAPlaceArray(Vec a, const PetscScalar b[]), (void)a, (void)b)
    1001             : VEC_HIP__DECL_OR_STUB(PetscErrorCode VecHIPPlaceArray(Vec a, const PetscScalar b[]), (void)a, (void)b)
    1002             : 
    1003             : VEC_CUDA_DECL_OR_STUB(PetscErrorCode VecCUDAReplaceArray(Vec a, const PetscScalar b[]), (void)a, (void)b)
    1004             : VEC_HIP__DECL_OR_STUB(PetscErrorCode VecHIPReplaceArray(Vec a, const PetscScalar b[]), (void)a, (void)b)
    1005             : 
    1006             : VEC_CUDA_DECL_OR_STUB(PetscErrorCode VecCUDAResetArray(Vec a), (void)a)
    1007             : VEC_HIP__DECL_OR_STUB(PetscErrorCode VecHIPResetArray(Vec a), (void)a)
    1008             : 
    1009             : #undef VEC_CUPM_NOT_CONFIGURED
    1010             : #undef VEC_CUDA_DECL_OR_STUB
    1011             : #undef VEC_HIP__DECL_OR_STUB

Generated by: LCOV version 1.14