From e165c45037aa74809d864b446ae467dc0870d307 Mon Sep 17 00:00:00 2001 From: Denis Davydov Date: Tue, 29 Dec 2015 10:44:19 +0100 Subject: [PATCH] rename initialise() to initialize() and remove an empty line --- include/deal.II/lac/petsc_precondition.h | 1 - include/deal.II/lac/petsc_solver.h | 4 ++-- source/lac/petsc_solver.cc | 2 +- tests/slepc/step-36_parallel.cc | 4 ++-- 4 files changed, 5 insertions(+), 6 deletions(-) diff --git a/include/deal.II/lac/petsc_precondition.h b/include/deal.II/lac/petsc_precondition.h index 48008b4fcd..74da30a338 100644 --- a/include/deal.II/lac/petsc_precondition.h +++ b/include/deal.II/lac/petsc_precondition.h @@ -152,7 +152,6 @@ namespace PETScWrappers PreconditionJacobi (const MPI_Comm communicator, const AdditionalData &additional_data = AdditionalData()); - /** * Initializes the preconditioner object and calculate all data that is * necessary for applying it in a solver. This function is automatically diff --git a/include/deal.II/lac/petsc_solver.h b/include/deal.II/lac/petsc_solver.h index 55a18791e3..89e7914ff9 100644 --- a/include/deal.II/lac/petsc_solver.h +++ b/include/deal.II/lac/petsc_solver.h @@ -157,10 +157,10 @@ namespace PETScWrappers SolverControl &control() const; /** - * Initialise the solver with the preconditioner. + * initialize the solver with the preconditioner. * This function is intended for use with SLEPc spectral transformation class. */ - void initialise(const PreconditionerBase &preconditioner); + void initialize(const PreconditionerBase &preconditioner); /** * Exception diff --git a/source/lac/petsc_solver.cc b/source/lac/petsc_solver.cc index 4e702f4bce..bd8c986476 100644 --- a/source/lac/petsc_solver.cc +++ b/source/lac/petsc_solver.cc @@ -206,7 +206,7 @@ namespace PETScWrappers } void - SolverBase::initialise(const PreconditionerBase &preconditioner) + SolverBase::initialize(const PreconditionerBase &preconditioner) { int ierr; diff --git a/tests/slepc/step-36_parallel.cc b/tests/slepc/step-36_parallel.cc index 64cffb4854..a675833b29 100644 --- a/tests/slepc/step-36_parallel.cc +++ b/tests/slepc/step-36_parallel.cc @@ -114,7 +114,7 @@ void test (std::string solver_name, mpi_communicator, locally_relevant_dofs); - // Initialise the stiffness and mass matrices + // initialize the stiffness and mass matrices stiffness_matrix.reinit (locally_owned_dofs, locally_owned_dofs, csp, @@ -222,7 +222,7 @@ void test (std::string solver_name, dealii::SolverControl linear_solver_control (dof_handler.n_dofs(), 1e-12,/*log_history*/false,/*log_results*/false); PETScWrappers::SolverCG linear_solver(linear_solver_control,mpi_communicator); - linear_solver.initialise(*preconditioner); + linear_solver.initialize(*preconditioner); for (unsigned int i=0; i < eigenvalues.size(); i++) eigenfunctions[i] = PetscScalar(); -- 2.39.5