Skip to content

Commit

Permalink
Apply suggestions from code review
Browse files Browse the repository at this point in the history
Fixed comment capitalization errors
  • Loading branch information
drreynolds authored Apr 26, 2024
1 parent 92eb0b9 commit 5ecb883
Show file tree
Hide file tree
Showing 29 changed files with 44 additions and 44 deletions.
4 changes: 2 additions & 2 deletions examples/arkode/CXX_parallel/ark_heat2D_p.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -41,7 +41,7 @@
* problem is advanced in time with a diagonally implicit Runge-Kutta method
* using an inexact Newton method paired with the PCG or SPGMR linear solver.
* Several command line options are available to change the problem parameters
* and ARKode settings. Use the flag --help for more information.
* and ARKODE settings. Use the flag --help for more information.
* ---------------------------------------------------------------------------*/

#include <cmath>
Expand Down Expand Up @@ -382,7 +382,7 @@ int main(int argc, char* argv[])
}

// --------------
// Setup ARKode
// Setup ARKODE
// --------------

// Create integrator
Expand Down
4 changes: 2 additions & 2 deletions examples/arkode/CXX_parhyp/ark_heat2D_hypre_ls.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -41,7 +41,7 @@
* problem is advanced in time with a diagonally implicit Runge-Kutta method
* using an inexact Newton method paired with the hypre's PCG or GMRES linear
* solver and PFMG preconditioner. Several command line options are available
* to change the problem parameters and ARKode settings. Use the flag --help
* to change the problem parameters and ARKODE settings. Use the flag --help
* for more information.
* ---------------------------------------------------------------------------*/

Expand Down Expand Up @@ -439,7 +439,7 @@ int main(int argc, char* argv[])
if (check_flag((void*)LS, "HypreLS", 0)) { return 1; }

// --------------
// Setup ARKode
// Setup ARKODE
// --------------

// Create integrator
Expand Down
4 changes: 2 additions & 2 deletions examples/arkode/CXX_parhyp/ark_heat2D_hypre_pfmg.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -41,7 +41,7 @@
* problem is advanced in time with a diagonally implicit Runge-Kutta method
* using an inexact Newton method paired with the PCG or SPGMR linear solver
* using hypre's PFMG preconditioner. Several command line options are available
* to change the problem parameters and ARKode settings. Use the flag --help
* to change the problem parameters and ARKODE settings. Use the flag --help
* for more information.
* ---------------------------------------------------------------------------*/

Expand Down Expand Up @@ -412,7 +412,7 @@ int main(int argc, char* argv[])
}

// --------------
// Setup ARKode
// Setup ARKODE
// --------------

// Create integrator
Expand Down
4 changes: 2 additions & 2 deletions examples/arkode/CXX_parhyp/ark_heat2D_hypre_pfmg_imex.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -41,7 +41,7 @@
* If the requested accuracy is 5th order, the problem is treated implicitly.
* This option is included for computing a reference solution.
* Several command line options are available to
* change the problem parameters and ARKode settings. Use the flag --help for
* change the problem parameters and ARKODE settings. Use the flag --help for
* more information.
* ---------------------------------------------------------------------------*/

Expand Down Expand Up @@ -391,7 +391,7 @@ int main(int argc, char* argv[])
}

// ----------------------------------------------
// Setup ARKode integrator and set options
// Setup ARKODE integrator and set options
// ----------------------------------------------

// Create integrator
Expand Down
2 changes: 1 addition & 1 deletion examples/arkode/CXX_parhyp/ark_heat2D_hypre_pfmg_mri.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -39,7 +39,7 @@
* an inexact Newton method paired with the PCG linear solver using hypre's PFMG
* preconditioner for the slow-implicit nonlinear solve and inexact Newton with
* GMRES for the fast nonlinear solve. Several command line options are
* available to change the problem parameters and ARKode settings. Use the flag
* available to change the problem parameters and ARKODE settings. Use the flag
* --help for more information.
* ---------------------------------------------------------------------------*/

Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -178,7 +178,7 @@ int main(int argc, char* argv[])
// Setup the integrator
// --------------------

// ARKode memory structure
// ARKODE memory structure
void* arkode_mem = nullptr;

// Matrix and linear solver for DIRK, IMEX, or MRI slow integrators
Expand Down
4 changes: 2 additions & 2 deletions examples/arkode/CXX_serial/ark_heat2D.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -41,7 +41,7 @@
* problem is advanced in time with a diagonally implicit Runge-Kutta method
* using an inexact Newton method paired with the PCG or SPGMR linear solver.
* Several command line options are available to change the problem parameters
* and ARKode settings. Use the flag --help for more information.
* and ARKODE settings. Use the flag --help for more information.
* ---------------------------------------------------------------------------*/

#include <chrono>
Expand Down Expand Up @@ -290,7 +290,7 @@ int main(int argc, char* argv[])
}

// --------------
// Setup ARKode
// Setup ARKODE
// --------------

// Create integrator
Expand Down
4 changes: 2 additions & 2 deletions examples/arkode/CXX_serial/ark_kpr_Mt.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -157,7 +157,7 @@ int main(int argc, char* argv[])
// general problem variables
int retval; // reusable error-checking flag
N_Vector y = NULL; // empty vector for the computed solution
void* arkode_mem = NULL; // empty ARKode memory structure
void* arkode_mem = NULL; // empty ARKODE memory structure
SUNMatrix A = NULL; // empty system matrix
SUNMatrix M = NULL; // empty mass matrix
SUNLinearSolver LS = NULL; // empty system linear solver object
Expand Down Expand Up @@ -667,7 +667,7 @@ static int check_order(void* arkode_mem, N_Vector y, sunrealtype T0,
cout << " -----------------------------------------------------\n";
for (size_t ih = 0; ih < hvals.size(); ih++)
{
// Reset ARKode for this run
// Reset ARKODE for this run
retval = Ytrue(T0, y);
if (check_retval(&retval, "Ytrue", 1)) { return 1; }
retval = ARKodeReset(arkode_mem, T0, y);
Expand Down
2 changes: 1 addition & 1 deletion examples/arkode/CXX_serial/ark_pendulum.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -370,7 +370,7 @@ int main(int argc, char* argv[])
* Clean up *
* -------- */

// Free ARKode integrator and SUNDIALS objects
// Free ARKODE integrator and SUNDIALS objects
ARKodeFree(&arkode_mem);
SUNLinSolFree(LS);
SUNMatDestroy(A);
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -481,7 +481,7 @@ int main(int argc, char* argv[])
MPI_Abort(grid.comm, 1);
}

/* Attach the matrix, linear solver, and Jacobian construction routine to ARKode */
/* Attach the matrix, linear solver, and Jacobian construction routine to ARKODE */
retval = ARKodeSetLinearSolver(arkode_mem, LS, A);
if (check_retval(&retval, "ARKodeSetLinearSolver", 1))
{
Expand All @@ -492,7 +492,7 @@ int main(int argc, char* argv[])
retval = ARKodeSetJacFn(arkode_mem, Jac);
if (check_retval(&retval, "ARKodeSetJacFn", 1)) { MPI_Abort(grid.comm, 1); }

/* Attach the mass matrix, linear solver and construction routines to ARKode;
/* Attach the mass matrix, linear solver and construction routines to ARKODE;
notify ARKode that the mass matrix is not time-dependent */
retval = ARKodeSetMassLinearSolver(arkode_mem, MLS, M, SUNFALSE);
if (check_retval(&retval, "ARKodeSetMassLinearSolver", 1))
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -448,7 +448,7 @@ int main(int argc, char* argv[])
}

// --------------
// Setup ARKode
// Setup ARKODE
// --------------

// Create integrator
Expand Down
2 changes: 1 addition & 1 deletion examples/arkode/CXX_xbraid/ark_heat2D_p_xbraid.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -402,7 +402,7 @@ int main(int argc, char* argv[])
}

// --------------
// Setup ARKode
// Setup ARKODE
// --------------

// Create integrator
Expand Down
4 changes: 2 additions & 2 deletions examples/arkode/CXX_xbraid/ark_heat2D_xbraid.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -41,7 +41,7 @@
* with a diagonally implicit Runge-Kutta method from the ARKODE ARKStep module
* using an inexact Newton method paired with the PCG or SPGMR linear solver.
* Several command line options are available to change the problem parameters
* and ARKode settings. Use the flag --help for more information.
* and ARKODE settings. Use the flag --help for more information.
* ---------------------------------------------------------------------------*/

#include <chrono>
Expand Down Expand Up @@ -340,7 +340,7 @@ int main(int argc, char* argv[])
}

// --------------
// Setup ARKode
// Setup ARKODE
// --------------

// Create integrator
Expand Down
4 changes: 2 additions & 2 deletions examples/arkode/C_openmp/ark_heat1D_omp.c
Original file line number Diff line number Diff line change
Expand Up @@ -97,7 +97,7 @@ int main(int argc, char* argv[])
int flag; /* reusable error-checking flag */
N_Vector y = NULL; /* empty vector for storing solution */
SUNLinearSolver LS = NULL; /* empty linear solver object */
void* arkode_mem = NULL; /* empty ARKode memory structure */
void* arkode_mem = NULL; /* empty ARKODE memory structure */
FILE *FID, *UFID;
sunrealtype t, dTout, tout;
int iout, num_threads;
Expand Down Expand Up @@ -156,7 +156,7 @@ int main(int argc, char* argv[])

/* Linear solver interface -- set user-supplied J*v routine (no 'jtsetup' required) */
flag = ARKodeSetLinearSolver(arkode_mem, LS,
NULL); /* Attach linear solver to ARKode */
NULL); /* Attach linear solver to ARKODE */
if (check_flag(&flag, "ARKodeSetLinearSolver", 1)) { return 1; }
flag = ARKodeSetJacTimes(arkode_mem, NULL, Jac); /* Set the Jacobian routine */
if (check_flag(&flag, "ARKodeSetJacTimes", 1)) { return 1; }
Expand Down
2 changes: 1 addition & 1 deletion examples/arkode/C_openmpdev/ark_analytic_nonlin_ompdev.c
Original file line number Diff line number Diff line change
Expand Up @@ -116,7 +116,7 @@ int main(void)
while (Tf - t > 1.0e-15)
{
flag = ARKodeEvolve(arkode_mem, tout, y, &t, ARK_NORMAL); /* call integrator */
if (check_flag(&flag, "ARKode", 1)) { break; }
if (check_flag(&flag, "ARKodeEvolve", 1)) { break; }
N_VCopyFromDevice_OpenMPDEV(y);
printf(" %10.6" FSYM " %10.6" FSYM "\n", t,
y_data[0]); /* access/print solution */
Expand Down
4 changes: 2 additions & 2 deletions examples/arkode/C_openmpdev/ark_heat1D_adapt_ompdev.c
Original file line number Diff line number Diff line change
Expand Up @@ -213,7 +213,7 @@ int main(void)

/* Linear solver interface -- set user-supplied J*v routine (no 'jtsetup' required) */
flag = ARKodeSetLinearSolver(arkode_mem, LS,
NULL); /* Attach linear solver to ARKode */
NULL); /* Attach linear solver to ARKODE */
if (check_flag(&flag, "ARKodeSetLinearSolver", 1)) { return 1; }
flag = ARKodeSetJacTimes(arkode_mem, NULL, Jac); /* Set the Jacobian routine */
if (check_flag(&flag, "ARKodeSetJacTimes", 1)) { return 1; }
Expand Down Expand Up @@ -311,7 +311,7 @@ int main(void)
flag = ARKodeResize(arkode_mem, y, hscale, t, NULL, NULL);
if (check_flag(&flag, "ARKodeResize", 1)) { return 1; }

/* destroy and re-allocate linear solver memory; reattach to ARKode interface */
/* destroy and re-allocate linear solver memory; reattach to ARKODE interface */
SUNLinSolFree(LS);
LS = SUNLinSol_PCG(y, 0, (int)N, ctx);
if (check_flag((void*)LS, "SUNLinSol_PCG", 0)) { return 1; }
Expand Down
2 changes: 1 addition & 1 deletion examples/arkode/C_openmpdev/ark_heat1D_ompdev.c
Original file line number Diff line number Diff line change
Expand Up @@ -97,7 +97,7 @@ int main(void)
int flag; /* reusable error-checking flag */
N_Vector y = NULL; /* empty vector for storing solution */
SUNLinearSolver LS = NULL; /* empty linear solver object */
void* arkode_mem = NULL; /* empty ARKode memory structure */
void* arkode_mem = NULL; /* empty ARKODE memory structure */
FILE *FID, *UFID;
sunrealtype t, dTout, tout;
int iout;
Expand Down
2 changes: 1 addition & 1 deletion examples/arkode/C_parallel/ark_diurnal_kry_bbd_p.c
Original file line number Diff line number Diff line change
Expand Up @@ -241,7 +241,7 @@ int main(int argc, char* argv[])
flag = ARKodeSStolerances(arkode_mem, reltol, abstol);
if (check_flag(&flag, "ARKodeSStolerances", 1, my_pe)) { return (1); }

/* Attach SPGMR solver structure to ARKode interface */
/* Attach SPGMR solver structure to ARKODE interface */
flag = ARKodeSetLinearSolver(arkode_mem, LS, NULL);
if (check_flag(&flag, "ARKodeSetLinearSolver", 1, my_pe))
{
Expand Down
2 changes: 1 addition & 1 deletion examples/arkode/C_parallel/ark_diurnal_kry_p.c
Original file line number Diff line number Diff line change
Expand Up @@ -255,7 +255,7 @@ int main(int argc, char* argv[])
flag = ARKodeSStolerances(arkode_mem, reltol, abstol);
if (check_flag(&flag, "ARKodeSStolerances", 1, my_pe)) { return (1); }

/* Attach SPGMR solver structure to ARKode interface */
/* Attach SPGMR solver structure to ARKODE interface */
flag = ARKodeSetLinearSolver(arkode_mem, LS, NULL);
if (check_flag(&flag, "ARKodeSetLinearSolver", 1, my_pe))
{
Expand Down
2 changes: 1 addition & 1 deletion examples/arkode/C_parhyp/ark_diurnal_kry_ph.c
Original file line number Diff line number Diff line change
Expand Up @@ -263,7 +263,7 @@ int main(int argc, char* argv[])
flag = ARKodeSStolerances(arkode_mem, reltol, abstol);
if (check_flag(&flag, "ARKodeSStolerances", 1, my_pe)) { return (1); }

/* Attach SPGMR solver structure to ARKode interface */
/* Attach SPGMR solver structure to ARKODE interface */
flag = ARKodeSetLinearSolver(arkode_mem, LS, NULL);
if (check_flag(&flag, "ARKodeSetLinearSolver", 1, my_pe))
{
Expand Down
8 changes: 4 additions & 4 deletions examples/arkode/C_petsc/ark_petsc_ex25.c
Original file line number Diff line number Diff line change
Expand Up @@ -60,7 +60,7 @@ static PetscErrorCode FormIFunction(PetscReal, Vec, Vec, Vec, void*);
static PetscErrorCode FormIJacobian(SNES, Vec, Mat, Mat, void*);
static PetscErrorCode FormInitialSolution(Vec, void*);

/* User-supplied Functions called by ARKode */
/* User-supplied Functions called by ARKODE */
static int f_I(PetscReal, N_Vector, N_Vector, void*);
static int f_E(PetscReal, N_Vector, N_Vector, void*);

Expand Down Expand Up @@ -188,7 +188,7 @@ int main(int argc, char** argv)
dt = 0.4 * PetscSqr(hx) / user.alpha; /* Diffusive stability limit */

/* - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - -
Create ARKode time stepper
Create ARKODE time stepper
- - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - */

/* Call ARKStepCreate to initialize the ARK timestepper module and
Expand Down Expand Up @@ -225,7 +225,7 @@ int main(int argc, char** argv)
CHKERRQ(ierr);

/* - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - -
Set ARKode options
Set ARKODE options
- - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - */

ierr = ARKodeSStolerances(arkode_mem, rtol, atol);
Expand Down Expand Up @@ -305,7 +305,7 @@ int main(int argc, char** argv)
}

/* - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - -
User provided functions in ARKode format
User provided functions in ARKODE format
- - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - */

/* Implicit component of RHS */
Expand Down
4 changes: 2 additions & 2 deletions examples/arkode/C_serial/ark_analytic_mels.c
Original file line number Diff line number Diff line change
Expand Up @@ -46,7 +46,7 @@
#define FSYM "f"
#endif

/* User-supplied functions called by ARKode */
/* User-supplied functions called by ARKODE */
static int f(sunrealtype t, N_Vector y, N_Vector ydot, void* user_data);

/* Custom linear solver data structure, accessor macros, and routines */
Expand Down Expand Up @@ -249,7 +249,7 @@ static int MatrixEmbeddedLSSolve(SUNLinearSolver LS, SUNMatrix A, N_Vector x,
sunrealtype* rdata;
sunrealtype lamda;

/* retrieve implicit system data from ARKode */
/* retrieve implicit system data from ARKODE */
retval = ARKodeGetNonlinearSystemData(LS->content, &tcur, &zpred, &z, &Fi,
&gamma, &sdata, &user_data);
if (check_retval((void*)&retval, "ARKodeGetNonlinearSystemData", 1))
Expand Down
2 changes: 1 addition & 1 deletion examples/arkode/C_serial/ark_brusselator1D_FEM_slu.c
Original file line number Diff line number Diff line change
Expand Up @@ -311,7 +311,7 @@ int main(int argc, char* argv[])
MLS = SUNLinSol_SuperLUMT(y, M, num_threads, ctx);
if (check_retval((void*)MLS, "SUNLinSol_SuperLUMT", 0)) { return (1); }

/* Attach the matrix, linear solver, and Jacobian construction routine to ARKode */
/* Attach the matrix, linear solver, and Jacobian construction routine to ARKODE */

/* Attach matrix and LS */
retval = ARKodeSetLinearSolver(arkode_mem, LS, A);
Expand Down
2 changes: 1 addition & 1 deletion examples/arkode/C_serial/ark_brusselator1D_klu.c
Original file line number Diff line number Diff line change
Expand Up @@ -236,7 +236,7 @@ int main(void)
LS = SUNLinSol_KLU(y, A, ctx);
if (check_flag((void*)LS, "SUNLinSol_KLU", 0)) { return 1; }

/* Attach the matrix, linear solver, and Jacobian construction routine to ARKode */
/* Attach the matrix, linear solver, and Jacobian construction routine to ARKODE */
flag = ARKodeSetLinearSolver(arkode_mem, LS, A); /* Attach matrix and LS */
if (check_flag(&flag, "ARKodeSetLinearSolver", 1)) { return 1; }
flag = ARKodeSetJacFn(arkode_mem, Jac); /* Supply Jac routine */
Expand Down
2 changes: 1 addition & 1 deletion examples/arkode/C_serial/ark_brusselator_fp.c
Original file line number Diff line number Diff line change
Expand Up @@ -185,7 +185,7 @@ int main(int argc, char* argv[])
arkode_mem = ARKStepCreate(fe, fi, T0, y, ctx);
if (check_flag((void*)arkode_mem, "ARKStepCreate", 0)) { return 1; }

/* Initialize fixed-point nonlinear solver and attach to ARKode */
/* Initialize fixed-point nonlinear solver and attach to ARKODE */
NLS = SUNNonlinSol_FixedPoint(y, fp_m, ctx);
if (check_flag((void*)NLS, "SUNNonlinSol_FixedPoint", 0)) { return 1; }

Expand Down
2 changes: 1 addition & 1 deletion examples/arkode/C_serial/ark_dissipated_exp_entropy.c
Original file line number Diff line number Diff line change
Expand Up @@ -383,7 +383,7 @@ int main(int argc, char* argv[])
* Clean up *
* -------- */

/* Free ARKode integrator and SUNDIALS objects */
/* Free ARKODE integrator and SUNDIALS objects */
ARKodeFree(&arkode_mem);
SUNLinSolFree(LS);
SUNMatDestroy(A);
Expand Down
2 changes: 1 addition & 1 deletion examples/arkode/C_serial/ark_heat1D.c
Original file line number Diff line number Diff line change
Expand Up @@ -141,7 +141,7 @@ int main(void)

/* Linear solver interface -- set user-supplied J*v routine (no 'jtsetup' required) */
flag = ARKodeSetLinearSolver(arkode_mem, LS,
NULL); /* Attach linear solver to ARKode */
NULL); /* Attach linear solver to ARKODE */
if (check_flag(&flag, "ARKodeSetLinearSolver", 1)) { return 1; }
flag = ARKodeSetJacTimes(arkode_mem, NULL, Jac); /* Set the Jacobian routine */
if (check_flag(&flag, "ARKodeSetJacTimes", 1)) { return 1; }
Expand Down
4 changes: 2 additions & 2 deletions examples/arkode/C_serial/ark_heat1D_adapt.c
Original file line number Diff line number Diff line change
Expand Up @@ -184,7 +184,7 @@ int main(void)

/* Linear solver interface -- set user-supplied J*v routine (no 'jtsetup' required) */
flag = ARKodeSetLinearSolver(arkode_mem, LS,
NULL); /* Attach linear solver to ARKode */
NULL); /* Attach linear solver to ARKODE */
if (check_flag(&flag, "ARKodeSetLinearSolver", 1)) { return 1; }
flag = ARKodeSetJacTimes(arkode_mem, NULL, Jac); /* Set the Jacobian routine */
if (check_flag(&flag, "ARKodeSetJacTimes", 1)) { return 1; }
Expand Down Expand Up @@ -266,7 +266,7 @@ int main(void)
flag = ARKodeResize(arkode_mem, y, hscale, t, NULL, NULL);
if (check_flag(&flag, "ARKodeResize", 1)) { return 1; }

/* destroy and re-allocate linear solver memory; reattach to ARKode interface */
/* destroy and re-allocate linear solver memory; reattach to ARKODE interface */
SUNLinSolFree(LS);
LS = SUNLinSol_PCG(y, 0, (int)N, ctx);
if (check_flag((void*)LS, "SUNLinSol_PCG", 0)) { return 1; }
Expand Down
2 changes: 1 addition & 1 deletion examples/arkode/F2003_custom/ark_brusselator1D_f2003.f90
Original file line number Diff line number Diff line change
Expand Up @@ -334,7 +334,7 @@ program main
stop 1
end if

! initialize custom matrix data structure and solver; attach to ARKode
! initialize custom matrix data structure and solver; attach to ARKODE
sunmat_A => FSUNMatNew_Fortran(Nvar, N, sunctx)
if (.not. associated(sunmat_A)) then
print *,'ERROR: sunmat = NULL'
Expand Down

0 comments on commit 5ecb883

Please sign in to comment.