Actual source code: aij.h
petsc-3.11.0 2019-03-29
5: #include <petsc/private/matimpl.h>
6: #include <petscctable.h>
8: /*
9: Struct header shared by SeqAIJ, SeqBAIJ and SeqSBAIJ matrix formats
10: */
11: #define SEQAIJHEADER(datatype) \
12: PetscBool roworiented; /* if true, row-oriented input, default */ \
13: PetscInt nonew; /* 1 don't add new nonzeros, -1 generate error on new */ \
14: PetscInt nounused; /* -1 generate error on unused space */ \
15: PetscBool singlemalloc; /* if true a, i, and j have been obtained with one big malloc */ \
16: PetscInt maxnz; /* allocated nonzeros */ \
17: PetscInt *imax; /* maximum space allocated for each row */ \
18: PetscInt *ilen; /* actual length of each row */ \
19: PetscInt *ipre; /* space preallocated for each row by user */ \
20: PetscBool free_imax_ilen; \
21: PetscInt reallocs; /* number of mallocs done during MatSetValues() \
22: as more values are set than were prealloced */\
23: PetscInt rmax; /* max nonzeros in any row */ \
24: PetscBool keepnonzeropattern; /* keeps matrix structure same in calls to MatZeroRows()*/ \
25: PetscBool ignorezeroentries; \
26: PetscBool free_ij; /* free the column indices j and row offsets i when the matrix is destroyed */ \
27: PetscBool free_a; /* free the numerical values when matrix is destroy */ \
28: Mat_CompressedRow compressedrow; /* use compressed row format */ \
29: PetscInt nz; /* nonzeros */ \
30: PetscInt *i; /* pointer to beginning of each row */ \
31: PetscInt *j; /* column values: j + i[k] - 1 is start of row k */ \
32: PetscInt *diag; /* pointers to diagonal elements */ \
33: PetscInt nonzerorowcnt; /* how many rows have nonzero entries */ \
34: PetscBool free_diag; \
35: datatype *a; /* nonzero elements */ \
36: PetscScalar *solve_work; /* work space used in MatSolve */ \
37: IS row, col, icol; /* index sets, used for reorderings */ \
38: PetscBool pivotinblocks; /* pivot inside factorization of each diagonal block */ \
39: Mat parent; /* set if this matrix was formed with MatDuplicate(...,MAT_SHARE_NONZERO_PATTERN,....); \
40: means that this shares some data structures with the parent including diag, ilen, imax, i, j */\
41: Mat_SubSppt *submatis1 /* used by MatCreateSubMatrices_MPIXAIJ_Local */
43: typedef struct {
44: MatTransposeColoring matcoloring;
45: Mat Bt_den; /* dense matrix of B^T */
46: Mat ABt_den; /* dense matrix of A*B^T */
47: PetscBool usecoloring;
48: PetscErrorCode (*destroy)(Mat);
49: } Mat_MatMatTransMult;
51: typedef struct { /* used by MatTransposeMatMult() */
52: Mat At; /* transpose of the first matrix */
53: Mat mA; /* maij matrix of A */
54: Vec bt,ct; /* vectors to hold locally transposed arrays of B and C */
55: PetscErrorCode (*destroy)(Mat);
56: } Mat_MatTransMatMult;
58: typedef struct {
59: PetscInt *api,*apj; /* symbolic structure of A*P */
60: PetscScalar *apa; /* temporary array for storing one row of A*P */
61: PetscErrorCode (*destroy)(Mat);
62: } Mat_AP;
64: typedef struct {
65: MatTransposeColoring matcoloring;
66: Mat Rt; /* sparse or dense matrix of R^T */
67: Mat RARt; /* dense matrix of R*A*R^T */
68: Mat ARt; /* A*R^T used for the case -matrart_color_art */
69: MatScalar *work; /* work array to store columns of A*R^T used in MatMatMatMultNumeric_SeqAIJ_SeqAIJ_SeqDense() */
70: PetscErrorCode (*destroy)(Mat);
71: } Mat_RARt;
73: typedef struct {
74: Mat BC; /* temp matrix for storing B*C */
75: PetscErrorCode (*destroy)(Mat);
76: } Mat_MatMatMatMult;
78: /*
79: MATSEQAIJ format - Compressed row storage (also called Yale sparse matrix
80: format) or compressed sparse row (CSR). The i[] and j[] arrays start at 0. For example,
81: j[i[k]+p] is the pth column in row k. Note that the diagonal
82: matrix elements are stored with the rest of the nonzeros (not separately).
83: */
85: /* Info about i-nodes (identical nodes) helper class for SeqAIJ */
86: typedef struct {
87: MatScalar *bdiag,*ibdiag,*ssor_work; /* diagonal blocks of matrix used for MatSOR_SeqAIJ_Inode() */
88: PetscInt bdiagsize; /* length of bdiag and ibdiag */
89: PetscBool ibdiagvalid; /* do ibdiag[] and bdiag[] contain the most recent values */
91: PetscBool use;
92: PetscInt node_count; /* number of inodes */
93: PetscInt *size; /* size of each inode */
94: PetscInt limit; /* inode limit */
95: PetscInt max_limit; /* maximum supported inode limit */
96: PetscBool checked; /* if inodes have been checked for */
97: PetscObjectState mat_nonzerostate; /* non-zero state when inodes were checked for */
98: } Mat_SeqAIJ_Inode;
100: PETSC_INTERN PetscErrorCode MatView_SeqAIJ_Inode(Mat,PetscViewer);
101: PETSC_INTERN PetscErrorCode MatAssemblyEnd_SeqAIJ_Inode(Mat,MatAssemblyType);
102: PETSC_INTERN PetscErrorCode MatDestroy_SeqAIJ_Inode(Mat);
103: PETSC_INTERN PetscErrorCode MatCreate_SeqAIJ_Inode(Mat);
104: PETSC_INTERN PetscErrorCode MatSetOption_SeqAIJ_Inode(Mat,MatOption,PetscBool);
105: PETSC_INTERN PetscErrorCode MatDuplicate_SeqAIJ_Inode(Mat,MatDuplicateOption,Mat*);
106: PETSC_INTERN PetscErrorCode MatDuplicateNoCreate_SeqAIJ(Mat,Mat,MatDuplicateOption,PetscBool);
107: PETSC_INTERN PetscErrorCode MatLUFactorNumeric_SeqAIJ_Inode_inplace(Mat,Mat,const MatFactorInfo*);
108: PETSC_INTERN PetscErrorCode MatLUFactorNumeric_SeqAIJ_Inode(Mat,Mat,const MatFactorInfo*);
110: typedef struct {
111: SEQAIJHEADER(MatScalar);
112: Mat_SeqAIJ_Inode inode;
113: MatScalar *saved_values; /* location for stashing nonzero values of matrix */
115: PetscScalar *idiag,*mdiag,*ssor_work; /* inverse of diagonal entries, diagonal values and workspace for Eisenstat trick */
116: PetscBool idiagvalid; /* current idiag[] and mdiag[] are valid */
117: PetscScalar *ibdiag; /* inverses of block diagonals */
118: PetscBool ibdiagvalid; /* inverses of block diagonals are valid. */
119: PetscBool diagonaldense; /* all entries along the diagonal have been set; i.e. no missing diagonal terms */
120: PetscScalar fshift,omega; /* last used omega and fshift */
122: ISColoring coloring; /* set with MatADSetColoring() used by MatADSetValues() */
124: PetscScalar *matmult_abdense; /* used by MatMatMult() */
125: Mat_AP *ap; /* used by MatPtAP() */
126: Mat_MatMatMatMult *matmatmatmult; /* used by MatMatMatMult() */
127: Mat_RARt *rart; /* used by MatRARt() */
128: Mat_MatMatTransMult *abt; /* used by MatMatTransposeMult() */
129: Mat_MatTransMatMult *atb; /* used by MatTransposeMatMult() */
130: } Mat_SeqAIJ;
132: /*
133: Frees the a, i, and j arrays from the XAIJ (AIJ, BAIJ, and SBAIJ) matrix types
134: */
135: PETSC_STATIC_INLINE PetscErrorCode MatSeqXAIJFreeAIJ(Mat AA,MatScalar **a,PetscInt **j,PetscInt **i)
136: {
138: Mat_SeqAIJ *A = (Mat_SeqAIJ*) AA->data;
139: if (A->singlemalloc) {
140: PetscFree3(*a,*j,*i);
141: } else {
142: if (A->free_a) {PetscFree(*a);}
143: if (A->free_ij) {PetscFree(*j);}
144: if (A->free_ij) {PetscFree(*i);}
145: }
146: return 0;
147: }
148: /*
149: Allocates larger a, i, and j arrays for the XAIJ (AIJ, BAIJ, and SBAIJ) matrix types
150: This is a macro because it takes the datatype as an argument which can be either a Mat or a MatScalar
151: */
152: #define MatSeqXAIJReallocateAIJ(Amat,AM,BS2,NROW,ROW,COL,RMAX,AA,AI,AJ,RP,AP,AIMAX,NONEW,datatype) \
153: if (NROW >= RMAX) { \
154: Mat_SeqAIJ *Ain = (Mat_SeqAIJ*)Amat->data; \
155: /* there is no extra room in row, therefore enlarge */ \
156: PetscInt CHUNKSIZE = 15,new_nz = AI[AM] + CHUNKSIZE,len,*new_i=0,*new_j=0; \
157: datatype *new_a; \
158: \
159: if (NONEW == -2) SETERRQ2(PETSC_COMM_SELF,PETSC_ERR_ARG_OUTOFRANGE,"New nonzero at (%D,%D) caused a malloc\nUse MatSetOption(A, MAT_NEW_NONZERO_ALLOCATION_ERR, PETSC_FALSE) to turn off this check",ROW,COL); \
160: /* malloc new storage space */ \
161: PetscMalloc3(BS2*new_nz,&new_a,new_nz,&new_j,AM+1,&new_i); \
162: \
163: /* copy over old data into new slots */ \
164: for (ii=0; ii<ROW+1; ii++) {new_i[ii] = AI[ii];} \
165: for (ii=ROW+1; ii<AM+1; ii++) {new_i[ii] = AI[ii]+CHUNKSIZE;} \
166: PetscMemcpy(new_j,AJ,(AI[ROW]+NROW)*sizeof(PetscInt)); \
167: len = (new_nz - CHUNKSIZE - AI[ROW] - NROW); \
168: PetscMemcpy(new_j+AI[ROW]+NROW+CHUNKSIZE,AJ+AI[ROW]+NROW,len*sizeof(PetscInt)); \
169: PetscMemcpy(new_a,AA,BS2*(AI[ROW]+NROW)*sizeof(datatype)); \
170: PetscMemzero(new_a+BS2*(AI[ROW]+NROW),BS2*CHUNKSIZE*sizeof(datatype)); \
171: PetscMemcpy(new_a+BS2*(AI[ROW]+NROW+CHUNKSIZE),AA+BS2*(AI[ROW]+NROW),BS2*len*sizeof(datatype)); \
172: /* free up old matrix storage */ \
173: MatSeqXAIJFreeAIJ(A,&Ain->a,&Ain->j,&Ain->i); \
174: AA = new_a; \
175: Ain->a = (MatScalar*) new_a; \
176: AI = Ain->i = new_i; AJ = Ain->j = new_j; \
177: Ain->singlemalloc = PETSC_TRUE; \
178: \
179: RP = AJ + AI[ROW]; AP = AA + BS2*AI[ROW]; \
180: RMAX = AIMAX[ROW] = AIMAX[ROW] + CHUNKSIZE; \
181: Ain->maxnz += BS2*CHUNKSIZE; \
182: Ain->reallocs++; \
183: } \
185: #define MatSeqXAIJReallocateAIJ_structure_only(Amat,AM,BS2,NROW,ROW,COL,RMAX,AI,AJ,RP,AIMAX,NONEW,datatype) \
186: if (NROW >= RMAX) { \
187: Mat_SeqAIJ *Ain = (Mat_SeqAIJ*)Amat->data; \
188: /* there is no extra room in row, therefore enlarge */ \
189: PetscInt CHUNKSIZE = 15,new_nz = AI[AM] + CHUNKSIZE,len,*new_i=0,*new_j=0; \
190: \
191: if (NONEW == -2) SETERRQ2(PETSC_COMM_SELF,PETSC_ERR_ARG_OUTOFRANGE,"New nonzero at (%D,%D) caused a malloc\nUse MatSetOption(A, MAT_NEW_NONZERO_ALLOCATION_ERR, PETSC_FALSE) to turn off this check",ROW,COL); \
192: /* malloc new storage space */ \
193: PetscMalloc1(new_nz,&new_j); \
194: PetscMalloc1(AM+1,&new_i);\
195: \
196: /* copy over old data into new slots */ \
197: for (ii=0; ii<ROW+1; ii++) {new_i[ii] = AI[ii];} \
198: for (ii=ROW+1; ii<AM+1; ii++) {new_i[ii] = AI[ii]+CHUNKSIZE;} \
199: PetscMemcpy(new_j,AJ,(AI[ROW]+NROW)*sizeof(PetscInt)); \
200: len = (new_nz - CHUNKSIZE - AI[ROW] - NROW); \
201: PetscMemcpy(new_j+AI[ROW]+NROW+CHUNKSIZE,AJ+AI[ROW]+NROW,len*sizeof(PetscInt)); \
202: \
203: /* free up old matrix storage */ \
204: MatSeqXAIJFreeAIJ(A,&Ain->a,&Ain->j,&Ain->i); \
205: Ain->a = NULL; \
206: AI = Ain->i = new_i; AJ = Ain->j = new_j; \
207: Ain->singlemalloc = PETSC_FALSE; \
208: Ain->free_a = PETSC_FALSE; \
209: \
210: RP = AJ + AI[ROW]; \
211: RMAX = AIMAX[ROW] = AIMAX[ROW] + CHUNKSIZE; \
212: Ain->maxnz += BS2*CHUNKSIZE; \
213: Ain->reallocs++; \
214: } \
216: PETSC_INTERN PetscErrorCode MatSeqAIJSetPreallocation_SeqAIJ(Mat,PetscInt,const PetscInt*);
217: PETSC_INTERN PetscErrorCode MatILUFactorSymbolic_SeqAIJ_inplace(Mat,Mat,IS,IS,const MatFactorInfo*);
218: PETSC_INTERN PetscErrorCode MatILUFactorSymbolic_SeqAIJ(Mat,Mat,IS,IS,const MatFactorInfo*);
219: PETSC_INTERN PetscErrorCode MatILUFactorSymbolic_SeqAIJ_ilu0(Mat,Mat,IS,IS,const MatFactorInfo*);
221: PETSC_INTERN PetscErrorCode MatICCFactorSymbolic_SeqAIJ_inplace(Mat,Mat,IS,const MatFactorInfo*);
222: PETSC_INTERN PetscErrorCode MatICCFactorSymbolic_SeqAIJ(Mat,Mat,IS,const MatFactorInfo*);
223: PETSC_INTERN PetscErrorCode MatCholeskyFactorSymbolic_SeqAIJ_inplace(Mat,Mat,IS,const MatFactorInfo*);
224: PETSC_INTERN PetscErrorCode MatCholeskyFactorSymbolic_SeqAIJ(Mat,Mat,IS,const MatFactorInfo*);
225: PETSC_INTERN PetscErrorCode MatCholeskyFactorNumeric_SeqAIJ_inplace(Mat,Mat,const MatFactorInfo*);
226: PETSC_INTERN PetscErrorCode MatCholeskyFactorNumeric_SeqAIJ(Mat,Mat,const MatFactorInfo*);
227: PETSC_INTERN PetscErrorCode MatDuplicate_SeqAIJ(Mat,MatDuplicateOption,Mat*);
228: PETSC_INTERN PetscErrorCode MatCopy_SeqAIJ(Mat,Mat,MatStructure);
229: PETSC_INTERN PetscErrorCode MatMissingDiagonal_SeqAIJ(Mat,PetscBool*,PetscInt*);
230: PETSC_INTERN PetscErrorCode MatMarkDiagonal_SeqAIJ(Mat);
231: PETSC_INTERN PetscErrorCode MatFindZeroDiagonals_SeqAIJ_Private(Mat,PetscInt*,PetscInt**);
233: PETSC_INTERN PetscErrorCode MatMult_SeqAIJ(Mat A,Vec,Vec);
234: PETSC_INTERN PetscErrorCode MatMultAdd_SeqAIJ(Mat A,Vec,Vec,Vec);
235: PETSC_INTERN PetscErrorCode MatMultTranspose_SeqAIJ(Mat A,Vec,Vec);
236: PETSC_INTERN PetscErrorCode MatMultTransposeAdd_SeqAIJ(Mat A,Vec,Vec,Vec);
237: PETSC_INTERN PetscErrorCode MatSOR_SeqAIJ(Mat,Vec,PetscReal,MatSORType,PetscReal,PetscInt,PetscInt,Vec);
239: PETSC_INTERN PetscErrorCode MatSetOption_SeqAIJ(Mat,MatOption,PetscBool);
241: PETSC_INTERN PetscErrorCode MatGetSymbolicTranspose_SeqAIJ(Mat,PetscInt *[],PetscInt *[]);
242: PETSC_INTERN PetscErrorCode MatGetSymbolicTransposeReduced_SeqAIJ(Mat,PetscInt,PetscInt,PetscInt *[],PetscInt *[]);
243: PETSC_INTERN PetscErrorCode MatTranspose_SeqAIJ_FAST(Mat,MatReuse,Mat *);
244: PETSC_INTERN PetscErrorCode MatRestoreSymbolicTranspose_SeqAIJ(Mat,PetscInt *[],PetscInt *[]);
245: PETSC_INTERN PetscErrorCode MatTransposeSymbolic_SeqAIJ(Mat,Mat*);
246: PETSC_INTERN PetscErrorCode MatTranspose_SeqAIJ(Mat,MatReuse,Mat*);
247: PETSC_INTERN PetscErrorCode MatToSymmetricIJ_SeqAIJ(PetscInt,PetscInt*,PetscInt*,PetscBool,PetscInt,PetscInt,PetscInt**,PetscInt**);
248: PETSC_INTERN PetscErrorCode MatLUFactorSymbolic_SeqAIJ_inplace(Mat,Mat,IS,IS,const MatFactorInfo*);
249: PETSC_INTERN PetscErrorCode MatLUFactorSymbolic_SeqAIJ(Mat,Mat,IS,IS,const MatFactorInfo*);
250: PETSC_INTERN PetscErrorCode MatLUFactorNumeric_SeqAIJ_inplace(Mat,Mat,const MatFactorInfo*);
251: PETSC_INTERN PetscErrorCode MatLUFactorNumeric_SeqAIJ(Mat,Mat,const MatFactorInfo*);
252: PETSC_INTERN PetscErrorCode MatLUFactorNumeric_SeqAIJ_InplaceWithPerm(Mat,Mat,const MatFactorInfo*);
253: PETSC_INTERN PetscErrorCode MatLUFactor_SeqAIJ(Mat,IS,IS,const MatFactorInfo*);
254: PETSC_INTERN PetscErrorCode MatSolve_SeqAIJ_inplace(Mat,Vec,Vec);
255: PETSC_INTERN PetscErrorCode MatSolve_SeqAIJ(Mat,Vec,Vec);
256: PETSC_INTERN PetscErrorCode MatSolve_SeqAIJ_Inode_inplace(Mat,Vec,Vec);
257: PETSC_INTERN PetscErrorCode MatSolve_SeqAIJ_Inode(Mat,Vec,Vec);
258: PETSC_INTERN PetscErrorCode MatSolve_SeqAIJ_NaturalOrdering_inplace(Mat,Vec,Vec);
259: PETSC_INTERN PetscErrorCode MatSolve_SeqAIJ_NaturalOrdering(Mat,Vec,Vec);
260: PETSC_INTERN PetscErrorCode MatSolve_SeqAIJ_InplaceWithPerm(Mat,Vec,Vec);
261: PETSC_INTERN PetscErrorCode MatSolveAdd_SeqAIJ_inplace(Mat,Vec,Vec,Vec);
262: PETSC_INTERN PetscErrorCode MatSolveAdd_SeqAIJ(Mat,Vec,Vec,Vec);
263: PETSC_INTERN PetscErrorCode MatSolveTranspose_SeqAIJ_inplace(Mat,Vec,Vec);
264: PETSC_INTERN PetscErrorCode MatSolveTranspose_SeqAIJ(Mat,Vec,Vec);
265: PETSC_INTERN PetscErrorCode MatSolveTransposeAdd_SeqAIJ_inplace(Mat,Vec,Vec,Vec);
266: PETSC_INTERN PetscErrorCode MatSolveTransposeAdd_SeqAIJ(Mat,Vec,Vec,Vec);
267: PETSC_INTERN PetscErrorCode MatMatSolve_SeqAIJ_inplace(Mat,Mat,Mat);
268: PETSC_INTERN PetscErrorCode MatMatSolve_SeqAIJ(Mat,Mat,Mat);
269: PETSC_INTERN PetscErrorCode MatEqual_SeqAIJ(Mat,Mat,PetscBool*);
270: PETSC_INTERN PetscErrorCode MatFDColoringCreate_SeqXAIJ(Mat,ISColoring,MatFDColoring);
271: PETSC_INTERN PetscErrorCode MatFDColoringSetUp_SeqXAIJ(Mat,ISColoring,MatFDColoring);
272: PETSC_INTERN PetscErrorCode MatFDColoringSetUpBlocked_AIJ_Private(Mat,MatFDColoring,PetscInt);
273: PETSC_INTERN PetscErrorCode MatLoad_AIJ_HDF5(Mat,PetscViewer);
274: PETSC_INTERN PetscErrorCode MatLoad_SeqAIJ_Binary(Mat,PetscViewer);
275: PETSC_INTERN PetscErrorCode MatLoad_SeqAIJ(Mat,PetscViewer);
276: PETSC_INTERN PetscErrorCode RegisterApplyPtAPRoutines_Private(Mat);
278: PETSC_INTERN PetscErrorCode MatMatMult_SeqAIJ_SeqAIJ(Mat,Mat,MatReuse,PetscReal,Mat*);
279: PETSC_INTERN PetscErrorCode MatMatMultSymbolic_SeqAIJ_SeqAIJ(Mat,Mat,PetscReal,Mat*);
280: PETSC_INTERN PetscErrorCode MatMatMultSymbolic_SeqAIJ_SeqAIJ_Sorted(Mat,Mat,PetscReal,Mat*);
281: PETSC_INTERN PetscErrorCode MatMatMultSymbolic_SeqDense_SeqAIJ(Mat,Mat,PetscReal,Mat*);
282: PETSC_INTERN PetscErrorCode MatMatMultSymbolic_SeqAIJ_SeqAIJ_Scalable(Mat,Mat,PetscReal,Mat*);
283: PETSC_INTERN PetscErrorCode MatMatMultSymbolic_SeqAIJ_SeqAIJ_Scalable_fast(Mat,Mat,PetscReal,Mat*);
284: PETSC_INTERN PetscErrorCode MatMatMultSymbolic_SeqAIJ_SeqAIJ_Heap(Mat,Mat,PetscReal,Mat*);
285: PETSC_INTERN PetscErrorCode MatMatMultSymbolic_SeqAIJ_SeqAIJ_BTHeap(Mat,Mat,PetscReal,Mat*);
286: PETSC_INTERN PetscErrorCode MatMatMultSymbolic_SeqAIJ_SeqAIJ_RowMerge(Mat,Mat,PetscReal,Mat*);
287: PETSC_INTERN PetscErrorCode MatMatMultSymbolic_SeqAIJ_SeqAIJ_LLCondensed(Mat,Mat,PetscReal,Mat*);
288: #if defined(PETSC_HAVE_HYPRE)
289: PETSC_INTERN PetscErrorCode MatMatMultSymbolic_AIJ_AIJ_wHYPRE(Mat,Mat,PetscReal,Mat*);
290: #endif
291: PETSC_INTERN PetscErrorCode MatMatMult_SeqAIJ_SeqAIJ_Combined(Mat,Mat,PetscReal,Mat*);
292: PETSC_INTERN PetscErrorCode MatMatMultNumeric_SeqAIJ_SeqAIJ(Mat,Mat,Mat);
293: PETSC_INTERN PetscErrorCode MatMatMultNumeric_SeqAIJ_SeqAIJ_Sorted(Mat,Mat,Mat);
294: PETSC_INTERN PetscErrorCode MatMatMultNumeric_SeqDense_SeqAIJ(Mat,Mat,Mat);
295: PETSC_INTERN PetscErrorCode MatMatMultNumeric_SeqAIJ_SeqAIJ_Scalable(Mat,Mat,Mat);
296: PETSC_INTERN PetscErrorCode MatMatMultNumeric_SeqAIJ_SeqAIJ_Combined(Mat,Mat,Mat);
298: PETSC_INTERN PetscErrorCode MatPtAP_SeqAIJ_SeqAIJ(Mat,Mat,MatReuse,PetscReal,Mat*);
299: PETSC_INTERN PetscErrorCode MatPtAPSymbolic_SeqAIJ_SeqAIJ_SparseAxpy(Mat,Mat,PetscReal,Mat*);
300: PETSC_INTERN PetscErrorCode MatPtAPNumeric_SeqAIJ_SeqAIJ(Mat,Mat,Mat);
301: PETSC_INTERN PetscErrorCode MatPtAPNumeric_SeqAIJ_SeqAIJ_SparseAxpy(Mat,Mat,Mat);
303: PETSC_INTERN PetscErrorCode MatRARtSymbolic_SeqAIJ_SeqAIJ(Mat,Mat,PetscReal,Mat*);
304: PETSC_INTERN PetscErrorCode MatRARtSymbolic_SeqAIJ_SeqAIJ_matmattransposemult(Mat,Mat,PetscReal,Mat*);
305: PETSC_INTERN PetscErrorCode MatRARtSymbolic_SeqAIJ_SeqAIJ_colorrart(Mat,Mat,PetscReal,Mat*);
306: PETSC_INTERN PetscErrorCode MatRARtNumeric_SeqAIJ_SeqAIJ(Mat,Mat,Mat);
307: PETSC_INTERN PetscErrorCode MatRARtNumeric_SeqAIJ_SeqAIJ_matmattransposemult(Mat,Mat,Mat);
308: PETSC_INTERN PetscErrorCode MatRARtNumeric_SeqAIJ_SeqAIJ_colorrart(Mat,Mat,Mat);
310: PETSC_INTERN PetscErrorCode MatTransposeMatMult_SeqAIJ_SeqAIJ(Mat,Mat,MatReuse,PetscReal,Mat*);
311: PETSC_INTERN PetscErrorCode MatTransposeMatMultSymbolic_SeqAIJ_SeqAIJ(Mat,Mat,PetscReal,Mat*);
312: PETSC_INTERN PetscErrorCode MatTransposeMatMultNumeric_SeqAIJ_SeqAIJ(Mat,Mat,Mat);
313: PETSC_INTERN PetscErrorCode MatDestroy_SeqAIJ_MatTransMatMult(Mat);
315: PETSC_INTERN PetscErrorCode MatTransposeMatMult_SeqAIJ_SeqDense(Mat,Mat,MatReuse,PetscReal,Mat*);
316: PETSC_INTERN PetscErrorCode MatTransposeMatMultSymbolic_SeqAIJ_SeqDense(Mat,Mat,PetscReal,Mat*);
317: PETSC_INTERN PetscErrorCode MatTransposeMatMultNumeric_SeqAIJ_SeqDense(Mat,Mat,Mat);
319: PETSC_INTERN PetscErrorCode MatMatTransposeMult_SeqAIJ_SeqAIJ(Mat,Mat,MatReuse,PetscReal,Mat*);
320: PETSC_INTERN PetscErrorCode MatMatTransposeMultSymbolic_SeqAIJ_SeqAIJ(Mat,Mat,PetscReal,Mat*);
321: PETSC_INTERN PetscErrorCode MatMatTransposeMultNumeric_SeqAIJ_SeqAIJ(Mat,Mat,Mat);
322: PETSC_INTERN PetscErrorCode MatTransposeColoringCreate_SeqAIJ(Mat,ISColoring,MatTransposeColoring);
323: PETSC_INTERN PetscErrorCode MatTransColoringApplySpToDen_SeqAIJ(MatTransposeColoring,Mat,Mat);
324: PETSC_INTERN PetscErrorCode MatTransColoringApplyDenToSp_SeqAIJ(MatTransposeColoring,Mat,Mat);
326: PETSC_INTERN PetscErrorCode MatMatMatMult_SeqAIJ_SeqAIJ_SeqAIJ(Mat,Mat,Mat,MatReuse,PetscReal,Mat*);
327: PETSC_INTERN PetscErrorCode MatMatMatMultSymbolic_SeqAIJ_SeqAIJ_SeqAIJ(Mat,Mat,Mat,PetscReal,Mat*);
328: PETSC_INTERN PetscErrorCode MatMatMatMultNumeric_SeqAIJ_SeqAIJ_SeqAIJ(Mat,Mat,Mat,Mat);
330: PETSC_INTERN PetscErrorCode MatSetValues_SeqAIJ(Mat,PetscInt,const PetscInt[],PetscInt,const PetscInt[],const PetscScalar[],InsertMode);
331: PETSC_INTERN PetscErrorCode MatGetRow_SeqAIJ(Mat,PetscInt,PetscInt*,PetscInt**,PetscScalar**);
332: PETSC_INTERN PetscErrorCode MatRestoreRow_SeqAIJ(Mat,PetscInt,PetscInt*,PetscInt**,PetscScalar**);
333: PETSC_INTERN PetscErrorCode MatScale_SeqAIJ(Mat,PetscScalar);
334: PETSC_INTERN PetscErrorCode MatDiagonalScale_SeqAIJ(Mat,Vec,Vec);
335: PETSC_INTERN PetscErrorCode MatDiagonalSet_SeqAIJ(Mat,Vec,InsertMode);
336: PETSC_INTERN PetscErrorCode MatAXPY_SeqAIJ(Mat,PetscScalar,Mat,MatStructure);
337: PETSC_INTERN PetscErrorCode MatGetRowIJ_SeqAIJ(Mat,PetscInt,PetscBool,PetscBool,PetscInt*,const PetscInt *[],const PetscInt *[],PetscBool*);
338: PETSC_INTERN PetscErrorCode MatRestoreRowIJ_SeqAIJ(Mat,PetscInt,PetscBool,PetscBool,PetscInt*,const PetscInt *[],const PetscInt *[],PetscBool*);
339: PETSC_INTERN PetscErrorCode MatGetColumnIJ_SeqAIJ(Mat,PetscInt,PetscBool,PetscBool,PetscInt*,const PetscInt *[],const PetscInt *[],PetscBool*);
340: PETSC_INTERN PetscErrorCode MatRestoreColumnIJ_SeqAIJ(Mat,PetscInt,PetscBool,PetscBool,PetscInt*,const PetscInt *[],const PetscInt *[],PetscBool*);
341: PETSC_INTERN PetscErrorCode MatGetColumnIJ_SeqAIJ_Color(Mat,PetscInt,PetscBool,PetscBool,PetscInt*,const PetscInt *[],const PetscInt *[],PetscInt *[],PetscBool*);
342: PETSC_INTERN PetscErrorCode MatRestoreColumnIJ_SeqAIJ_Color(Mat,PetscInt,PetscBool,PetscBool,PetscInt*,const PetscInt *[],const PetscInt *[],PetscInt *[],PetscBool*);
343: PETSC_INTERN PetscErrorCode MatDestroy_SeqAIJ(Mat);
344: PETSC_INTERN PetscErrorCode MatSetUp_SeqAIJ(Mat);
345: PETSC_INTERN PetscErrorCode MatView_SeqAIJ(Mat,PetscViewer);
347: PETSC_INTERN PetscErrorCode MatSeqAIJInvalidateDiagonal(Mat);
348: PETSC_INTERN PetscErrorCode MatSeqAIJInvalidateDiagonal_Inode(Mat);
349: PETSC_INTERN PetscErrorCode MatSeqAIJCheckInode(Mat);
350: PETSC_INTERN PetscErrorCode MatSeqAIJCheckInode_FactorLU(Mat);
352: PETSC_INTERN PetscErrorCode MatAXPYGetPreallocation_SeqAIJ(Mat,Mat,PetscInt*);
354: PETSC_INTERN PetscErrorCode MatMatMatMult_Transpose_AIJ_AIJ(Mat,Mat,Mat,MatReuse,PetscReal,Mat*);
355: #if defined(PETSC_HAVE_MATLAB_ENGINE)
356: PETSC_EXTERN PetscErrorCode MatlabEnginePut_SeqAIJ(PetscObject,void*);
357: PETSC_EXTERN PetscErrorCode MatlabEngineGet_SeqAIJ(PetscObject,void*);
358: #endif
359: PETSC_INTERN PetscErrorCode MatConvert_SeqAIJ_SeqSBAIJ(Mat,MatType,MatReuse,Mat*);
360: PETSC_INTERN PetscErrorCode MatConvert_SeqAIJ_SeqBAIJ(Mat,MatType,MatReuse,Mat*);
361: PETSC_INTERN PetscErrorCode MatConvert_SeqAIJ_SeqDense(Mat,MatType,MatReuse,Mat*);
362: PETSC_INTERN PetscErrorCode MatConvert_SeqAIJ_SeqAIJCRL(Mat,MatType,MatReuse,Mat*);
363: PETSC_INTERN PetscErrorCode MatConvert_SeqAIJ_Elemental(Mat,MatType,MatReuse,Mat*);
364: PETSC_INTERN PetscErrorCode MatConvert_AIJ_HYPRE(Mat,MatType,MatReuse,Mat*);
365: PETSC_INTERN PetscErrorCode MatConvert_SeqAIJ_SeqAIJPERM(Mat,MatType,MatReuse,Mat*);
366: PETSC_INTERN PetscErrorCode MatConvert_SeqAIJ_SeqAIJSELL(Mat,MatType,MatReuse,Mat*);
367: PETSC_INTERN PetscErrorCode MatConvert_SeqAIJ_SeqAIJMKL(Mat,MatType,MatReuse,Mat*);
368: PETSC_INTERN PetscErrorCode MatConvert_SeqAIJ_SeqAIJViennaCL(Mat,MatType,MatReuse,Mat*);
369: PETSC_INTERN PetscErrorCode MatReorderForNonzeroDiagonal_SeqAIJ(Mat,PetscReal,IS,IS);
370: PETSC_INTERN PetscErrorCode MatMatMult_SeqDense_SeqAIJ(Mat,Mat,MatReuse,PetscReal,Mat*);
371: PETSC_INTERN PetscErrorCode MatRARt_SeqAIJ_SeqAIJ(Mat,Mat,MatReuse,PetscReal,Mat*);
372: PETSC_EXTERN PetscErrorCode MatCreate_SeqAIJ(Mat);
373: PETSC_INTERN PetscErrorCode MatAssemblyEnd_SeqAIJ(Mat,MatAssemblyType);
375: PETSC_INTERN PetscErrorCode MatAXPYGetPreallocation_SeqX_private(PetscInt,const PetscInt*,const PetscInt*,const PetscInt*,const PetscInt*,PetscInt*);
376: PETSC_INTERN PetscErrorCode MatCreateMPIMatConcatenateSeqMat_SeqAIJ(MPI_Comm,Mat,PetscInt,MatReuse,Mat*);
377: PETSC_INTERN PetscErrorCode MatCreateMPIMatConcatenateSeqMat_MPIAIJ(MPI_Comm,Mat,PetscInt,MatReuse,Mat*);
379: PETSC_INTERN PetscErrorCode MatSetSeqMat_SeqAIJ(Mat,IS,IS,MatStructure,Mat);
380: PETSC_INTERN PetscErrorCode MatDestroySubMatrix_Private(Mat_SubSppt*);
381: PETSC_INTERN PetscErrorCode MatDestroySubMatrix_SeqAIJ(Mat);
382: PETSC_INTERN PetscErrorCode MatDestroySubMatrix_Dummy(Mat);
383: PETSC_INTERN PetscErrorCode MatDestroySubMatrices_Dummy(PetscInt, Mat*[]);
384: PETSC_INTERN PetscErrorCode MatCreateSubMatrix_SeqAIJ(Mat,IS,IS,PetscInt,MatReuse,Mat*);
386: PETSC_INTERN PetscErrorCode MatSeqAIJCompactOutExtraColumns_SeqAIJ(Mat,ISLocalToGlobalMapping*);
388: /*
389: PetscSparseDenseMinusDot - The inner kernel of triangular solves and Gauss-Siedel smoothing. \sum_i xv[i] * r[xi[i]] for CSR storage
391: Input Parameters:
392: + nnz - the number of entries
393: . r - the array of vector values
394: . xv - the matrix values for the row
395: - xi - the column indices of the nonzeros in the row
397: Output Parameter:
398: . sum - negative the sum of results
400: PETSc compile flags:
401: + PETSC_KERNEL_USE_UNROLL_4
402: - PETSC_KERNEL_USE_UNROLL_2
404: Developer Notes:
405: The macro changes sum but not other parameters
407: .seealso: PetscSparseDensePlusDot()
409: */
410: #if defined(PETSC_KERNEL_USE_UNROLL_4)
411: #define PetscSparseDenseMinusDot(sum,r,xv,xi,nnz) { \
412: if (nnz > 0) { \
413: PetscInt nnz2=nnz,rem=nnz&0x3; \
414: switch (rem) { \
415: case 3: sum -= *xv++ *r[*xi++]; \
416: case 2: sum -= *xv++ *r[*xi++]; \
417: case 1: sum -= *xv++ *r[*xi++]; \
418: nnz2 -= rem;} \
419: while (nnz2 > 0) { \
420: sum -= xv[0] * r[xi[0]] + xv[1] * r[xi[1]] + \
421: xv[2] * r[xi[2]] + xv[3] * r[xi[3]]; \
422: xv += 4; xi += 4; nnz2 -= 4; \
423: } \
424: xv -= nnz; xi -= nnz; \
425: } \
426: }
428: #elif defined(PETSC_KERNEL_USE_UNROLL_2)
429: #define PetscSparseDenseMinusDot(sum,r,xv,xi,nnz) { \
430: PetscInt __i,__i1,__i2; \
431: for (__i=0; __i<nnz-1; __i+=2) {__i1 = xi[__i]; __i2=xi[__i+1]; \
432: sum -= (xv[__i]*r[__i1] + xv[__i+1]*r[__i2]);} \
433: if (nnz & 0x1) sum -= xv[__i] * r[xi[__i]];}
435: #else
436: #define PetscSparseDenseMinusDot(sum,r,xv,xi,nnz) { \
437: PetscInt __i; \
438: for (__i=0; __i<nnz; __i++) sum -= xv[__i] * r[xi[__i]];}
439: #endif
443: /*
444: PetscSparseDensePlusDot - The inner kernel of matrix-vector product \sum_i xv[i] * r[xi[i]] for CSR storage
446: Input Parameters:
447: + nnz - the number of entries
448: . r - the array of vector values
449: . xv - the matrix values for the row
450: - xi - the column indices of the nonzeros in the row
452: Output Parameter:
453: . sum - the sum of results
455: PETSc compile flags:
456: + PETSC_KERNEL_USE_UNROLL_4
457: - PETSC_KERNEL_USE_UNROLL_2
459: Developer Notes:
460: The macro changes sum but not other parameters
462: .seealso: PetscSparseDenseMinusDot()
464: */
465: #if defined(PETSC_KERNEL_USE_UNROLL_4)
466: #define PetscSparseDensePlusDot(sum,r,xv,xi,nnz) { \
467: if (nnz > 0) { \
468: PetscInt nnz2=nnz,rem=nnz&0x3; \
469: switch (rem) { \
470: case 3: sum += *xv++ *r[*xi++]; \
471: case 2: sum += *xv++ *r[*xi++]; \
472: case 1: sum += *xv++ *r[*xi++]; \
473: nnz2 -= rem;} \
474: while (nnz2 > 0) { \
475: sum += xv[0] * r[xi[0]] + xv[1] * r[xi[1]] + \
476: xv[2] * r[xi[2]] + xv[3] * r[xi[3]]; \
477: xv += 4; xi += 4; nnz2 -= 4; \
478: } \
479: xv -= nnz; xi -= nnz; \
480: } \
481: }
483: #elif defined(PETSC_KERNEL_USE_UNROLL_2)
484: #define PetscSparseDensePlusDot(sum,r,xv,xi,nnz) { \
485: PetscInt __i,__i1,__i2; \
486: for (__i=0; __i<nnz-1; __i+=2) {__i1 = xi[__i]; __i2=xi[__i+1]; \
487: sum += (xv[__i]*r[__i1] + xv[__i+1]*r[__i2]);} \
488: if (nnz & 0x1) sum += xv[__i] * r[xi[__i]];}
490: #elif defined(PETSC_USE_AVX512_KERNELS) && defined(PETSC_HAVE_IMMINTRIN_H) && defined(__AVX512F__) && defined(PETSC_USE_REAL_DOUBLE) && !defined(PETSC_USE_COMPLEX) && !defined(PETSC_USE_64BIT_INDICES)
491: #define PetscSparseDensePlusDot(sum,r,xv,xi,nnz) PetscSparseDensePlusDot_AVX512_Private(&(sum),(r),(xv),(xi),(nnz))
493: #else
494: #define PetscSparseDensePlusDot(sum,r,xv,xi,nnz) { \
495: PetscInt __i; \
496: for (__i=0; __i<nnz; __i++) sum += xv[__i] * r[xi[__i]];}
497: #endif
499: #if defined(PETSC_USE_AVX512_KERNELS) && defined(PETSC_HAVE_IMMINTRIN_H) && defined(__AVX512F__) && defined(PETSC_USE_REAL_DOUBLE) && !defined(PETSC_USE_COMPLEX) && !defined(PETSC_USE_64BIT_INDICES)
500: #include <immintrin.h>
501: #if !defined(_MM_SCALE_8)
502: #define _MM_SCALE_8 8
503: #endif
505: PETSC_STATIC_INLINE void PetscSparseDensePlusDot_AVX512_Private(PetscScalar *sum,const PetscScalar *x,const MatScalar *aa,const PetscInt *aj,PetscInt n)
506: {
507: __m512d vec_x,vec_y,vec_vals;
508: __m256i vec_idx;
509: __mmask8 mask;
510: PetscInt j;
512: vec_y = _mm512_setzero_pd();
513: for (j=0; j<(n>>3); j++) {
514: vec_idx = _mm256_loadu_si256((__m256i const*)aj);
515: vec_vals = _mm512_loadu_pd(aa);
516: vec_x = _mm512_i32gather_pd(vec_idx,x,_MM_SCALE_8);
517: vec_y = _mm512_fmadd_pd(vec_x,vec_vals,vec_y);
518: aj += 8; aa += 8;
519: }
520: /* masked load does not work on KNL, it requires avx512vl */
521: if ((n&0x07)>2) {
522: mask = (__mmask8)(0xff >> (8-(n&0x07)));
523: vec_idx = _mm256_loadu_si256((__m256i const*)aj);
524: vec_vals = _mm512_loadu_pd(aa);
525: vec_x = _mm512_mask_i32gather_pd(vec_x,mask,vec_idx,x,_MM_SCALE_8);
526: vec_y = _mm512_mask3_fmadd_pd(vec_x,vec_vals,vec_y,mask);
527: } else if ((n&0x07)==2) {
528: *sum += aa[0]*x[aj[0]];
529: *sum += aa[1]*x[aj[1]];
530: } else if ((n&0x07)==1) {
531: *sum += aa[0]*x[aj[0]];
532: }
533: if (n>2) *sum += _mm512_reduce_add_pd(vec_y);
534: /*
535: for(j=0;j<(n&0x07);j++) *sum += aa[j]*x[aj[j]];
536: */
537: }
538: #endif
540: /*
541: PetscSparseDenseMaxDot - The inner kernel of a modified matrix-vector product \max_i xv[i] * r[xi[i]] for CSR storage
543: Input Parameters:
544: + nnz - the number of entries
545: . r - the array of vector values
546: . xv - the matrix values for the row
547: - xi - the column indices of the nonzeros in the row
549: Output Parameter:
550: . max - the max of results
552: .seealso: PetscSparseDensePlusDot(), PetscSparseDenseMinusDot()
554: */
555: #define PetscSparseDenseMaxDot(max,r,xv,xi,nnz) { \
556: PetscInt __i; \
557: for (__i=0; __i<nnz; __i++) max = PetscMax(PetscRealPart(max), PetscRealPart(xv[__i] * r[xi[__i]]));}
559: /*
560: Add column indices into table for counting the max nonzeros of merged rows
561: */
562: #define MatRowMergeMax_SeqAIJ(mat,nrows,ta) { \
563: PetscInt _j,_row,_nz,*_col; \
564: if (mat) { \
565: for (_row=0; _row<nrows; _row++) { \
566: _nz = mat->i[_row+1] - mat->i[_row]; \
567: for (_j=0; _j<_nz; _j++) { \
568: _col = _j + mat->j + mat->i[_row]; \
569: PetscTableAdd(ta,*_col+1,1,INSERT_VALUES); \
570: } \
571: } \
572: } \
573: }
575: /*
576: Add column indices into table for counting the nonzeros of merged rows
577: */
578: #define MatMergeRows_SeqAIJ(mat,nrows,rows,ta) { \
579: PetscInt _j,_row,_nz,*_col,_i; \
580: for (_i=0; _i<nrows; _i++) {\
581: _row = rows[_i]; \
582: _nz = mat->i[_row+1] - mat->i[_row]; \
583: for (_j=0; _j<_nz; _j++) { \
584: _col = _j + mat->j + mat->i[_row]; \
585: PetscTableAdd(ta,*_col+1,1,INSERT_VALUES); \
586: } \
587: } \
588: }
590: #endif