Skip to content

Commit

Permalink
Fix typos caught by the typos program.
Browse files Browse the repository at this point in the history
  • Loading branch information
drwells committed Jun 20, 2023
1 parent ea8d4d9 commit 66620f8
Show file tree
Hide file tree
Showing 35 changed files with 64 additions and 64 deletions.
4 changes: 2 additions & 2 deletions doc/news/changes/incompatibilities/20221211Munch
Original file line number Diff line number Diff line change
@@ -1,9 +1,9 @@
Fixed: The function ParamerHandler::add_parameter() used to
Fixed: The function ParameterHandler::add_parameter() used to
call the internal action. Within that step, the action
converts the default value to a string and back afterwards.
This can lead to round-off errors so that the default
values might change in the case of floating-point numbers.
The action is not called any more during ParamerHandler::add_parameter(),
The action is not called any more during ParameterHandler::add_parameter(),
fixing the problem.
<br>
(Peter Munch, Magdalena Schreter, 2022/12/11)
2 changes: 1 addition & 1 deletion doc/news/changes/incompatibilities/20230511Turcksin
Original file line number Diff line number Diff line change
@@ -1,3 +1,3 @@
Extensive rework of CUDAWrappers::MatrixFree and CUDAWrappers::FEEvalution.
Extensive rework of CUDAWrappers::MatrixFree and CUDAWrappers::FEEvaluation.
<br>
(Bruno Turcksin, 2023/05/11)
2 changes: 1 addition & 1 deletion doc/news/changes/minor/20230118Heinz
Original file line number Diff line number Diff line change
@@ -1,4 +1,4 @@
Improved: Introduce a function that only checks if Bounding Boxes are overlapping.
Fixed: If a 1D BBox is completely contained in another one, it was not recognized as mergable neighbor.
Fixed: If a 1D BBox is completely contained in another one, it was not recognized as mergeable neighbor.
<br>
(Johannes Heinz, 2022/07/07)
2 changes: 1 addition & 1 deletion examples/step-27/doc/results.dox
Original file line number Diff line number Diff line change
Expand Up @@ -296,6 +296,6 @@ it, we recommend reading step-18 for the former and step-40 for the
latter case first for further background information on the topic, and
then come back to this tutorial to try out your newly acquired skills.

We go one step further in step-75: Here, we combine hp-adapative and
We go one step further in step-75: Here, we combine hp-adaptive and
MatrixFree methods in combination with
parallel::distributed::Triangulation objects.
2 changes: 1 addition & 1 deletion examples/step-44/step-44.cc
Original file line number Diff line number Diff line change
Expand Up @@ -73,7 +73,7 @@

// Defined in these two headers are some operations that are pertinent to
// finite strain elasticity. The first will help us compute some kinematic
// quantities, and the second provides some stanard tensor definitions.
// quantities, and the second provides some standard tensor definitions.
#include <deal.II/physics/elasticity/kinematics.h>
#include <deal.II/physics/elasticity/standard_tensors.h>

Expand Down
2 changes: 1 addition & 1 deletion examples/step-50/doc/results.dox
Original file line number Diff line number Diff line change
Expand Up @@ -293,7 +293,7 @@ matrix in 2d, and a $27\times 27$ matrix in 3d; for the coarse mesh we
use on the $L$-shaped domain of the current program, these sizes are
$21\times 21$ in 2d and $117\times 117$ in 3d. But if the coarse mesh
consists of hundreds or thousands of cells, this approach will no
longer work and might start to dominate the overall run-time of each V-cyle.
longer work and might start to dominate the overall run-time of each V-cycle.
A common approach is then to solve the coarse mesh problem using an
algebraic multigrid preconditioner; this would then, however, require
assembling the coarse matrix (even for the matrix-free version) as
Expand Down
2 changes: 1 addition & 1 deletion examples/step-50/step-50.cc
Original file line number Diff line number Diff line change
Expand Up @@ -909,7 +909,7 @@ void LaplaceProblem<dim, degree>::assemble_multigrid()
// This function has two parts in the integration loop: applying the negative
// of matrix $A$ to $u_0$ by submitting the negative of the gradient, and adding
// the right-hand side contribution by submitting the value $f$. We must be sure
// to use `read_dof_values_plain()` for evaluating $u_0$ as `read_dof_vaues()`
// to use `read_dof_values_plain()` for evaluating $u_0$ as `read_dof_values()`
// would set all Dirichlet values to zero.
//
// Finally, the system_rhs vector is of type LA::MPI::Vector, but the
Expand Down
2 changes: 1 addition & 1 deletion examples/step-69/doc/results.dox
Original file line number Diff line number Diff line change
Expand Up @@ -199,7 +199,7 @@ One can also with relative ease further extend this to the 3d case:
Solving this becomes expensive, however: The simulation was done with
1,817 million degrees of freedom (continuous $Q_1$ finite elements)
per component (for a total of 9.09 billion spatial degrees of freedom)
and ran on 30,720 MPI ranks. The code achieved an average througput of
and ran on 30,720 MPI ranks. The code achieved an average throughput of
969M grid points per second (0.04M gridpoints per second per CPU). The
front and back wall show a "Schlieren plot": the magnitude of the
gradient of the density on an exponential scale from white (low) to
Expand Down
2 changes: 1 addition & 1 deletion examples/step-82/step-82.cc
Original file line number Diff line number Diff line change
Expand Up @@ -1351,7 +1351,7 @@ namespace Step82
// neighboring <code>neighbor_cell</code> of <code>cell</code>, namely we
// fill-in the variable <code>discrete_hessians_neigh[face_no][i][q]</code>.
// For the lifting terms, we only need to add the contribution of the
// face adjecent to <code>cell</code> and <code>neighbor_cell</code>.
// face adjacent to <code>cell</code> and <code>neighbor_cell</code>.
for (unsigned int face_no = 0; face_no < cell->n_faces(); ++face_no)
{
const typename DoFHandler<dim>::face_iterator face =
Expand Down
2 changes: 1 addition & 1 deletion include/deal.II/base/config.h.in
Original file line number Diff line number Diff line change
Expand Up @@ -121,7 +121,7 @@
/*
* This sets the largest number of vectorization bits detected for the given
* compiler flags and hardware (e.g. 256 for AVX on x86-64 architectures) for
* use in deal.II's instrinsics-based VectorizedArray class.
* use in deal.II's intrinsics-based VectorizedArray class.
*/
#define DEAL_II_VECTORIZATION_WIDTH_IN_BITS @DEAL_II_VECTORIZATION_WIDTH_IN_BITS@

Expand Down
2 changes: 1 addition & 1 deletion include/deal.II/base/hdf5.h
Original file line number Diff line number Diff line change
Expand Up @@ -399,7 +399,7 @@ namespace HDF5

protected:
/**
* Name of the HDF5Oject. In the case of File, @p name corresponds to the
* Name of the HDF5Object. In the case of File, @p name corresponds to the
* file name. In the case of Group and DataSet @p name corresponds to the
* name of the object in the HDF5 file.
*/
Expand Down
2 changes: 1 addition & 1 deletion include/deal.II/base/mpi.h
Original file line number Diff line number Diff line change
Expand Up @@ -1029,7 +1029,7 @@ namespace Utilities
* @note This function performs a single reduction sweep.
*
* @pre Size of the input ArrayView has to be the same on all processes
* and the input and output ArrayVew have to have the same size.
* and the input and output ArrayView have to have the same size.
*/
void
min_max_avg(const ArrayView<const double> &my_values,
Expand Down
2 changes: 1 addition & 1 deletion include/deal.II/base/parsed_convergence_table.h
Original file line number Diff line number Diff line change
Expand Up @@ -106,7 +106,7 @@ class ParameterHandler;
* By calling the method add_parameters() passing a ParameterHandler object,
* the following options will be defined in the given ParameterHandler object
* (in the current level of the ParameterHandler object, i.e., whatever level
* you have entered with the ParamterHandler::enter_subsection() method),
* you have entered with the ParameterHandler::enter_subsection() method),
* and can be modified at run time through a parameter file:
* @code
* set Enable computation of the errors = true
Expand Down
4 changes: 2 additions & 2 deletions include/deal.II/base/time_stepping.templates.h
Original file line number Diff line number Diff line change
Expand Up @@ -50,11 +50,11 @@ namespace TimeStepping
AssertThrow(
F.size() == 0,
ExcMessage(
"RungeKutta methods cannot handle more that one function to integate."));
"RungeKutta methods cannot handle more that one function to integrate."));
AssertThrow(
J_inverse.size() == 0,
ExcMessage(
"RungeKutta methods cannot handle more that one function to integate."));
"RungeKutta methods cannot handle more that one function to integrate."));

return evolve_one_time_step(F[0], J_inverse[0], t, delta_t, y);
}
Expand Down
2 changes: 1 addition & 1 deletion include/deal.II/base/vectorization.h
Original file line number Diff line number Diff line change
Expand Up @@ -4138,7 +4138,7 @@ vectorized_load_and_transpose(const unsigned int n_entries,
const unsigned int n_chunks = n_entries / 4;

// To avoid warnings about uninitialized variables, need to initialize one
// variable to a pre-exisiting value in out, which will never get used in
// variable to a pre-existing value in out, which will never get used in
// the end. Keep the initialization outside the loop because of a bug in
// gcc-9.1 which generates a "vmovapd" instruction instead of "vmovupd" in
// case t3 is initialized to zero (inside/outside of loop), see
Expand Down
2 changes: 1 addition & 1 deletion include/deal.II/fe/fe_series.h
Original file line number Diff line number Diff line change
Expand Up @@ -543,7 +543,7 @@ FESeries::process_coefficients(
std::vector<double> norm_values;

// first, parse all table elements into a map of predicate values and
// coefficients. We could have stored (predicate values ->TableIndicies) map,
// coefficients. We could have stored (predicate values ->TableIndices) map,
// but its processing would have been much harder later on.
std::map<unsigned int, std::vector<CoefficientType>> pred_to_values;
internal::FESeriesImplementation::fill_map(coefficients,
Expand Down
2 changes: 1 addition & 1 deletion include/deal.II/fe/fe_tools.h
Original file line number Diff line number Diff line change
Expand Up @@ -495,7 +495,7 @@ namespace FETools
* with M>N unknowns is well-defined, but often yields funny and non-
* intuitive results. Secondly, one would think that if the quadrature point
* data is defined in the support points of the finite element, i.e. the
* quadrature points of <tt>ths_quadrature</tt> equal
* quadrature points of <tt>rhs_quadrature</tt> equal
* <tt>fe.get_unit_support_points()</tt>, then the projection should be the
* identity, i.e. each degree of freedom of the finite element equals the
* value of the given data in the support point of the corresponding shape
Expand Down
2 changes: 1 addition & 1 deletion include/deal.II/lac/lapack_full_matrix.h
Original file line number Diff line number Diff line change
Expand Up @@ -793,7 +793,7 @@ class LAPACKFullMatrix : public TransposeTable<number>
* values of A. V is a NxN orthonal matrix containing the right singular
* vectors corresponding the singular values of A.
*
* Note that the variable #svd_vt contains the tranpose of V and can be
* Note that the variable #svd_vt contains the transpose of V and can be
* accessed by get_svd_vt(), while U is accessed with get_svd_u().
*/
void
Expand Down
2 changes: 1 addition & 1 deletion include/deal.II/lac/petsc_precondition.h
Original file line number Diff line number Diff line change
Expand Up @@ -96,7 +96,7 @@ namespace PETScWrappers
Tvmult(VectorBase &dst, const VectorBase &src) const;

/**
* Explictly call setup. This is usually not needed since PETSc will
* Explicitly call setup. This is usually not needed since PETSc will
* automatically call the setup function when needed.
*/
void
Expand Down
2 changes: 1 addition & 1 deletion include/deal.II/lac/scalapack.h
Original file line number Diff line number Diff line change
Expand Up @@ -641,7 +641,7 @@ class ScaLAPACKMatrix : protected TransposeTable<NumberType>
* vectors. The residual sum of squares for each column is given by the sum of
* squares of elements $M$ to $N-1$ in that column.
*
* If(!tranpose) then $\mathbf{B} \in \mathbb{R}^{M \times N_{\rm RHS}}$,
* If(!transpose) then $\mathbf{B} \in \mathbb{R}^{M \times N_{\rm RHS}}$,
* otherwise $\mathbf{B} \in \mathbb{R}^{N \times N_{\rm RHS}}$.
* The matrices $\mathbf{A}$ and $\mathbf{B}$ must have an identical block
* cyclic distribution for rows and columns.
Expand Down
6 changes: 3 additions & 3 deletions include/deal.II/lac/solver_gmres.h
Original file line number Diff line number Diff line change
Expand Up @@ -922,7 +922,7 @@ namespace internal
!is_dealii_compatible_distributed_vector<VectorType>::value,
VectorType> * = nullptr>
double
substract_and_norm(
subtract_and_norm(
const unsigned int dim,
const internal::SolverGMRESImplementation::TmpVectors<VectorType>
& orthogonal_vectors,
Expand All @@ -944,7 +944,7 @@ namespace internal
is_dealii_compatible_distributed_vector<VectorType>::value,
VectorType> * = nullptr>
double
substract_and_norm(
subtract_and_norm(
const unsigned int dim,
const internal::SolverGMRESImplementation::TmpVectors<VectorType>
& orthogonal_vectors,
Expand Down Expand Up @@ -1183,7 +1183,7 @@ namespace internal
classical_gram_schmidt)
{
Tvmult_add(dim, vv, orthogonal_vectors, h);
norm_vv = substract_and_norm(dim, orthogonal_vectors, h, vv);
norm_vv = subtract_and_norm(dim, orthogonal_vectors, h, vv);
}
else
{
Expand Down
2 changes: 1 addition & 1 deletion include/deal.II/matrix_free/cuda_fe_evaluation.h
Original file line number Diff line number Diff line change
Expand Up @@ -121,7 +121,7 @@ namespace CUDAWrappers
* the function DoFAccessor::get_interpolated_dof_values when no
* constraints are present, but it also includes constraints from hanging
* nodes, so once can see it as a similar function to
* AffineConstraints::read_dof_valuess as well.
* AffineConstraints::read_dof_values() as well.
*/
DEAL_II_HOST_DEVICE void
read_dof_values(const Number *src);
Expand Down
2 changes: 1 addition & 1 deletion include/deal.II/matrix_free/cuda_matrix_free.h
Original file line number Diff line number Diff line change
Expand Up @@ -81,7 +81,7 @@ namespace CUDAWrappers
* write to vectors in parallel without having to explicitly synchronize
* access to these vectors and matrices. This class does not implement any
* shape values, all it does is to cache the respective data. To implement
* finite element operations, use the class CUDAWrappers::FEEvalutation.
* finite element operations, use the class CUDAWrappers::FEEvaluation.
*
* This class traverse the cells in a different order than the usual
* Triangulation class in deal.II.
Expand Down
2 changes: 1 addition & 1 deletion include/deal.II/matrix_free/matrix_free.h
Original file line number Diff line number Diff line change
Expand Up @@ -1483,7 +1483,7 @@ class MatrixFree : public Subscriptor
* To be able to evaluate all face integrals (with values or gradients
* from the neighboring cells), all ghost values from neighboring cells are
* updated. Use
* FEFaceEvalution::reinit(cell, face_no) to access quantities on arbitrary
* FEFaceEvaluation::reinit(cell, face_no) to access quantities on arbitrary
* faces of a cell and the respective neighbors.
*
* @param cell_operation Pointer to member function of `CLASS` with the
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -3768,10 +3768,10 @@ namespace internal
std::vector<Point<dim>> points;
points.resize(local_support_point_indices.size());

const auto locally_onwed_support_point =
const auto locally_owned_support_point =
dof_handler_support_points->locally_owned_dofs();
std::vector<unsigned int> indices_state(
locally_onwed_support_point.n_elements(),
locally_owned_support_point.n_elements(),
numbers::invalid_unsigned_int);

AssertIndexRange(local_support_point_indices.size(),
Expand All @@ -3798,10 +3798,10 @@ namespace internal
cell->get_dof_indices(dof_indices);

for (const unsigned int q : fe_values.quadrature_point_indices())
if (locally_onwed_support_point.is_element(dof_indices[q]))
if (locally_owned_support_point.is_element(dof_indices[q]))
{
const auto index =
locally_onwed_support_point.index_within_set(dof_indices[q]);
locally_owned_support_point.index_within_set(dof_indices[q]);

if (indices_state[index] != numbers::invalid_unsigned_int)
{
Expand Down
6 changes: 3 additions & 3 deletions include/deal.II/numerics/data_out_dof_data.templates.h
Original file line number Diff line number Diff line change
Expand Up @@ -190,14 +190,14 @@ namespace internal
inline std::vector<Point<2>>
generate_simplex_evaluation_points(const unsigned int n_subdivisions)
{
std::vector<Point<2>> evalution_points;
std::vector<Point<2>> evaluation_points;

generate_simplex_evaluation_points_recursively(
{{Point<2>(0.0, 0.0), Point<2>(1.0, 0.0), Point<2>(0.0, 1.0)}},
n_subdivisions,
evalution_points);
evaluation_points);

return evalution_points;
return evaluation_points;
}


Expand Down
8 changes: 4 additions & 4 deletions include/deal.II/numerics/rtree.h
Original file line number Diff line number Diff line change
Expand Up @@ -337,7 +337,7 @@ struct ExtractLevelVisitor

/**
* Implements the visitor interface for InternalNode objects. If the node
* belongs to the @p target_leve, then fill the bounding box vector.
* belongs to the @p target_level, then fill the bounding box vector.
*/
inline void
operator()(InternalNode const &node);
Expand Down Expand Up @@ -500,7 +500,7 @@ void
ExtractLevelVisitor<Value, Options, Translator, Box, Allocators>::operator()(
const ExtractLevelVisitor::InternalNode &node)
{
using ElmentsType =
using ElementsType =
typename boost::geometry::index::detail::rtree::elements_type<
InternalNode>::type;

Expand All @@ -512,7 +512,7 @@ ExtractLevelVisitor<Value, Options, Translator, Box, Allocators>::operator()(
boxes.resize(offset + elements.size());

unsigned int i = offset;
for (typename ElmentsType::const_iterator it = elements.begin();
for (typename ElementsType::const_iterator it = elements.begin();
it != elements.end();
++it)
{
Expand All @@ -525,7 +525,7 @@ ExtractLevelVisitor<Value, Options, Translator, Box, Allocators>::operator()(
const size_t level_backup = level;
++level;

for (typename ElmentsType::const_iterator it = elements.begin();
for (typename ElementsType::const_iterator it = elements.begin();
it != elements.end();
++it)
{
Expand Down
4 changes: 2 additions & 2 deletions source/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -37,7 +37,7 @@ endif()

#
# Automatically add the current source and binary directory as include
# directory. The binary directory is needed in order to find the expaned
# directory. The binary directory is needed in order to find the expanded
# .inst include files.
#
set(CMAKE_INCLUDE_CURRENT_DIR true)
Expand Down Expand Up @@ -77,7 +77,7 @@ add_subdirectory(arborx)

#
# Define a "dealii", i.e., "${DEAL_II_TARGET_NAME}", target that contains
# DEAL_II_CXX_FLAGS[_DEBUG|_RELEASE] and otherwsie aliases dealii_debug or
# DEAL_II_CXX_FLAGS[_DEBUG|_RELEASE] and otherwise aliases dealii_debug or
# dealii_release depending on the downstream CMAKE_BUILD_TYPE.
#

Expand Down
2 changes: 1 addition & 1 deletion source/base/data_out_base.cc
Original file line number Diff line number Diff line change
Expand Up @@ -4367,7 +4367,7 @@ namespace DataOutBase
float max_color_value = std::numeric_limits<float>::min();

// Array for z-coordinates of points. The elevation determined by a function
// if spacedim=2 or the z-cooridate of the grid point if spacedim=3
// if spacedim=2 or the z-coordinate of the grid point if spacedim=3
double heights[4] = {0, 0, 0, 0};

// compute the cells for output and enter them into the set above note that
Expand Down
4 changes: 2 additions & 2 deletions source/dofs/dof_tools.cc
Original file line number Diff line number Diff line change
Expand Up @@ -506,11 +506,11 @@ namespace DoFTools

// next set up a table for the degrees of freedom on each of the cells
// whether it is something interesting or not
std::vector<unsigned char> local_component_asssociation =
std::vector<unsigned char> local_component_association =
internal::get_local_component_association(fe, component_mask);
std::vector<bool> local_selected_dofs(fe.n_dofs_per_cell());
for (unsigned int i = 0; i < fe.n_dofs_per_cell(); ++i)
local_selected_dofs[i] = component_mask[local_component_asssociation[i]];
local_selected_dofs[i] = component_mask[local_component_association[i]];

// then loop over all cells and do work
std::vector<types::global_dof_index> indices(fe.n_dofs_per_cell());
Expand Down
2 changes: 1 addition & 1 deletion source/fe/fe_dg_vector.cc
Original file line number Diff line number Diff line change
Expand Up @@ -36,7 +36,7 @@ template <int dim, int spacedim>
std::string
FE_DGNedelec<dim, spacedim>::get_name() const
{
// note that the FETools::get_fe_by_nam function depends on the
// note that FETools::get_fe_by_name() depends on the
// particular format of the string
// this function returns, so they
// have to be kept in synch
Expand Down
2 changes: 1 addition & 1 deletion source/grid/grid_generator.cc
Original file line number Diff line number Diff line change
Expand Up @@ -1090,7 +1090,7 @@ namespace GridGenerator
const double alpha = bias_alpha(1 - (1.0 * iy) / n_cells_y);
// define points on upper/lower horizontal far field side,
// i.e. face DG or FI. Incline factor to move points G and I
// to the right by distance incline_facor*lenght_b2
// to the right by distance incline_factor*length_b2
const Point<2> p(ix * dx + center_mesh +
incline_factor * length_b2 * ix /
n_cells_x_1,
Expand Down

0 comments on commit 66620f8

Please sign in to comment.