Bug Summary

File:mat/impls/aij/seq/fdaij.c
Warning:line 264, column 30
Dereference of undefined pointer value

Annotated Source Code

[?] Use j/k keys for keyboard navigation

1#include <../src/mat/impls/aij/seq/aij.h>
2#include <../src/mat/impls/baij/seq/baij.h>
3#include <../src/mat/impls/sell/seq/sell.h>
4#include <petsc/private/isimpl.h>
5
6/*
7 This routine is shared by SeqAIJ and SeqBAIJ matrices,
8 since it operators only on the nonzero structure of the elements or blocks.
9*/
10PetscErrorCode MatFDColoringCreate_SeqXAIJ(Mat mat,ISColoring iscoloring,MatFDColoring c)
11{
12 PetscErrorCode ierr;
13 PetscInt bs,nis=iscoloring->n,m=mat->rmap->n;
14 PetscBool isBAIJ,isSELL;
15
16 PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize
< 64)) { petscstack->function[petscstack->currentsize
] = __func__; petscstack->file[petscstack->currentsize]
= "/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
; petscstack->line[petscstack->currentsize] = 16; petscstack
->petscroutine[petscstack->currentsize] = PETSC_TRUE; petscstack
->currentsize++; } if (petscstack) { petscstack->hotdepth
+= (PETSC_FALSE || petscstack->hotdepth); } ; } while (0)
; ; } while (0)
;
17 /* set default brows and bcols for speedup inserting the dense matrix into sparse Jacobian */
18 ierr = MatGetBlockSize(mat,&bs);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),18,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
19 ierr = PetscObjectBaseTypeCompare((PetscObject)mat,MATSEQBAIJ"seqbaij",&isBAIJ);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),19,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
20 ierr = PetscObjectTypeCompare((PetscObject)mat,MATSEQSELL"seqsell",&isSELL);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),20,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
21 if (isBAIJ) {
22 c->brows = m;
23 c->bcols = 1;
24 } else { /* seqaij matrix */
25 /* bcols is chosen s.t. dy-array takes 50% of memory space as mat */
26 PetscReal mem;
27 PetscInt nz,brows,bcols;
28 if (isSELL) {
29 Mat_SeqSELL *spA = (Mat_SeqSELL*)mat->data;
30 nz = spA->nz;
31 } else {
32 Mat_SeqAIJ *spA = (Mat_SeqAIJ*)mat->data;
33 nz = spA->nz;
34 }
35
36 bs = 1; /* only bs=1 is supported for SeqAIJ matrix */
37 mem = nz*(sizeof(PetscScalar) + sizeof(PetscInt)) + 3*m*sizeof(PetscInt);
38 bcols = (PetscInt)(0.5*mem /(m*sizeof(PetscScalar)));
39 brows = 1000/bcols;
40 if (bcols > nis) bcols = nis;
41 if (brows == 0 || brows > m) brows = m;
42 c->brows = brows;
43 c->bcols = bcols;
44 }
45
46 c->M = mat->rmap->N/bs; /* set total rows, columns and local rows */
47 c->N = mat->cmap->N/bs;
48 c->m = mat->rmap->N/bs;
49 c->rstart = 0;
50 c->ncolors = nis;
51 c->ctype = iscoloring->ctype;
52 PetscFunctionReturn(0)do { do { ; if (petscstack && petscstack->currentsize
> 0) { petscstack->currentsize--; petscstack->function
[petscstack->currentsize] = 0; petscstack->file[petscstack
->currentsize] = 0; petscstack->line[petscstack->currentsize
] = 0; petscstack->petscroutine[petscstack->currentsize
] = PETSC_FALSE; } if (petscstack) { petscstack->hotdepth =
(((petscstack->hotdepth-1)<(0)) ? (0) : (petscstack->
hotdepth-1)); } ; } while (0); return(0);} while (0)
;
53}
54
55/*
56 Reorder Jentry such that blocked brows*bols of entries from dense matrix are inserted into Jacobian for improved cache performance
57 Input Parameters:
58+ mat - the matrix containing the nonzero structure of the Jacobian
59. color - the coloring context
60- nz - number of local non-zeros in mat
61*/
62PetscErrorCode MatFDColoringSetUpBlocked_AIJ_Private(Mat mat,MatFDColoring c,PetscInt nz)
63{
64 PetscErrorCode ierr;
65 PetscInt i,j,nrows,nbcols,brows=c->brows,bcols=c->bcols,mbs=c->m,nis=c->ncolors;
66 PetscInt *color_start,*row_start,*nrows_new,nz_new,row_end;
67
68 PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize
< 64)) { petscstack->function[petscstack->currentsize
] = __func__; petscstack->file[petscstack->currentsize]
= "/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
; petscstack->line[petscstack->currentsize] = 68; petscstack
->petscroutine[petscstack->currentsize] = PETSC_TRUE; petscstack
->currentsize++; } if (petscstack) { petscstack->hotdepth
+= (PETSC_FALSE || petscstack->hotdepth); } ; } while (0)
; ; } while (0)
;
69 if (brows < 1 || brows > mbs) brows = mbs;
70 ierr = PetscMalloc2(bcols+1,&color_start,bcols,&row_start)PetscMallocA(2,PETSC_FALSE,70,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,(size_t)(bcols+1)*sizeof(**(&color_start)),(&color_start
),(size_t)(bcols)*sizeof(**(&row_start)),(&row_start)
)
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),70,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
71 ierr = PetscCalloc1(nis,&nrows_new)PetscMallocA(1,PETSC_TRUE,71,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,(size_t)(nis)*sizeof(**(&nrows_new)),(&nrows_new))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),71,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
72 ierr = PetscMalloc1(bcols*mat->rmap->n,&c->dy)PetscMallocA(1,PETSC_FALSE,72,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,(size_t)(bcols*mat->rmap->n)*sizeof(**(&c->dy))
,(&c->dy))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),72,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
73 ierr = PetscLogObjectMemory((PetscObject)c,bcols*mat->rmap->n*sizeof(PetscScalar));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),73,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
74
75 nz_new = 0;
76 nbcols = 0;
77 color_start[bcols] = 0;
78
79 if (c->htype[0] == 'd') { /* ---- c->htype == 'ds', use MatEntry --------*/
80 MatEntry *Jentry_new,*Jentry=c->matentry;
81
82 ierr = PetscMalloc1(nz,&Jentry_new)PetscMallocA(1,PETSC_FALSE,82,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,(size_t)(nz)*sizeof(**(&Jentry_new)),(&Jentry_new))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),82,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
83 for (i=0; i<nis; i+=bcols) { /* loop over colors */
84 if (i + bcols > nis) {
85 color_start[nis - i] = color_start[bcols];
86 bcols = nis - i;
87 }
88
89 color_start[0] = color_start[bcols];
90 for (j=0; j<bcols; j++) {
91 color_start[j+1] = c->nrows[i+j] + color_start[j];
92 row_start[j] = 0;
93 }
94
95 row_end = brows;
96 if (row_end > mbs) row_end = mbs;
97
98 while (row_end <= mbs) { /* loop over block rows */
99 for (j=0; j<bcols; j++) { /* loop over block columns */
100 nrows = c->nrows[i+j];
101 nz = color_start[j];
102 while (row_start[j] < nrows) {
103 if (Jentry[nz].row >= row_end) {
104 color_start[j] = nz;
105 break;
106 } else { /* copy Jentry[nz] to Jentry_new[nz_new] */
107 Jentry_new[nz_new].row = Jentry[nz].row + j*mbs; /* index in dy-array */
108 Jentry_new[nz_new].col = Jentry[nz].col;
109 Jentry_new[nz_new].valaddr = Jentry[nz].valaddr;
110 nz_new++; nz++; row_start[j]++;
111 }
112 }
113 }
114 if (row_end == mbs) break;
115 row_end += brows;
116 if (row_end > mbs) row_end = mbs;
117 }
118 nrows_new[nbcols++] = nz_new;
119 }
120 ierr = PetscFree(Jentry)((*PetscTrFree)((void*)(Jentry),120,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
) || ((Jentry) = 0,0))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),120,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
121 c->matentry = Jentry_new;
122 } else { /* --------- c->htype == 'wp', use MatEntry2 ------------------*/
123 MatEntry2 *Jentry2_new,*Jentry2=c->matentry2;
124
125 ierr = PetscMalloc1(nz,&Jentry2_new)PetscMallocA(1,PETSC_FALSE,125,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,(size_t)(nz)*sizeof(**(&Jentry2_new)),(&Jentry2_new)
)
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),125,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
126 for (i=0; i<nis; i+=bcols) { /* loop over colors */
127 if (i + bcols > nis) {
128 color_start[nis - i] = color_start[bcols];
129 bcols = nis - i;
130 }
131
132 color_start[0] = color_start[bcols];
133 for (j=0; j<bcols; j++) {
134 color_start[j+1] = c->nrows[i+j] + color_start[j];
135 row_start[j] = 0;
136 }
137
138 row_end = brows;
139 if (row_end > mbs) row_end = mbs;
140
141 while (row_end <= mbs) { /* loop over block rows */
142 for (j=0; j<bcols; j++) { /* loop over block columns */
143 nrows = c->nrows[i+j];
144 nz = color_start[j];
145 while (row_start[j] < nrows) {
146 if (Jentry2[nz].row >= row_end) {
147 color_start[j] = nz;
148 break;
149 } else { /* copy Jentry2[nz] to Jentry2_new[nz_new] */
150 Jentry2_new[nz_new].row = Jentry2[nz].row + j*mbs; /* index in dy-array */
151 Jentry2_new[nz_new].valaddr = Jentry2[nz].valaddr;
152 nz_new++; nz++; row_start[j]++;
153 }
154 }
155 }
156 if (row_end == mbs) break;
157 row_end += brows;
158 if (row_end > mbs) row_end = mbs;
159 }
160 nrows_new[nbcols++] = nz_new;
161 }
162 ierr = PetscFree(Jentry2)((*PetscTrFree)((void*)(Jentry2),162,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
) || ((Jentry2) = 0,0))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),162,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
163 c->matentry2 = Jentry2_new;
164 } /* ---------------------------------------------*/
165
166 ierr = PetscFree2(color_start,row_start)PetscFreeA(2,166,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,&(color_start),&(row_start))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),166,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
167
168 for (i=nbcols-1; i>0; i--) nrows_new[i] -= nrows_new[i-1];
169 ierr = PetscFree(c->nrows)((*PetscTrFree)((void*)(c->nrows),169,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
) || ((c->nrows) = 0,0))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),169,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
170 c->nrows = nrows_new;
171 PetscFunctionReturn(0)do { do { ; if (petscstack && petscstack->currentsize
> 0) { petscstack->currentsize--; petscstack->function
[petscstack->currentsize] = 0; petscstack->file[petscstack
->currentsize] = 0; petscstack->line[petscstack->currentsize
] = 0; petscstack->petscroutine[petscstack->currentsize
] = PETSC_FALSE; } if (petscstack) { petscstack->hotdepth =
(((petscstack->hotdepth-1)<(0)) ? (0) : (petscstack->
hotdepth-1)); } ; } while (0); return(0);} while (0)
;
172}
173
174PetscErrorCode MatFDColoringSetUp_SeqXAIJ(Mat mat,ISColoring iscoloring,MatFDColoring c)
175{
176 PetscErrorCode ierr;
177 PetscInt i,n,nrows,mbs=c->m,j,k,m,ncols,col,nis=iscoloring->n,*rowhit,bs,bs2,*spidx,nz,tmp;
178 const PetscInt *is,*row,*ci,*cj;
179 PetscBool isBAIJ,isSELL;
180 const PetscScalar *A_val;
181 PetscScalar **valaddrhit;
182 MatEntry *Jentry;
1
'Jentry' declared without an initial value
183 MatEntry2 *Jentry2;
184
185 PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize
< 64)) { petscstack->function[petscstack->currentsize
] = __func__; petscstack->file[petscstack->currentsize]
= "/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
; petscstack->line[petscstack->currentsize] = 185; petscstack
->petscroutine[petscstack->currentsize] = PETSC_TRUE; petscstack
->currentsize++; } if (petscstack) { petscstack->hotdepth
+= (PETSC_FALSE || petscstack->hotdepth); } ; } while (0)
; ; } while (0)
;
186 ierr = ISColoringGetIS(iscoloring,PETSC_OWN_POINTER,PETSC_IGNORE((void*)0),&c->isa);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),186,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
187
188 ierr = MatGetBlockSize(mat,&bs);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),188,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
189 ierr = PetscObjectBaseTypeCompare((PetscObject)mat,MATSEQBAIJ"seqbaij",&isBAIJ);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),189,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
190 ierr = PetscObjectTypeCompare((PetscObject)mat,MATSEQSELL"seqsell",&isSELL);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),190,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
191 if (isBAIJ) {
2
Assuming 'isBAIJ' is 0
3
Taking false branch
192 Mat_SeqBAIJ *spA = (Mat_SeqBAIJ*)mat->data;
193
194 A_val = spA->a;
195 nz = spA->nz;
196 } else if (isSELL) {
4
Assuming 'isSELL' is 0
5
Taking false branch
197 Mat_SeqSELL *spA = (Mat_SeqSELL*)mat->data;
198
199 A_val = spA->val;
200 nz = spA->nz;
201 bs = 1; /* only bs=1 is supported for SeqSELL matrix */
202 } else {
203 Mat_SeqAIJ *spA = (Mat_SeqAIJ*)mat->data;
204
205 A_val = spA->a;
206 nz = spA->nz;
207 bs = 1; /* only bs=1 is supported for SeqAIJ matrix */
208 }
209
210 ierr = PetscMalloc2(nis,&c->ncolumns,nis,&c->columns)PetscMallocA(2,PETSC_FALSE,210,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,(size_t)(nis)*sizeof(**(&c->ncolumns)),(&c->ncolumns
),(size_t)(nis)*sizeof(**(&c->columns)),(&c->columns
))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),210,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
211 ierr = PetscMalloc1(nis,&c->nrows)PetscMallocA(1,PETSC_FALSE,211,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,(size_t)(nis)*sizeof(**(&c->nrows)),(&c->nrows
))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),211,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
; /* nrows is freeed seperately from ncolumns and columns */
212 ierr = PetscLogObjectMemory((PetscObject)c,3*nis*sizeof(PetscInt));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),212,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
213
214 if (c->htype[0] == 'd') {
6
Assuming the condition is false
7
Taking false branch
215 ierr = PetscMalloc1(nz,&Jentry)PetscMallocA(1,PETSC_FALSE,215,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,(size_t)(nz)*sizeof(**(&Jentry)),(&Jentry))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),215,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
216 ierr = PetscLogObjectMemory((PetscObject)c,nz*sizeof(MatEntry));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),216,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
217 c->matentry = Jentry;
218 } else if (c->htype[0] == 'w') {
8
Assuming the condition is true
9
Taking true branch
219 ierr = PetscMalloc1(nz,&Jentry2)PetscMallocA(1,PETSC_FALSE,219,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,(size_t)(nz)*sizeof(**(&Jentry2)),(&Jentry2))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),219,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
220 ierr = PetscLogObjectMemory((PetscObject)c,nz*sizeof(MatEntry2));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),220,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
221 c->matentry2 = Jentry2;
222 } else SETERRQ(PetscObjectComm((PetscObject)mat),PETSC_ERR_SUP,"htype is not supported")return PetscError(PetscObjectComm((PetscObject)mat),222,__func__
,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,56,PETSC_ERROR_INITIAL,"htype is not supported")
;
223
224 if (isBAIJ) {
10
Taking false branch
225 ierr = MatGetColumnIJ_SeqBAIJ_Color(mat,0,PETSC_FALSE,PETSC_FALSE,&ncols,&ci,&cj,&spidx,NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),225,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
226 } else if (isSELL) {
11
Taking false branch
227 ierr = MatGetColumnIJ_SeqSELL_Color(mat,0,PETSC_FALSE,PETSC_FALSE,&ncols,&ci,&cj,&spidx,NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),227,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
228 } else {
229 ierr = MatGetColumnIJ_SeqAIJ_Color(mat,0,PETSC_FALSE,PETSC_FALSE,&ncols,&ci,&cj,&spidx,NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),229,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
230 }
231
232 ierr = PetscCalloc1(c->m,&rowhit)PetscMallocA(1,PETSC_TRUE,232,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,(size_t)(c->m)*sizeof(**(&rowhit)),(&rowhit))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),232,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
233 ierr = PetscMalloc1(c->m,&valaddrhit)PetscMallocA(1,PETSC_FALSE,233,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,(size_t)(c->m)*sizeof(**(&valaddrhit)),(&valaddrhit
))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),233,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
234
235 nz = 0;
236 for (i=0; i<nis; i++) { /* loop over colors */
12
Assuming 'i' is < 'nis'
13
Loop condition is true. Entering loop body
237 ierr = ISGetLocalSize(c->isa[i],&n);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),237,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
238 ierr = ISGetIndices(c->isa[i],&is);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),238,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
239
240 c->ncolumns[i] = n;
241 c->columns[i] = (PetscInt*)is;
242 /* note: we know that c->isa is going to be around as long at the c->columns values */
243 ierr = ISRestoreIndices(c->isa[i],&is);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),243,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
244
245 /* fast, crude version requires O(N*N) work */
246 bs2 = bs*bs;
247 nrows = 0;
248 for (j=0; j<n; j++) { /* loop over columns */
14
Assuming 'j' is >= 'n'
15
Loop condition is false. Execution continues on line 259
249 col = is[j];
250 tmp = ci[col];
251 row = cj + tmp;
252 m = ci[col+1] - tmp;
253 nrows += m;
254 for (k=0; k<m; k++) { /* loop over columns marking them in rowhit */
255 rowhit[*row] = col + 1;
256 valaddrhit[*row++] = (PetscScalar*)&A_val[bs2*spidx[tmp + k]];
257 }
258 }
259 c->nrows[i] = nrows; /* total num of rows for this color */
260
261 if (c->htype[0] == 'd') {
16
Assuming the condition is true
17
Taking true branch
262 for (j=0; j<mbs; j++) { /* loop over rows */
18
Assuming 'j' is < 'mbs'
19
Loop condition is true. Entering loop body
263 if (rowhit[j]) {
20
Assuming the condition is true
21
Taking true branch
264 Jentry[nz].row = j; /* local row index */
22
Dereference of undefined pointer value
265 Jentry[nz].col = rowhit[j] - 1; /* local column index */
266 Jentry[nz].valaddr = valaddrhit[j]; /* address of mat value for this entry */
267 nz++;
268 rowhit[j] = 0.0; /* zero rowhit for reuse */
269 }
270 }
271 } else { /* c->htype == 'wp' */
272 for (j=0; j<mbs; j++) { /* loop over rows */
273 if (rowhit[j]) {
274 Jentry2[nz].row = j; /* local row index */
275 Jentry2[nz].valaddr = valaddrhit[j]; /* address of mat value for this entry */
276 nz++;
277 rowhit[j] = 0.0; /* zero rowhit for reuse */
278 }
279 }
280 }
281 }
282
283 if (c->bcols > 1) { /* reorder Jentry for faster MatFDColoringApply() */
284 ierr = MatFDColoringSetUpBlocked_AIJ_Private(mat,c,nz);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),284,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
285 }
286
287 if (isBAIJ) {
288 ierr = MatRestoreColumnIJ_SeqBAIJ_Color(mat,0,PETSC_FALSE,PETSC_FALSE,&ncols,&ci,&cj,&spidx,NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),288,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
289 ierr = PetscMalloc1(bs*mat->rmap->n,&c->dy)PetscMallocA(1,PETSC_FALSE,289,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,(size_t)(bs*mat->rmap->n)*sizeof(**(&c->dy)),(&
c->dy))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),289,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
290 ierr = PetscLogObjectMemory((PetscObject)c,bs*mat->rmap->n*sizeof(PetscScalar));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),290,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
291 } else if (isSELL) {
292 ierr = MatRestoreColumnIJ_SeqSELL_Color(mat,0,PETSC_FALSE,PETSC_FALSE,&ncols,&ci,&cj,&spidx,NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),292,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
293 } else {
294 ierr = MatRestoreColumnIJ_SeqAIJ_Color(mat,0,PETSC_FALSE,PETSC_FALSE,&ncols,&ci,&cj,&spidx,NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),294,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
295 }
296 ierr = PetscFree(rowhit)((*PetscTrFree)((void*)(rowhit),296,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
) || ((rowhit) = 0,0))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),296,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
297 ierr = PetscFree(valaddrhit)((*PetscTrFree)((void*)(valaddrhit),297,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
) || ((valaddrhit) = 0,0))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),297,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
298 ierr = ISColoringRestoreIS(iscoloring,PETSC_OWN_POINTER,&c->isa);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),298,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
299
300 ierr = VecCreateGhost(PetscObjectComm((PetscObject)mat),mat->rmap->n,PETSC_DETERMINE-1,0,NULL((void*)0),&c->vscale);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),300,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
301 ierr = PetscInfo3(c,"ncolors %D, brows %D and bcols %D are used.\n",c->ncolors,c->brows,c->bcols)PetscInfo_Private(__func__,c,"ncolors %D, brows %D and bcols %D are used.\n"
,c->ncolors,c->brows,c->bcols)
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),301,__func__,"/sandbox/petsc/petsc.next-tmp/src/mat/impls/aij/seq/fdaij.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
302 PetscFunctionReturn(0)do { do { ; if (petscstack && petscstack->currentsize
> 0) { petscstack->currentsize--; petscstack->function
[petscstack->currentsize] = 0; petscstack->file[petscstack
->currentsize] = 0; petscstack->line[petscstack->currentsize
] = 0; petscstack->petscroutine[petscstack->currentsize
] = PETSC_FALSE; } if (petscstack) { petscstack->hotdepth =
(((petscstack->hotdepth-1)<(0)) ? (0) : (petscstack->
hotdepth-1)); } ; } while (0); return(0);} while (0)
;
303}