<div dir="ltr">Thank you very much! Some of the tests are even working now. Just the little attempt at QC through the test runs has given an understanding about your emphasis on method of manufactured solutions test cases, and why is is perfectly justified.<div><br></div><div>Robert<br><div><br></div><div><br></div></div></div><div class="gmail_extra"><br clear="all"><div><div class="gmail_signature" data-smartmail="gmail_signature"><div dir="ltr"><div>Robert L. Walker<br></div><div>MS Petroleum Engineering</div><div>Mork Family Department of Chemicals and Materials Sciences<br></div><div>University of Southern California<br>----------------------------------------------<br></div><div>Mobile US: +1 (213) - 290 -7101<br></div><div>Mobile EU: +34 62 274 66 40<br></div><div><a href="mailto:rlwalker@usc.edu" target="_blank">rlwalker@usc.edu</a><br></div></div></div></div>
<br><div class="gmail_quote">On Fri, Jul 21, 2017 at 7:14 AM, Matthew Knepley <span dir="ltr"><<a href="mailto:knepley@gmail.com" target="_blank">knepley@gmail.com</a>></span> wrote:<br><blockquote class="gmail_quote" style="margin:0 0 0 .8ex;border-left:1px #ccc solid;padding-left:1ex"><div dir="ltr">I have pushed updates for the code. Now I have to update the regression check code.<div><br></div><div>  Thanks,</div><div><br></div><div>    Matt</div></div><div class="gmail_extra"><br><div class="gmail_quote">On Wed, Jul 19, 2017 at 9:56 PM, Robert Walker <span dir="ltr"><<a href="mailto:rlwalker@usc.edu" target="_blank">rlwalker@usc.edu</a>></span> wrote:<br><blockquote class="gmail_quote" style="margin:0 0 0 .8ex;border-left:1px #ccc solid;padding-left:1ex"><div dir="ltr"><div><div>Hello,<br><br></div>I am having an issue compiling code that I got from Matt at the crustal dynamics workshop a while back...it states that DM_FOREST_****** type terms are undeclared. I want to say that Matt advised me on what the issue was at the conference, but of course the laptop I was using promptly died upon arriving home. Below is the error output after running "make magma":<br><br></div>Thank you for your help.<br><div>##############################<wbr>##############################<wbr>#######<br><br>mpicc -o magma.o -c -fPIC  -Wall -Wwrite-strings -Wno-strict-aliasing -Wno-unknown-pragmas -fstack-protector -fvisibility=hidden -O3 -march=native -mtune=native  -I. -I/home/dockimble/PETSc/petsc/<wbr>include -I/home/dockimble/PETSc/petsc/<wbr>linux-gnu-c-debug/include    `pwd`/magma.c<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c: In function ‘CreateMesh’:<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:13<wbr>8:105: error: incompatible type for argument 2 of ‘DMSetPeriodicity’<br>   if (periodic) {for (d = 0; d < 3; ++d) maxCell[d] = 1.1*(L[d]/cells[d]); ierr = DMSetPeriodicity(*dm, maxCell, L, user->bd);CHKERRQ(ierr);}<br>                              <wbr>                              <wbr>                              <wbr>               ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petscdmda.h:4:0,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:12,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscdm.h:131:29: note: expected ‘PetscBool {aka enum <anonymous>}’ but argument is of type ‘PetscReal * {aka double *}’<br> PETSC_EXTERN PetscErrorCode DMSetPeriodicity(DM,PetscBool,<wbr>const PetscReal[],const PetscReal[],const DMBoundaryType[]);<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:13<wbr>8:117: warning: passing argument 4 of ‘DMSetPeriodicity’ from incompatible pointer type [-Wincompatible-pointer-types]<br>   if (periodic) {for (d = 0; d < 3; ++d) maxCell[d] = 1.1*(L[d]/cells[d]); ierr = DMSetPeriodicity(*dm, maxCell, L, user->bd);CHKERRQ(ierr);}<br>                              <wbr>                              <wbr>                              <wbr>                           ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petscdmda.h:4:0,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:12,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscdm.h:131:29: note: expected ‘const PetscReal * {aka const double *}’ but argument is of type ‘DMBoundaryType * {aka enum <anonymous> *}’<br> PETSC_EXTERN PetscErrorCode DMSetPeriodicity(DM,PetscBool,<wbr>const PetscReal[],const PetscReal[],const DMBoundaryType[]);<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:13<wbr>8:83: error: too few arguments to function ‘DMSetPeriodicity’<br>   if (periodic) {for (d = 0; d < 3; ++d) maxCell[d] = 1.1*(L[d]/cells[d]); ierr = DMSetPeriodicity(*dm, maxCell, L, user->bd);CHKERRQ(ierr);}<br>                              <wbr>                              <wbr>                       ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petscdmda.h:4:0,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:12,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscdm.h:131:29: note: declared here<br> PETSC_EXTERN PetscErrorCode DMSetPeriodicity(DM,PetscBool,<wbr>const PetscReal[],const PetscReal[],const DMBoundaryType[]);<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c: In function ‘SetupProblem’:<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:19<wbr>1:40: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetResidual(prob, 0, f0_vector_zero,       f1_momentum_balance);CHKERRQ(i<wbr>err);<br>                              <wbr>          ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:19<wbr>1:62: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetResidual(prob, 0, f0_vector_zero,       f1_momentum_balance);CHKERRQ(i<wbr>err);<br>                              <wbr>                              <wbr>  ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:19<wbr>2:40: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetResidual(prob, 1, f0_mass_balance,      f1_mass_balance);CHKERRQ(ierr)<wbr>;<br>                              <wbr>          ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:19<wbr>2:62: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetResidual(prob, 1, f0_mass_balance,      f1_mass_balance);CHKERRQ(ierr)<wbr>;<br>                              <wbr>                              <wbr>  ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:19<wbr>3:40: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetResidual(prob, 2, f0_passive_advection, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>          ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:19<wbr>3:62: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetResidual(prob, 2, f0_passive_advection, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>                              <wbr>  ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:19<wbr>4:45: warning: passing argument 3 of ‘PetscDSSetRiemannSolver’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetRiemannSolver(prob, 2, riemann_coupled_advection);CHK<wbr>ERRQ(ierr);<br>                              <wbr>               ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:213:29: note: expected ‘void (*)(PetscInt,  PetscInt,  const PetscReal *, const PetscReal *, const PetscScalar *, const PetscScalar *, PetscInt,  const PetscScalar *, PetscScalar *, void *) {aka void (*)(int,  int,  const double *, const double *, const double *, const double *, int,  const double *, double *, void *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  const PetscReal *, const PetscReal *, const PetscScalar *, const PetscScalar *, PetscScalar *, void *) {aka void (*)(int,  int,  const double *, const double *, const double *, const double *, double *, void *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetRiemannSolver(PetscD<wbr>S, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:19<wbr>5:75: warning: passing argument 7 of ‘PetscDSSetJacobianPreconditio<wbr>ner’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobianPrecondition<wbr>er(prob, 0, 0, NULL, NULL, NULL, g3_magma_uu);CHKERRQ(ierr);<br>                              <wbr>                              <wbr>               ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:159:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPrecondition<wbr>er(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:19<wbr>6:69: warning: passing argument 6 of ‘PetscDSSetJacobianPreconditio<wbr>ner’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobianPrecondition<wbr>er(prob, 0, 1, NULL, NULL, g2_stokes_up, NULL);CHKERRQ(ierr);<br>                              <wbr>                              <wbr>         ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:159:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPrecondition<wbr>er(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:19<wbr>7:63: warning: passing argument 5 of ‘PetscDSSetJacobianPreconditio<wbr>ner’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobianPrecondition<wbr>er(prob, 1, 0, NULL, g1_stokes_pu, NULL, NULL);CHKERRQ(ierr);<br>                              <wbr>                              <wbr>   ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:159:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPrecondition<wbr>er(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:19<wbr>8:57: warning: passing argument 4 of ‘PetscDSSetJacobianPreconditio<wbr>ner’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobianPrecondition<wbr>er(prob, 1, 1, g0_stokes_phi, NULL, NULL, g3_magma_pp);CHKERRQ(ierr);<br>                              <wbr>                           ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:159:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPrecondition<wbr>er(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:19<wbr>8:84: warning: passing argument 7 of ‘PetscDSSetJacobianPreconditio<wbr>ner’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobianPrecondition<wbr>er(prob, 1, 1, g0_stokes_phi, NULL, NULL, g3_magma_pp);CHKERRQ(ierr);<br>                              <wbr>                              <wbr>                        ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:159:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPrecondition<wbr>er(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:19<wbr>9:57: warning: passing argument 4 of ‘PetscDSSetJacobianPreconditio<wbr>ner’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobianPrecondition<wbr>er(prob, 2, 2, g0_stokes_phi, NULL, NULL, NULL);CHKERRQ(ierr);<br>                              <wbr>                           ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:159:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPrecondition<wbr>er(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:21<wbr>4:40: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetResidual(prob, 0, f0_vector_zero, f1_vector_zero);CHKERRQ(ierr);<br>                              <wbr>          ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:21<wbr>4:56: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetResidual(prob, 0, f0_vector_zero, f1_vector_zero);CHKERRQ(ierr);<br>                              <wbr>                          ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:21<wbr>5:40: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetResidual(prob, 1, f0_scalar_zero, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>          ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:21<wbr>5:56: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetResidual(prob, 1, f0_scalar_zero, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>                          ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:21<wbr>6:40: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetResidual(prob, 2, f0_advection,   f1_advection);CHKERRQ(ierr);<br>                              <wbr>          ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:21<wbr>6:56: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetResidual(prob, 2, f0_advection,   f1_advection);CHKERRQ(ierr);<br>                              <wbr>                          ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:21<wbr>7:45: warning: passing argument 3 of ‘PetscDSSetRiemannSolver’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetRiemannSolver(prob, 2, riemann_coupled_advection);CHK<wbr>ERRQ(ierr);<br>                              <wbr>               ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:213:29: note: expected ‘void (*)(PetscInt,  PetscInt,  const PetscReal *, const PetscReal *, const PetscScalar *, const PetscScalar *, PetscInt,  const PetscScalar *, PetscScalar *, void *) {aka void (*)(int,  int,  const double *, const double *, const double *, const double *, int,  const double *, double *, void *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  const PetscReal *, const PetscReal *, const PetscScalar *, const PetscScalar *, PetscScalar *, void *) {aka void (*)(int,  int,  const double *, const double *, const double *, const double *, double *, void *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetRiemannSolver(PetscD<wbr>S, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:22<wbr>6:42: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 0, f0_stokes_periodic_u, f1_stokes_u);CHKERRQ(ierr);<br>                              <wbr>            ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:22<wbr>6:64: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 0, f0_stokes_periodic_u, f1_stokes_u);CHKERRQ(ierr);<br>                              <wbr>                              <wbr>    ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:22<wbr>8:42: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 0, f0_stokes_u,          f1_stokes_u);CHKERRQ(ierr);<br>                              <wbr>            ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:22<wbr>8:64: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 0, f0_stokes_u,          f1_stokes_u);CHKERRQ(ierr);<br>                              <wbr>                              <wbr>    ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:23<wbr>0:40: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetResidual(prob, 1, f0_stokes_p, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>          ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:23<wbr>0:53: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetResidual(prob, 1, f0_stokes_p, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>                       ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:23<wbr>1:40: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetResidual(prob, 2, f0_porosity, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>          ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:23<wbr>1:53: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetResidual(prob, 2, f0_porosity, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>                       ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:23<wbr>2:61: warning: passing argument 7 of ‘PetscDSSetJacobian’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobian(prob, 0, 0, NULL, NULL, NULL, g3_stokes_uu);CHKERRQ(ierr);<br>                              <wbr>                               ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:124:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:23<wbr>3:55: warning: passing argument 6 of ‘PetscDSSetJacobian’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobian(prob, 0, 1, NULL, NULL, g2_stokes_up, NULL);CHKERRQ(ierr);<br>                              <wbr>                         ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:124:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:23<wbr>4:49: warning: passing argument 5 of ‘PetscDSSetJacobian’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobian(prob, 1, 0, NULL, g1_stokes_pu, NULL, NULL);CHKERRQ(ierr);<br>                              <wbr>                   ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:124:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:23<wbr>5:43: warning: passing argument 4 of ‘PetscDSSetJacobian’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobian(prob, 2, 2, g0_stokes_phi, NULL, NULL, NULL);CHKERRQ(ierr);<br>                              <wbr>             ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:124:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:23<wbr>6:75: warning: passing argument 7 of ‘PetscDSSetJacobianPreconditio<wbr>ner’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobianPrecondition<wbr>er(prob, 0, 0, NULL, NULL, NULL, g3_stokes_uu);CHKERRQ(ierr);<br>                              <wbr>                              <wbr>               ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:159:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPrecondition<wbr>er(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:23<wbr>7:57: warning: passing argument 4 of ‘PetscDSSetJacobianPreconditio<wbr>ner’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobianPrecondition<wbr>er(prob, 1, 1, g0_stokes_phi, NULL, NULL, NULL);CHKERRQ(ierr);<br>                              <wbr>                           ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:159:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPrecondition<wbr>er(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:23<wbr>8:57: warning: passing argument 4 of ‘PetscDSSetJacobianPreconditio<wbr>ner’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobianPrecondition<wbr>er(prob, 2, 2, g0_stokes_phi, NULL, NULL, NULL);CHKERRQ(ierr);<br>                              <wbr>                           ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:159:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetJacobianPrecondition<wbr>er(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:26<wbr>1:42: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 0, f0_lap_periodic_u,    f1_lap_u);CHKERRQ(ierr);<br>                              <wbr>            ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:26<wbr>1:64: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 0, f0_lap_periodic_u,    f1_lap_u);CHKERRQ(ierr);<br>                              <wbr>                              <wbr>    ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:26<wbr>2:42: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 1, f0_periodic_pressure, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>            ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:26<wbr>2:64: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 1, f0_periodic_pressure, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>                              <wbr>    ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:26<wbr>5:42: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 0, f0_lap_u,    f1_lap_u);CHKERRQ(ierr);<br>                              <wbr>            ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:26<wbr>5:55: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 0, f0_lap_u,    f1_lap_u);CHKERRQ(ierr);<br>                              <wbr>                         ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:26<wbr>6:42: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 1, f0_pressure, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>            ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:26<wbr>6:55: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 1, f0_pressure, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>                         ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:26<wbr>9:40: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetResidual(prob, 2, f0_porosity, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>          ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:26<wbr>9:53: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetResidual(prob, 2, f0_porosity, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>                       ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:27<wbr>0:61: warning: passing argument 7 of ‘PetscDSSetJacobian’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobian(prob, 0, 0, NULL, NULL, NULL, g3_uu);CHKERRQ(ierr);<br>                              <wbr>                               ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:124:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:27<wbr>1:43: warning: passing argument 4 of ‘PetscDSSetJacobian’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobian(prob, 1, 1, g0_pressure, NULL, NULL, NULL);CHKERRQ(ierr);<br>                              <wbr>             ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:124:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:27<wbr>2:43: warning: passing argument 4 of ‘PetscDSSetJacobian’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobian(prob, 2, 2, g0_pressure, NULL, NULL, NULL);CHKERRQ(ierr);<br>                              <wbr>             ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:124:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:29<wbr>4:42: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 0, f0_doubly_periodic_velocity, f1_vector_zero);CHKERRQ(ierr);<br>                              <wbr>            ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:29<wbr>4:71: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 0, f0_doubly_periodic_velocity, f1_vector_zero);CHKERRQ(ierr);<br>                              <wbr>                              <wbr>           ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:29<wbr>5:42: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 1, f0_doubly_periodic_pressure, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>            ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:29<wbr>5:71: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 1, f0_doubly_periodic_pressure, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>                              <wbr>           ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:29<wbr>7:42: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 0, f0_periodic_velocity, f1_vector_zero);CHKERRQ(ierr);<br>                              <wbr>            ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:29<wbr>7:64: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 0, f0_periodic_velocity, f1_vector_zero);CHKERRQ(ierr);<br>                              <wbr>                              <wbr>    ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:29<wbr>8:42: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 1, f0_periodic_pressure, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>            ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:29<wbr>8:64: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 1, f0_periodic_pressure, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>                              <wbr>    ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:30<wbr>0:42: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 0, f0_velocity, f1_vector_zero);CHKERRQ(ierr);<br>                              <wbr>            ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:30<wbr>0:55: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 0, f0_velocity, f1_vector_zero);CHKERRQ(ierr);<br>                              <wbr>                         ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:30<wbr>1:42: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 1, f0_pressure, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>            ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:30<wbr>1:55: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetResidual(prob, 1, f0_pressure, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>                         ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:30<wbr>3:40: warning: passing argument 3 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetResidual(prob, 2, f0_porosity, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>          ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:30<wbr>3:53: warning: passing argument 4 of ‘PetscDSSetResidual’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetResidual(prob, 2, f0_porosity, f1_scalar_zero);CHKERRQ(ierr);<br>                              <wbr>                       ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:97:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetResidual(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:30<wbr>4:43: warning: passing argument 4 of ‘PetscDSSetJacobian’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobian(prob, 0, 0, g0_velocity, NULL, NULL, NULL);CHKERRQ(ierr);<br>                              <wbr>             ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:124:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:30<wbr>5:43: warning: passing argument 4 of ‘PetscDSSetJacobian’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobian(prob, 1, 1, g0_pressure, NULL, NULL, NULL);CHKERRQ(ierr);<br>                              <wbr>             ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:124:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:30<wbr>6:43: warning: passing argument 4 of ‘PetscDSSetJacobian’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobian(prob, 2, 2, g0_pressure, NULL, NULL, NULL);CHKERRQ(ierr);<br>                              <wbr>             ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:124:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetJacobian(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c: In function ‘BenchmarkMonitor’:<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:79<wbr>8:38: error: incompatible type for argument 2 of ‘DMProjectField’<br>       ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, C);CHKERRQ(ierr);<br>                              <wbr>        ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petscsnes.h:6:0,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petscts.h:7,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:26,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscksp.h:713:29: note: expected ‘PetscReal {aka double}’ but argument is of type ‘Vec {aka struct _p_Vec *}’<br> PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:79<wbr>8:41: warning: passing argument 3 of ‘DMProjectField’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, C);CHKERRQ(ierr);<br>                              <wbr>           ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petscsnes.h:6:0,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petscts.h:7,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:26,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscksp.h:713:29: note: expected ‘Vec {aka struct _p_Vec *}’ but argument is of type ‘void (**)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (**)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:79<wbr>8:48: warning: passing argument 4 of ‘DMProjectField’ makes pointer from integer without a cast [-Wint-conversion]<br>       ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, C);CHKERRQ(ierr);<br>                              <wbr>                  ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petscsnes.h:6:0,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petscts.h:7,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:26,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscksp.h:713:29: note: expected ‘void (**)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (**)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘int’<br> PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:79<wbr>8:63: error: incompatible type for argument 5 of ‘DMProjectField’<br>       ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, C);CHKERRQ(ierr);<br>                              <wbr>                              <wbr>   ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petscsnes.h:6:0,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petscts.h:7,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:26,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscksp.h:713:29: note: expected ‘InsertMode {aka enum <anonymous>}’ but argument is of type ‘Vec {aka struct _p_Vec *}’<br> PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:79<wbr>8:14: error: too few arguments to function ‘DMProjectField’<br>       ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, C);CHKERRQ(ierr);<br>              ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petscsnes.h:6:0,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petscts.h:7,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:26,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscksp.h:713:29: note: declared here<br> PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec,<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c: In function ‘CreateErrorFE’:<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:84<wbr>1:54: error: incompatible type for argument 5 of ‘PetscDTGaussTensorQuadrature’<br>   ierr = PetscDTGaussTensorQuadrature(d<wbr>im,2,-1.0,1.0,&quad);CHKERRQ(i<wbr>err);<br>                              <wbr>                        ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petscfe.h:7:0,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petscdmda.h:8,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:12,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscdt.h:34:29: note: expected ‘PetscReal {aka double}’ but argument is of type ‘struct _p_PetscQuadrature **’<br> PETSC_EXTERN PetscErrorCode PetscDTGaussTensorQuadrature(P<wbr>etscInt,PetscInt,PetscInt,Pets<wbr>cReal,PetscReal,PetscQuadratur<wbr>e*);<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:84<wbr>1:10: error: too few arguments to function ‘PetscDTGaussTensorQuadrature’<br>   ierr = PetscDTGaussTensorQuadrature(d<wbr>im,2,-1.0,1.0,&quad);CHKERRQ(i<wbr>err);<br>          ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petscfe.h:7:0,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petscdmda.h:8,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:12,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscdt.h:34:29: note: declared here<br> PETSC_EXTERN PetscErrorCode PetscDTGaussTensorQuadrature(P<wbr>etscInt,PetscInt,PetscInt,Pets<wbr>cReal,PetscReal,PetscQuadratur<wbr>e*);<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c: In function ‘AdaptPorosityExact’:<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:97<wbr>0:49: error: ‘DM_FOREST_REFINE’ undeclared (first use in this function)<br>       ierr = DMLabelSetDefaultValue(refineL<wbr>abel,DM_FOREST_REFINE);CHKERRQ<wbr>(ierr);<br>                              <wbr>                   ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:97<wbr>0:49: note: each undeclared identifier is reported only once for each function it appears in<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:97<wbr>1:14: warning: implicit declaration of function ‘DMForestAdaptLabel’ [-Wimplicit-function-declarati<wbr>on]<br>       ierr = DMForestAdaptLabel(dm,"adapt",<wbr>&adaptedDM);CHKERRQ(ierr);<br>              ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:98<wbr>8:46: error: ‘DM_FOREST_KEEP’ undeclared (first use in this function)<br>     ierr = DMLabelSetDefaultValue(adaptLa<wbr>bel,DM_FOREST_KEEP);CHKERRQ(<wbr>ierr);<br>                              <wbr>                ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:99<wbr>5:45: error: ‘DM_FOREST_COARSEN’ undeclared (first use in this function)<br>         ierr = DMLabelSetValue(adaptLabel,i,D<wbr>M_FOREST_COARSEN);CHKERRQ(ierr<wbr>);<br>                              <wbr>               ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c: In function ‘AdaptPorosityGradient’:<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:11<wbr>51:51: warning: passing argument 4 of ‘PetscQuadratureGetData’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscQuadratureGetData(q,&dim,<wbr>&nPoints,&points,&weights);CHK<wbr>ERRQ(ierr);<br>                              <wbr>                     ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petscfe.h:7:0,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petscdmda.h:8,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:12,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscdt.h:24:29: note: expected ‘PetscInt * {aka int *}’ but argument is of type ‘const PetscReal ** {aka const double **}’<br> PETSC_EXTERN PetscErrorCode PetscQuadratureGetData(PetscQu<wbr>adrature, PetscInt*, PetscInt*, PetscInt*, const PetscReal *[], const PetscReal *[]);<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:11<wbr>51:12: error: too few arguments to function ‘PetscQuadratureGetData’<br>     ierr = PetscQuadratureGetData(q,&dim,<wbr>&nPoints,&points,&weights);CHK<wbr>ERRQ(ierr);<br>            ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petscfe.h:7:0,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petscdmda.h:8,<br>                 from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:12,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscdt.h:24:29: note: declared here<br> PETSC_EXTERN PetscErrorCode PetscQuadratureGetData(PetscQu<wbr>adrature, PetscInt*, PetscInt*, PetscInt*, const PetscReal *[], const PetscReal *[]);<br>                             ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:12<wbr>50:49: error: ‘DM_FOREST_REFINE’ undeclared (first use in this function)<br>       ierr = DMLabelSetDefaultValue(refineL<wbr>abel,DM_FOREST_REFINE);CHKERRQ<wbr>(ierr);<br>                              <wbr>                   ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:12<wbr>69:46: error: ‘DM_FOREST_KEEP’ undeclared (first use in this function)<br>     ierr = DMLabelSetDefaultValue(adaptLa<wbr>bel,DM_FOREST_KEEP);CHKERRQ(<wbr>ierr);<br>                              <wbr>                ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:12<wbr>83:47: error: ‘DM_FOREST_COARSEN’ undeclared (first use in this function)<br>           ierr = DMLabelSetValue(adaptLabel,i,D<wbr>M_FOREST_COARSEN);CHKERRQ(ierr<wbr>);<br>                              <wbr>                 ^<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c: In function ‘main’:<br>/home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:15<wbr>92:43: warning: passing argument 3 of ‘PetscDSSetObjective’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetObjective(prob, 2, compactionRateError);CHKERRQ(i<wbr>err);<br>                              <wbr>             ^<br>In file included from /home/dockimble/PETSc/petsc/in<wbr>clude/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dy<wbr>namics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/in<wbr>clude/petscds.h:83:29: note: expected ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscInt,  const PetscScalar *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, int,  const double *, double *)}’ but argument is of type ‘void (*)(PetscInt,  PetscInt,  PetscInt,  const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, const PetscInt *, const PetscInt *, const PetscScalar *, const PetscScalar *, const PetscScalar *, PetscReal,  const PetscReal *, PetscScalar *) {aka void (*)(int,  int,  int,  const int *, const int *, const double *, const double *, const double *, const int *, const int *, const double *, const double *, const double *, double,  const double *, double *)}’<br> PETSC_EXTERN PetscErrorCode PetscDSSetObjective(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/petsc/li<wbr>b/petsc/conf/rules:401: recipe for target 'magma.o' failed<br>make: *** [magma.o] Error 1    <br><div><div><br><br clear="all"><div><div class="m_-2766793395579171514m_2626112137906650417gmail_signature"><div dir="ltr"><div>Robert L. Walker<br></div><div>MS Petroleum Engineering</div><div>Mork Family Department of Chemicals and Materials Sciences<br></div><div>University of Southern California<br>------------------------------<wbr>----------------<br></div><div>Mobile US: <a href="tel:(213)%20290-7101" value="+12132907101" target="_blank">+1 (213) - 290 -7101</a><br></div><div>Mobile EU: +34 62 274 66 40<br></div><div><a href="mailto:rlwalker@usc.edu" target="_blank">rlwalker@usc.edu</a><span class="HOEnZb"><font color="#888888"><br></font></span></div></div></div></div><span class="HOEnZb"><font color="#888888">
</font></span></div></div></div></div><span class="HOEnZb"><font color="#888888">
</font></span></blockquote></div><span class="HOEnZb"><font color="#888888"><br><br clear="all"><div><br></div>-- <br><div class="m_-2766793395579171514gmail_signature" data-smartmail="gmail_signature"><div dir="ltr"><div>What most experimenters take for granted before they begin their experiments is infinitely more interesting than any results to which their experiments lead.<br>-- Norbert Wiener</div><div><br></div><div><a href="https://urldefense.proofpoint.com/v2/url?u=http-3A__www.caam.rice.edu_-7Emk51_&d=DwMFaQ&c=clK7kQUTWtAVEOVIgvi0NU5BOUHhpN0H8p7CSfnc_gI&r=BWOpUsAp5dvI5cUiP4uZxQ&m=dyb6gE7oLWDyVTOEqWOvaOAiwEthuIFVV7Pmb2oPv60&s=0u0R5U6z84losx6_YeNP4mJrvXMNx2MqXnxvXWQFLb0&e=" target="_blank">http://www.caam.rice.edu/~<wbr>mk51/</a><br></div></div></div>
</font></span></div>
</blockquote></div><br></div>