* 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
// 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;
* 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.
* 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.
* 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.
* 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.
* 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.
* 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.
* 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.
* 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.
* 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.
* 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.
* 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.
* 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.
Vec petsc_nest_vector;
/**
- * Utility to setup the VECNEST object
+ * Utility to set up the VECNEST object
*/
void
setup_nest_vec();
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;
* #include <deal.II/numerics/point_value_history.h>
* //....
*
- * //... 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;
* // call the constructor
* PointValueHistory<dim> 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 <dim> > point_vector(2);
* point_vector[0] = Point <dim>(0, 0);
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(
std::function<int(const VectorType &x, VectorType &f)> residual;
/**
- * A helper function to setup Jacobian.
+ * A helper function to set up Jacobian.
*/
std::function<int(const VectorType &x)> setup_jacobian;
buffers.clear();
requests.clear();
- // setup communication pattern
+ // set up communication pattern
std::vector<unsigned int> owning_ranks_of_ghosts(
indexset_want.n_elements());
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<unsigned int, std::vector<types::global_dof_index>> recv_map;
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
// find how much the individual processes that want import from me
std::map<unsigned int, IndexSet> 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());
mpi_communicator);
AssertThrowMPI(ierr);
- // setup partition
+ // set up partition
LinearAlgebra::distributed::Vector<double> partition(partitioner);
for (std::uint64_t i = 0, weight = process_local_weight_offset;
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);
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);