* GridTools::internal::DistributedComputePointLocationsInternal.
*
* This function is called internally by the reinit() function above.
- * Having it as a seperate function makes it possible to setup the class
+ * Having it as a separate function makes it possible to setup the class
* if it is known in which cells corresponding reference points are
* located (e.g. if intersections of cells are known).
*/
* }
* @endcode
* The advantage of using json-files is that this format is natively supported
- * by Python, simplifying the running of paramter studies tremendously.
+ * by Python, simplifying the running of parameter studies tremendously.
*
* <h3>Including other input files</h3>
*
*
* This constructor obviously requires that the @p ElementType type is
* either equal to @p Number, or is convertible to @p Number.
- * Number.
*
* @note This function can also be used in @ref GlossDevice "device" code.
*/
using SolverCG = TrilinosWrappers::SolverCG;
/**
- * Typdef for the GMRES solver type used.
+ * Typedef for the GMRES solver type used.
*/
using SolverGMRES = TrilinosWrappers::SolverGMRES;
*
* @note By default, the GPU @ref GlossDevice "device" id is chosen in a round-robin fashion
* according to the local MPI rank id. To choose a different @ref GlossDevice "device", Kokkos
- * has to be initialized explicitly providing the respective devide id
+ * has to be initialized explicitly providing the respective device id
* explicitly.
*
* <h4>MPI-3 shared-memory support</h4>
* associated to the @p indices_want only.
*
* This emulates the corresponding constructor in
- * Utilies::MPI::NoncontiguousPartitioner.
+ * Utilities::MPI::NoncontiguousPartitioner.
*/
void
reinit(const std::vector<types::global_dof_index> &indices_locally_owned,
* @param maximum_non_linear_iterations Maximum number of iterations allowed.
* @param max_n_function_evaluations Maximum number of function evaluations allowed.
*
- * @note All parameters values specified here can be overriden by
+ * @note All parameters values specified here can be overridden by
* command line choices.
*
* @ingroup PETScWrappers
// case is to use FD and thus assemble a dense operator by finite
// differencing the residual callbacks. Here instead we decide to
// use a full matrix-free approach by default. This choice can always
- // be overriden from command line.
+ // be overridden from command line.
{
set_use_matrix_free(snes, false, true);
}
// In case solve_with_jacobian is provided, create a shell
// preconditioner wrapping the user call. The internal Krylov
// solver will apply the preconditioner only once. This choice
- // can be overriden by command line and users can use any other
+ // can be overridden by command line and users can use any other
// Krylov method if their solve is not accurate enough.
// Using solve_with_jacobian as a preconditioner allows users
// to provide approximate solvers and possibly iterate on a matrix-free
* Initialize a Matrix from a PETSc Mat object. Note that we do not copy
* the matrix. The Mat object is referenced by the newly created instance
* of the class using PetscObjectReference. This is in line with the PETSc
- * approach to object ownership, which mimicks std::shared_ptr.
+ * approach to object ownership, which mimics std::shared_ptr.
*/
explicit SparseMatrix(const Mat &);
* Initialize a SparseMatrix from a PETSc Mat object. Note that we do not
* copy the matrix. The Mat object is referenced by the newly created
* instance of the class using PetscObjectReference. This is in line with
- * the PETSc approach to object ownership, which mimicks std::shared_ptr.
+ * the PETSc approach to object ownership, which mimics std::shared_ptr.
*/
explicit SparseMatrix(const Mat &);
* Adaptive time stepping is disabled by default.
* Negative values indicate using PETSc's default.
*
- * @note All parameters values specified here can be overriden by
+ * @note All parameters values specified here can be overridden by
* command line choices.
*
* @ingroup PETScWrappers
// case is to use FD and thus assemble a dense operator by finite
// differencing the residual callbacks. Here instead we decide to
// use a full matrix-free approach by default. This choice can always
- // be overriden from command line.
+ // be overridden from command line.
if (!explicit_jacobian && !implicit_jacobian)
{
set_use_matrix_free(ts, false, true);
// In case solve_with_jacobian is provided, create a shell
// preconditioner wrapping the user call. The default internal Krylov
// solver only applies the preconditioner. This choice
- // can be overriden by command line and users can use any other
+ // can be overridden by command line and users can use any other
// Krylov method if their solve is not accurate enough.
// Using solve_with_jacobian as a preconditioner allow users
// to provide approximate solvers and possibly iterate on a matrix-free
};
/**
- * Consturctor.
+ * Constructor.
*/
TensorProductMatrixSymmetricSumCollection(
const AdditionalData &additional_data = AdditionalData());
* want to compile all degrees up to eight; recommended setting) or by
* compiling `evaluation_template_factory.templates.h` and
* `evaluation_template_face_factory.templates.h` with the
- * `FE_EVAL_FACTORY_DEGREE_MAX` overriden to the desired value. In the second
+ * `FE_EVAL_FACTORY_DEGREE_MAX` overridden to the desired value. In the second
* option, symbols will be available twice, and it depends on your linker and
* dynamic library loader whether the user-specified setting takes precedence;
* use `LD_PRELOAD` to select the desired library. You can check if fast
bool fast_path;
/**
- * Connection to NonMatching::MappingInfo to check wheter mapping data
+ * Connection to NonMatching::MappingInfo to check whether mapping data
* has been invalidated.
*/
boost::signals2::connection connection_is_reinitialized;
matrix_free;
/**
- * Index of the valid FE. Currently, ony a single one is supported.
+ * Index of the valid FE. Currently, only a single one is supported.
*/
unsigned int fe_index_valid;
};
dof_handler.get_fe().n_dofs_per_cell() ==
dof_handler_support_points.get_fe().n_dofs_per_cell(),
ExcMessage(
- "For now multple components are not considered and therefore DoFHandlers need the same degree."));
+ "For now multiple components are not considered and therefore DoFHandlers need the same degree."));
const auto degree = dof_handler.get_fe().degree;
const auto dofs_per_cell = dof_handler.get_fe().n_dofs_per_cell();
* is
* false) the call to the coarse solver on @p level.
*
- * The coarse solve will be done with ``defect[leve]`` and returned in
+ * The coarse solve will be done with ``defect[level]`` and returned in
* ``solution[level]``, which can be inspected by the user using this
* signal.
*/
* Read IGES files and translate their content into openCascade topological
* entities. The option scale_factor is used to compensate for different
* units being used in the IGES files and in the target application. The
- * standard unit for IGES files is millimiters. The return object is a
+ * standard unit for IGES files is millimeters. The return object is a
* TopoDS_Shape which contains all objects from the file.
*/
TopoDS_Shape
* Read STEP files and translate their content into openCascade topological
* entities. The option scale_factor is used to compensate for different
* units being used in the STEP files and in the target application. The
- * standard unit for STEP files is millimiters. The return object is a
+ * standard unit for STEP files is millimeters. The return object is a
* TopoDS_Shape which contains all objects from the file.
*/
TopoDS_Shape
* $[\nabla_u F(u)]^{-1}$ to
* @p y, writes the result in @p x and returns the number of
* linear iterations the linear solver needed.
- * The parameter @p tolerance species the error reduction if a
- * interative solver is used. The Jacobian to be used
+ * The parameter @p tolerance species the error reduction if an
+ * iterative solver is used. The Jacobian to be used
* (i.e., more precisely: the linearization point $u$ above) is
* the one computed when the `setup_jacobian` function was last called.
*
{
public:
/**
- * Constructor. The class is intialized by the solution vector and
+ * Constructor. The class is initialized by the solution vector and
* functions to compute the residual, to setup the jacobian, and
* to solve the Jacobian.
*/
void
NOXSolver<VectorType>::clear()
{
- // clear interal counters
+ // clear internal counters
n_residual_evaluations = 0;
n_jacobian_applications = 0;
n_nonlinear_iterations = 0;
n_residual_evaluations++;
- // evalute residual
+ // evaluate residual
return internal::NOXWrappers::call_and_possibly_capture_exception(
residual, pending_exception, x, f);
},
argv_new[argc] = const_cast<char *>(threads_flag_string.c_str());
argv_new[argc + 1] = nullptr;
// The first argument in Kokkos::initialize is of type int&. Hence, we
- // need to define a new variable to pass to it (insted of using argc+1
+ // need to define a new variable to pass to it (instead of using argc+1
// inline).
int argc_new = argc + 1;
Kokkos::initialize(argc_new, argv_new.data());
path_lists.insert(map_type(std::string("PARAMETER"), v));
/*
- * TODO: reenable some sensible default paths. Maier, 2012
+ * TODO: re-enable some sensible default paths. Maier, 2012
*/
path_lists.insert(map_type(std::string("MESH"), v));
}
- // This functino is deprecated:
+ // This function is deprecated:
template <int dim, int spacedim>
DEAL_II_DEPRECATED_EARLY void
map_dofs_to_support_points(
}
- // This functino is deprecated:
+ // This function is deprecated:
template <int dim, int spacedim>
DEAL_II_DEPRECATED_EARLY void
map_dofs_to_support_points(
std::stable_sort(recv_components.begin(),
recv_components.end(),
[&](const auto &a, const auto &b) {
- // intersecton index
+ // intersection index
if (std::get<1>(a) != std::get<1>(b))
return std::get<1>(a) < std::get<1>(b);
PetscErrorCode ierr;
// Create empty matrices if needed
- // This is neeeded by the base class
+ // This is needed by the base class
// not by MATNEST
std::vector<size_type> row_sizes(m, size_type(-1));
std::vector<size_type> col_sizes(n, size_type(-1));
/*
* by default we set up the preconditioner only once.
- * this can be overriden by command line.
+ * this can be overridden by command line.
*/
AssertPETSc(KSPSetReusePreconditioner(ksp, PETSC_TRUE));
}
/*
* by default we set up the preconditioner only once.
- * this can be overriden by command line.
+ * this can be overridden by command line.
*/
AssertPETSc(KSPSetReusePreconditioner(ksp, PETSC_TRUE));
}