<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>###################################################################<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/include -I/home/dockimble/PETSc/petsc/linux-gnu-c-debug/include    `pwd`/magma.c<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function ‘CreateMesh’:<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:138: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>                                                                                                         ^<br>In file included from /home/dockimble/PETSc/petsc/include/petscdmda.h:4:0,<br>                 from /home/dockimble/PETSc/petsc/include/petsc.h:12,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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,const PetscReal[],const PetscReal[],const DMBoundaryType[]);<br>                             ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:138: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>                                                                                                                     ^<br>In file included from /home/dockimble/PETSc/petsc/include/petscdmda.h:4:0,<br>                 from /home/dockimble/PETSc/petsc/include/petsc.h:12,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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,const PetscReal[],const PetscReal[],const DMBoundaryType[]);<br>                             ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:138: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>                                                                                   ^<br>In file included from /home/dockimble/PETSc/petsc/include/petscdmda.h:4:0,<br>                 from /home/dockimble/PETSc/petsc/include/petsc.h:12,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/petscdm.h:131:29: note: declared here<br> PETSC_EXTERN PetscErrorCode DMSetPeriodicity(DM,PetscBool,const PetscReal[],const PetscReal[],const DMBoundaryType[]);<br>                             ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function ‘SetupProblem’:<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:191: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(ierr);<br>                                        ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:191: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(ierr);<br>                                                              ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:192: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);<br>                                        ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:192: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);<br>                                                              ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:193: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>                                        ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:193: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>                                                              ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:194:45: warning: passing argument 3 of ‘PetscDSSetRiemannSolver’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetRiemannSolver(prob, 2, riemann_coupled_advection);CHKERRQ(ierr);<br>                                             ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:195:75: warning: passing argument 7 of ‘PetscDSSetJacobianPreconditioner’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobianPreconditioner(prob, 0, 0, NULL, NULL, NULL, g3_magma_uu);CHKERRQ(ierr);<br>                                                                           ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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 PetscDSSetJacobianPreconditioner(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:196:69: warning: passing argument 6 of ‘PetscDSSetJacobianPreconditioner’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobianPreconditioner(prob, 0, 1, NULL, NULL, g2_stokes_up, NULL);CHKERRQ(ierr);<br>                                                                     ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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 PetscDSSetJacobianPreconditioner(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:197:63: warning: passing argument 5 of ‘PetscDSSetJacobianPreconditioner’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobianPreconditioner(prob, 1, 0, NULL, g1_stokes_pu, NULL, NULL);CHKERRQ(ierr);<br>                                                               ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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 PetscDSSetJacobianPreconditioner(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:198:57: warning: passing argument 4 of ‘PetscDSSetJacobianPreconditioner’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobianPreconditioner(prob, 1, 1, g0_stokes_phi, NULL, NULL, g3_magma_pp);CHKERRQ(ierr);<br>                                                         ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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 PetscDSSetJacobianPreconditioner(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:198:84: warning: passing argument 7 of ‘PetscDSSetJacobianPreconditioner’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobianPreconditioner(prob, 1, 1, g0_stokes_phi, NULL, NULL, g3_magma_pp);CHKERRQ(ierr);<br>                                                                                    ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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 PetscDSSetJacobianPreconditioner(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:199:57: warning: passing argument 4 of ‘PetscDSSetJacobianPreconditioner’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobianPreconditioner(prob, 2, 2, g0_stokes_phi, NULL, NULL, NULL);CHKERRQ(ierr);<br>                                                         ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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 PetscDSSetJacobianPreconditioner(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:214: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>                                        ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:214: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>                                                        ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:215: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>                                        ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:215: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>                                                        ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:216: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>                                        ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:216: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>                                                        ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:217:45: warning: passing argument 3 of ‘PetscDSSetRiemannSolver’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetRiemannSolver(prob, 2, riemann_coupled_advection);CHKERRQ(ierr);<br>                                             ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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(PetscDS, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:226: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>                                          ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:226: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>                                                                ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:228: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>                                          ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:228: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>                                                                ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:230: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>                                        ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:230: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>                                                     ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:231: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>                                        ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:231: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>                                                     ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:232: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>                                                             ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:233: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>                                                       ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:234: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>                                                 ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:235: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>                                           ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:236:75: warning: passing argument 7 of ‘PetscDSSetJacobianPreconditioner’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobianPreconditioner(prob, 0, 0, NULL, NULL, NULL, g3_stokes_uu);CHKERRQ(ierr);<br>                                                                           ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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 PetscDSSetJacobianPreconditioner(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:237:57: warning: passing argument 4 of ‘PetscDSSetJacobianPreconditioner’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobianPreconditioner(prob, 1, 1, g0_stokes_phi, NULL, NULL, NULL);CHKERRQ(ierr);<br>                                                         ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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 PetscDSSetJacobianPreconditioner(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:238:57: warning: passing argument 4 of ‘PetscDSSetJacobianPreconditioner’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscDSSetJacobianPreconditioner(prob, 2, 2, g0_stokes_phi, NULL, NULL, NULL);CHKERRQ(ierr);<br>                                                         ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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 PetscDSSetJacobianPreconditioner(PetscDS, PetscInt, PetscInt,<br>                             ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:261: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>                                          ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:261: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>                                                                ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:262: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>                                          ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:262: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>                                                                ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:265: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>                                          ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:265: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>                                                       ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:266: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>                                          ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:266: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>                                                       ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:269: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>                                        ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:269: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>                                                     ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:270: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>                                                             ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:271: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>                                           ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:272: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>                                           ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:294: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>                                          ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:294: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>                                                                       ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:295: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>                                          ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:295: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>                                                                       ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:297: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>                                          ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:297: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>                                                                ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:298: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>                                          ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:298: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>                                                                ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:300: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>                                          ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:300: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>                                                       ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:301: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>                                          ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:301: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>                                                       ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:303: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>                                        ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:303: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>                                                     ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:304: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>                                           ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:305: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>                                           ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:306: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>                                           ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c: In function ‘BenchmarkMonitor’:<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:798:38: error: incompatible type for argument 2 of ‘DMProjectField’<br>       ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, C);CHKERRQ(ierr);<br>                                      ^<br>In file included from /home/dockimble/PETSc/petsc/include/petscsnes.h:6:0,<br>                 from /home/dockimble/PETSc/petsc/include/petscts.h:7,<br>                 from /home/dockimble/PETSc/petsc/include/petsc.h:26,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:798: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>                                         ^<br>In file included from /home/dockimble/PETSc/petsc/include/petscsnes.h:6:0,<br>                 from /home/dockimble/PETSc/petsc/include/petscts.h:7,<br>                 from /home/dockimble/PETSc/petsc/include/petsc.h:26,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:798: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>                                                ^<br>In file included from /home/dockimble/PETSc/petsc/include/petscsnes.h:6:0,<br>                 from /home/dockimble/PETSc/petsc/include/petscts.h:7,<br>                 from /home/dockimble/PETSc/petsc/include/petsc.h:26,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:798:63: error: incompatible type for argument 5 of ‘DMProjectField’<br>       ierr = DMProjectField(dmBench, u, funcs, INSERT_VALUES, C);CHKERRQ(ierr);<br>                                                               ^<br>In file included from /home/dockimble/PETSc/petsc/include/petscsnes.h:6:0,<br>                 from /home/dockimble/PETSc/petsc/include/petscts.h:7,<br>                 from /home/dockimble/PETSc/petsc/include/petsc.h:26,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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-dynamics-problems/src/magma.c:798: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/include/petscsnes.h:6:0,<br>                 from /home/dockimble/PETSc/petsc/include/petscts.h:7,<br>                 from /home/dockimble/PETSc/petsc/include/petsc.h:26,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/petscksp.h:713:29: note: declared here<br> PETSC_EXTERN PetscErrorCode DMProjectField(DM, PetscReal, Vec,<br>                             ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function ‘CreateErrorFE’:<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:841:54: error: incompatible type for argument 5 of ‘PetscDTGaussTensorQuadrature’<br>   ierr = PetscDTGaussTensorQuadrature(dim,2,-1.0,1.0,&quad);CHKERRQ(ierr);<br>                                                      ^<br>In file included from /home/dockimble/PETSc/petsc/include/petscfe.h:7:0,<br>                 from /home/dockimble/PETSc/petsc/include/petscdmda.h:8,<br>                 from /home/dockimble/PETSc/petsc/include/petsc.h:12,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/petscdt.h:34:29: note: expected ‘PetscReal {aka double}’ but argument is of type ‘struct _p_PetscQuadrature **’<br> PETSC_EXTERN PetscErrorCode PetscDTGaussTensorQuadrature(PetscInt,PetscInt,PetscInt,PetscReal,PetscReal,PetscQuadrature*);<br>                             ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:841:10: error: too few arguments to function ‘PetscDTGaussTensorQuadrature’<br>   ierr = PetscDTGaussTensorQuadrature(dim,2,-1.0,1.0,&quad);CHKERRQ(ierr);<br>          ^<br>In file included from /home/dockimble/PETSc/petsc/include/petscfe.h:7:0,<br>                 from /home/dockimble/PETSc/petsc/include/petscdmda.h:8,<br>                 from /home/dockimble/PETSc/petsc/include/petsc.h:12,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/petscdt.h:34:29: note: declared here<br> PETSC_EXTERN PetscErrorCode PetscDTGaussTensorQuadrature(PetscInt,PetscInt,PetscInt,PetscReal,PetscReal,PetscQuadrature*);<br>                             ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function ‘AdaptPorosityExact’:<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:970:49: error: ‘DM_FOREST_REFINE’ undeclared (first use in this function)<br>       ierr = DMLabelSetDefaultValue(refineLabel,DM_FOREST_REFINE);CHKERRQ(ierr);<br>                                                 ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:970:49: note: each undeclared identifier is reported only once for each function it appears in<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:971:14: warning: implicit declaration of function ‘DMForestAdaptLabel’ [-Wimplicit-function-declaration]<br>       ierr = DMForestAdaptLabel(dm,"adapt",&adaptedDM);CHKERRQ(ierr);<br>              ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:988:46: error: ‘DM_FOREST_KEEP’ undeclared (first use in this function)<br>     ierr = DMLabelSetDefaultValue(adaptLabel,DM_FOREST_KEEP);CHKERRQ(ierr);<br>                                              ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:995:45: error: ‘DM_FOREST_COARSEN’ undeclared (first use in this function)<br>         ierr = DMLabelSetValue(adaptLabel,i,DM_FOREST_COARSEN);CHKERRQ(ierr);<br>                                             ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function ‘AdaptPorosityGradient’:<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1151:51: warning: passing argument 4 of ‘PetscQuadratureGetData’ from incompatible pointer type [-Wincompatible-pointer-types]<br>     ierr = PetscQuadratureGetData(q,&dim,&nPoints,&points,&weights);CHKERRQ(ierr);<br>                                                   ^<br>In file included from /home/dockimble/PETSc/petsc/include/petscfe.h:7:0,<br>                 from /home/dockimble/PETSc/petsc/include/petscdmda.h:8,<br>                 from /home/dockimble/PETSc/petsc/include/petsc.h:12,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/petscdt.h:24:29: note: expected ‘PetscInt * {aka int *}’ but argument is of type ‘const PetscReal ** {aka const double **}’<br> PETSC_EXTERN PetscErrorCode PetscQuadratureGetData(PetscQuadrature, PetscInt*, PetscInt*, PetscInt*, const PetscReal *[], const PetscReal *[]);<br>                             ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1151:12: error: too few arguments to function ‘PetscQuadratureGetData’<br>     ierr = PetscQuadratureGetData(q,&dim,&nPoints,&points,&weights);CHKERRQ(ierr);<br>            ^<br>In file included from /home/dockimble/PETSc/petsc/include/petscfe.h:7:0,<br>                 from /home/dockimble/PETSc/petsc/include/petscdmda.h:8,<br>                 from /home/dockimble/PETSc/petsc/include/petsc.h:12,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/petscdt.h:24:29: note: declared here<br> PETSC_EXTERN PetscErrorCode PetscQuadratureGetData(PetscQuadrature, PetscInt*, PetscInt*, PetscInt*, const PetscReal *[], const PetscReal *[]);<br>                             ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1250:49: error: ‘DM_FOREST_REFINE’ undeclared (first use in this function)<br>       ierr = DMLabelSetDefaultValue(refineLabel,DM_FOREST_REFINE);CHKERRQ(ierr);<br>                                                 ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1269:46: error: ‘DM_FOREST_KEEP’ undeclared (first use in this function)<br>     ierr = DMLabelSetDefaultValue(adaptLabel,DM_FOREST_KEEP);CHKERRQ(ierr);<br>                                              ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1283:47: error: ‘DM_FOREST_COARSEN’ undeclared (first use in this function)<br>           ierr = DMLabelSetValue(adaptLabel,i,DM_FOREST_COARSEN);CHKERRQ(ierr);<br>                                               ^<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c: In function ‘main’:<br>/home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:1592:43: warning: passing argument 3 of ‘PetscDSSetObjective’ from incompatible pointer type [-Wincompatible-pointer-types]<br>       ierr = PetscDSSetObjective(prob, 2, compactionRateError);CHKERRQ(ierr);<br>                                           ^<br>In file included from /home/dockimble/PETSc/petsc/include/petsc.h:21:0,<br>                 from /home/dockimble/PETSc/magma-dynamics-problems/src/magma.c:4:<br>/home/dockimble/PETSc/petsc/include/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/lib/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="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>
</div></div></div></div>