Actual source code: petscvec.h
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: */
7: #ifndef __PETSCVEC_H
9: #include petscis.h
10: #include petscsys.h
13: /*S
14: Vec - Abstract PETSc vector object
16: Level: beginner
18: Concepts: field variables, unknowns, arrays
20: .seealso: VecCreate(), VecType, VecSetType()
21: S*/
22: typedef struct _p_Vec* Vec;
24: /*S
25: VecScatter - Object used to manage communication of data
26: between vectors in parallel. Manages both scatters and gathers
28: Level: beginner
30: Concepts: scatter
32: .seealso: VecScatterCreate(), VecScatterBegin(), VecScatterEnd()
33: S*/
34: typedef struct _p_VecScatter* VecScatter;
36: /*E
37: VecType - String with the name of a PETSc vector or the creation function
38: with an optional dynamic library name, for example
39: http://www.mcs.anl.gov/petsc/lib.a:myveccreate()
41: Level: beginner
43: .seealso: VecSetType(), Vec
44: E*/
45: #define VecType char*
46: #define VECSEQ "seq"
47: #define VECMPI "mpi"
48: #define VECFETI "feti"
49: #define VECSHARED "shared"
50: #define VECSIEVE "sieve"
52: /* Logging support */
53: #define VEC_FILE_COOKIE 1211214
57: EXTERN PetscErrorCode VecInitializePackage(const char[]);
58: EXTERN PetscErrorCode VecFinalizePackage(void);
60: EXTERN PetscErrorCode VecCreate(MPI_Comm,Vec*);
61: PetscPolymorphicSubroutine(VecCreate,(Vec *x),(PETSC_COMM_SELF,x))
62: EXTERN PetscErrorCode VecCreateSeq(MPI_Comm,PetscInt,Vec*);
63: PetscPolymorphicSubroutine(VecCreateSeq,(PetscInt n,Vec *x),(PETSC_COMM_SELF,n,x))
64: EXTERN PetscErrorCode VecCreateMPI(MPI_Comm,PetscInt,PetscInt,Vec*);
65: PetscPolymorphicSubroutine(VecCreateMPI,(PetscInt n,PetscInt N,Vec *x),(PETSC_COMM_WORLD,n,N,x))
66: EXTERN PetscErrorCode VecCreateSeqWithArray(MPI_Comm,PetscInt,const PetscScalar[],Vec*);
67: PetscPolymorphicSubroutine(VecCreateSeqWithArray,(PetscInt n,PetscScalar s[],Vec *x),(PETSC_COMM_SELF,n,s,x))
68: EXTERN PetscErrorCode VecCreateMPIWithArray(MPI_Comm,PetscInt,PetscInt,const PetscScalar[],Vec*);
69: PetscPolymorphicSubroutine(VecCreateMPIWithArray,(PetscInt n,PetscInt N,PetscScalar s[],Vec *x),(PETSC_COMM_WORLD,n,N,s,x))
70: EXTERN PetscErrorCode VecCreateShared(MPI_Comm,PetscInt,PetscInt,Vec*);
71: EXTERN PetscErrorCode VecSetFromOptions(Vec);
72: EXTERN PetscErrorCode VecSetUp(Vec);
73: EXTERN PetscErrorCode VecDestroy(Vec);
74: EXTERN PetscErrorCode VecZeroEntries(Vec);
75: EXTERN PetscErrorCode VecSetOptionsPrefix(Vec,const char[]);
76: EXTERN PetscErrorCode VecAppendOptionsPrefix(Vec,const char[]);
77: EXTERN PetscErrorCode VecGetOptionsPrefix(Vec,const char*[]);
79: EXTERN PetscErrorCode VecSetSizes(Vec,PetscInt,PetscInt);
81: EXTERN PetscErrorCode VecDotNorm2(Vec,Vec,PetscScalar*,PetscScalar*);
82: EXTERN PetscErrorCode VecDot(Vec,Vec,PetscScalar*);
83: PetscPolymorphicFunction(VecDot,(Vec x,Vec y),(x,y,&s),PetscScalar,s)
84: EXTERN PetscErrorCode VecTDot(Vec,Vec,PetscScalar*);
85: PetscPolymorphicFunction(VecTDot,(Vec x,Vec y),(x,y,&s),PetscScalar,s)
86: EXTERN PetscErrorCode VecMDot(Vec,PetscInt,const Vec[],PetscScalar[]);
87: EXTERN PetscErrorCode VecMTDot(Vec,PetscInt,const Vec[],PetscScalar[]);
89: /*E
90: NormType - determines what type of norm to compute
92: Level: beginner
94: .seealso: VecNorm(), VecNormBegin(), VecNormEnd(), MatNorm()
95: E*/
96: typedef enum {NORM_1=0,NORM_2=1,NORM_FROBENIUS=2,NORM_INFINITY=3,NORM_1_AND_2=4} NormType;
98: #define NORM_MAX NORM_INFINITY
100: /*MC
101: NORM_1 - the one norm, ||v|| = sum_i | v_i |. ||A|| = max_j || v_*j ||, maximum column sum
103: Level: beginner
105: .seealso: NormType, MatNorm(), VecNorm(), VecNormBegin(), VecNormEnd(), NORM_2, NORM_FROBENIUS,
106: NORM_INFINITY, NORM_1_AND_2
108: M*/
110: /*MC
111: NORM_2 - the two norm, ||v|| = sqrt(sum_i (v_i)^2) (vectors only)
113: Level: beginner
115: .seealso: NormType, MatNorm(), VecNorm(), VecNormBegin(), VecNormEnd(), NORM_1, NORM_FROBENIUS,
116: NORM_INFINITY, NORM_1_AND_2
118: M*/
120: /*MC
121: NORM_FROBENIUS - ||A|| = sqrt(sum_ij (A_ij)^2), same as NORM_2 for vectors
123: Level: beginner
125: .seealso: NormType, MatNorm(), VecNorm(), VecNormBegin(), VecNormEnd(), NORM_1, NORM_2,
126: NORM_INFINITY, NORM_1_AND_2
128: M*/
130: /*MC
131: NORM_INFINITY - ||v|| = max_i |v_i|. ||A|| = max_i || v_i* ||, maximum row sum
133: Level: beginner
135: .seealso: NormType, MatNorm(), VecNorm(), VecNormBegin(), VecNormEnd(), NORM_1, NORM_2,
136: NORM_FROBINIUS, NORM_1_AND_2
138: M*/
140: /*MC
141: NORM_1_AND_2 - computes both the 1 and 2 norm of a vector
143: Level: beginner
145: .seealso: NormType, MatNorm(), VecNorm(), VecNormBegin(), VecNormEnd(), NORM_1, NORM_2,
146: NORM_FROBINIUS, NORM_INFINITY
148: M*/
150: /*MC
151: NORM_MAX - see NORM_INFINITY
153: Level: beginner
155: M*/
157: EXTERN PetscErrorCode VecNorm(Vec,NormType,PetscReal *);
158: PetscPolymorphicSubroutine(VecNorm,(Vec x,PetscReal *r),(x,NORM_2,r))
159: PetscPolymorphicFunction(VecNorm,(Vec x,NormType t),(x,t,&r),PetscReal,r)
160: PetscPolymorphicFunction(VecNorm,(Vec x),(x,NORM_2,&r),PetscReal,r)
161: EXTERN PetscErrorCode VecNormalize(Vec,PetscReal *);
162: EXTERN PetscErrorCode VecSum(Vec,PetscScalar*);
163: EXTERN PetscErrorCode VecMax(Vec,PetscInt*,PetscReal *);
164: PetscPolymorphicSubroutine(VecMax,(Vec x,PetscReal *r),(x,PETSC_NULL,r))
165: EXTERN PetscErrorCode VecMin(Vec,PetscInt*,PetscReal *);
166: PetscPolymorphicSubroutine(VecMin,(Vec x,PetscReal *r),(x,PETSC_NULL,r))
167: EXTERN PetscErrorCode VecScale(Vec,PetscScalar);
168: EXTERN PetscErrorCode VecCopy(Vec,Vec);
169: EXTERN PetscErrorCode VecSetRandom(Vec,PetscRandom);
170: EXTERN PetscErrorCode VecSet(Vec,PetscScalar);
171: EXTERN PetscErrorCode VecSwap(Vec,Vec);
172: EXTERN PetscErrorCode VecAXPY(Vec,PetscScalar,Vec);
173: EXTERN PetscErrorCode VecAXPBY(Vec,PetscScalar,PetscScalar,Vec);
174: EXTERN PetscErrorCode VecMAXPY(Vec,PetscInt,const PetscScalar[],Vec[]);
175: EXTERN PetscErrorCode VecAYPX(Vec,PetscScalar,Vec);
176: EXTERN PetscErrorCode VecWAXPY(Vec,PetscScalar,Vec,Vec);
177: EXTERN PetscErrorCode VecAXPBYPCZ(Vec,PetscScalar,PetscScalar,PetscScalar,Vec,Vec);
178: EXTERN PetscErrorCode VecPointwiseMax(Vec,Vec,Vec);
179: PetscPolymorphicSubroutine(VecPointwiseMax,(Vec x,Vec y),(x,y,y))
180: EXTERN PetscErrorCode VecPointwiseMaxAbs(Vec,Vec,Vec);
181: PetscPolymorphicSubroutine(VecPointwiseMaxAbs,(Vec x,Vec y),(x,y,y))
182: EXTERN PetscErrorCode VecPointwiseMin(Vec,Vec,Vec);
183: PetscPolymorphicSubroutine(VecPointwiseMin,(Vec x,Vec y),(x,y,y))
184: EXTERN PetscErrorCode VecPointwiseMult(Vec,Vec,Vec);
185: PetscPolymorphicSubroutine(VecPointwiseMult,(Vec x,Vec y),(x,x,y))
186: EXTERN PetscErrorCode VecPointwiseDivide(Vec,Vec,Vec);
187: PetscPolymorphicSubroutine(VecPointwiseDivide,(Vec x,Vec y),(x,x,y))
188: EXTERN PetscErrorCode VecMaxPointwiseDivide(Vec,Vec,PetscReal*);
189: EXTERN PetscErrorCode VecShift(Vec,PetscScalar);
190: EXTERN PetscErrorCode VecReciprocal(Vec);
191: EXTERN PetscErrorCode VecPermute(Vec, IS, PetscTruth);
192: EXTERN PetscErrorCode VecSqrt(Vec);
193: EXTERN PetscErrorCode VecLog(Vec);
194: EXTERN PetscErrorCode VecExp(Vec);
195: EXTERN PetscErrorCode VecAbs(Vec);
196: EXTERN PetscErrorCode VecDuplicate(Vec,Vec*);
197: EXTERN PetscErrorCode VecDuplicateVecs(Vec,PetscInt,Vec*[]);
198: EXTERN PetscErrorCode VecDestroyVecs(Vec[],PetscInt);
199: EXTERN PetscErrorCode VecStrideNormAll(Vec,NormType,PetscReal[]);
200: EXTERN PetscErrorCode VecStrideMaxAll(Vec,PetscInt [],PetscReal []);
201: EXTERN PetscErrorCode VecStrideMinAll(Vec,PetscInt [],PetscReal []);
202: EXTERN PetscErrorCode VecStrideScaleAll(Vec,PetscScalar[]);
204: EXTERN PetscErrorCode VecStrideNorm(Vec,PetscInt,NormType,PetscReal*);
205: PetscPolymorphicFunction(VecStrideNorm,(Vec x,PetscInt i),(x,i,NORM_2,&r),PetscReal,r)
206: PetscPolymorphicFunction(VecStrideNorm,(Vec x,PetscInt i,NormType t),(x,i,t,&r),PetscReal,r)
207: EXTERN PetscErrorCode VecStrideMax(Vec,PetscInt,PetscInt *,PetscReal *);
208: PetscPolymorphicFunction(VecStrideMax,(Vec x,PetscInt i),(x,i,PETSC_NULL,&r),PetscReal,r)
209: EXTERN PetscErrorCode VecStrideMin(Vec,PetscInt,PetscInt *,PetscReal *);
210: PetscPolymorphicFunction(VecStrideMin,(Vec x,PetscInt i),(x,i,PETSC_NULL,&r),PetscReal,r)
211: EXTERN PetscErrorCode VecStrideScale(Vec,PetscInt,PetscScalar);
214: EXTERN PetscErrorCode VecStrideGather(Vec,PetscInt,Vec,InsertMode);
215: EXTERN PetscErrorCode VecStrideScatter(Vec,PetscInt,Vec,InsertMode);
216: EXTERN PetscErrorCode VecStrideGatherAll(Vec,Vec[],InsertMode);
217: EXTERN PetscErrorCode VecStrideScatterAll(Vec[],Vec,InsertMode);
219: EXTERN PetscErrorCode VecSetValues(Vec,PetscInt,const PetscInt[],const PetscScalar[],InsertMode);
220: EXTERN PetscErrorCode VecGetValues(Vec,PetscInt,const PetscInt[],PetscScalar[]);
221: EXTERN PetscErrorCode VecAssemblyBegin(Vec);
222: EXTERN PetscErrorCode VecAssemblyEnd(Vec);
223: EXTERN PetscErrorCode VecStashSetInitialSize(Vec,PetscInt,PetscInt);
224: EXTERN PetscErrorCode VecStashView(Vec,PetscViewer);
225: EXTERN PetscErrorCode VecStashGetInfo(Vec,PetscInt*,PetscInt*,PetscInt*,PetscInt*);
227: /*MC
228: VecSetValue - Set a single entry into a vector.
230: Synopsis:
231: PetscErrorCode VecSetValue(Vec v,int row,PetscScalar value, InsertMode mode);
233: Not Collective
235: Input Parameters:
236: + v - the vector
237: . row - the row location of the entry
238: . value - the value to insert
239: - mode - either INSERT_VALUES or ADD_VALUES
241: Notes:
242: For efficiency one should use VecSetValues() and set several or
243: many values simultaneously if possible.
245: These values may be cached, so VecAssemblyBegin() and VecAssemblyEnd()
246: MUST be called after all calls to VecSetValues() have been completed.
248: VecSetValues() uses 0-based indices in Fortran as well as in C.
250: Level: beginner
252: .seealso: VecSetValues(), VecAssemblyBegin(), VecAssemblyEnd(), VecSetValuesBlockedLocal(), VecSetValueLocal()
253: M*/
254: PETSC_STATIC_INLINE PetscErrorCode VecSetValue(Vec v,PetscInt i,PetscScalar va,InsertMode mode) {return VecSetValues(v,1,&i,&va,mode);}
257: EXTERN PetscErrorCode VecSetBlockSize(Vec,PetscInt);
258: EXTERN PetscErrorCode VecGetBlockSize(Vec,PetscInt*);
259: PetscPolymorphicFunction(VecGetBlockSize,(Vec x),(x,&i),PetscInt,i)
260: EXTERN PetscErrorCode VecSetValuesBlocked(Vec,PetscInt,const PetscInt[],const PetscScalar[],InsertMode);
262: /* Dynamic creation and loading functions */
265: EXTERN PetscErrorCode VecSetType(Vec, const VecType);
266: EXTERN PetscErrorCode VecGetType(Vec, const VecType *);
267: EXTERN PetscErrorCode VecRegister(const char[],const char[],const char[],PetscErrorCode (*)(Vec));
268: EXTERN PetscErrorCode VecRegisterAll(const char []);
269: EXTERN PetscErrorCode VecRegisterDestroy(void);
271: /*MC
272: VecRegisterDynamic - Adds a new vector component implementation
274: Synopsis:
275: PetscErrorCode VecRegisterDynamic(char *name, char *path, char *func_name, PetscErrorCode (*create_func)(Vec))
277: Not Collective
279: Input Parameters:
280: + name - The name of a new user-defined creation routine
281: . path - The path (either absolute or relative) of the library containing this routine
282: . func_name - The name of routine to create method context
283: - create_func - The creation routine itself
285: Notes:
286: VecRegisterDynamic() may be called multiple times to add several user-defined vectors
288: If dynamic libraries are used, then the fourth input argument (routine_create) is ignored.
290: Sample usage:
291: .vb
292: VecRegisterDynamic("my_vec","/home/username/my_lib/lib/libO/solaris/libmy.a", "MyVectorCreate", MyVectorCreate);
293: .ve
295: Then, your vector type can be chosen with the procedural interface via
296: .vb
297: VecCreate(MPI_Comm, Vec *);
298: VecSetType(Vec,"my_vector_name");
299: .ve
300: or at runtime via the option
301: .vb
302: -vec_type my_vector_name
303: .ve
305: Notes: $PETSC_ARCH occuring in pathname will be replaced with appropriate values.
306: If your function is not being put into a shared library then use VecRegister() instead
307:
308: Level: advanced
310: .keywords: Vec, register
311: .seealso: VecRegisterAll(), VecRegisterDestroy(), VecRegister()
312: M*/
313: #if defined(PETSC_USE_DYNAMIC_LIBRARIES)
314: #define VecRegisterDynamic(a,b,c,d) VecRegister(a,b,c,0)
315: #else
316: #define VecRegisterDynamic(a,b,c,d) VecRegister(a,b,c,d)
317: #endif
320: EXTERN PetscErrorCode VecScatterCreate(Vec,IS,Vec,IS,VecScatter *);
321: PetscPolymorphicFunction(VecScatterCreate,(Vec x,IS is1,Vec y,IS is2),(x,is1,y,is2,&s),VecScatter,s)
322: PetscPolymorphicSubroutine(VecScatterCreate,(Vec x,IS is,Vec y,VecScatter *s),(x,is,y,PETSC_NULL,s))
323: PetscPolymorphicFunction(VecScatterCreate,(Vec x,IS is,Vec y),(x,is,y,PETSC_NULL,&s),VecScatter,s)
324: PetscPolymorphicSubroutine(VecScatterCreate,(Vec x,Vec y,IS is,VecScatter *s),(x,PETSC_NULL,y,is,s))
325: PetscPolymorphicFunction(VecScatterCreate,(Vec x,Vec y,IS is),(x,PETSC_NULL,y,is,&s),VecScatter,s)
326: EXTERN PetscErrorCode VecScatterCreateEmpty(MPI_Comm,VecScatter *);
327: EXTERN PetscErrorCode VecScatterCreateLocal(VecScatter,PetscInt,const PetscInt[],const PetscInt[],const PetscInt[],PetscInt,const PetscInt[],const PetscInt[],const PetscInt[],PetscInt);
328: EXTERN PetscErrorCode VecScatterBegin(VecScatter,Vec,Vec,InsertMode,ScatterMode);
329: EXTERN PetscErrorCode VecScatterEnd(VecScatter,Vec,Vec,InsertMode,ScatterMode);
330: EXTERN PetscErrorCode VecScatterDestroy(VecScatter);
331: EXTERN PetscErrorCode VecScatterCopy(VecScatter,VecScatter *);
332: EXTERN PetscErrorCode VecScatterView(VecScatter,PetscViewer);
333: EXTERN PetscErrorCode VecScatterRemap(VecScatter,PetscInt *,PetscInt*);
334: EXTERN PetscErrorCode VecScatterGetMerged(VecScatter,PetscTruth*);
336: EXTERN PetscErrorCode VecGetArray_Private(Vec,PetscScalar*[]);
337: EXTERN PetscErrorCode VecRestoreArray_Private(Vec,PetscScalar*[]);
338: EXTERN PetscErrorCode VecGetArray4d(Vec,PetscInt,PetscInt,PetscInt,PetscInt,PetscInt,PetscInt,PetscInt,PetscInt,PetscScalar****[]);
339: EXTERN PetscErrorCode VecRestoreArray4d(Vec,PetscInt,PetscInt,PetscInt,PetscInt,PetscInt,PetscInt,PetscInt,PetscInt,PetscScalar****[]);
340: EXTERN PetscErrorCode VecGetArray3d(Vec,PetscInt,PetscInt,PetscInt,PetscInt,PetscInt,PetscInt,PetscScalar***[]);
341: EXTERN PetscErrorCode VecRestoreArray3d(Vec,PetscInt,PetscInt,PetscInt,PetscInt,PetscInt,PetscInt,PetscScalar***[]);
342: EXTERN PetscErrorCode VecGetArray2d(Vec,PetscInt,PetscInt,PetscInt,PetscInt,PetscScalar**[]);
343: EXTERN PetscErrorCode VecRestoreArray2d(Vec,PetscInt,PetscInt,PetscInt,PetscInt,PetscScalar**[]);
344: EXTERN PetscErrorCode VecGetArray1d(Vec,PetscInt,PetscInt,PetscScalar *[]);
345: EXTERN PetscErrorCode VecRestoreArray1d(Vec,PetscInt,PetscInt,PetscScalar *[]);
347: EXTERN PetscErrorCode VecPlaceArray(Vec,const PetscScalar[]);
348: EXTERN PetscErrorCode VecResetArray(Vec);
349: EXTERN PetscErrorCode VecReplaceArray(Vec,const PetscScalar[]);
350: EXTERN PetscErrorCode VecGetArrays(const Vec[],PetscInt,PetscScalar**[]);
351: EXTERN PetscErrorCode VecRestoreArrays(const Vec[],PetscInt,PetscScalar**[]);
353: EXTERN PetscErrorCode VecValid(Vec,PetscTruth*);
354: EXTERN PetscErrorCode VecView(Vec,PetscViewer);
355: EXTERN PetscErrorCode VecViewFromOptions(Vec, const char *);
356: EXTERN PetscErrorCode VecEqual(Vec,Vec,PetscTruth*);
357: PetscPolymorphicFunction(VecEqual,(Vec x,Vec y),(x,y,&s),PetscTruth,s)
358: EXTERN PetscErrorCode VecLoad(PetscViewer,const VecType,Vec*);
359: EXTERN PetscErrorCode VecLoadIntoVector(PetscViewer,Vec);
361: EXTERN PetscErrorCode VecGetSize(Vec,PetscInt*);
362: PetscPolymorphicFunction(VecGetSize,(Vec x),(x,&s),PetscInt,s)
363: EXTERN PetscErrorCode VecGetLocalSize(Vec,PetscInt*);
364: PetscPolymorphicFunction(VecGetLocalSize,(Vec x),(x,&s),PetscInt,s)
365: EXTERN PetscErrorCode VecGetOwnershipRange(Vec,PetscInt*,PetscInt*);
366: EXTERN PetscErrorCode VecGetOwnershipRanges(Vec,const PetscInt *[]);
368: EXTERN PetscErrorCode VecSetLocalToGlobalMapping(Vec,ISLocalToGlobalMapping);
369: EXTERN PetscErrorCode VecSetValuesLocal(Vec,PetscInt,const PetscInt[],const PetscScalar[],InsertMode);
371: /*MC
372: VecSetValueLocal - Set a single entry into a vector using the local numbering
374: Synopsis:
375: PetscErrorCode VecSetValueLocal(Vec v,int row,PetscScalar value, InsertMode mode);
377: Not Collective
379: Input Parameters:
380: + v - the vector
381: . row - the row location of the entry
382: . value - the value to insert
383: - mode - either INSERT_VALUES or ADD_VALUES
385: Notes:
386: For efficiency one should use VecSetValues() and set several or
387: many values simultaneously if possible.
389: These values may be cached, so VecAssemblyBegin() and VecAssemblyEnd()
390: MUST be called after all calls to VecSetValues() have been completed.
392: VecSetValues() uses 0-based indices in Fortran as well as in C.
394: Level: beginner
396: .seealso: VecSetValues(), VecAssemblyBegin(), VecAssemblyEnd(), VecSetValuesBlockedLocal(), VecSetValue()
397: M*/
398: PETSC_STATIC_INLINE PetscErrorCode VecSetValueLocal(Vec v,PetscInt i,PetscScalar va,InsertMode mode) {return VecSetValuesLocal(v,1,&i,&va,mode);}
400: EXTERN PetscErrorCode VecSetLocalToGlobalMappingBlock(Vec,ISLocalToGlobalMapping);
401: EXTERN PetscErrorCode VecSetValuesBlockedLocal(Vec,PetscInt,const PetscInt[],const PetscScalar[],InsertMode);
403: EXTERN PetscErrorCode VecDotBegin(Vec,Vec,PetscScalar *);
404: PetscPolymorphicSubroutine(VecDotBegin,(Vec x,Vec y),(x,y,PETSC_NULL))
405: EXTERN PetscErrorCode VecDotEnd(Vec,Vec,PetscScalar *);
406: PetscPolymorphicFunction(VecDotEnd,(Vec x,Vec y),(x,y,&s),PetscScalar,s)
407: EXTERN PetscErrorCode VecTDotBegin(Vec,Vec,PetscScalar *);
408: PetscPolymorphicSubroutine(VecTDotBegin,(Vec x,Vec y),(x,y,PETSC_NULL))
409: EXTERN PetscErrorCode VecTDotEnd(Vec,Vec,PetscScalar *);
410: PetscPolymorphicFunction(VecTDotEnd,(Vec x,Vec y),(x,y,&s),PetscScalar,s)
411: EXTERN PetscErrorCode VecNormBegin(Vec,NormType,PetscReal *);
412: PetscPolymorphicSubroutine(VecNormBegin,(Vec x,NormType t),(x,t,PETSC_NULL))
413: PetscPolymorphicSubroutine(VecNormBegin,(Vec x),(x,NORM_2,PETSC_NULL))
414: EXTERN PetscErrorCode VecNormEnd(Vec,NormType,PetscReal *);
415: PetscPolymorphicFunction(VecNormEnd,(Vec x,NormType t),(x,t,&s),PetscReal,s)
416: PetscPolymorphicFunction(VecNormEnd,(Vec x),(x,NORM_2,&s),PetscReal,s)
418: EXTERN PetscErrorCode VecMDotBegin(Vec,PetscInt,const Vec[],PetscScalar[]);
419: EXTERN PetscErrorCode VecMDotEnd(Vec,PetscInt,const Vec[],PetscScalar[]);
420: EXTERN PetscErrorCode VecMTDotBegin(Vec,PetscInt,const Vec[],PetscScalar[]);
421: EXTERN PetscErrorCode VecMTDotEnd(Vec,PetscInt,const Vec[],PetscScalar[]);
424: typedef enum {VEC_IGNORE_OFF_PROC_ENTRIES,VEC_IGNORE_NEGATIVE_INDICES} VecOption;
425: EXTERN PetscErrorCode VecSetOption(Vec,VecOption,PetscTruth);
427: /*
428: Expose VecGetArray()/VecRestoreArray() to users. Allows this to work without any function
429: call overhead on any 'native' Vecs.
430: */
432: #include private/vecimpl.h
434: EXTERN PetscErrorCode VecContourScale(Vec,PetscReal,PetscReal);
436: /*
437: These numbers need to match the entries in
438: the function table in vecimpl.h
439: */
440: typedef enum { VECOP_VIEW = 33, VECOP_LOADINTOVECTOR = 41} VecOperation;
441: EXTERN PetscErrorCode VecSetOperation(Vec,VecOperation,void(*)(void));
443: /*
444: Routines for dealing with ghosted vectors:
445: vectors with ghost elements at the end of the array.
446: */
447: EXTERN PetscErrorCode VecCreateGhost(MPI_Comm,PetscInt,PetscInt,PetscInt,const PetscInt[],Vec*);
448: EXTERN PetscErrorCode VecCreateGhostWithArray(MPI_Comm,PetscInt,PetscInt,PetscInt,const PetscInt[],const PetscScalar[],Vec*);
449: EXTERN PetscErrorCode VecCreateGhostBlock(MPI_Comm,PetscInt,PetscInt,PetscInt,PetscInt,const PetscInt[],Vec*);
450: EXTERN PetscErrorCode VecCreateGhostBlockWithArray(MPI_Comm,PetscInt,PetscInt,PetscInt,PetscInt,const PetscInt[],const PetscScalar[],Vec*);
451: EXTERN PetscErrorCode VecGhostGetLocalForm(Vec,Vec*);
452: PetscPolymorphicFunction(VecGhostGetLocalForm,(Vec x),(x,&s),Vec,s)
453: EXTERN PetscErrorCode VecGhostRestoreLocalForm(Vec,Vec*);
454: EXTERN PetscErrorCode VecGhostUpdateBegin(Vec,InsertMode,ScatterMode);
455: EXTERN PetscErrorCode VecGhostUpdateEnd(Vec,InsertMode,ScatterMode);
457: EXTERN PetscErrorCode VecConjugate(Vec);
459: EXTERN PetscErrorCode VecScatterCreateToAll(Vec,VecScatter*,Vec*);
460: EXTERN PetscErrorCode VecScatterCreateToZero(Vec,VecScatter*,Vec*);
462: EXTERN PetscErrorCode PetscViewerMathematicaGetVector(PetscViewer, Vec);
463: EXTERN PetscErrorCode PetscViewerMathematicaPutVector(PetscViewer, Vec);
465: /*S
466: Vecs - Collection of vectors where the data for the vectors is stored in
467: one contiguous memory
469: Level: advanced
471: Notes:
472: Temporary construct for handling multiply right hand side solves
474: This is faked by storing a single vector that has enough array space for
475: n vectors
477: Concepts: parallel decomposition
479: S*/
480: struct _n_Vecs {PetscInt n; Vec v;};
481: typedef struct _n_Vecs* Vecs;
482: #define VecsDestroy(x) (VecDestroy((x)->v) || PetscFree(x))
483: #define VecsCreateSeq(comm,p,m,x) (PetscNew(struct _n_Vecs,x) || VecCreateSeq(comm,p*m,&(*(x))->v) || (-1 == ((*(x))->n = (m))))
484: #define VecsCreateSeqWithArray(comm,p,m,a,x) (PetscNew(struct _n_Vecs,x) || VecCreateSeqWithArray(comm,p*m,a,&(*(x))->v) || (-1 == ((*(x))->n = (m))))
485: #define VecsDuplicate(x,y) (PetscNew(struct _n_Vecs,y) || VecDuplicate(x->v,&(*(y))->v) || (-1 == ((*(y))->n = (x)->n)))
489: #endif