File: | dm/dt/fe/impls/basic/febasic.c |
Warning: | line 469, column 9 11th function call argument is an uninitialized value |
[?] Use j/k keys for keyboard navigation
1 | #include <petsc/private/petscfeimpl.h> /*I "petscfe.h" I*/ | |||
2 | #include <petscblaslapack.h> | |||
3 | ||||
4 | PetscErrorCode PetscFEDestroy_Basic(PetscFE fem) | |||
5 | { | |||
6 | PetscFE_Basic *b = (PetscFE_Basic *) fem->data; | |||
7 | PetscErrorCode ierr; | |||
8 | ||||
9 | PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize < 64)) { petscstack->function[petscstack->currentsize ] = __func__; petscstack->file[petscstack->currentsize] = "/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ; petscstack->line[petscstack->currentsize] = 9; petscstack ->petscroutine[petscstack->currentsize] = PETSC_TRUE; petscstack ->currentsize++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE || petscstack->hotdepth); } ; } while (0) ; ; } while (0); | |||
10 | ierr = PetscFree(b)((*PetscTrFree)((void*)(b),10,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ) || ((b) = 0,0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),10,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
11 | 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); | |||
12 | } | |||
13 | ||||
14 | PetscErrorCode PetscFEView_Basic_Ascii(PetscFE fe, PetscViewer v) | |||
15 | { | |||
16 | PetscInt dim, Nc; | |||
17 | PetscSpace basis = NULL((void*)0); | |||
18 | PetscDualSpace dual = NULL((void*)0); | |||
19 | PetscQuadrature quad = NULL((void*)0); | |||
20 | PetscErrorCode ierr; | |||
21 | ||||
22 | PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize < 64)) { petscstack->function[petscstack->currentsize ] = __func__; petscstack->file[petscstack->currentsize] = "/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ; petscstack->line[petscstack->currentsize] = 22; petscstack ->petscroutine[petscstack->currentsize] = PETSC_TRUE; petscstack ->currentsize++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE || petscstack->hotdepth); } ; } while (0) ; ; } while (0); | |||
23 | ierr = PetscFEGetSpatialDimension(fe, &dim);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),23,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
24 | ierr = PetscFEGetNumComponents(fe, &Nc);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),24,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
25 | ierr = PetscFEGetBasisSpace(fe, &basis);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),25,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
26 | ierr = PetscFEGetDualSpace(fe, &dual);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),26,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
27 | ierr = PetscFEGetQuadrature(fe, &quad);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),27,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
28 | ierr = PetscViewerASCIIPushTab(v);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),28,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
29 | ierr = PetscViewerASCIIPrintf(v, "Basic Finite Element in %D dimensions with %D components\n",dim,Nc);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),29,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
30 | if (basis) {ierr = PetscSpaceView(basis, v);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),30,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
31 | if (dual) {ierr = PetscDualSpaceView(dual, v);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),31,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
32 | if (quad) {ierr = PetscQuadratureView(quad, v);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),32,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
33 | ierr = PetscViewerASCIIPopTab(v);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),33,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
34 | 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); | |||
35 | } | |||
36 | ||||
37 | PetscErrorCode PetscFEView_Basic(PetscFE fe, PetscViewer v) | |||
38 | { | |||
39 | PetscBool iascii; | |||
40 | PetscErrorCode ierr; | |||
41 | ||||
42 | PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize < 64)) { petscstack->function[petscstack->currentsize ] = __func__; petscstack->file[petscstack->currentsize] = "/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ; petscstack->line[petscstack->currentsize] = 42; petscstack ->petscroutine[petscstack->currentsize] = PETSC_TRUE; petscstack ->currentsize++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE || petscstack->hotdepth); } ; } while (0) ; ; } while (0); | |||
43 | ierr = PetscObjectTypeCompare((PetscObject) v, PETSCVIEWERASCII"ascii", &iascii);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),43,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
44 | if (iascii) {ierr = PetscFEView_Basic_Ascii(fe, v);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),44,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
45 | 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); | |||
46 | } | |||
47 | ||||
48 | /* Construct the change of basis from prime basis to nodal basis */ | |||
49 | PetscErrorCode PetscFESetUp_Basic(PetscFE fem) | |||
50 | { | |||
51 | PetscScalar *work, *invVscalar; | |||
52 | PetscBLASInt *pivots; | |||
53 | PetscBLASInt n, info; | |||
54 | PetscInt pdim, j; | |||
55 | PetscErrorCode ierr; | |||
56 | ||||
57 | PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize < 64)) { petscstack->function[petscstack->currentsize ] = __func__; petscstack->file[petscstack->currentsize] = "/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ; petscstack->line[petscstack->currentsize] = 57; petscstack ->petscroutine[petscstack->currentsize] = PETSC_TRUE; petscstack ->currentsize++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE || petscstack->hotdepth); } ; } while (0) ; ; } while (0); | |||
58 | ierr = PetscDualSpaceGetDimension(fem->dualSpace, &pdim);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),58,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
59 | ierr = PetscMalloc1(pdim*pdim,&fem->invV)PetscMallocA(1,PETSC_FALSE,59,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,(size_t)(pdim*pdim)*sizeof(**(&fem->invV)),(&fem-> invV));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),59,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
60 | #if defined(PETSC_USE_COMPLEX) | |||
61 | ierr = PetscMalloc1(pdim*pdim,&invVscalar)PetscMallocA(1,PETSC_FALSE,61,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,(size_t)(pdim*pdim)*sizeof(**(&invVscalar)),(&invVscalar ));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),61,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
62 | #else | |||
63 | invVscalar = fem->invV; | |||
64 | #endif | |||
65 | for (j = 0; j < pdim; ++j) { | |||
66 | PetscReal *Bf; | |||
67 | PetscQuadrature f; | |||
68 | const PetscReal *points, *weights; | |||
69 | PetscInt Nc, Nq, q, k, c; | |||
70 | ||||
71 | ierr = PetscDualSpaceGetFunctional(fem->dualSpace, j, &f);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),71,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
72 | ierr = PetscQuadratureGetData(f, NULL((void*)0), &Nc, &Nq, &points, &weights);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),72,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
73 | ierr = PetscMalloc1(Nc*Nq*pdim,&Bf)PetscMallocA(1,PETSC_FALSE,73,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,(size_t)(Nc*Nq*pdim)*sizeof(**(&Bf)),(&Bf));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),73,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
74 | ierr = PetscSpaceEvaluate(fem->basisSpace, Nq, points, Bf, NULL((void*)0), NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),74,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
75 | for (k = 0; k < pdim; ++k) { | |||
76 | /* V_{jk} = n_j(\phi_k) = \int \phi_k(x) n_j(x) dx */ | |||
77 | invVscalar[j*pdim+k] = 0.0; | |||
78 | ||||
79 | for (q = 0; q < Nq; ++q) { | |||
80 | for (c = 0; c < Nc; ++c) invVscalar[j*pdim+k] += Bf[(q*pdim + k)*Nc + c]*weights[q*Nc + c]; | |||
81 | } | |||
82 | } | |||
83 | ierr = PetscFree(Bf)((*PetscTrFree)((void*)(Bf),83,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ) || ((Bf) = 0,0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),83,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
84 | } | |||
85 | ierr = PetscMalloc2(pdim,&pivots,pdim,&work)PetscMallocA(2,PETSC_FALSE,85,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,(size_t)(pdim)*sizeof(**(&pivots)),(&pivots),(size_t )(pdim)*sizeof(**(&work)),(&work));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),85,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
86 | n = pdim; | |||
87 | PetscStackCallBLAS("LAPACKgetrf", LAPACKgetrf_(&n, &n, invVscalar, &n, pivots, &info))do { do { ; if (petscstack && (petscstack->currentsize < 64)) { petscstack->function[petscstack->currentsize ] = "LAPACKgetrf"; petscstack->file[petscstack->currentsize ] = "/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ; petscstack->line[petscstack->currentsize] = 87; petscstack ->petscroutine[petscstack->currentsize] = PETSC_FALSE; petscstack ->currentsize++; } if (petscstack) { petscstack->hotdepth += (PETSC_TRUE || petscstack->hotdepth); } ; } while (0); dgetrf_(&n, &n, invVscalar, &n, pivots, &info ); do { do {PetscErrorCode _7_ierr = PetscMallocValidate(87,__func__ ,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" );do {if (__builtin_expect(!!(_7_ierr),0)) return PetscError( ((MPI_Comm)0x44000001),87,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,_7_ierr,PETSC_ERROR_REPEAT," ");} while (0);} while(0); 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); } while (0); } while(0); | |||
88 | PetscStackCallBLAS("LAPACKgetri", LAPACKgetri_(&n, invVscalar, &n, pivots, work, &n, &info))do { do { ; if (petscstack && (petscstack->currentsize < 64)) { petscstack->function[petscstack->currentsize ] = "LAPACKgetri"; petscstack->file[petscstack->currentsize ] = "/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ; petscstack->line[petscstack->currentsize] = 88; petscstack ->petscroutine[petscstack->currentsize] = PETSC_FALSE; petscstack ->currentsize++; } if (petscstack) { petscstack->hotdepth += (PETSC_TRUE || petscstack->hotdepth); } ; } while (0); dgetri_(&n, invVscalar, &n, pivots, work, &n, & info); do { do {PetscErrorCode _7_ierr = PetscMallocValidate( 88,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" );do {if (__builtin_expect(!!(_7_ierr),0)) return PetscError( ((MPI_Comm)0x44000001),88,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,_7_ierr,PETSC_ERROR_REPEAT," ");} while (0);} while(0); 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); } while (0); } while(0); | |||
89 | #if defined(PETSC_USE_COMPLEX) | |||
90 | for (j = 0; j < pdim*pdim; j++) fem->invV[j] = PetscRealPart(invVscalar[j])(invVscalar[j]); | |||
91 | ierr = PetscFree(invVscalar)((*PetscTrFree)((void*)(invVscalar),91,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ) || ((invVscalar) = 0,0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),91,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
92 | #endif | |||
93 | ierr = PetscFree2(pivots,work)PetscFreeA(2,93,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,&(pivots),&(work));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),93,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
94 | 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); | |||
95 | } | |||
96 | ||||
97 | PetscErrorCode PetscFEGetDimension_Basic(PetscFE fem, PetscInt *dim) | |||
98 | { | |||
99 | PetscErrorCode ierr; | |||
100 | ||||
101 | PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize < 64)) { petscstack->function[petscstack->currentsize ] = __func__; petscstack->file[petscstack->currentsize] = "/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ; petscstack->line[petscstack->currentsize] = 101; petscstack ->petscroutine[petscstack->currentsize] = PETSC_TRUE; petscstack ->currentsize++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE || petscstack->hotdepth); } ; } while (0) ; ; } while (0); | |||
102 | ierr = PetscDualSpaceGetDimension(fem->dualSpace, dim);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),102,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
103 | 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); | |||
104 | } | |||
105 | ||||
106 | PetscErrorCode PetscFEGetTabulation_Basic(PetscFE fem, PetscInt npoints, const PetscReal points[], PetscReal *B, PetscReal *D, PetscReal *H) | |||
107 | { | |||
108 | DM dm; | |||
109 | PetscInt pdim; /* Dimension of FE space P */ | |||
110 | PetscInt dim; /* Spatial dimension */ | |||
111 | PetscInt Nc; /* Field components */ | |||
112 | PetscReal *tmpB, *tmpD, *tmpH; | |||
113 | PetscInt p, d, j, k, c; | |||
114 | PetscErrorCode ierr; | |||
115 | ||||
116 | PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize < 64)) { petscstack->function[petscstack->currentsize ] = __func__; petscstack->file[petscstack->currentsize] = "/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ; petscstack->line[petscstack->currentsize] = 116; petscstack ->petscroutine[petscstack->currentsize] = PETSC_TRUE; petscstack ->currentsize++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE || petscstack->hotdepth); } ; } while (0) ; ; } while (0); | |||
117 | ierr = PetscDualSpaceGetDM(fem->dualSpace, &dm);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),117,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
118 | ierr = DMGetDimension(dm, &dim);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),118,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
119 | ierr = PetscDualSpaceGetDimension(fem->dualSpace, &pdim);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),119,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
120 | ierr = PetscFEGetNumComponents(fem, &Nc);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),120,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
121 | /* Evaluate the prime basis functions at all points */ | |||
122 | if (B) {ierr = DMGetWorkArray(dm, npoints*pdim*Nc, MPIU_REAL((MPI_Datatype)0x4c00080b), &tmpB);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),122,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
123 | if (D) {ierr = DMGetWorkArray(dm, npoints*pdim*Nc*dim, MPIU_REAL((MPI_Datatype)0x4c00080b), &tmpD);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),123,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
124 | if (H) {ierr = DMGetWorkArray(dm, npoints*pdim*Nc*dim*dim, MPIU_REAL((MPI_Datatype)0x4c00080b), &tmpH);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),124,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
125 | ierr = PetscSpaceEvaluate(fem->basisSpace, npoints, points, B ? tmpB : NULL((void*)0), D ? tmpD : NULL((void*)0), H ? tmpH : NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),125,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
126 | /* Translate to the nodal basis */ | |||
127 | for (p = 0; p < npoints; ++p) { | |||
128 | if (B) { | |||
129 | /* Multiply by V^{-1} (pdim x pdim) */ | |||
130 | for (j = 0; j < pdim; ++j) { | |||
131 | const PetscInt i = (p*pdim + j)*Nc; | |||
132 | ||||
133 | for (c = 0; c < Nc; ++c) { | |||
134 | B[i+c] = 0.0; | |||
135 | for (k = 0; k < pdim; ++k) { | |||
136 | B[i+c] += fem->invV[k*pdim+j] * tmpB[(p*pdim + k)*Nc+c]; | |||
137 | } | |||
138 | } | |||
139 | } | |||
140 | } | |||
141 | if (D) { | |||
142 | /* Multiply by V^{-1} (pdim x pdim) */ | |||
143 | for (j = 0; j < pdim; ++j) { | |||
144 | for (c = 0; c < Nc; ++c) { | |||
145 | for (d = 0; d < dim; ++d) { | |||
146 | const PetscInt i = ((p*pdim + j)*Nc + c)*dim + d; | |||
147 | ||||
148 | D[i] = 0.0; | |||
149 | for (k = 0; k < pdim; ++k) { | |||
150 | D[i] += fem->invV[k*pdim+j] * tmpD[((p*pdim + k)*Nc + c)*dim + d]; | |||
151 | } | |||
152 | } | |||
153 | } | |||
154 | } | |||
155 | } | |||
156 | if (H) { | |||
157 | /* Multiply by V^{-1} (pdim x pdim) */ | |||
158 | for (j = 0; j < pdim; ++j) { | |||
159 | for (c = 0; c < Nc; ++c) { | |||
160 | for (d = 0; d < dim*dim; ++d) { | |||
161 | const PetscInt i = ((p*pdim + j)*Nc + c)*dim*dim + d; | |||
162 | ||||
163 | H[i] = 0.0; | |||
164 | for (k = 0; k < pdim; ++k) { | |||
165 | H[i] += fem->invV[k*pdim+j] * tmpH[((p*pdim + k)*Nc + c)*dim*dim + d]; | |||
166 | } | |||
167 | } | |||
168 | } | |||
169 | } | |||
170 | } | |||
171 | } | |||
172 | if (B) {ierr = DMRestoreWorkArray(dm, npoints*pdim*Nc, MPIU_REAL((MPI_Datatype)0x4c00080b), &tmpB);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),172,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
173 | if (D) {ierr = DMRestoreWorkArray(dm, npoints*pdim*Nc*dim, MPIU_REAL((MPI_Datatype)0x4c00080b), &tmpD);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),173,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
174 | if (H) {ierr = DMRestoreWorkArray(dm, npoints*pdim*Nc*dim*dim, MPIU_REAL((MPI_Datatype)0x4c00080b), &tmpH);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),174,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
175 | 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); | |||
176 | } | |||
177 | ||||
178 | PetscErrorCode PetscFEIntegrate_Basic(PetscDS ds, PetscInt field, PetscInt Ne, PetscFEGeom *cgeom, | |||
179 | const PetscScalar coefficients[], PetscDS dsAux, const PetscScalar coefficientsAux[], PetscScalar integral[]) | |||
180 | { | |||
181 | const PetscInt debug = 0; | |||
182 | PetscFE fe; | |||
183 | PetscPointFunc obj_func; | |||
184 | PetscQuadrature quad; | |||
185 | PetscScalar *u, *u_x, *a, *a_x; | |||
186 | const PetscScalar *constants; | |||
187 | PetscReal *x; | |||
188 | PetscReal **B, **D, **BAux = NULL((void*)0), **DAux = NULL((void*)0); | |||
189 | PetscInt *uOff, *uOff_x, *aOff = NULL((void*)0), *aOff_x = NULL((void*)0), *Nb, *Nc, *NbAux = NULL((void*)0), *NcAux = NULL((void*)0); | |||
190 | PetscInt dim, dE, Np, numConstants, Nf, NfAux = 0, totDim, totDimAux = 0, cOffset = 0, cOffsetAux = 0, e; | |||
191 | PetscBool isAffine; | |||
192 | const PetscReal *quadPoints, *quadWeights; | |||
193 | PetscInt qNc, Nq, q; | |||
194 | PetscErrorCode ierr; | |||
195 | ||||
196 | PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize < 64)) { petscstack->function[petscstack->currentsize ] = __func__; petscstack->file[petscstack->currentsize] = "/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ; petscstack->line[petscstack->currentsize] = 196; petscstack ->petscroutine[petscstack->currentsize] = PETSC_TRUE; petscstack ->currentsize++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE || petscstack->hotdepth); } ; } while (0) ; ; } while (0); | |||
197 | ierr = PetscDSGetObjective(ds, field, &obj_func);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),197,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
198 | if (!obj_func) 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); | |||
199 | ierr = PetscDSGetDiscretization(ds, field, (PetscObject *) &fe);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),199,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
200 | ierr = PetscFEGetSpatialDimension(fe, &dim);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),200,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
201 | ierr = PetscFEGetQuadrature(fe, &quad);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),201,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
202 | ierr = PetscDSGetNumFields(ds, &Nf);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),202,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
203 | ierr = PetscDSGetTotalDimension(ds, &totDim);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),203,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
204 | ierr = PetscDSGetDimensions(ds, &Nb);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),204,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
205 | ierr = PetscDSGetComponents(ds, &Nc);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),205,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
206 | ierr = PetscDSGetComponentOffsets(ds, &uOff);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),206,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
207 | ierr = PetscDSGetComponentDerivativeOffsets(ds, &uOff_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),207,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
208 | ierr = PetscDSGetEvaluationArrays(ds, &u, NULL((void*)0), &u_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),208,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
209 | ierr = PetscDSGetWorkspace(ds, &x, NULL((void*)0), NULL((void*)0), NULL((void*)0), NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),209,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
210 | ierr = PetscDSGetTabulation(ds, &B, &D);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),210,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
211 | ierr = PetscDSGetConstants(ds, &numConstants, &constants);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),211,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
212 | if (dsAux) { | |||
213 | ierr = PetscDSGetNumFields(dsAux, &NfAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),213,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
214 | ierr = PetscDSGetTotalDimension(dsAux, &totDimAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),214,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
215 | ierr = PetscDSGetDimensions(dsAux, &NbAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),215,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
216 | ierr = PetscDSGetComponents(dsAux, &NcAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),216,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
217 | ierr = PetscDSGetComponentOffsets(dsAux, &aOff);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),217,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
218 | ierr = PetscDSGetComponentDerivativeOffsets(dsAux, &aOff_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),218,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
219 | ierr = PetscDSGetEvaluationArrays(dsAux, &a, NULL((void*)0), &a_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),219,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
220 | ierr = PetscDSGetTabulation(dsAux, &BAux, &DAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),220,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
221 | } | |||
222 | ierr = PetscQuadratureGetData(quad, NULL((void*)0), &qNc, &Nq, &quadPoints, &quadWeights);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),222,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
223 | if (qNc != 1) SETERRQ1(PETSC_COMM_SELF, PETSC_ERR_SUP, "Only supports scalar quadrature, not %D components\n", qNc)return PetscError(((MPI_Comm)0x44000001),223,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,56,PETSC_ERROR_INITIAL,"Only supports scalar quadrature, not %D components\n" ,qNc); | |||
224 | Np = cgeom->numPoints; | |||
225 | dE = cgeom->dimEmbed; | |||
226 | isAffine = cgeom->isAffine; | |||
227 | for (e = 0; e < Ne; ++e) { | |||
228 | PetscFEGeom fegeom; | |||
229 | ||||
230 | if (isAffine) { | |||
231 | fegeom.v = x; | |||
232 | fegeom.xi = cgeom->xi; | |||
233 | fegeom.J = &cgeom->J[e*dE*dE]; | |||
234 | fegeom.invJ = &cgeom->invJ[e*dE*dE]; | |||
235 | fegeom.detJ = &cgeom->detJ[e]; | |||
236 | } | |||
237 | for (q = 0; q < Nq; ++q) { | |||
238 | PetscScalar integrand; | |||
239 | PetscReal w; | |||
240 | ||||
241 | if (isAffine) { | |||
242 | CoordinatesRefToReal(dE, dim, fegeom.xi, &cgeom->v[e*dE], fegeom.J, &quadPoints[q*dim], x); | |||
243 | } else { | |||
244 | fegeom.v = &cgeom->v[(e*Np+q)*dE]; | |||
245 | fegeom.J = &cgeom->J[(e*Np+q)*dE*dE]; | |||
246 | fegeom.invJ = &cgeom->invJ[(e*Np+q)*dE*dE]; | |||
247 | fegeom.detJ = &cgeom->detJ[e*Np+q]; | |||
248 | } | |||
249 | w = fegeom.detJ[0]*quadWeights[q]; | |||
250 | if (debug > 1 && q < Np) { | |||
251 | ierr = PetscPrintf(PETSC_COMM_SELF((MPI_Comm)0x44000001), " detJ: %g\n", fegeom.detJ[0]);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),251,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
252 | #if !defined(PETSC_USE_COMPLEX) | |||
253 | ierr = DMPrintCellMatrix(e, "invJ", dim, dim, fegeom.invJ);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),253,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
254 | #endif | |||
255 | } | |||
256 | if (debug) {ierr = PetscPrintf(PETSC_COMM_SELF((MPI_Comm)0x44000001), " quad point %d\n", q);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),256,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
257 | ierr = PetscFEEvaluateFieldJets_Internal(ds, dim, Nf, Nb, Nc, q, B, D, &fegeom, &coefficients[cOffset], NULL((void*)0), u, u_x, NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),257,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
258 | if (dsAux) {ierr = PetscFEEvaluateFieldJets_Internal(dsAux, dim, NfAux, NbAux, NcAux, q, BAux, DAux, &fegeom, &coefficientsAux[cOffsetAux], NULL((void*)0), a, a_x, NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),258,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
259 | obj_func(dim, Nf, NfAux, uOff, uOff_x, u, NULL((void*)0), u_x, aOff, aOff_x, a, NULL((void*)0), a_x, 0.0, fegeom.v, numConstants, constants, &integrand); | |||
260 | integrand *= w; | |||
261 | integral[e*Nf+field] += integrand; | |||
262 | if (debug > 1) {ierr = PetscPrintf(PETSC_COMM_SELF((MPI_Comm)0x44000001), " int: %g %g\n", (double) PetscRealPart(integrand)(integrand), (double) PetscRealPart(integral[field])(integral[field]));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),262,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
263 | } | |||
264 | cOffset += totDim; | |||
265 | cOffsetAux += totDimAux; | |||
266 | } | |||
267 | 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); | |||
268 | } | |||
269 | ||||
270 | PetscErrorCode PetscFEIntegrateBd_Basic(PetscDS ds, PetscInt field, | |||
271 | PetscBdPointFunc obj_func, | |||
272 | PetscInt Ne, PetscFEGeom *fgeom, const PetscScalar coefficients[], PetscDS dsAux, const PetscScalar coefficientsAux[], PetscScalar integral[]) | |||
273 | { | |||
274 | const PetscInt debug = 0; | |||
275 | PetscFE fe; | |||
276 | PetscQuadrature quad; | |||
277 | PetscScalar *u, *u_x, *a, *a_x, *basisReal, *basisDerReal; | |||
278 | const PetscScalar *constants; | |||
279 | PetscReal *x; | |||
280 | PetscReal **B, **D, **BAux = NULL((void*)0), **DAux = NULL((void*)0); | |||
281 | PetscInt *uOff, *uOff_x, *aOff = NULL((void*)0), *aOff_x = NULL((void*)0), *Nb, *Nc, *NbAux = NULL((void*)0), *NcAux = NULL((void*)0); | |||
282 | PetscBool isAffine, auxOnBd; | |||
283 | const PetscReal *quadPoints, *quadWeights; | |||
284 | PetscInt qNc, Nq, q, Np, dE; | |||
285 | PetscInt dim, dimAux, numConstants, Nf, NfAux = 0, totDim, totDimAux = 0, cOffset = 0, cOffsetAux = 0, e; | |||
286 | PetscErrorCode ierr; | |||
287 | ||||
288 | PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize < 64)) { petscstack->function[petscstack->currentsize ] = __func__; petscstack->file[petscstack->currentsize] = "/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ; petscstack->line[petscstack->currentsize] = 288; petscstack ->petscroutine[petscstack->currentsize] = PETSC_TRUE; petscstack ->currentsize++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE || petscstack->hotdepth); } ; } while (0) ; ; } while (0); | |||
289 | if (!obj_func) 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); | |||
290 | ierr = PetscDSGetDiscretization(ds, field, (PetscObject *) &fe);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),290,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
291 | ierr = PetscFEGetSpatialDimension(fe, &dim);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),291,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
292 | ierr = PetscFEGetFaceQuadrature(fe, &quad);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),292,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
293 | ierr = PetscDSGetNumFields(ds, &Nf);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),293,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
294 | ierr = PetscDSGetTotalDimension(ds, &totDim);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),294,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
295 | ierr = PetscDSGetDimensions(ds, &Nb);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),295,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
296 | ierr = PetscDSGetComponents(ds, &Nc);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),296,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
297 | ierr = PetscDSGetComponentOffsets(ds, &uOff);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),297,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
298 | ierr = PetscDSGetComponentDerivativeOffsets(ds, &uOff_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),298,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
299 | ierr = PetscDSGetEvaluationArrays(ds, &u, NULL((void*)0), &u_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),299,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
300 | ierr = PetscDSGetWorkspace(ds, &x, &basisReal, &basisDerReal, NULL((void*)0), NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),300,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
301 | ierr = PetscDSGetFaceTabulation(ds, &B, &D);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),301,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
302 | ierr = PetscDSGetConstants(ds, &numConstants, &constants);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),302,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
303 | if (dsAux) { | |||
304 | ierr = PetscDSGetSpatialDimension(dsAux, &dimAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),304,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
305 | ierr = PetscDSGetNumFields(dsAux, &NfAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),305,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
306 | ierr = PetscDSGetTotalDimension(dsAux, &totDimAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),306,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
307 | ierr = PetscDSGetDimensions(dsAux, &NbAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),307,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
308 | ierr = PetscDSGetComponents(dsAux, &NcAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),308,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
309 | ierr = PetscDSGetComponentOffsets(dsAux, &aOff);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),309,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
310 | ierr = PetscDSGetComponentDerivativeOffsets(dsAux, &aOff_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),310,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
311 | ierr = PetscDSGetEvaluationArrays(dsAux, &a, NULL((void*)0), &a_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),311,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
312 | auxOnBd = dimAux < dim ? PETSC_TRUE : PETSC_FALSE; | |||
313 | if (auxOnBd) {ierr = PetscDSGetTabulation(dsAux, &BAux, &DAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),313,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
314 | else {ierr = PetscDSGetFaceTabulation(dsAux, &BAux, &DAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),314,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
315 | } | |||
316 | ierr = PetscQuadratureGetData(quad, NULL((void*)0), &qNc, &Nq, &quadPoints, &quadWeights);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),316,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
317 | if (qNc != 1) SETERRQ1(PETSC_COMM_SELF, PETSC_ERR_SUP, "Only supports scalar quadrature, not %D components\n", qNc)return PetscError(((MPI_Comm)0x44000001),317,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,56,PETSC_ERROR_INITIAL,"Only supports scalar quadrature, not %D components\n" ,qNc); | |||
318 | Np = fgeom->numPoints; | |||
319 | dE = fgeom->dimEmbed; | |||
320 | isAffine = fgeom->isAffine; | |||
321 | for (e = 0; e < Ne; ++e) { | |||
322 | PetscFEGeom fegeom, cgeom; | |||
323 | const PetscInt face = fgeom->face[e][0]; /* Local face number in cell */ | |||
324 | fegeom.n = 0; | |||
325 | fegeom.v = 0; | |||
326 | fegeom.J = 0; | |||
327 | fegeom.detJ = 0; | |||
328 | if (isAffine) { | |||
329 | fegeom.v = x; | |||
330 | fegeom.xi = fgeom->xi; | |||
331 | fegeom.J = &fgeom->J[e*dE*dE]; | |||
332 | fegeom.invJ = &fgeom->invJ[e*dE*dE]; | |||
333 | fegeom.detJ = &fgeom->detJ[e]; | |||
334 | fegeom.n = &fgeom->n[e*dE]; | |||
335 | ||||
336 | cgeom.J = &fgeom->suppJ[0][e*dE*dE]; | |||
337 | cgeom.invJ = &fgeom->suppInvJ[0][e*dE*dE]; | |||
338 | cgeom.detJ = &fgeom->suppDetJ[0][e]; | |||
339 | } | |||
340 | for (q = 0; q < Nq; ++q) { | |||
341 | PetscScalar integrand; | |||
342 | PetscReal w; | |||
343 | ||||
344 | if (isAffine) { | |||
345 | CoordinatesRefToReal(dE, dim-1, fegeom.xi, &fgeom->v[e*dE], fegeom.J, &quadPoints[q*(dim-1)], x); | |||
346 | } else { | |||
347 | fegeom.v = &fgeom->v[(e*Np+q)*dE]; | |||
348 | fegeom.J = &fgeom->J[(e*Np+q)*dE*dE]; | |||
349 | fegeom.invJ = &fgeom->invJ[(e*Np+q)*dE*dE]; | |||
350 | fegeom.detJ = &fgeom->detJ[e*Np+q]; | |||
351 | fegeom.n = &fgeom->n[(e*Np+q)*dE]; | |||
352 | ||||
353 | cgeom.J = &fgeom->suppJ[0][(e*Np+q)*dE*dE]; | |||
354 | cgeom.invJ = &fgeom->suppInvJ[0][(e*Np+q)*dE*dE]; | |||
355 | cgeom.detJ = &fgeom->suppDetJ[0][e*Np+q]; | |||
356 | } | |||
357 | w = fegeom.detJ[0]*quadWeights[q]; | |||
358 | if (debug > 1 && q < Np) { | |||
359 | ierr = PetscPrintf(PETSC_COMM_SELF((MPI_Comm)0x44000001), " detJ: %g\n", fegeom.detJ[0]);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),359,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
360 | #ifndef PETSC_USE_COMPLEX | |||
361 | ierr = DMPrintCellMatrix(e, "invJ", dim, dim, fegeom.invJ);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),361,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
362 | #endif | |||
363 | } | |||
364 | if (debug > 1) {ierr = PetscPrintf(PETSC_COMM_SELF((MPI_Comm)0x44000001), " quad point %d\n", q);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),364,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
365 | ierr = PetscFEEvaluateFieldJets_Internal(ds, dim, Nf, Nb, Nc, face*Nq+q, B, D, &cgeom, &coefficients[cOffset], NULL((void*)0), u, u_x, NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),365,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
366 | if (dsAux) {ierr = PetscFEEvaluateFieldJets_Internal(dsAux, dimAux, NfAux, NbAux, NcAux, face*Nq+q, BAux, DAux, &cgeom, &coefficientsAux[cOffsetAux], NULL((void*)0), a, a_x, NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),366,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
367 | obj_func(dim, Nf, NfAux, uOff, uOff_x, u, NULL((void*)0), u_x, aOff, aOff_x, a, NULL((void*)0), a_x, 0.0, fegeom.v, fegeom.n, numConstants, constants, &integrand); | |||
368 | integrand *= w; | |||
369 | integral[e*Nf+field] += integrand; | |||
370 | if (debug > 1) {ierr = PetscPrintf(PETSC_COMM_SELF((MPI_Comm)0x44000001), " int: %g %g\n", (double) PetscRealPart(integrand)(integrand), (double) PetscRealPart(integral[e*Nf+field])(integral[e*Nf+field]));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),370,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
371 | } | |||
372 | cOffset += totDim; | |||
373 | cOffsetAux += totDimAux; | |||
374 | } | |||
375 | 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); | |||
376 | } | |||
377 | ||||
378 | PetscErrorCode PetscFEIntegrateResidual_Basic(PetscDS ds, PetscInt field, PetscInt Ne, PetscFEGeom *cgeom, | |||
379 | const PetscScalar coefficients[], const PetscScalar coefficients_t[], PetscDS dsAux, const PetscScalar coefficientsAux[], PetscReal t, PetscScalar elemVec[]) | |||
380 | { | |||
381 | const PetscInt debug = 0; | |||
382 | PetscFE fe; | |||
383 | PetscPointFunc f0_func; | |||
384 | PetscPointFunc f1_func; | |||
385 | PetscQuadrature quad; | |||
386 | PetscScalar *f0, *f1, *u, *u_t = NULL((void*)0), *u_x, *a, *a_x, *basisReal, *basisDerReal; | |||
| ||||
387 | const PetscScalar *constants; | |||
388 | PetscReal *x; | |||
389 | PetscReal **B, **D, **BAux = NULL((void*)0), **DAux = NULL((void*)0), *BI, *DI; | |||
390 | PetscInt *uOff, *uOff_x, *aOff = NULL((void*)0), *aOff_x = NULL((void*)0), *Nb, *Nc, *NbAux = NULL((void*)0), *NcAux = NULL((void*)0); | |||
391 | PetscInt dim, numConstants, Nf, NfAux = 0, totDim, totDimAux = 0, cOffset = 0, cOffsetAux = 0, fOffset, e, NbI, NcI; | |||
392 | PetscBool isAffine; | |||
393 | const PetscReal *quadPoints, *quadWeights; | |||
394 | PetscInt qNc, Nq, q, Np, dE; | |||
395 | PetscErrorCode ierr; | |||
396 | ||||
397 | PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize < 64)) { petscstack->function[petscstack->currentsize ] = __func__; petscstack->file[petscstack->currentsize] = "/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ; petscstack->line[petscstack->currentsize] = 397; petscstack ->petscroutine[petscstack->currentsize] = PETSC_TRUE; petscstack ->currentsize++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE || petscstack->hotdepth); } ; } while (0) ; ; } while (0); | |||
398 | ierr = PetscDSGetDiscretization(ds, field, (PetscObject *) &fe);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),398,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
399 | ierr = PetscFEGetSpatialDimension(fe, &dim);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),399,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
400 | ierr = PetscFEGetQuadrature(fe, &quad);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),400,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
401 | ierr = PetscDSGetNumFields(ds, &Nf);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),401,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
402 | ierr = PetscDSGetTotalDimension(ds, &totDim);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),402,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
403 | ierr = PetscDSGetDimensions(ds, &Nb);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),403,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
404 | ierr = PetscDSGetComponents(ds, &Nc);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),404,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
405 | ierr = PetscDSGetComponentOffsets(ds, &uOff);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),405,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
406 | ierr = PetscDSGetComponentDerivativeOffsets(ds, &uOff_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),406,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
407 | ierr = PetscDSGetFieldOffset(ds, field, &fOffset);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),407,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
408 | ierr = PetscDSGetResidual(ds, field, &f0_func, &f1_func);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),408,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
409 | ierr = PetscDSGetEvaluationArrays(ds, &u, coefficients_t ? &u_t : NULL((void*)0), &u_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),409,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
410 | ierr = PetscDSGetWorkspace(ds, &x, &basisReal, &basisDerReal, NULL((void*)0), NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),410,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
411 | ierr = PetscDSGetWeakFormArrays(ds, &f0, &f1, NULL((void*)0), NULL((void*)0), NULL((void*)0), NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),411,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
412 | if (!f0_func && !f1_func) 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); | |||
413 | ierr = PetscDSGetTabulation(ds, &B, &D);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),413,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
414 | ierr = PetscDSGetConstants(ds, &numConstants, &constants);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),414,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
415 | if (dsAux) { | |||
416 | ierr = PetscDSGetNumFields(dsAux, &NfAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),416,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
417 | ierr = PetscDSGetTotalDimension(dsAux, &totDimAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),417,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
418 | ierr = PetscDSGetDimensions(dsAux, &NbAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),418,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
419 | ierr = PetscDSGetComponents(dsAux, &NcAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),419,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
420 | ierr = PetscDSGetComponentOffsets(dsAux, &aOff);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),420,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
421 | ierr = PetscDSGetComponentDerivativeOffsets(dsAux, &aOff_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),421,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
422 | ierr = PetscDSGetEvaluationArrays(dsAux, &a, NULL((void*)0), &a_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),422,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
423 | ierr = PetscDSGetTabulation(dsAux, &BAux, &DAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),423,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
424 | } | |||
425 | NbI = Nb[field]; | |||
426 | NcI = Nc[field]; | |||
427 | BI = B[field]; | |||
428 | DI = D[field]; | |||
429 | ierr = PetscQuadratureGetData(quad, NULL((void*)0), &qNc, &Nq, &quadPoints, &quadWeights);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),429,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
430 | if (qNc != 1) SETERRQ1(PETSC_COMM_SELF, PETSC_ERR_SUP, "Only supports scalar quadrature, not %D components\n", qNc)return PetscError(((MPI_Comm)0x44000001),430,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,56,PETSC_ERROR_INITIAL,"Only supports scalar quadrature, not %D components\n" ,qNc); | |||
431 | Np = cgeom->numPoints; | |||
432 | dE = cgeom->dimEmbed; | |||
433 | isAffine = cgeom->isAffine; | |||
434 | for (e = 0; e < Ne; ++e) { | |||
435 | PetscFEGeom fegeom; | |||
436 | ||||
437 | if (isAffine) { | |||
438 | fegeom.v = x; | |||
439 | fegeom.xi = cgeom->xi; | |||
440 | fegeom.J = &cgeom->J[e*dE*dE]; | |||
441 | fegeom.invJ = &cgeom->invJ[e*dE*dE]; | |||
442 | fegeom.detJ = &cgeom->detJ[e]; | |||
443 | } | |||
444 | ierr = PetscArrayzero(f0, Nq*NcI)PetscMemzero(f0,(Nq*NcI)*sizeof(*(f0)));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),444,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
445 | ierr = PetscArrayzero(f1, Nq*NcI*dim)PetscMemzero(f1,(Nq*NcI*dim)*sizeof(*(f1)));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),445,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
446 | for (q = 0; q < Nq; ++q) { | |||
447 | PetscReal w; | |||
448 | PetscInt c, d; | |||
449 | ||||
450 | if (isAffine) { | |||
451 | CoordinatesRefToReal(dE, dim, fegeom.xi, &cgeom->v[e*dE], fegeom.J, &quadPoints[q*dim], x); | |||
452 | } else { | |||
453 | fegeom.v = &cgeom->v[(e*Np+q)*dE]; | |||
454 | fegeom.J = &cgeom->J[(e*Np+q)*dE*dE]; | |||
455 | fegeom.invJ = &cgeom->invJ[(e*Np+q)*dE*dE]; | |||
456 | fegeom.detJ = &cgeom->detJ[e*Np+q]; | |||
457 | } | |||
458 | w = fegeom.detJ[0]*quadWeights[q]; | |||
459 | if (debug > 1 && q < Np) { | |||
460 | ierr = PetscPrintf(PETSC_COMM_SELF((MPI_Comm)0x44000001), " detJ: %g\n", fegeom.detJ[0]);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),460,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
461 | #if !defined(PETSC_USE_COMPLEX) | |||
462 | ierr = DMPrintCellMatrix(e, "invJ", dim, dim, fegeom.invJ);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),462,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
463 | #endif | |||
464 | } | |||
465 | if (debug) {ierr = PetscPrintf(PETSC_COMM_SELF((MPI_Comm)0x44000001), " quad point %d\n", q);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),465,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
466 | ierr = PetscFEEvaluateFieldJets_Internal(ds, dim, Nf, Nb, Nc, q, B, D, &fegeom, &coefficients[cOffset], &coefficients_t[cOffset], u, u_x, u_t);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),466,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
467 | if (dsAux) {ierr = PetscFEEvaluateFieldJets_Internal(dsAux, dim, NfAux, NbAux, NcAux, q, BAux, DAux, &fegeom, &coefficientsAux[cOffsetAux], NULL((void*)0), a, a_x, NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),467,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
468 | if (f0_func) { | |||
469 | f0_func(dim, Nf, NfAux, uOff, uOff_x, u, u_t, u_x, aOff, aOff_x, a, NULL((void*)0), a_x, t, fegeom.v, numConstants, constants, &f0[q*NcI]); | |||
| ||||
470 | for (c = 0; c < NcI; ++c) f0[q*NcI+c] *= w; | |||
471 | } | |||
472 | if (f1_func) { | |||
473 | f1_func(dim, Nf, NfAux, uOff, uOff_x, u, u_t, u_x, aOff, aOff_x, a, NULL((void*)0), a_x, t, fegeom.v, numConstants, constants, &f1[q*NcI*dim]); | |||
474 | for (c = 0; c < NcI; ++c) for (d = 0; d < dim; ++d) f1[(q*NcI+c)*dim+d] *= w; | |||
475 | } | |||
476 | } | |||
477 | ierr = PetscFEUpdateElementVec_Internal(fe, dim, Nq, NbI, NcI, BI, DI, basisReal, basisDerReal, &fegeom, f0, f1, &elemVec[cOffset+fOffset]);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),477,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
478 | cOffset += totDim; | |||
479 | cOffsetAux += totDimAux; | |||
480 | } | |||
481 | 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); | |||
482 | } | |||
483 | ||||
484 | PetscErrorCode PetscFEIntegrateBdResidual_Basic(PetscDS ds, PetscInt field, PetscInt Ne, PetscFEGeom *fgeom, | |||
485 | const PetscScalar coefficients[], const PetscScalar coefficients_t[], PetscDS dsAux, const PetscScalar coefficientsAux[], PetscReal t, PetscScalar elemVec[]) | |||
486 | { | |||
487 | const PetscInt debug = 0; | |||
488 | PetscFE fe; | |||
489 | PetscBdPointFunc f0_func; | |||
490 | PetscBdPointFunc f1_func; | |||
491 | PetscQuadrature quad; | |||
492 | PetscScalar *f0, *f1, *u, *u_t = NULL((void*)0), *u_x, *a, *a_x, *basisReal, *basisDerReal; | |||
493 | const PetscScalar *constants; | |||
494 | PetscReal *x; | |||
495 | PetscReal **B, **D, **BAux = NULL((void*)0), **DAux = NULL((void*)0), *BI, *DI; | |||
496 | PetscInt *uOff, *uOff_x, *aOff = NULL((void*)0), *aOff_x = NULL((void*)0), *Nb, *Nc, *NbAux = NULL((void*)0), *NcAux = NULL((void*)0); | |||
497 | PetscInt dim, dimAux, numConstants, Nf, NfAux = 0, totDim, totDimAux = 0, cOffset = 0, cOffsetAux = 0, fOffset, e, NbI, NcI; | |||
498 | PetscBool isAffine, auxOnBd = PETSC_FALSE; | |||
499 | const PetscReal *quadPoints, *quadWeights; | |||
500 | PetscInt qNc, Nq, q, Np, dE; | |||
501 | PetscErrorCode ierr; | |||
502 | ||||
503 | PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize < 64)) { petscstack->function[petscstack->currentsize ] = __func__; petscstack->file[petscstack->currentsize] = "/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ; petscstack->line[petscstack->currentsize] = 503; petscstack ->petscroutine[petscstack->currentsize] = PETSC_TRUE; petscstack ->currentsize++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE || petscstack->hotdepth); } ; } while (0) ; ; } while (0); | |||
504 | ierr = PetscDSGetDiscretization(ds, field, (PetscObject *) &fe);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),504,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
505 | ierr = PetscFEGetSpatialDimension(fe, &dim);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),505,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
506 | ierr = PetscFEGetFaceQuadrature(fe, &quad);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),506,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
507 | ierr = PetscDSGetNumFields(ds, &Nf);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),507,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
508 | ierr = PetscDSGetTotalDimension(ds, &totDim);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),508,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
509 | ierr = PetscDSGetDimensions(ds, &Nb);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),509,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
510 | ierr = PetscDSGetComponents(ds, &Nc);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),510,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
511 | ierr = PetscDSGetComponentOffsets(ds, &uOff);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),511,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
512 | ierr = PetscDSGetComponentDerivativeOffsets(ds, &uOff_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),512,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
513 | ierr = PetscDSGetFieldOffset(ds, field, &fOffset);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),513,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
514 | ierr = PetscDSGetBdResidual(ds, field, &f0_func, &f1_func);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),514,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
515 | if (!f0_func && !f1_func) 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); | |||
516 | ierr = PetscDSGetEvaluationArrays(ds, &u, coefficients_t ? &u_t : NULL((void*)0), &u_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),516,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
517 | ierr = PetscDSGetWorkspace(ds, &x, &basisReal, &basisDerReal, NULL((void*)0), NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),517,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
518 | ierr = PetscDSGetWeakFormArrays(ds, &f0, &f1, NULL((void*)0), NULL((void*)0), NULL((void*)0), NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),518,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
519 | ierr = PetscDSGetFaceTabulation(ds, &B, &D);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),519,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
520 | ierr = PetscDSGetConstants(ds, &numConstants, &constants);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),520,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
521 | if (dsAux) { | |||
522 | ierr = PetscDSGetSpatialDimension(dsAux, &dimAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),522,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
523 | ierr = PetscDSGetNumFields(dsAux, &NfAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),523,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
524 | ierr = PetscDSGetTotalDimension(dsAux, &totDimAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),524,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
525 | ierr = PetscDSGetDimensions(dsAux, &NbAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),525,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
526 | ierr = PetscDSGetComponents(dsAux, &NcAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),526,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
527 | ierr = PetscDSGetComponentOffsets(dsAux, &aOff);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),527,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
528 | ierr = PetscDSGetComponentDerivativeOffsets(dsAux, &aOff_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),528,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
529 | ierr = PetscDSGetEvaluationArrays(dsAux, &a, NULL((void*)0), &a_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),529,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
530 | auxOnBd = dimAux < dim ? PETSC_TRUE : PETSC_FALSE; | |||
531 | if (auxOnBd) {ierr = PetscDSGetTabulation(dsAux, &BAux, &DAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),531,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
532 | else {ierr = PetscDSGetFaceTabulation(dsAux, &BAux, &DAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),532,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
533 | } | |||
534 | NbI = Nb[field]; | |||
535 | NcI = Nc[field]; | |||
536 | BI = B[field]; | |||
537 | DI = D[field]; | |||
538 | ierr = PetscQuadratureGetData(quad, NULL((void*)0), &qNc, &Nq, &quadPoints, &quadWeights);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),538,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
539 | if (qNc != 1) SETERRQ1(PETSC_COMM_SELF, PETSC_ERR_SUP, "Only supports scalar quadrature, not %D components\n", qNc)return PetscError(((MPI_Comm)0x44000001),539,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,56,PETSC_ERROR_INITIAL,"Only supports scalar quadrature, not %D components\n" ,qNc); | |||
540 | Np = fgeom->numPoints; | |||
541 | dE = fgeom->dimEmbed; | |||
542 | isAffine = fgeom->isAffine; | |||
543 | for (e = 0; e < Ne; ++e) { | |||
544 | PetscFEGeom fegeom, cgeom; | |||
545 | const PetscInt face = fgeom->face[e][0]; | |||
546 | fegeom.n = 0; | |||
547 | fegeom.v = 0; | |||
548 | fegeom.J = 0; | |||
549 | fegeom.detJ = 0; | |||
550 | if (isAffine) { | |||
551 | fegeom.v = x; | |||
552 | fegeom.xi = fgeom->xi; | |||
553 | fegeom.J = &fgeom->J[e*dE*dE]; | |||
554 | fegeom.invJ = &fgeom->invJ[e*dE*dE]; | |||
555 | fegeom.detJ = &fgeom->detJ[e]; | |||
556 | fegeom.n = &fgeom->n[e*dE]; | |||
557 | ||||
558 | cgeom.J = &fgeom->suppJ[0][e*dE*dE]; | |||
559 | cgeom.invJ = &fgeom->suppInvJ[0][e*dE*dE]; | |||
560 | cgeom.detJ = &fgeom->suppDetJ[0][e]; | |||
561 | } | |||
562 | ierr = PetscArrayzero(f0, Nq*NcI)PetscMemzero(f0,(Nq*NcI)*sizeof(*(f0)));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),562,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
563 | ierr = PetscArrayzero(f1, Nq*NcI*dim)PetscMemzero(f1,(Nq*NcI*dim)*sizeof(*(f1)));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),563,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
564 | for (q = 0; q < Nq; ++q) { | |||
565 | PetscReal w; | |||
566 | PetscInt c, d; | |||
567 | ||||
568 | if (isAffine) { | |||
569 | CoordinatesRefToReal(dE, dim-1, fegeom.xi, &fgeom->v[e*dE], fegeom.J, &quadPoints[q*(dim-1)], x); | |||
570 | } else { | |||
571 | fegeom.v = &fgeom->v[(e*Np+q)*dE]; | |||
572 | fegeom.J = &fgeom->J[(e*Np+q)*dE*dE]; | |||
573 | fegeom.invJ = &fgeom->invJ[(e*Np+q)*dE*dE]; | |||
574 | fegeom.detJ = &fgeom->detJ[e*Np+q]; | |||
575 | fegeom.n = &fgeom->n[(e*Np+q)*dE]; | |||
576 | ||||
577 | cgeom.J = &fgeom->suppJ[0][(e*Np+q)*dE*dE]; | |||
578 | cgeom.invJ = &fgeom->suppInvJ[0][(e*Np+q)*dE*dE]; | |||
579 | cgeom.detJ = &fgeom->suppDetJ[0][e*Np+q]; | |||
580 | } | |||
581 | w = fegeom.detJ[0]*quadWeights[q]; | |||
582 | if (debug > 1 && q < Np) { | |||
583 | ierr = PetscPrintf(PETSC_COMM_SELF((MPI_Comm)0x44000001), " detJ: %g\n", fegeom.detJ[0]);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),583,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
584 | #if !defined(PETSC_USE_COMPLEX) | |||
585 | ierr = DMPrintCellMatrix(e, "invJ", dim, dim, fegeom.invJ);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),585,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
586 | #endif | |||
587 | } | |||
588 | if (debug) {ierr = PetscPrintf(PETSC_COMM_SELF((MPI_Comm)0x44000001), " quad point %d\n", q);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),588,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
589 | ierr = PetscFEEvaluateFieldJets_Internal(ds, dim, Nf, Nb, Nc, face*Nq+q, B, D, &cgeom, &coefficients[cOffset], &coefficients_t[cOffset], u, u_x, u_t);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),589,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
590 | if (dsAux) {ierr = PetscFEEvaluateFieldJets_Internal(dsAux, dimAux, NfAux, NbAux, NcAux, auxOnBd ? q : face*Nq+q, BAux, DAux, &cgeom, &coefficientsAux[cOffsetAux], NULL((void*)0), a, a_x, NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),590,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
591 | if (f0_func) { | |||
592 | f0_func(dim, Nf, NfAux, uOff, uOff_x, u, u_t, u_x, aOff, aOff_x, a, NULL((void*)0), a_x, t, fegeom.v, fegeom.n, numConstants, constants, &f0[q*NcI]); | |||
593 | for (c = 0; c < NcI; ++c) f0[q*NcI+c] *= w; | |||
594 | } | |||
595 | if (f1_func) { | |||
596 | f1_func(dim, Nf, NfAux, uOff, uOff_x, u, u_t, u_x, aOff, aOff_x, a, NULL((void*)0), a_x, t, fegeom.v, fegeom.n, numConstants, constants, &f1[q*NcI*dim]); | |||
597 | for (c = 0; c < NcI; ++c) for (d = 0; d < dim; ++d) f1[(q*NcI+c)*dim+d] *= w; | |||
598 | } | |||
599 | } | |||
600 | ierr = PetscFEUpdateElementVec_Internal(fe, dim, Nq, NbI, NcI, &BI[face*Nq*NbI*NcI], &DI[face*Nq*NbI*NcI*dim], basisReal, basisDerReal, &cgeom, f0, f1, &elemVec[cOffset+fOffset]);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),600,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
601 | cOffset += totDim; | |||
602 | cOffsetAux += totDimAux; | |||
603 | } | |||
604 | 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); | |||
605 | } | |||
606 | ||||
607 | PetscErrorCode PetscFEIntegrateJacobian_Basic(PetscDS ds, PetscFEJacobianType jtype, PetscInt fieldI, PetscInt fieldJ, PetscInt Ne, PetscFEGeom *cgeom, | |||
608 | const PetscScalar coefficients[], const PetscScalar coefficients_t[], PetscDS dsAux, const PetscScalar coefficientsAux[], PetscReal t, PetscReal u_tshift, PetscScalar elemMat[]) | |||
609 | { | |||
610 | const PetscInt debug = 0; | |||
611 | PetscFE feI, feJ; | |||
612 | PetscPointJac g0_func, g1_func, g2_func, g3_func; | |||
613 | PetscInt cOffset = 0; /* Offset into coefficients[] for element e */ | |||
614 | PetscInt cOffsetAux = 0; /* Offset into coefficientsAux[] for element e */ | |||
615 | PetscInt eOffset = 0; /* Offset into elemMat[] for element e */ | |||
616 | PetscInt offsetI = 0; /* Offset into an element vector for fieldI */ | |||
617 | PetscInt offsetJ = 0; /* Offset into an element vector for fieldJ */ | |||
618 | PetscQuadrature quad; | |||
619 | PetscScalar *g0, *g1, *g2, *g3, *u, *u_t = NULL((void*)0), *u_x, *a, *a_x, *basisReal, *basisDerReal, *testReal, *testDerReal; | |||
620 | const PetscScalar *constants; | |||
621 | PetscReal *x; | |||
622 | PetscReal **B, **D, **BAux = NULL((void*)0), **DAux = NULL((void*)0), *BI, *DI, *BJ, *DJ; | |||
623 | PetscInt *uOff, *uOff_x, *aOff = NULL((void*)0), *aOff_x = NULL((void*)0), *Nb, *Nc, *NbAux = NULL((void*)0), *NcAux = NULL((void*)0); | |||
624 | PetscInt NbI = 0, NcI = 0, NbJ = 0, NcJ = 0; | |||
625 | PetscInt dim, numConstants, Nf, NfAux = 0, totDim, totDimAux = 0, e; | |||
626 | PetscInt dE, Np; | |||
627 | PetscBool isAffine; | |||
628 | const PetscReal *quadPoints, *quadWeights; | |||
629 | PetscInt qNc, Nq, q; | |||
630 | PetscErrorCode ierr; | |||
631 | ||||
632 | PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize < 64)) { petscstack->function[petscstack->currentsize ] = __func__; petscstack->file[petscstack->currentsize] = "/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ; petscstack->line[petscstack->currentsize] = 632; petscstack ->petscroutine[petscstack->currentsize] = PETSC_TRUE; petscstack ->currentsize++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE || petscstack->hotdepth); } ; } while (0) ; ; } while (0); | |||
633 | ierr = PetscDSGetDiscretization(ds, fieldI, (PetscObject *) &feI);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),633,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
634 | ierr = PetscDSGetDiscretization(ds, fieldJ, (PetscObject *) &feJ);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),634,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
635 | ierr = PetscFEGetSpatialDimension(feI, &dim);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),635,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
636 | ierr = PetscFEGetQuadrature(feI, &quad);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),636,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
637 | ierr = PetscDSGetNumFields(ds, &Nf);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),637,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
638 | ierr = PetscDSGetTotalDimension(ds, &totDim);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),638,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
639 | ierr = PetscDSGetDimensions(ds, &Nb);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),639,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
640 | ierr = PetscDSGetComponents(ds, &Nc);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),640,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
641 | ierr = PetscDSGetComponentOffsets(ds, &uOff);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),641,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
642 | ierr = PetscDSGetComponentDerivativeOffsets(ds, &uOff_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),642,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
643 | switch(jtype) { | |||
644 | case PETSCFE_JACOBIAN_DYN: ierr = PetscDSGetDynamicJacobian(ds, fieldI, fieldJ, &g0_func, &g1_func, &g2_func, &g3_func);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),644,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);break; | |||
645 | case PETSCFE_JACOBIAN_PRE: ierr = PetscDSGetJacobianPreconditioner(ds, fieldI, fieldJ, &g0_func, &g1_func, &g2_func, &g3_func);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),645,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);break; | |||
646 | case PETSCFE_JACOBIAN: ierr = PetscDSGetJacobian(ds, fieldI, fieldJ, &g0_func, &g1_func, &g2_func, &g3_func);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),646,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);break; | |||
647 | } | |||
648 | if (!g0_func && !g1_func && !g2_func && !g3_func) 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); | |||
649 | ierr = PetscDSGetEvaluationArrays(ds, &u, coefficients_t ? &u_t : NULL((void*)0), &u_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),649,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
650 | ierr = PetscDSGetWorkspace(ds, &x, &basisReal, &basisDerReal, &testReal, &testDerReal);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),650,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
651 | ierr = PetscDSGetWeakFormArrays(ds, NULL((void*)0), NULL((void*)0), &g0, &g1, &g2, &g3);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),651,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
652 | ierr = PetscDSGetTabulation(ds, &B, &D);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),652,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
653 | ierr = PetscDSGetFieldOffset(ds, fieldI, &offsetI);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),653,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
654 | ierr = PetscDSGetFieldOffset(ds, fieldJ, &offsetJ);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),654,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
655 | ierr = PetscDSGetConstants(ds, &numConstants, &constants);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),655,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
656 | if (dsAux) { | |||
657 | ierr = PetscDSGetNumFields(dsAux, &NfAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),657,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
658 | ierr = PetscDSGetTotalDimension(dsAux, &totDimAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),658,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
659 | ierr = PetscDSGetDimensions(dsAux, &NbAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),659,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
660 | ierr = PetscDSGetComponents(dsAux, &NcAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),660,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
661 | ierr = PetscDSGetComponentOffsets(dsAux, &aOff);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),661,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
662 | ierr = PetscDSGetComponentDerivativeOffsets(dsAux, &aOff_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),662,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
663 | ierr = PetscDSGetEvaluationArrays(dsAux, &a, NULL((void*)0), &a_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),663,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
664 | ierr = PetscDSGetTabulation(dsAux, &BAux, &DAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),664,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
665 | } | |||
666 | NbI = Nb[fieldI], NbJ = Nb[fieldJ]; | |||
667 | NcI = Nc[fieldI], NcJ = Nc[fieldJ]; | |||
668 | BI = B[fieldI], BJ = B[fieldJ]; | |||
669 | DI = D[fieldI], DJ = D[fieldJ]; | |||
670 | /* Initialize here in case the function is not defined */ | |||
671 | ierr = PetscArrayzero(g0, NcI*NcJ)PetscMemzero(g0,(NcI*NcJ)*sizeof(*(g0)));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),671,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
672 | ierr = PetscArrayzero(g1, NcI*NcJ*dim)PetscMemzero(g1,(NcI*NcJ*dim)*sizeof(*(g1)));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),672,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
673 | ierr = PetscArrayzero(g2, NcI*NcJ*dim)PetscMemzero(g2,(NcI*NcJ*dim)*sizeof(*(g2)));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),673,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
674 | ierr = PetscArrayzero(g3, NcI*NcJ*dim*dim)PetscMemzero(g3,(NcI*NcJ*dim*dim)*sizeof(*(g3)));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),674,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
675 | ierr = PetscQuadratureGetData(quad, NULL((void*)0), &qNc, &Nq, &quadPoints, &quadWeights);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),675,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
676 | if (qNc != 1) SETERRQ1(PETSC_COMM_SELF, PETSC_ERR_SUP, "Only supports scalar quadrature, not %D components\n", qNc)return PetscError(((MPI_Comm)0x44000001),676,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,56,PETSC_ERROR_INITIAL,"Only supports scalar quadrature, not %D components\n" ,qNc); | |||
677 | Np = cgeom->numPoints; | |||
678 | dE = cgeom->dimEmbed; | |||
679 | isAffine = cgeom->isAffine; | |||
680 | for (e = 0; e < Ne; ++e) { | |||
681 | PetscFEGeom fegeom; | |||
682 | ||||
683 | if (isAffine) { | |||
684 | fegeom.v = x; | |||
685 | fegeom.xi = cgeom->xi; | |||
686 | fegeom.J = &cgeom->J[e*dE*dE]; | |||
687 | fegeom.invJ = &cgeom->invJ[e*dE*dE]; | |||
688 | fegeom.detJ = &cgeom->detJ[e]; | |||
689 | } | |||
690 | for (q = 0; q < Nq; ++q) { | |||
691 | const PetscReal *BIq = &BI[q*NbI*NcI], *BJq = &BJ[q*NbJ*NcJ]; | |||
692 | const PetscReal *DIq = &DI[q*NbI*NcI*dim], *DJq = &DJ[q*NbJ*NcJ*dim]; | |||
693 | PetscReal w; | |||
694 | PetscInt c; | |||
695 | ||||
696 | if (debug) {ierr = PetscPrintf(PETSC_COMM_SELF((MPI_Comm)0x44000001), " quad point %d\n", q);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),696,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
697 | if (isAffine) { | |||
698 | CoordinatesRefToReal(dE, dim, fegeom.xi, &cgeom->v[e*dE], fegeom.J, &quadPoints[q*dim], x); | |||
699 | } else { | |||
700 | fegeom.v = &cgeom->v[(e*Np+q)*dE]; | |||
701 | fegeom.J = &cgeom->J[(e*Np+q)*dE*dE]; | |||
702 | fegeom.invJ = &cgeom->invJ[(e*Np+q)*dE*dE]; | |||
703 | fegeom.detJ = &cgeom->detJ[e*Np+q]; | |||
704 | } | |||
705 | w = fegeom.detJ[0]*quadWeights[q]; | |||
706 | if (coefficients) {ierr = PetscFEEvaluateFieldJets_Internal(ds, dim, Nf, Nb, Nc, q, B, D, &fegeom, &coefficients[cOffset], &coefficients_t[cOffset], u, u_x, u_t);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),706,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
707 | if (dsAux) {ierr = PetscFEEvaluateFieldJets_Internal(dsAux, dim, NfAux, NbAux, NcAux, q, BAux, DAux, &fegeom, &coefficientsAux[cOffsetAux], NULL((void*)0), a, a_x, NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),707,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
708 | if (g0_func) { | |||
709 | ierr = PetscArrayzero(g0, NcI*NcJ)PetscMemzero(g0,(NcI*NcJ)*sizeof(*(g0)));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),709,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
710 | g0_func(dim, Nf, NfAux, uOff, uOff_x, u, u_t, u_x, aOff, aOff_x, a, NULL((void*)0), a_x, t, u_tshift, fegeom.v, numConstants, constants, g0); | |||
711 | for (c = 0; c < NcI*NcJ; ++c) g0[c] *= w; | |||
712 | } | |||
713 | if (g1_func) { | |||
714 | ierr = PetscArrayzero(g1, NcI*NcJ*dim)PetscMemzero(g1,(NcI*NcJ*dim)*sizeof(*(g1)));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),714,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
715 | g1_func(dim, Nf, NfAux, uOff, uOff_x, u, u_t, u_x, aOff, aOff_x, a, NULL((void*)0), a_x, t, u_tshift, fegeom.v, numConstants, constants, g1); | |||
716 | for (c = 0; c < NcI*NcJ*dim; ++c) g1[c] *= w; | |||
717 | } | |||
718 | if (g2_func) { | |||
719 | ierr = PetscArrayzero(g2, NcI*NcJ*dim)PetscMemzero(g2,(NcI*NcJ*dim)*sizeof(*(g2)));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),719,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
720 | g2_func(dim, Nf, NfAux, uOff, uOff_x, u, u_t, u_x, aOff, aOff_x, a, NULL((void*)0), a_x, t, u_tshift, fegeom.v, numConstants, constants, g2); | |||
721 | for (c = 0; c < NcI*NcJ*dim; ++c) g2[c] *= w; | |||
722 | } | |||
723 | if (g3_func) { | |||
724 | ierr = PetscArrayzero(g3, NcI*NcJ*dim*dim)PetscMemzero(g3,(NcI*NcJ*dim*dim)*sizeof(*(g3)));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),724,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
725 | g3_func(dim, Nf, NfAux, uOff, uOff_x, u, u_t, u_x, aOff, aOff_x, a, NULL((void*)0), a_x, t, u_tshift, fegeom.v, numConstants, constants, g3); | |||
726 | for (c = 0; c < NcI*NcJ*dim*dim; ++c) g3[c] *= w; | |||
727 | } | |||
728 | ||||
729 | ierr = PetscFEUpdateElementMat_Internal(feI, feJ, dim, NbI, NcI, BIq, DIq, basisReal, basisDerReal, NbJ, NcJ, BJq, DJq, testReal, testDerReal, &fegeom, g0, g1, g2, g3, eOffset, totDim, offsetI, offsetJ, elemMat);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),729,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
730 | } | |||
731 | if (debug > 1) { | |||
732 | PetscInt fc, f, gc, g; | |||
733 | ||||
734 | ierr = PetscPrintf(PETSC_COMM_SELF((MPI_Comm)0x44000001), "Element matrix for fields %d and %d\n", fieldI, fieldJ);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),734,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
735 | for (fc = 0; fc < NcI; ++fc) { | |||
736 | for (f = 0; f < NbI; ++f) { | |||
737 | const PetscInt i = offsetI + f*NcI+fc; | |||
738 | for (gc = 0; gc < NcJ; ++gc) { | |||
739 | for (g = 0; g < NbJ; ++g) { | |||
740 | const PetscInt j = offsetJ + g*NcJ+gc; | |||
741 | ierr = PetscPrintf(PETSC_COMM_SELF((MPI_Comm)0x44000001), " elemMat[%d,%d,%d,%d]: %g\n", f, fc, g, gc, PetscRealPart(elemMat[eOffset+i*totDim+j])(elemMat[eOffset+i*totDim+j]));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),741,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
742 | } | |||
743 | } | |||
744 | ierr = PetscPrintf(PETSC_COMM_SELF((MPI_Comm)0x44000001), "\n");CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),744,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
745 | } | |||
746 | } | |||
747 | } | |||
748 | cOffset += totDim; | |||
749 | cOffsetAux += totDimAux; | |||
750 | eOffset += PetscSqr(totDim)((totDim)*(totDim)); | |||
751 | } | |||
752 | 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); | |||
753 | } | |||
754 | ||||
755 | PetscErrorCode PetscFEIntegrateBdJacobian_Basic(PetscDS ds, PetscInt fieldI, PetscInt fieldJ, PetscInt Ne, PetscFEGeom *fgeom, | |||
756 | const PetscScalar coefficients[], const PetscScalar coefficients_t[], PetscDS dsAux, const PetscScalar coefficientsAux[], PetscReal t, PetscReal u_tshift, PetscScalar elemMat[]) | |||
757 | { | |||
758 | const PetscInt debug = 0; | |||
759 | PetscFE feI, feJ; | |||
760 | PetscBdPointJac g0_func, g1_func, g2_func, g3_func; | |||
761 | PetscInt cOffset = 0; /* Offset into coefficients[] for element e */ | |||
762 | PetscInt cOffsetAux = 0; /* Offset into coefficientsAux[] for element e */ | |||
763 | PetscInt eOffset = 0; /* Offset into elemMat[] for element e */ | |||
764 | PetscInt offsetI = 0; /* Offset into an element vector for fieldI */ | |||
765 | PetscInt offsetJ = 0; /* Offset into an element vector for fieldJ */ | |||
766 | PetscQuadrature quad; | |||
767 | PetscScalar *g0, *g1, *g2, *g3, *u, *u_t = NULL((void*)0), *u_x, *a, *a_x, *basisReal, *basisDerReal, *testReal, *testDerReal; | |||
768 | const PetscScalar *constants; | |||
769 | PetscReal *x; | |||
770 | PetscReal **B, **D, **BAux = NULL((void*)0), **DAux = NULL((void*)0), *BI, *DI, *BJ, *DJ; | |||
771 | PetscInt *uOff, *uOff_x, *aOff = NULL((void*)0), *aOff_x = NULL((void*)0), *Nb, *Nc, *NbAux = NULL((void*)0), *NcAux = NULL((void*)0); | |||
772 | PetscInt NbI = 0, NcI = 0, NbJ = 0, NcJ = 0; | |||
773 | PetscInt dim, numConstants, Nf, NfAux = 0, totDim, totDimAux = 0, e; | |||
774 | PetscBool isAffine; | |||
775 | const PetscReal *quadPoints, *quadWeights; | |||
776 | PetscInt qNc, Nq, q, Np, dE; | |||
777 | PetscErrorCode ierr; | |||
778 | ||||
779 | PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize < 64)) { petscstack->function[petscstack->currentsize ] = __func__; petscstack->file[petscstack->currentsize] = "/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ; petscstack->line[petscstack->currentsize] = 779; petscstack ->petscroutine[petscstack->currentsize] = PETSC_TRUE; petscstack ->currentsize++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE || petscstack->hotdepth); } ; } while (0) ; ; } while (0); | |||
780 | ierr = PetscDSGetDiscretization(ds, fieldI, (PetscObject *) &feI);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),780,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
781 | ierr = PetscDSGetDiscretization(ds, fieldJ, (PetscObject *) &feJ);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),781,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
782 | ierr = PetscFEGetSpatialDimension(feI, &dim);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),782,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
783 | ierr = PetscFEGetFaceQuadrature(feI, &quad);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),783,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
784 | ierr = PetscDSGetNumFields(ds, &Nf);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),784,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
785 | ierr = PetscDSGetTotalDimension(ds, &totDim);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),785,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
786 | ierr = PetscDSGetDimensions(ds, &Nb);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),786,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
787 | ierr = PetscDSGetComponents(ds, &Nc);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),787,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
788 | ierr = PetscDSGetComponentOffsets(ds, &uOff);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),788,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
789 | ierr = PetscDSGetComponentDerivativeOffsets(ds, &uOff_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),789,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
790 | ierr = PetscDSGetFieldOffset(ds, fieldI, &offsetI);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),790,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
791 | ierr = PetscDSGetFieldOffset(ds, fieldJ, &offsetJ);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),791,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
792 | ierr = PetscDSGetBdJacobian(ds, fieldI, fieldJ, &g0_func, &g1_func, &g2_func, &g3_func);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),792,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
793 | ierr = PetscDSGetEvaluationArrays(ds, &u, coefficients_t ? &u_t : NULL((void*)0), &u_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),793,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
794 | ierr = PetscDSGetWorkspace(ds, &x, &basisReal, &basisDerReal, &testReal, &testDerReal);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),794,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
795 | ierr = PetscDSGetWeakFormArrays(ds, NULL((void*)0), NULL((void*)0), &g0, &g1, &g2, &g3);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),795,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
796 | ierr = PetscDSGetFaceTabulation(ds, &B, &D);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),796,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
797 | ierr = PetscDSGetConstants(ds, &numConstants, &constants);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),797,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
798 | if (dsAux) { | |||
799 | ierr = PetscDSGetNumFields(dsAux, &NfAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),799,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
800 | ierr = PetscDSGetTotalDimension(dsAux, &totDimAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),800,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
801 | ierr = PetscDSGetDimensions(dsAux, &NbAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),801,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
802 | ierr = PetscDSGetComponents(dsAux, &NcAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),802,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
803 | ierr = PetscDSGetComponentOffsets(dsAux, &aOff);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),803,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
804 | ierr = PetscDSGetComponentDerivativeOffsets(dsAux, &aOff_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),804,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
805 | ierr = PetscDSGetEvaluationArrays(dsAux, &a, NULL((void*)0), &a_x);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),805,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
806 | ierr = PetscDSGetFaceTabulation(dsAux, &BAux, &DAux);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),806,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
807 | } | |||
808 | NbI = Nb[fieldI], NbJ = Nb[fieldJ]; | |||
809 | NcI = Nc[fieldI], NcJ = Nc[fieldJ]; | |||
810 | BI = B[fieldI], BJ = B[fieldJ]; | |||
811 | DI = D[fieldI], DJ = D[fieldJ]; | |||
812 | /* Initialize here in case the function is not defined */ | |||
813 | ierr = PetscArrayzero(g0, NcI*NcJ)PetscMemzero(g0,(NcI*NcJ)*sizeof(*(g0)));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),813,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
814 | ierr = PetscArrayzero(g1, NcI*NcJ*dim)PetscMemzero(g1,(NcI*NcJ*dim)*sizeof(*(g1)));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),814,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
815 | ierr = PetscArrayzero(g2, NcI*NcJ*dim)PetscMemzero(g2,(NcI*NcJ*dim)*sizeof(*(g2)));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),815,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
816 | ierr = PetscArrayzero(g3, NcI*NcJ*dim*dim)PetscMemzero(g3,(NcI*NcJ*dim*dim)*sizeof(*(g3)));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),816,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
817 | ierr = PetscQuadratureGetData(quad, NULL((void*)0), &qNc, &Nq, &quadPoints, &quadWeights);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),817,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
818 | if (qNc != 1) SETERRQ1(PETSC_COMM_SELF, PETSC_ERR_SUP, "Only supports scalar quadrature, not %D components\n", qNc)return PetscError(((MPI_Comm)0x44000001),818,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,56,PETSC_ERROR_INITIAL,"Only supports scalar quadrature, not %D components\n" ,qNc); | |||
819 | Np = fgeom->numPoints; | |||
820 | dE = fgeom->dimEmbed; | |||
821 | isAffine = fgeom->isAffine; | |||
822 | for (e = 0; e < Ne; ++e) { | |||
823 | PetscFEGeom fegeom, cgeom; | |||
824 | const PetscInt face = fgeom->face[e][0]; | |||
825 | fegeom.n = 0; | |||
826 | fegeom.v = 0; | |||
827 | fegeom.J = 0; | |||
828 | fegeom.detJ = 0; | |||
829 | if (isAffine) { | |||
830 | fegeom.v = x; | |||
831 | fegeom.xi = fgeom->xi; | |||
832 | fegeom.J = &fgeom->J[e*dE*dE]; | |||
833 | fegeom.invJ = &fgeom->invJ[e*dE*dE]; | |||
834 | fegeom.detJ = &fgeom->detJ[e]; | |||
835 | fegeom.n = &fgeom->n[e*dE]; | |||
836 | ||||
837 | cgeom.J = &fgeom->suppJ[0][e*dE*dE]; | |||
838 | cgeom.invJ = &fgeom->suppInvJ[0][e*dE*dE]; | |||
839 | cgeom.detJ = &fgeom->suppDetJ[0][e]; | |||
840 | } | |||
841 | for (q = 0; q < Nq; ++q) { | |||
842 | const PetscReal *BIq = &BI[(face*Nq+q)*NbI*NcI], *BJq = &BJ[(face*Nq+q)*NbJ*NcJ]; | |||
843 | const PetscReal *DIq = &DI[(face*Nq+q)*NbI*NcI*dim], *DJq = &DJ[(face*Nq+q)*NbJ*NcJ*dim]; | |||
844 | PetscReal w; | |||
845 | PetscInt c; | |||
846 | ||||
847 | if (debug) {ierr = PetscPrintf(PETSC_COMM_SELF((MPI_Comm)0x44000001), " quad point %d\n", q);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),847,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
848 | if (isAffine) { | |||
849 | CoordinatesRefToReal(dE, dim-1, fegeom.xi, &fgeom->v[e*dE], fegeom.J, &quadPoints[q*(dim-1)], x); | |||
850 | } else { | |||
851 | fegeom.v = &fgeom->v[(e*Np+q)*dE]; | |||
852 | fegeom.J = &fgeom->J[(e*Np+q)*dE*dE]; | |||
853 | fegeom.invJ = &fgeom->invJ[(e*Np+q)*dE*dE]; | |||
854 | fegeom.detJ = &fgeom->detJ[e*Np+q]; | |||
855 | fegeom.n = &fgeom->n[(e*Np+q)*dE]; | |||
856 | ||||
857 | cgeom.J = &fgeom->suppJ[0][(e*Np+q)*dE*dE]; | |||
858 | cgeom.invJ = &fgeom->suppInvJ[0][(e*Np+q)*dE*dE]; | |||
859 | cgeom.detJ = &fgeom->suppDetJ[0][e*Np+q]; | |||
860 | } | |||
861 | w = fegeom.detJ[0]*quadWeights[q]; | |||
862 | if (coefficients) {ierr = PetscFEEvaluateFieldJets_Internal(ds, dim, Nf, Nb, Nc, face*Nq+q, B, D, &cgeom, &coefficients[cOffset], &coefficients_t[cOffset], u, u_x, u_t);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),862,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
863 | if (dsAux) {ierr = PetscFEEvaluateFieldJets_Internal(dsAux, dim, NfAux, NbAux, NcAux, face*Nq+q, BAux, DAux, &cgeom, &coefficientsAux[cOffsetAux], NULL((void*)0), a, a_x, NULL((void*)0));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),863,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0);} | |||
864 | if (g0_func) { | |||
865 | ierr = PetscArrayzero(g0, NcI*NcJ)PetscMemzero(g0,(NcI*NcJ)*sizeof(*(g0)));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),865,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
866 | g0_func(dim, Nf, NfAux, uOff, uOff_x, u, u_t, u_x, aOff, aOff_x, a, NULL((void*)0), a_x, t, u_tshift, fegeom.v, fegeom.n, numConstants, constants, g0); | |||
867 | for (c = 0; c < NcI*NcJ; ++c) g0[c] *= w; | |||
868 | } | |||
869 | if (g1_func) { | |||
870 | ierr = PetscArrayzero(g1, NcI*NcJ*dim)PetscMemzero(g1,(NcI*NcJ*dim)*sizeof(*(g1)));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),870,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
871 | g1_func(dim, Nf, NfAux, uOff, uOff_x, u, u_t, u_x, aOff, aOff_x, a, NULL((void*)0), a_x, t, u_tshift, fegeom.v, fegeom.n, numConstants, constants, g1); | |||
872 | for (c = 0; c < NcI*NcJ*dim; ++c) g1[c] *= w; | |||
873 | } | |||
874 | if (g2_func) { | |||
875 | ierr = PetscArrayzero(g2, NcI*NcJ*dim)PetscMemzero(g2,(NcI*NcJ*dim)*sizeof(*(g2)));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),875,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
876 | g2_func(dim, Nf, NfAux, uOff, uOff_x, u, u_t, u_x, aOff, aOff_x, a, NULL((void*)0), a_x, t, u_tshift, fegeom.v, fegeom.n, numConstants, constants, g2); | |||
877 | for (c = 0; c < NcI*NcJ*dim; ++c) g2[c] *= w; | |||
878 | } | |||
879 | if (g3_func) { | |||
880 | ierr = PetscArrayzero(g3, NcI*NcJ*dim*dim)PetscMemzero(g3,(NcI*NcJ*dim*dim)*sizeof(*(g3)));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),880,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
881 | g3_func(dim, Nf, NfAux, uOff, uOff_x, u, u_t, u_x, aOff, aOff_x, a, NULL((void*)0), a_x, t, u_tshift, fegeom.v, fegeom.n, numConstants, constants, g3); | |||
882 | for (c = 0; c < NcI*NcJ*dim*dim; ++c) g3[c] *= w; | |||
883 | } | |||
884 | ||||
885 | ierr = PetscFEUpdateElementMat_Internal(feI, feJ, dim, NbI, NcI, BIq, DIq, basisReal, basisDerReal, NbJ, NcJ, BJq, DJq, testReal, testDerReal, &cgeom, g0, g1, g2, g3, eOffset, totDim, offsetI, offsetJ, elemMat);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),885,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
886 | } | |||
887 | if (debug > 1) { | |||
888 | PetscInt fc, f, gc, g; | |||
889 | ||||
890 | ierr = PetscPrintf(PETSC_COMM_SELF((MPI_Comm)0x44000001), "Element matrix for fields %d and %d\n", fieldI, fieldJ);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),890,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
891 | for (fc = 0; fc < NcI; ++fc) { | |||
892 | for (f = 0; f < NbI; ++f) { | |||
893 | const PetscInt i = offsetI + f*NcI+fc; | |||
894 | for (gc = 0; gc < NcJ; ++gc) { | |||
895 | for (g = 0; g < NbJ; ++g) { | |||
896 | const PetscInt j = offsetJ + g*NcJ+gc; | |||
897 | ierr = PetscPrintf(PETSC_COMM_SELF((MPI_Comm)0x44000001), " elemMat[%d,%d,%d,%d]: %g\n", f, fc, g, gc, PetscRealPart(elemMat[eOffset+i*totDim+j])(elemMat[eOffset+i*totDim+j]));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),897,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
898 | } | |||
899 | } | |||
900 | ierr = PetscPrintf(PETSC_COMM_SELF((MPI_Comm)0x44000001), "\n");CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),900,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
901 | } | |||
902 | } | |||
903 | } | |||
904 | cOffset += totDim; | |||
905 | cOffsetAux += totDimAux; | |||
906 | eOffset += PetscSqr(totDim)((totDim)*(totDim)); | |||
907 | } | |||
908 | 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); | |||
909 | } | |||
910 | ||||
911 | PetscErrorCode PetscFEInitialize_Basic(PetscFE fem) | |||
912 | { | |||
913 | PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize < 64)) { petscstack->function[petscstack->currentsize ] = __func__; petscstack->file[petscstack->currentsize] = "/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ; petscstack->line[petscstack->currentsize] = 913; petscstack ->petscroutine[petscstack->currentsize] = PETSC_TRUE; petscstack ->currentsize++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE || petscstack->hotdepth); } ; } while (0) ; ; } while (0); | |||
914 | fem->ops->setfromoptions = NULL((void*)0); | |||
915 | fem->ops->setup = PetscFESetUp_Basic; | |||
916 | fem->ops->view = PetscFEView_Basic; | |||
917 | fem->ops->destroy = PetscFEDestroy_Basic; | |||
918 | fem->ops->getdimension = PetscFEGetDimension_Basic; | |||
919 | fem->ops->gettabulation = PetscFEGetTabulation_Basic; | |||
920 | fem->ops->integrate = PetscFEIntegrate_Basic; | |||
921 | fem->ops->integratebd = PetscFEIntegrateBd_Basic; | |||
922 | fem->ops->integrateresidual = PetscFEIntegrateResidual_Basic; | |||
923 | fem->ops->integratebdresidual = PetscFEIntegrateBdResidual_Basic; | |||
924 | fem->ops->integratejacobianaction = NULL((void*)0)/* PetscFEIntegrateJacobianAction_Basic */; | |||
925 | fem->ops->integratejacobian = PetscFEIntegrateJacobian_Basic; | |||
926 | fem->ops->integratebdjacobian = PetscFEIntegrateBdJacobian_Basic; | |||
927 | 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); | |||
928 | } | |||
929 | ||||
930 | /*MC | |||
931 | PETSCFEBASIC = "basic" - A PetscFE object that integrates with basic tiling and no vectorization | |||
932 | ||||
933 | Level: intermediate | |||
934 | ||||
935 | .seealso: PetscFEType, PetscFECreate(), PetscFESetType() | |||
936 | M*/ | |||
937 | ||||
938 | PETSC_EXTERNextern __attribute__((visibility ("default"))) PetscErrorCode PetscFECreate_Basic(PetscFE fem) | |||
939 | { | |||
940 | PetscFE_Basic *b; | |||
941 | PetscErrorCode ierr; | |||
942 | ||||
943 | PetscFunctionBegindo { do { ; if (petscstack && (petscstack->currentsize < 64)) { petscstack->function[petscstack->currentsize ] = __func__; petscstack->file[petscstack->currentsize] = "/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ; petscstack->line[petscstack->currentsize] = 943; petscstack ->petscroutine[petscstack->currentsize] = PETSC_TRUE; petscstack ->currentsize++; } if (petscstack) { petscstack->hotdepth += (PETSC_FALSE || petscstack->hotdepth); } ; } while (0) ; ; } while (0); | |||
944 | PetscValidHeaderSpecific(fem, PETSCFE_CLASSID, 1)do { if (!fem) return PetscError(((MPI_Comm)0x44000001),944,__func__ ,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,85,PETSC_ERROR_INITIAL,"Null Object: Parameter # %d",1); if ( !PetscCheckPointer(fem,PETSC_OBJECT)) return PetscError(((MPI_Comm )0x44000001),944,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,64,PETSC_ERROR_INITIAL,"Invalid Pointer to Object: Parameter # %d" ,1); if (((PetscObject)(fem))->classid != PETSCFE_CLASSID) { if (((PetscObject)(fem))->classid == -1) return PetscError (((MPI_Comm)0x44000001),944,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,64,PETSC_ERROR_INITIAL,"Object already free: Parameter # %d" ,1); else return PetscError(((MPI_Comm)0x44000001),944,__func__ ,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,62,PETSC_ERROR_INITIAL,"Wrong type of object: Parameter # %d" ,1); } } while (0); | |||
945 | ierr = PetscNewLog(fem,&b)(PetscMallocA(1,PETSC_TRUE,945,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,(size_t)(1)*sizeof(**(((&b)))),(((&b)))) || PetscLogObjectMemory ((PetscObject)fem,sizeof(**(&b))));CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),945,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
946 | fem->data = b; | |||
947 | ||||
948 | ierr = PetscFEInitialize_Basic(fem);CHKERRQ(ierr)do {if (__builtin_expect(!!(ierr),0)) return PetscError(((MPI_Comm )0x44000001),948,__func__,"/sandbox/petsc/petsc.next-tmp/src/dm/dt/fe/impls/basic/febasic.c" ,ierr,PETSC_ERROR_REPEAT," ");} while (0); | |||
949 | 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); | |||
950 | } |