Bug Summary

File:ksp/pc/impls/hmg/hmg.c
Warning:line 158, column 3
Value stored to 'ierr' is never read

Annotated Source Code

[?] Use j/k keys for keyboard navigation

1#include <petscdm.h>
2#include <petscctable.h>
3#include <petsc/private/matimpl.h>
4#include <petsc/private/pcmgimpl.h>
5#include <petsc/private/pcimpl.h> /*I "petscpc.h" I*/
6
7typedef struct {
8 PC innerpc; /* A MG inner PC (Hypre or PCGAMG) to setup interpolations and coarse operators */
9 char* innerpctype; /* PCGAMG or PCHYPRE */
10 PetscBool reuseinterp; /* A flag indicates if or not to reuse the interpolations */
11 PetscBool subcoarsening;
12} PC_HMG;
13
14PetscErrorCode PCSetFromOptions_HMG(PetscOptionItems*,PC);
15PetscErrorCode PCReset_MG(PC);
16
17static PetscErrorCode PCHMGExtractSubMatrix_Private(Mat pmat,Mat *submat,MatReuse reuse,PetscInt blocksize)
18{
19 IS isrow;
20 PetscErrorCode ierr;
21 PetscInt rstart,rend;
22 MPI_Comm comm;
23
24 PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize
< 64)) { petscstack->function[petscstack->currentsize
] = __func__; petscstack->file[petscstack->currentsize]
= "/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"; petscstack
->line[petscstack->currentsize] = 24; petscstack->petscroutine
[petscstack->currentsize] = PETSC_TRUE; petscstack->currentsize
++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE
|| petscstack->hotdepth); } ; } while (0); ; } while (0)
;
25 ierr = PetscObjectGetComm((PetscObject)pmat,&comm);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),25,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
26 ierr = MatGetOwnershipRange(pmat,&rstart,&rend);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),26,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
27 if ((rend-rstart)%blocksize != 0) SETERRQ3(comm,PETSC_ERR_ARG_INCOMP,"Block size %d is inconsisent for [%d, %d) \n",blocksize,rstart,rend)return PetscError(comm,27,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,75,PETSC_ERROR_INITIAL,"Block size %d is inconsisent for [%d, %d) \n"
,blocksize,rstart,rend)
;
28 ierr = ISCreateStride(comm,(rend-rstart)/blocksize,rstart,blocksize,&isrow);
29 ierr = MatCreateSubMatrix(pmat,isrow,isrow,reuse,submat);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),29,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
30 ierr = ISDestroy(&isrow);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),30,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
31 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)
;
32}
33
34static PetscErrorCode PCHMGExpandInterpolation_Private(Mat subinterp, Mat *interp, PetscInt blocksize)
35{
36 PetscInt subrstart,subrend,subrowsize,subcolsize,subcstart,subcend,rowsize,colsize;
37 PetscInt subrow,row,nz,*d_nnz,*o_nnz,i,j,dnz,onz,max_nz,*indices;
38 const PetscInt *idx;
39 const PetscScalar *values;
40 PetscErrorCode ierr;
41 MPI_Comm comm;
42
43 PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize
< 64)) { petscstack->function[petscstack->currentsize
] = __func__; petscstack->file[petscstack->currentsize]
= "/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"; petscstack
->line[petscstack->currentsize] = 43; petscstack->petscroutine
[petscstack->currentsize] = PETSC_TRUE; petscstack->currentsize
++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE
|| petscstack->hotdepth); } ; } while (0); ; } while (0)
;
44 ierr = PetscObjectGetComm((PetscObject)subinterp,&comm);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),44,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
45 ierr = MatGetOwnershipRange(subinterp,&subrstart,&subrend);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),45,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
46 subrowsize = subrend-subrstart;
47 rowsize = subrowsize*blocksize;
48 ierr = PetscCalloc2(rowsize,&d_nnz,rowsize,&o_nnz)PetscMallocA(2,PETSC_TRUE,48,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,(size_t)(rowsize)*sizeof(**(&d_nnz)),(&d_nnz),(size_t
)(rowsize)*sizeof(**(&o_nnz)),(&o_nnz))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),48,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
49 ierr = MatGetOwnershipRangeColumn(subinterp,&subcstart,&subcend);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),49,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
50 subcolsize = subcend - subcstart;
51 colsize = subcolsize*blocksize;
52 max_nz = 0;
53 for (subrow=subrstart;subrow<subrend;subrow++) {
54 ierr = MatGetRow(subinterp,subrow,&nz,&idx,NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),54,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
55 if (max_nz<nz) max_nz = nz;
56 dnz = 0; onz = 0;
57 for (i=0;i<nz;i++) {
58 if(idx[i]>=subcstart && idx[i]<subcend) dnz++;
59 else onz++;
60 }
61 for (i=0;i<blocksize;i++) {
62 d_nnz[(subrow-subrstart)*blocksize+i] = dnz;
63 o_nnz[(subrow-subrstart)*blocksize+i] = onz;
64 }
65 ierr = MatRestoreRow(subinterp,subrow,&nz,&idx,NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),65,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
66 }
67 ierr = MatCreateAIJ(comm,rowsize,colsize,PETSC_DETERMINE-1,PETSC_DETERMINE-1,0,d_nnz,0,o_nnz,interp);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),67,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
68 ierr = MatSetOption(*interp,MAT_IGNORE_OFF_PROC_ENTRIES,PETSC_TRUE);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),68,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
69 ierr = MatSetOption(*interp,MAT_IGNORE_ZERO_ENTRIES,PETSC_TRUE);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),69,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
70 ierr = MatSetOption(*interp,MAT_NEW_NONZERO_ALLOCATION_ERR,PETSC_TRUE);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),70,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
71 ierr = MatSetFromOptions(*interp);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),71,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
72
73 ierr = MatSetUp(*interp);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),73,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
74 ierr = PetscFree2(d_nnz,o_nnz)PetscFreeA(2,74,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,&(d_nnz),&(o_nnz))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),74,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
75 ierr = PetscMalloc1(max_nz,&indices)PetscMallocA(1,PETSC_FALSE,75,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,(size_t)(max_nz)*sizeof(**(&indices)),(&indices))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),75,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
76 for (subrow=subrstart; subrow<subrend; subrow++) {
77 ierr = MatGetRow(subinterp,subrow,&nz,&idx,&values);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),77,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
78 for (i=0;i<blocksize;i++) {
79 row = subrow*blocksize+i;
80 for (j=0;j<nz;j++) {
81 indices[j] = idx[j]*blocksize+i;
82 }
83 ierr = MatSetValues(*interp,1,&row,nz,indices,values,INSERT_VALUES);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),83,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
84 }
85 ierr = MatRestoreRow(subinterp,subrow,&nz,&idx,&values);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),85,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
86 }
87 ierr = PetscFree(indices)((*PetscTrFree)((void*)(indices),87,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
) || ((indices) = 0,0))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),87,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
88 ierr = MatAssemblyBegin(*interp,MAT_FINAL_ASSEMBLY);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),88,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
89 ierr = MatAssemblyEnd(*interp,MAT_FINAL_ASSEMBLY);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),89,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
90 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)
;
91}
92
93PetscErrorCode PCSetUp_HMG(PC pc)
94{
95 PetscErrorCode ierr;
96 Mat PA, submat;
97 PC_MG *mg = (PC_MG*)pc->data;
98 PC_HMG *hmg = (PC_HMG*) mg->innerctx;
99 MPI_Comm comm;
100 PetscInt level;
101 PetscInt num_levels;
102 Mat *operators,*interpolations;
103 PetscInt blocksize;
104 const char *prefix;
105 PCMGGalerkinType galerkin;
106
107 PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize
< 64)) { petscstack->function[petscstack->currentsize
] = __func__; petscstack->file[petscstack->currentsize]
= "/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"; petscstack
->line[petscstack->currentsize] = 107; petscstack->petscroutine
[petscstack->currentsize] = PETSC_TRUE; petscstack->currentsize
++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE
|| petscstack->hotdepth); } ; } while (0); ; } while (0)
;
108 ierr = PetscObjectGetComm((PetscObject)pc,&comm);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),108,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
109 if (pc->setupcalled) {
110 if (hmg->reuseinterp) {
111 /* If we did not use Galerkin in the last call or we have a different sparsity pattern now,
112 * we have to build from scratch
113 * */
114 ierr = PCMGGetGalerkin(pc,&galerkin);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),114,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
115 if (galerkin == PC_MG_GALERKIN_NONE || pc->flag != SAME_NONZERO_PATTERN) pc->setupcalled = PETSC_FALSE;
116 ierr = PCMGSetGalerkin(pc,PC_MG_GALERKIN_PMAT);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),116,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
117 ierr = PCSetUp_MG(pc);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),117,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
118 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)
;
119 } else {
120 ierr = PCReset_MG(pc);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),120,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
121 pc->setupcalled = PETSC_FALSE;
122 }
123 }
124
125 /* Create an inner PC (GAMG or HYPRE) */
126 if (!hmg->innerpc) {
127 ierr = PCCreate(comm,&hmg->innerpc);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),127,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
128 /* If users do not set an inner pc type, we need to set a default value */
129 if (!hmg->innerpctype) {
130 /* If hypre is available, use hypre, otherwise, use gamg */
131#if PETSC_HAVE_HYPRE
132 ierr = PetscStrallocpy(PCHYPRE"hypre",&(hmg->innerpctype));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),132,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
133#else
134 ierr = PetscStrallocpy(PCGAMG"gamg",&(hmg->innerpctype));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),134,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
135#endif
136 }
137 ierr = PCSetType(hmg->innerpc,hmg->innerpctype);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),137,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
138 }
139 ierr = PCGetOperators(pc,NULL((void*)0),&PA);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),139,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
140 /* Users need to correctly set a block size of matrix in order to use subspace coarsening */
141 ierr = MatGetBlockSize(PA,&blocksize);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),141,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
142 if (blocksize<=1) hmg->subcoarsening = PETSC_FALSE;
143 /* Extract a submatrix for constructing subinterpolations */
144 if (hmg->subcoarsening) {
145 ierr = PCHMGExtractSubMatrix_Private(PA,&submat,MAT_INITIAL_MATRIX,blocksize);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),145,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
146 PA = submat;
147 }
148 ierr = PCSetOperators(hmg->innerpc,PA,PA);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),148,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
149 if (hmg->subcoarsening) {
150 ierr = MatDestroy(&PA);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),150,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
151 }
152 /* Setup inner PC correctly. During this step, matrix will be coarsened */
153 ierr = PCSetUseAmat(hmg->innerpc,PETSC_FALSE);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),153,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
154 ierr = PetscObjectGetOptionsPrefix((PetscObject)pc,&prefix);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),154,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
155 ierr = PetscObjectSetOptionsPrefix((PetscObject)hmg->innerpc,prefix);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),155,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
156 ierr = PetscObjectAppendOptionsPrefix((PetscObject)hmg->innerpc,"hmg_inner_");CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),156,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
157 ierr = PCSetFromOptions(hmg->innerpc);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),157,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
158 ierr = PCSetUp(hmg->innerpc);
Value stored to 'ierr' is never read
159
160 /* Obtain interpolations IN PLACE. For BoomerAMG, (I,J,data) is reused to avoid memory overhead */
161 ierr = PCGetInterpolations(hmg->innerpc,&num_levels,&interpolations);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),161,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
162 /* We can reuse the coarse operators when we do the full space coarsening */
163 if (!hmg->subcoarsening) {
164 ierr = PCGetCoarseOperators(hmg->innerpc,&num_levels,&operators);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),164,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
165 }
166
167 ierr = PCDestroy(&hmg->innerpc);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),167,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
168 hmg->innerpc = 0;
169 ierr = PCMGSetLevels_MG(pc,num_levels,NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),169,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
170 /* Set coarse matrices and interpolations to PCMG */
171 for (level=num_levels-1; level>0; level--) {
172 Mat P=0, pmat=0;
173 Vec b, x,r;
174 if (hmg->subcoarsening) {
175 /* Grow interpolation. In the future, we should use MAIJ */
176 ierr = PCHMGExpandInterpolation_Private(interpolations[level-1],&P,blocksize);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),176,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
177 ierr = MatDestroy(&interpolations[level-1]);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),177,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
178 } else {
179 P = interpolations[level-1];
180 }
181 ierr = MatCreateVecs(P,&b,&r);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),181,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
182 ierr = PCMGSetInterpolation(pc,level,P);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),182,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
183 ierr = PCMGSetRestriction(pc,level,P);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),183,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
184 ierr = MatDestroy(&P);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),184,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
185 /* We reuse the matrices when we do not do subspace coarsening */
186 if ((level-1)>=0 && !hmg->subcoarsening) {
187 pmat = operators[level-1];
188 ierr = PCMGSetOperators(pc,level-1,pmat,pmat);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),188,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
189 ierr = MatDestroy(&pmat);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),189,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
190 }
191 ierr = PCMGSetRhs(pc,level-1,b);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),191,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
192
193 ierr = PCMGSetR(pc,level,r);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),193,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
194 ierr = VecDestroy(&r);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),194,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
195
196 ierr = VecDuplicate(b,&x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),196,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
197 ierr = PCMGSetX(pc,level-1,x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),197,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
198 ierr = VecDestroy(&x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),198,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
199 ierr = VecDestroy(&b);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),199,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
200 }
201 ierr = PetscFree(interpolations)((*PetscTrFree)((void*)(interpolations),201,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
) || ((interpolations) = 0,0))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),201,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
202 if (!hmg->subcoarsening) {
203 ierr = PetscFree(operators)((*PetscTrFree)((void*)(operators),203,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
) || ((operators) = 0,0))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),203,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
204 }
205 /* Turn Galerkin off when we already have coarse operators */
206 ierr = PCMGSetGalerkin(pc,hmg->subcoarsening ? PC_MG_GALERKIN_PMAT:PC_MG_GALERKIN_NONE);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),206,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
207 ierr = PCSetDM(pc,NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),207,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
208 ierr = PCSetUseAmat(pc,PETSC_FALSE);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),208,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
209 ierr = PetscObjectOptionsBegin((PetscObject)pc)0; do { PetscOptionItems PetscOptionsObjectBase; PetscOptionItems
*PetscOptionsObject = &PetscOptionsObjectBase; PetscOptionsObject
->options = ((PetscObject)(PetscObject)pc)->options; for
(PetscOptionsObject->count=(PetscOptionsPublish?-1:1); PetscOptionsObject
->count<2; PetscOptionsObject->count++) { PetscErrorCode
_5_ierr = PetscObjectOptionsBegin_Private(PetscOptionsObject
,(PetscObject)pc);do {if (__builtin_expect(!!(_5_ierr),0)) return
PetscError(((MPI_Comm)0x44000001),209,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,_5_ierr,PETSC_ERROR_REPEAT," ");} while (0)
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),209,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
210 ierr = PCSetFromOptions_MG(PetscOptionsObject,pc);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),210,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
; /* should be called in PCSetFromOptions_HMG(), but cannot be called prior to PCMGSetLevels() */
211 ierr = PetscOptionsEnd()_5_ierr = PetscOptionsEnd_Private(PetscOptionsObject);do {if (
__builtin_expect(!!(_5_ierr),0)) return PetscError(((MPI_Comm
)0x44000001),211,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,_5_ierr,PETSC_ERROR_REPEAT," ");} while (0);}} while (0)
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),211,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
212 ierr = PCSetUp_MG(pc);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),212,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
213 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)
;
214}
215
216PetscErrorCode PCDestroy_HMG(PC pc)
217{
218 PetscErrorCode ierr;
219 PC_MG *mg = (PC_MG*)pc->data;
220 PC_HMG *hmg = (PC_HMG*) mg->innerctx;
221
222 PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize
< 64)) { petscstack->function[petscstack->currentsize
] = __func__; petscstack->file[petscstack->currentsize]
= "/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"; petscstack
->line[petscstack->currentsize] = 222; petscstack->petscroutine
[petscstack->currentsize] = PETSC_TRUE; petscstack->currentsize
++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE
|| petscstack->hotdepth); } ; } while (0); ; } while (0)
;
223 ierr = PCDestroy(&hmg->innerpc);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),223,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
224 ierr = PetscFree(hmg->innerpctype)((*PetscTrFree)((void*)(hmg->innerpctype),224,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
) || ((hmg->innerpctype) = 0,0))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),224,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
225 ierr = PetscFree(hmg)((*PetscTrFree)((void*)(hmg),225,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
) || ((hmg) = 0,0))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),225,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
226 ierr = PCDestroy_MG(pc);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),226,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
227
228 ierr = PetscObjectComposeFunction((PetscObject)pc,"PCHMGSetReuseInterpolation_C",NULL)PetscObjectComposeFunction_Private((PetscObject)pc,"PCHMGSetReuseInterpolation_C"
,(PetscVoidFunction)(((void*)0)))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),228,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
229 ierr = PetscObjectComposeFunction((PetscObject)pc,"PCHMGSetUseSubspaceCoarsening_C",NULL)PetscObjectComposeFunction_Private((PetscObject)pc,"PCHMGSetUseSubspaceCoarsening_C"
,(PetscVoidFunction)(((void*)0)))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),229,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
230 ierr = PetscObjectComposeFunction((PetscObject)pc,"PCHMGSetInnerPCType_C",NULL)PetscObjectComposeFunction_Private((PetscObject)pc,"PCHMGSetInnerPCType_C"
,(PetscVoidFunction)(((void*)0)))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),230,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
231 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)
;
232}
233
234PetscErrorCode PCView_HMG(PC pc,PetscViewer viewer)
235{
236 PC_MG *mg = (PC_MG*)pc->data;
237 PC_HMG *hmg = (PC_HMG*) mg->innerctx;
238 PetscErrorCode ierr;
239 PetscBool iascii;
240
241 PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize
< 64)) { petscstack->function[petscstack->currentsize
] = __func__; petscstack->file[petscstack->currentsize]
= "/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"; petscstack
->line[petscstack->currentsize] = 241; petscstack->petscroutine
[petscstack->currentsize] = PETSC_TRUE; petscstack->currentsize
++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE
|| petscstack->hotdepth); } ; } while (0); ; } while (0)
;
242 ierr = PetscObjectTypeCompare((PetscObject)viewer,PETSCVIEWERASCII"ascii",&iascii);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),242,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
243 if (iascii) {
244 ierr = PetscViewerASCIIPrintf(viewer," Reuse interpolation: %s\n",hmg->reuseinterp? "true":"false");CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),244,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
245 ierr = PetscViewerASCIIPrintf(viewer," Use subspace coarsening: %s\n",hmg->subcoarsening? "true":"false");CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),245,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
246 ierr = PetscViewerASCIIPrintf(viewer," Inner PC type: %s \n",hmg->innerpctype);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),246,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
247 }
248 ierr = PCView_MG(pc,viewer);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),248,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
249 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)
;
250}
251
252PetscErrorCode PCSetFromOptions_HMG(PetscOptionItems *PetscOptionsObject,PC pc)
253{
254 PetscErrorCode ierr;
255 PC_MG *mg = (PC_MG*)pc->data;
256 PC_HMG *hmg = (PC_HMG*) mg->innerctx;
257
258 PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize
< 64)) { petscstack->function[petscstack->currentsize
] = __func__; petscstack->file[petscstack->currentsize]
= "/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"; petscstack
->line[petscstack->currentsize] = 258; petscstack->petscroutine
[petscstack->currentsize] = PETSC_TRUE; petscstack->currentsize
++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE
|| petscstack->hotdepth); } ; } while (0); ; } while (0)
;
259 ierr = PetscOptionsHead(PetscOptionsObject,"HMG");CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),259,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
260 ierr = PetscOptionsBool("-pc_hmg_reuse_interpolation","Reuse the interpolation operators when possible (cheaper, weaker when matrix entries change a lot)","None",hmg->reuseinterp,&hmg->reuseinterp,NULL)PetscOptionsBool_Private(PetscOptionsObject,"-pc_hmg_reuse_interpolation"
,"Reuse the interpolation operators when possible (cheaper, weaker when matrix entries change a lot)"
,"None",hmg->reuseinterp,&hmg->reuseinterp,((void*)
0))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),260,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
261 ierr = PetscOptionsBool("-pc_hmg_use_subspace_coarsening","Use the subspace coarsening to compute the interpolations","None",hmg->subcoarsening,&hmg->subcoarsening,NULL)PetscOptionsBool_Private(PetscOptionsObject,"-pc_hmg_use_subspace_coarsening"
,"Use the subspace coarsening to compute the interpolations",
"None",hmg->subcoarsening,&hmg->subcoarsening,((void
*)0))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),261,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
262 ierr = PetscOptionsTail()0; do {if (PetscOptionsObject->count != 1) 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);} while(0)
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),262,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
263 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)
;
264}
265
266static PetscErrorCode PCHMGSetReuseInterpolation_HMG(PC pc, PetscBool reuse)
267{
268 PC_MG *mg = (PC_MG*)pc->data;
269 PC_HMG *hmg = (PC_HMG*) mg->innerctx;
270
271 PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize
< 64)) { petscstack->function[petscstack->currentsize
] = __func__; petscstack->file[petscstack->currentsize]
= "/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"; petscstack
->line[petscstack->currentsize] = 271; petscstack->petscroutine
[petscstack->currentsize] = PETSC_TRUE; petscstack->currentsize
++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE
|| petscstack->hotdepth); } ; } while (0); ; } while (0)
;
272 hmg->reuseinterp = reuse;
273 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)
;
274}
275
276/*MC
277 PCHMGSetReuseInterpolation - Reuse interpolation matrices in HMG
278
279 Logically Collective on PC
280
281 Input Parameters:
282+ pc - the HMG context
283- reuse - True indicates that HMG will reuse the interpolations
284
285 Options Database Keys:
286+ -pc_hmg_reuse_interpolation <true | false> - Whether or not to reuse the interpolations. If true, it potentially save the compute time.
287
288 Level: beginner
289
290.keywords: HMG, multigrid, interpolation, reuse, set
291
292.seealso: PCHMG
293M*/
294PetscErrorCode PCHMGSetReuseInterpolation(PC pc, PetscBool reuse)
295{
296 PetscErrorCode ierr;
297
298 PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize
< 64)) { petscstack->function[petscstack->currentsize
] = __func__; petscstack->file[petscstack->currentsize]
= "/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"; petscstack
->line[petscstack->currentsize] = 298; petscstack->petscroutine
[petscstack->currentsize] = PETSC_TRUE; petscstack->currentsize
++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE
|| petscstack->hotdepth); } ; } while (0); ; } while (0)
;
299 PetscValidHeaderSpecific(pc,PC_CLASSID,1)do { if (!pc) return PetscError(((MPI_Comm)0x44000001),299,__func__
,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c",85,PETSC_ERROR_INITIAL
,"Null Object: Parameter # %d",1); if (!PetscCheckPointer(pc,
PETSC_OBJECT)) return PetscError(((MPI_Comm)0x44000001),299,__func__
,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c",64,PETSC_ERROR_INITIAL
,"Invalid Pointer to Object: Parameter # %d",1); if (((PetscObject
)(pc))->classid != PC_CLASSID) { if (((PetscObject)(pc))->
classid == -1) return PetscError(((MPI_Comm)0x44000001),299,__func__
,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c",64,PETSC_ERROR_INITIAL
,"Object already free: Parameter # %d",1); else return PetscError
(((MPI_Comm)0x44000001),299,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,62,PETSC_ERROR_INITIAL,"Wrong type of object: Parameter # %d"
,1); } } while (0)
;
300 ierr = PetscUseMethod(pc,"PCHMGSetReuseInterpolation_C",(PC,PetscBool),(pc,reuse))0; do { PetscErrorCode (*_7_f)(PC,PetscBool), _7_ierr; _7_ierr
= PetscObjectQueryFunction_Private(((PetscObject)(pc)),("PCHMGSetReuseInterpolation_C"
),(PetscVoidFunction*)(&_7_f));do {if (__builtin_expect(!
!(_7_ierr),0)) return PetscError(((MPI_Comm)0x44000001),300,__func__
,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c",_7_ierr
,PETSC_ERROR_REPEAT," ");} while (0); if (_7_f) {_7_ierr = (*
_7_f)(pc,reuse);do {if (__builtin_expect(!!(_7_ierr),0)) return
PetscError(((MPI_Comm)0x44000001),300,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,_7_ierr,PETSC_ERROR_REPEAT," ");} while (0);} else return PetscError
(PetscObjectComm((PetscObject)(pc)),300,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,56,PETSC_ERROR_INITIAL,"Cannot locate function %s in object"
,"PCHMGSetReuseInterpolation_C"); } while(0)
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),300,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
301 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)
;
302}
303
304static PetscErrorCode PCHMGSetUseSubspaceCoarsening_HMG(PC pc, PetscBool subspace)
305{
306 PC_MG *mg = (PC_MG*)pc->data;
307 PC_HMG *hmg = (PC_HMG*) mg->innerctx;
308
309 PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize
< 64)) { petscstack->function[petscstack->currentsize
] = __func__; petscstack->file[petscstack->currentsize]
= "/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"; petscstack
->line[petscstack->currentsize] = 309; petscstack->petscroutine
[petscstack->currentsize] = PETSC_TRUE; petscstack->currentsize
++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE
|| petscstack->hotdepth); } ; } while (0); ; } while (0)
;
310 hmg->subcoarsening = subspace;
311 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)
;
312}
313
314/*MC
315 PCHMGSetUseSubspaceCoarsening - Use subspace coarsening in HMG
316
317 Logically Collective on PC
318
319 Input Parameters:
320+ pc - the HMG context
321- reuse - True indicates that HMG will use the subspace coarsening
322
323 Options Database Keys:
324+ -pc_hmg_use_subspace_coarsening <true | false> - Whether or not to use subspace coarsening (that is, coarsen a submatrix).
325
326 Level: beginner
327
328.keywords: HMG, multigrid, interpolation, subspace, coarsening
329
330.seealso: PCHMG
331M*/
332PetscErrorCode PCHMGSetUseSubspaceCoarsening(PC pc, PetscBool subspace)
333{
334 PetscErrorCode ierr;
335
336 PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize
< 64)) { petscstack->function[petscstack->currentsize
] = __func__; petscstack->file[petscstack->currentsize]
= "/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"; petscstack
->line[petscstack->currentsize] = 336; petscstack->petscroutine
[petscstack->currentsize] = PETSC_TRUE; petscstack->currentsize
++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE
|| petscstack->hotdepth); } ; } while (0); ; } while (0)
;
337 PetscValidHeaderSpecific(pc,PC_CLASSID,1)do { if (!pc) return PetscError(((MPI_Comm)0x44000001),337,__func__
,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c",85,PETSC_ERROR_INITIAL
,"Null Object: Parameter # %d",1); if (!PetscCheckPointer(pc,
PETSC_OBJECT)) return PetscError(((MPI_Comm)0x44000001),337,__func__
,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c",64,PETSC_ERROR_INITIAL
,"Invalid Pointer to Object: Parameter # %d",1); if (((PetscObject
)(pc))->classid != PC_CLASSID) { if (((PetscObject)(pc))->
classid == -1) return PetscError(((MPI_Comm)0x44000001),337,__func__
,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c",64,PETSC_ERROR_INITIAL
,"Object already free: Parameter # %d",1); else return PetscError
(((MPI_Comm)0x44000001),337,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,62,PETSC_ERROR_INITIAL,"Wrong type of object: Parameter # %d"
,1); } } while (0)
;
338 ierr = PetscUseMethod(pc,"PCHMGSetUseSubspaceCoarsening_C",(PC,PetscBool),(pc,subspace))0; do { PetscErrorCode (*_7_f)(PC,PetscBool), _7_ierr; _7_ierr
= PetscObjectQueryFunction_Private(((PetscObject)(pc)),("PCHMGSetUseSubspaceCoarsening_C"
),(PetscVoidFunction*)(&_7_f));do {if (__builtin_expect(!
!(_7_ierr),0)) return PetscError(((MPI_Comm)0x44000001),338,__func__
,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c",_7_ierr
,PETSC_ERROR_REPEAT," ");} while (0); if (_7_f) {_7_ierr = (*
_7_f)(pc,subspace);do {if (__builtin_expect(!!(_7_ierr),0)) return
PetscError(((MPI_Comm)0x44000001),338,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,_7_ierr,PETSC_ERROR_REPEAT," ");} while (0);} else return PetscError
(PetscObjectComm((PetscObject)(pc)),338,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,56,PETSC_ERROR_INITIAL,"Cannot locate function %s in object"
,"PCHMGSetUseSubspaceCoarsening_C"); } while(0)
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),338,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
339 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)
;
340}
341
342static PetscErrorCode PCHMGSetInnerPCType_HMG(PC pc, PCType type)
343{
344 PC_MG *mg = (PC_MG*)pc->data;
345 PC_HMG *hmg = (PC_HMG*) mg->innerctx;
346 PetscErrorCode ierr;
347
348 PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize
< 64)) { petscstack->function[petscstack->currentsize
] = __func__; petscstack->file[petscstack->currentsize]
= "/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"; petscstack
->line[petscstack->currentsize] = 348; petscstack->petscroutine
[petscstack->currentsize] = PETSC_TRUE; petscstack->currentsize
++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE
|| petscstack->hotdepth); } ; } while (0); ; } while (0)
;
349 ierr = PetscStrallocpy(type,&(hmg->innerpctype));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),349,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
350 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)
;
351}
352
353/*MC
354 PCHMGSetInnerPCType - Set an inner PC type
355
356 Logically Collective on PC
357
358 Input Parameters:
359+ pc - the HMG context
360- type - <hypre, gamg> coarsening algorithm
361
362 Options Database Keys:
363+ -hmg_inner_pc_type <hypre, gamg> - What method is used to coarsen matrix
364
365 Level: beginner
366
367.keywords: HMG, multigrid, interpolation, coarsening
368
369.seealso: PCHMG, PCType
370M*/
371PetscErrorCode PCHMGSetInnerPCType(PC pc, PCType type)
372{
373 PetscErrorCode ierr;
374
375 PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize
< 64)) { petscstack->function[petscstack->currentsize
] = __func__; petscstack->file[petscstack->currentsize]
= "/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"; petscstack
->line[petscstack->currentsize] = 375; petscstack->petscroutine
[petscstack->currentsize] = PETSC_TRUE; petscstack->currentsize
++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE
|| petscstack->hotdepth); } ; } while (0); ; } while (0)
;
376 PetscValidHeaderSpecific(pc,PC_CLASSID,1)do { if (!pc) return PetscError(((MPI_Comm)0x44000001),376,__func__
,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c",85,PETSC_ERROR_INITIAL
,"Null Object: Parameter # %d",1); if (!PetscCheckPointer(pc,
PETSC_OBJECT)) return PetscError(((MPI_Comm)0x44000001),376,__func__
,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c",64,PETSC_ERROR_INITIAL
,"Invalid Pointer to Object: Parameter # %d",1); if (((PetscObject
)(pc))->classid != PC_CLASSID) { if (((PetscObject)(pc))->
classid == -1) return PetscError(((MPI_Comm)0x44000001),376,__func__
,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c",64,PETSC_ERROR_INITIAL
,"Object already free: Parameter # %d",1); else return PetscError
(((MPI_Comm)0x44000001),376,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,62,PETSC_ERROR_INITIAL,"Wrong type of object: Parameter # %d"
,1); } } while (0)
;
377 ierr = PetscUseMethod(pc,"PCHMGSetInnerPCType_C",(PC,PCType),(pc,type))0; do { PetscErrorCode (*_7_f)(PC,PCType), _7_ierr; _7_ierr =
PetscObjectQueryFunction_Private(((PetscObject)(pc)),("PCHMGSetInnerPCType_C"
),(PetscVoidFunction*)(&_7_f));do {if (__builtin_expect(!
!(_7_ierr),0)) return PetscError(((MPI_Comm)0x44000001),377,__func__
,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c",_7_ierr
,PETSC_ERROR_REPEAT," ");} while (0); if (_7_f) {_7_ierr = (*
_7_f)(pc,type);do {if (__builtin_expect(!!(_7_ierr),0)) return
PetscError(((MPI_Comm)0x44000001),377,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,_7_ierr,PETSC_ERROR_REPEAT," ");} while (0);} else return PetscError
(PetscObjectComm((PetscObject)(pc)),377,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,56,PETSC_ERROR_INITIAL,"Cannot locate function %s in object"
,"PCHMGSetInnerPCType_C"); } while(0)
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),377,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
378 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)
;
379}
380
381/*MC
382 PCHMG - Hybrid of PETSc preconditioners (such as ASM, BJacobi, SOR, etc.) and Hypre BoomerAMG, GAMG or other multilevel methods. BoomerAMG, GAMG
383 or other multilevel methods is used to coarsen matrix and generate a sequence of coarse matrices and interpolations. The matrices and
384 interpolations are employed to construct PCMG, and then any available PETSc preconditioners can be chosen as smoothers and the coarse solver.
385
386 Options Database Keys:
387+ -pc_hmg_reuse_interpolation <true | false> - Whether or not to reuse the interpolations. If true, it potentially save the compute time.
388. -pc_hmg_use_subspace_coarsening <true | false> - Whether or not to use subspace coarsening (that is, coarsen a submatrix).
389. -hmg_inner_pc_type <hypre, gamg, ...> - What method is used to coarsen matrix
390
391
392 Notes:
393 For multicomponent problems, we can just coarsen one submatrix associated with one particular component. In this way, the preconditioner setup
394 time is significantly reduced. One typical use case is neutron transport equations. There are many variables on each mesh vertex due to the
395 of angle and energy. Each variable, in fact, corresponds to the same PDEs but with different material properties.
396
397 Level: beginner
398
399 Concepts: Hybrid of ASM and MG, Subspace Coarsening
400
401 References:
402+ 1. - Fande Kong, Yaqi Wang, Derek R Gaston, Cody J Permann, Andrew E Slaughter, Alexander D Lindsay, Richard C Martineau, A highly parallel multilevel
403 Newton-Krylov-Schwarz method with subspace-based coarsening and partition-based balancing for the multigroup neutron transport equations on
404 3D unstructured meshes, arXiv preprint arXiv:1903.03659, 2019
405
406.seealso: PCCreate(), PCSetType(), PCType, PC, PCMG, PCHYPRE, PCHMG, PCGetCoarseOperators(), PCGetInterpolations(), PCHMGSetReuseInterpolation(), PCHMGSetUseSubspaceCoarsening(),
407 PCHMGSetInnerPCType()
408
409M*/
410PETSC_EXTERNextern __attribute__((visibility ("default"))) PetscErrorCode PCCreate_HMG(PC pc)
411{
412 PetscErrorCode ierr;
413 PC_HMG *hmg;
414 PC_MG *mg;
415
416 PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize
< 64)) { petscstack->function[petscstack->currentsize
] = __func__; petscstack->file[petscstack->currentsize]
= "/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"; petscstack
->line[petscstack->currentsize] = 416; petscstack->petscroutine
[petscstack->currentsize] = PETSC_TRUE; petscstack->currentsize
++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE
|| petscstack->hotdepth); } ; } while (0); ; } while (0)
;
417 /* if type was previously mg; must manually destroy it because call to PCSetType(pc,PCMG) will not destroy it */
418 if (pc->ops->destroy) {
419 ierr = (*pc->ops->destroy)(pc);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),419,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
420 pc->data = 0;
421 }
422 ierr = PetscFree(((PetscObject)pc)->type_name)((*PetscTrFree)((void*)(((PetscObject)pc)->type_name),422,
__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
) || ((((PetscObject)pc)->type_name) = 0,0))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),422,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
423
424 ierr = PCSetType(pc,PCMG"mg");CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),424,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
425 ierr = PetscNew(&hmg)PetscMallocA(1,PETSC_TRUE,425,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,(size_t)(1)*sizeof(**((&hmg))),((&hmg)))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),425,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
426
427 mg = (PC_MG*) pc->data;
428 mg->innerctx = hmg;
429 hmg->reuseinterp = PETSC_FALSE;
430 hmg->subcoarsening = PETSC_FALSE;
431 hmg->innerpc = NULL((void*)0);
432
433 pc->ops->setfromoptions = PCSetFromOptions_HMG;
434 pc->ops->view = PCView_HMG;
435 pc->ops->destroy = PCDestroy_HMG;
436 pc->ops->setup = PCSetUp_HMG;
437
438 ierr = PetscObjectComposeFunction((PetscObject)pc,"PCHMGSetReuseInterpolation_C",PCHMGSetReuseInterpolation_HMG)PetscObjectComposeFunction_Private((PetscObject)pc,"PCHMGSetReuseInterpolation_C"
,(PetscVoidFunction)(PCHMGSetReuseInterpolation_HMG))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),438,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
439 ierr = PetscObjectComposeFunction((PetscObject)pc,"PCHMGSetUseSubspaceCoarsening_C",PCHMGSetUseSubspaceCoarsening_HMG)PetscObjectComposeFunction_Private((PetscObject)pc,"PCHMGSetUseSubspaceCoarsening_C"
,(PetscVoidFunction)(PCHMGSetUseSubspaceCoarsening_HMG))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),439,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
440 ierr = PetscObjectComposeFunction((PetscObject)pc,"PCHMGSetInnerPCType_C",PCHMGSetInnerPCType_HMG)PetscObjectComposeFunction_Private((PetscObject)pc,"PCHMGSetInnerPCType_C"
,(PetscVoidFunction)(PCHMGSetInnerPCType_HMG))
;CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm
)0x44000001),440,__func__,"/sandbox/petsc/petsc.next/src/ksp/pc/impls/hmg/hmg.c"
,ierr,PETSC_ERROR_REPEAT," ");} while (0)
;
441 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)
;
442}