From: Martin Kronbichler Date: Wed, 21 Jun 2023 06:06:29 +0000 (+0200) Subject: Spell 'set up' when used as a verb X-Git-Tag: v9.5.0-rc1~61^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=67f80997b728a76121870687f499b4866ebc25fd;p=dealii.git Spell 'set up' when used as a verb --- diff --git a/include/deal.II/base/process_grid.h b/include/deal.II/base/process_grid.h index 9c3b427ab1..f6dd9bbafb 100644 --- a/include/deal.II/base/process_grid.h +++ b/include/deal.II/base/process_grid.h @@ -52,7 +52,7 @@ namespace Utilities * A shared pointer to this class is provided to ScaLAPACKMatrix matrices to * perform block-cyclic distribution. * - * Note that this class allows to setup a process grid which has fewer + * Note that this class allows to set up a process grid which has fewer * MPI cores than the total number of cores in the communicator. * * Currently the only place where one would use a ProcessGrid object is diff --git a/include/deal.II/differentiation/ad/sacado_number_types.h b/include/deal.II/differentiation/ad/sacado_number_types.h index 9680e7b37d..82112d1b3c 100644 --- a/include/deal.II/differentiation/ad/sacado_number_types.h +++ b/include/deal.II/differentiation/ad/sacado_number_types.h @@ -337,7 +337,7 @@ namespace Differentiation // For Sacado::Rad::ADvar numbers, we have to initialize the // ADNumber with an already fully-configured value. This means // that if this nests another ADNumber then the nested number - // must already be setup and ready for use. + // must already be set up and ready for use. // Initialize potential nested directional derivatives derivative_type derivative_initializer; diff --git a/include/deal.II/lac/ginkgo_solver.h b/include/deal.II/lac/ginkgo_solver.h index f9f5889010..ec7bbf0f9d 100644 --- a/include/deal.II/lac/ginkgo_solver.h +++ b/include/deal.II/lac/ginkgo_solver.h @@ -225,7 +225,7 @@ namespace GinkgoWrappers * Constructor. * * @param[in,out] solver_control The solver control object is then used to - * set the parameters and setup the CG solver from the CG factory which + * set the parameters and set up the CG solver from the CG factory which * solves the linear system. * * @param[in] exec_type The execution paradigm for the CG solver. @@ -240,7 +240,7 @@ namespace GinkgoWrappers * Constructor. * * @param[in,out] solver_control The solver control object is then used to - * set the parameters and setup the CG solver from the CG factory which + * set the parameters and set up the CG solver from the CG factory which * solves the linear system. * * @param[in] exec_type The execution paradigm for the CG solver. @@ -281,7 +281,7 @@ namespace GinkgoWrappers * Constructor. * * @param[in,out] solver_control The solver control object is then used to - * set the parameters and setup the Bicgstab solver from the Bicgstab + * set the parameters and set up the Bicgstab solver from the Bicgstab * factory which solves the linear system. * * @param[in] exec_type The execution paradigm for the Bicgstab solver. @@ -296,7 +296,7 @@ namespace GinkgoWrappers * Constructor. * * @param[in,out] solver_control The solver control object is then used to - * set the parameters and setup the Bicgstab solver from the Bicgstab + * set the parameters and set up the Bicgstab solver from the Bicgstab * factory which solves the linear system. * * @param[in] exec_type The execution paradigm for the Bicgstab solver. @@ -339,7 +339,7 @@ namespace GinkgoWrappers * Constructor. * * @param[in,out] solver_control The solver control object is then used to - * set the parameters and setup the CGS solver from the CGS factory which + * set the parameters and set up the CGS solver from the CGS factory which * solves the linear system. * * @param[in] exec_type The execution paradigm for the CGS solver. @@ -354,7 +354,7 @@ namespace GinkgoWrappers * Constructor. * * @param[in,out] solver_control The solver control object is then used to - * set the parameters and setup the CGS solver from the CGS factory which + * set the parameters and set up the CGS solver from the CGS factory which * solves the linear system. * * @param[in] exec_type The execution paradigm for the CGS solver. @@ -406,7 +406,7 @@ namespace GinkgoWrappers * Constructor. * * @param[in,out] solver_control The solver control object is then used to - * set the parameters and setup the FCG solver from the FCG factory which + * set the parameters and set up the FCG solver from the FCG factory which * solves the linear system. * * @param[in] exec_type The execution paradigm for the FCG solver. @@ -421,7 +421,7 @@ namespace GinkgoWrappers * Constructor. * * @param[in,out] solver_control The solver control object is then used to - * set the parameters and setup the FCG solver from the FCG factory which + * set the parameters and set up the FCG solver from the FCG factory which * solves the linear system. * * @param[in] exec_type The execution paradigm for the FCG solver. @@ -472,7 +472,7 @@ namespace GinkgoWrappers * Constructor. * * @param[in,out] solver_control The solver control object is then used to - * set the parameters and setup the GMRES solver from the GMRES factory + * set the parameters and set up the GMRES solver from the GMRES factory * which solves the linear system. * * @param[in] exec_type The execution paradigm for the GMRES solver. @@ -487,7 +487,7 @@ namespace GinkgoWrappers * Constructor. * * @param[in,out] solver_control The solver control object is then used to - * set the parameters and setup the GMRES solver from the GMRES factory + * set the parameters and set up the GMRES solver from the GMRES factory * which solves the linear system. * * @param[in] exec_type The execution paradigm for the GMRES solver. @@ -531,7 +531,7 @@ namespace GinkgoWrappers * Constructor. * * @param[in,out] solver_control The solver control object is then used to - * set the parameters and setup the IR solver from the IR factory which + * set the parameters and set up the IR solver from the IR factory which * solves the linear system. * * @param[in] exec_type The execution paradigm for the IR solver. @@ -546,7 +546,7 @@ namespace GinkgoWrappers * Constructor. * * @param[in,out] solver_control The solver control object is then used to - * set the parameters and setup the IR solver from the IR factory which + * set the parameters and set up the IR solver from the IR factory which * solves the linear system. * * @param[in] exec_type The execution paradigm for the IR solver. diff --git a/include/deal.II/lac/petsc_block_vector.h b/include/deal.II/lac/petsc_block_vector.h index cc69935ed5..642e0e71d4 100644 --- a/include/deal.II/lac/petsc_block_vector.h +++ b/include/deal.II/lac/petsc_block_vector.h @@ -365,7 +365,7 @@ namespace PETScWrappers Vec petsc_nest_vector; /** - * Utility to setup the VECNEST object + * Utility to set up the VECNEST object */ void setup_nest_vec(); diff --git a/include/deal.II/matrix_free/shape_info.templates.h b/include/deal.II/matrix_free/shape_info.templates.h index 411c59c942..f453d5b150 100644 --- a/include/deal.II/matrix_free/shape_info.templates.h +++ b/include/deal.II/matrix_free/shape_info.templates.h @@ -582,7 +582,7 @@ namespace internal univariate_shape_data.nodal_at_cell_boundaries = true; - // TODO: setup face_to_cell_index_nodal, face_to_cell_index_hermite, + // TODO: set up face_to_cell_index_nodal, face_to_cell_index_hermite, // face_orientations return; diff --git a/include/deal.II/numerics/point_value_history.h b/include/deal.II/numerics/point_value_history.h index 54db549e4a..b1a3401f59 100644 --- a/include/deal.II/numerics/point_value_history.h +++ b/include/deal.II/numerics/point_value_history.h @@ -175,8 +175,8 @@ namespace internal * #include * //.... * - * //... code to setup Triangulation, perform any refinement necessary - * // and setup DoFHandler, sizing solution Vectors etc + * //... code to set up Triangulation, perform any refinement necessary + * // and set up DoFHandler, sizing solution Vectors etc * * // just one independent value, which happens to be an input * unsigned int n_inputs = 1; @@ -184,7 +184,7 @@ namespace internal * // call the constructor * PointValueHistory node_monitor(dof_handler, n_inputs); * - * // setup fields and points required + * // set up fields and points required * node_monitor.add_field_name("Solution"); * std::vector > point_vector(2); * point_vector[0] = Point (0, 0); diff --git a/include/deal.II/trilinos/nox.templates.h b/include/deal.II/trilinos/nox.templates.h index f91a9784b8..b33fcfa067 100644 --- a/include/deal.II/trilinos/nox.templates.h +++ b/include/deal.II/trilinos/nox.templates.h @@ -355,7 +355,7 @@ namespace TrilinosWrappers public: /** * Constructor. The class is initialized by the solution vector and - * functions to compute the residual, to setup the jacobian, and + * functions to compute the residual, to set up the jacobian, and * to solve the Jacobian. */ Group( @@ -768,7 +768,7 @@ namespace TrilinosWrappers std::function residual; /** - * A helper function to setup Jacobian. + * A helper function to set up Jacobian. */ std::function setup_jacobian; diff --git a/source/base/mpi_noncontiguous_partitioner.cc b/source/base/mpi_noncontiguous_partitioner.cc index 6a00ef16fd..3f4ba90765 100644 --- a/source/base/mpi_noncontiguous_partitioner.cc +++ b/source/base/mpi_noncontiguous_partitioner.cc @@ -105,7 +105,7 @@ namespace Utilities buffers.clear(); requests.clear(); - // setup communication pattern + // set up communication pattern std::vector owning_ranks_of_ghosts( indexset_want.n_elements()); @@ -124,7 +124,7 @@ namespace Utilities consensus_algorithm; consensus_algorithm.run(process, communicator); - // setup map of processes from where this rank will receive values + // set up map of processes from where this rank will receive values { std::map> recv_map; @@ -215,7 +215,7 @@ namespace Utilities index_set_want.add_indices(indices_want_clean.begin(), indices_want_clean.end()); - // step 2) setup internal data structures with indexset + // step 2) set up internal data structures with indexset this->reinit(index_set_has, index_set_want, communicator); // step 3) fix inner data structures so that it is sorted as diff --git a/source/base/partitioner.cc b/source/base/partitioner.cc index 9f4a47542a..4c0177ee40 100644 --- a/source/base/partitioner.cc +++ b/source/base/partitioner.cc @@ -314,7 +314,7 @@ namespace Utilities // find how much the individual processes that want import from me std::map import_data = process.get_requesters(); - // count import requests and setup the compressed indices + // count import requests and set up the compressed indices n_import_indices_data = 0; import_targets_data = {}; import_targets_data.reserve(import_data.size()); diff --git a/source/distributed/repartitioning_policy_tools.cc b/source/distributed/repartitioning_policy_tools.cc index e1deb26c1b..4e77977e71 100644 --- a/source/distributed/repartitioning_policy_tools.cc +++ b/source/distributed/repartitioning_policy_tools.cc @@ -329,7 +329,7 @@ namespace RepartitioningPolicyTools mpi_communicator); AssertThrowMPI(ierr); - // setup partition + // set up partition LinearAlgebra::distributed::Vector partition(partitioner); for (std::uint64_t i = 0, weight = process_local_weight_offset; diff --git a/source/numerics/point_value_history.cc b/source/numerics/point_value_history.cc index 74ece23a49..cbb5f92005 100644 --- a/source/numerics/point_value_history.cc +++ b/source/numerics/point_value_history.cc @@ -227,8 +227,7 @@ PointValueHistory::add_point(const Point &location) for (unsigned int support_point = 0; support_point < n_support_points; support_point++) { - // setup valid data in the empty - // vectors + // set up valid data in the empty vectors unsigned int component = dof_handler->get_fe().system_to_component_index(support_point).first; current_points[component] = fe_values.quadrature_point(support_point); @@ -373,8 +372,7 @@ PointValueHistory::add_points(const std::vector> &locations) for (unsigned int support_point = 0; support_point < n_support_points; support_point++) { - // setup valid data in the empty - // vectors + // set up valid data in the empty vectors unsigned int component = dof_handler->get_fe().system_to_component_index(support_point).first; temp_points[component] = fe_values.quadrature_point(support_point);