Found via codespell -q 3 -S ./bundled,./doc/news -L ans,ba,bu,clen,commend,compontent,elemente,indx,inout,methode,nd,pres,readin,re-use,re-used,re-using,ro,rotat,sie,stoer,ue,workd
#include <deal.II/base/symmetric_tensor.h>
// And lastly a header that contains some functions that will help us compute
-// rotaton matrices of the local coordinate systems at specific points in the
+// rotation matrices of the local coordinate systems at specific points in the
// domain.
#include <deal.II/physics/transformations.h>
{
// Use the same algorithm as above, but because the matrix is
// not square, we can now do without the split for diagonal/
- // entries before the diagional/entries are the diagonal.
+ // entries before the diagonal/entries are the diagonal.
size_type counter = 0;
for (size_type i = 0; i < n_cols; ++i)
{
* quadrature dimension the same as the space dimension) or for a face
* integrator (with quadrature dimension one less)
*
- * @tparam VectorizedArrayType Type of array to be woked on in a vectorized
+ * @tparam VectorizedArrayType Type of array to be worked on in a vectorized
* fashion, defaults to VectorizedArray<Number>
*
* @note Currently only VectorizedArray<Number, width> is supported as
*
* @tparam Number Number format, usually @p double or @p float
*
- * @tparam VectorizedArrayType Type of array to be woked on in a vectorized
+ * @tparam VectorizedArrayType Type of array to be worked on in a vectorized
* fashion, defaults to VectorizedArray<Number>
*
* @note Currently only VectorizedArray<Number, width> is supported as
* quadrature dimension the same as the space dimension) or for a face
* integrator (with quadrature dimension one less)
*
- * @tparam VectorizedArrayType Type of array to be woked on in a vectorized
+ * @tparam VectorizedArrayType Type of array to be worked on in a vectorized
* fashion, defaults to VectorizedArray<Number>
*
* @note Currently only VectorizedArray<Number, width> is supported as
}
// The xml function is reused to read in the xml into the parameter file.
- // This function can only read mangled files. Therefore, we create a mangeled
+ // This function can only read mangled files. Therefore, we create a mangled
// tree first.
boost::property_tree::ptree node_tree_mangled;
recursively_mangle_or_demangle(node_tree,
// major ordering, we take the SVD of A^T by running the gesvd command.
// The results (V^T)^T and U^T are provided in column major that we use
// as row major results V^T and U.
- // It essentially computs A^T = (V^T)^T S U^T and gives us V^T and U.
+ // It essentially computes A^T = (V^T)^T S U^T and gives us V^T and U.
// This trick gives what we originally wanted (A = U S V^T) but the order
// of U and V^T is reversed.
std::array<Number, dim> S;
// At this point, we have
// counted all dofs
- // contributiong from cells
+ // contributing from cells
// coupled topologically to the
// adjacent cells, but we
// subtracted some faces.
// At this point, we have
// counted all dofs
- // contributiong from cells
+ // contributing from cells
// coupled topologically to the
// adjacent cells, but we
// subtracted some faces.
const std::vector<Point<3>> vertices(&vertices_parallelograms[0],
&vertices_parallelograms[n_vertices]);
- // create grid with all possible combintations of face_flip, face_orientation
+ // create grid with all possible combinations of face_flip, face_orientation
// and face_rotation flags
static const int cell_vertices[][GeometryInfo<3>::vertices_per_cell] = {
{0, 1, 9, 10, 3, 4, 12, 13}, // cell 1 standard
const std::vector<Point<3>> vertices(&vertices_parallelograms[0],
&vertices_parallelograms[n_vertices]);
- // create grid with all possible combintations of face_flip, face_orientation
+ // create grid with all possible combinations of face_flip, face_orientation
// and face_rotation flags
static const int cell_vertices[][GeometryInfo<3>::vertices_per_cell] = {
{0, 1, 9, 10, 3, 4, 12, 13}, // cell 1 standard
// Same as hp/boundary_matrices, but with different FE objects. Tests
-// the boundary mass matrces for vector-valued (non-primiteve) hp-
+// the boundary mass matrices for vector-valued (non-primiteve) hp-
// FE objects.
#include "../tests.h"
// In https://github.com/dealii/dealii/pull/14342, we have observed that
-// overlapping comunication/computation does not work properly since
+// overlapping communication/computation does not work properly since
// ghost faces might be assigned to the wrong partition if
// FE_Nothing is used. This is a test which shows this problem by
// running the same problem on a large mesh where 50% of the
solve();
}
- // finialise output
+ // finalise output
output_table.write_text(std::cout);
deallog << std::endl;
}
output_table.add_value("lambda", 2.);
output_table.add_value("error", "-");
- // finialise output
+ // finalise output
output_table.write_text(std::cout);
deallog << std::endl;
}
solve();
}
- // finialise output
+ // finalise output
output_table.write_text(std::cout);
deallog << std::endl;
}