From 51fe44077a3bc608295f3af62009b1a5200702ab Mon Sep 17 00:00:00 2001 From: "luz.paz" Date: Mon, 12 Mar 2018 01:03:33 -0400 Subject: [PATCH] Found more typos --- contrib/python-bindings/include/point_wrapper.h | 2 +- .../python-bindings/include/triangulation_wrapper.h | 6 +++--- contrib/python-bindings/notebooks/tutorial-1.ipynb | 2 +- .../python-bindings/source/export_triangulation.cc | 4 ++-- contrib/utilities/wrapcomments.py | 2 +- examples/step-18/step-18.cc | 4 ++-- examples/step-26/doc/intro.dox | 2 +- examples/step-31/step-31.cc | 4 ++-- examples/step-32/step-32.cc | 4 ++-- examples/step-33/doc/results.dox | 4 ++-- examples/step-37/doc/results.dox | 2 +- examples/step-44/step-44.cc | 2 +- examples/step-57/step-57.cc | 2 +- examples/step-9/step-9.cc | 2 +- include/deal.II/lac/trilinos_solver.h | 4 ++-- include/deal.II/lac/vector_view.h | 2 +- source/base/data_out_base.cc | 2 +- source/base/parameter_acceptor.cc | 2 +- source/distributed/tria.cc | 2 +- source/dofs/dof_tools.cc | 2 +- source/fe/fe_nedelec.cc | 2 +- source/fe/mapping_q_generic.cc | 2 +- source/grid/grid_in.cc | 12 ++++++------ source/grid/grid_tools.cc | 2 +- source/grid/grid_tools_dof_handlers.cc | 4 ++-- source/grid/tria.cc | 8 ++++---- source/grid/tria_boundary_lib.cc | 4 ++-- source/lac/petsc_parallel_sparse_matrix.cc | 2 +- source/lac/petsc_solver.cc | 2 +- source/lac/trilinos_precondition.cc | 2 +- source/lac/trilinos_sparse_matrix.cc | 2 +- source/lac/trilinos_sparsity_pattern.cc | 2 +- source/multigrid/mg_tools.cc | 2 +- tests/manifold/transfinite_manifold_07.cc | 2 +- 34 files changed, 52 insertions(+), 52 deletions(-) diff --git a/contrib/python-bindings/include/point_wrapper.h b/contrib/python-bindings/include/point_wrapper.h index fd014c4905..2a95b4eeae 100644 --- a/contrib/python-bindings/include/point_wrapper.h +++ b/contrib/python-bindings/include/point_wrapper.h @@ -40,7 +40,7 @@ namespace python PointWrapper(boost::python::list list); /** - * Constructor. Intialize PointWrapper using a Point. + * Constructor. Initialize PointWrapper using a Point. */ template PointWrapper(const Point &p); diff --git a/contrib/python-bindings/include/triangulation_wrapper.h b/contrib/python-bindings/include/triangulation_wrapper.h index 35d4704f2f..a73e80ca51 100644 --- a/contrib/python-bindings/include/triangulation_wrapper.h +++ b/contrib/python-bindings/include/triangulation_wrapper.h @@ -184,7 +184,7 @@ namespace python /** * A subdivided parallelepided, i.e., the same as above, but where the - * number of subdivisions in each ot the @tparam dim directsions may vary. + * number of subdivisions in each of the @tparam dim directions may vary. * Colorizing is done according to hyper_rectangle(). */ void generate_varying_subdivided_parallelepiped(boost::python::list &n_subdivisions, @@ -231,7 +231,7 @@ namespace python * Generate a hyper-ball intersected with the positive orthant relate to @p * center, which contains three elements in 2d and four in 3d. The boundary * indicators for the final triangulations are 0 for the curved boundary - * and 1 for the cut plane. The appropiate boundary class is + * and 1 for the cut plane. The appropriate boundary class is * HyperBallBoundary. */ void generate_quarter_hyper_ball(PointWrapper ¢er, @@ -328,7 +328,7 @@ namespace python private: /** - * Helper function for the contructors. + * Helper function for the constructors. */ void setup(const std::string &dimension, const std::string &spacedimension); diff --git a/contrib/python-bindings/notebooks/tutorial-1.ipynb b/contrib/python-bindings/notebooks/tutorial-1.ipynb index 9c76980eef..5dc91d03b4 100644 --- a/contrib/python-bindings/notebooks/tutorial-1.ipynb +++ b/contrib/python-bindings/notebooks/tutorial-1.ipynb @@ -31,7 +31,7 @@ "cell_type": "markdown", "metadata": {}, "source": [ - "We start by creating a 2D **Triangulation** of an hyper cube and we globally refine it twice. You can read the documention of **Triangulation** by typing:\n", + "We start by creating a 2D **Triangulation** of an hyper cube and we globally refine it twice. You can read the documentation of **Triangulation** by typing:\n", "```python\n", "help(dealii.Triangulation)\n", "```\n", diff --git a/contrib/python-bindings/source/export_triangulation.cc b/contrib/python-bindings/source/export_triangulation.cc index 6dc543f4eb..ae2f62aa60 100644 --- a/contrib/python-bindings/source/export_triangulation.cc +++ b/contrib/python-bindings/source/export_triangulation.cc @@ -182,7 +182,7 @@ namespace python const char generate_varying_subdivided_parallelepiped_docstring [] = "A subdivided parallelepided, i.e., the same as above, but where the \n" - "number of subdivisions in each ot the dim directsions may vary. \n" + "number of subdivisions in each of the dim directions may vary. \n" "Colorizing is done according to hyper_rectangle(). \n" ; @@ -226,7 +226,7 @@ namespace python "Generate a hyper-ball intersected with the positive orthant relate to \n" "center, which contains three elements in 2d and four in 3d. The \n" "boundary indicators for the final triangulations are 0 for the curved \n" - "boundary and 1 for the cut plane. The appropiate boundary class is \n" + "boundary and 1 for the cut plane. The appropriate boundary class is \n" "HyperBallBoundary. \n" ; diff --git a/contrib/utilities/wrapcomments.py b/contrib/utilities/wrapcomments.py index fe8e37650d..2f4af7757e 100755 --- a/contrib/utilities/wrapcomments.py +++ b/contrib/utilities/wrapcomments.py @@ -31,7 +31,7 @@ import sys, re # As of python 2.6 we can tell the text wrapper to not break on hyphens. This is # usually what we want to do: we don't want to split URLs with hyphens and # doxygen will format 'non-primitive' as 'non- primitive' if it is -# (inadvertantly) split across two lines. +# (inadvertently) split across two lines. wrapper = textwrap.TextWrapper(break_on_hyphens=False) # take an array of lines and wrap them to 78 columns and let each line start diff --git a/examples/step-18/step-18.cc b/examples/step-18/step-18.cc index ac33fc07b8..938adeda2e 100644 --- a/examples/step-18/step-18.cc +++ b/examples/step-18/step-18.cc @@ -348,7 +348,7 @@ namespace Step18 // good number of more member functions now, which we will explain below. // // The external interface of the class, however, is unchanged: it has a - // public constructor and desctructor, and it has a run + // public constructor and destructor, and it has a run // function that initiated all the work. template class TopLevel @@ -1388,7 +1388,7 @@ namespace Step18 // Finally, we write the paraview record, that references all .pvtu files and // their respective time. Note that the variable times_and_names is declared - // static, so it will retain the entries from the pervious timesteps. + // static, so it will retain the entries from the previous timesteps. static std::vector > times_and_names; times_and_names.push_back (std::pair (present_time, pvtu_master_filename)); std::ofstream pvd_output ("solution.pvd"); diff --git a/examples/step-26/doc/intro.dox b/examples/step-26/doc/intro.dox index 616844299c..de58294e16 100644 --- a/examples/step-26/doc/intro.dox +++ b/examples/step-26/doc/intro.dox @@ -422,7 +422,7 @@ Here, \end{array} \right. @f} -In other words, in every period of lenght $\tau$, the right hand side first +In other words, in every period of length $\tau$, the right hand side first flashes on in domain 1, then off completely, then on in domain 2, then off completely again. This pattern is probably best observed via the little animation of the solution shown in the results diff --git a/examples/step-31/step-31.cc b/examples/step-31/step-31.cc index 3516584150..07a43270b4 100644 --- a/examples/step-31/step-31.cc +++ b/examples/step-31/step-31.cc @@ -2080,8 +2080,8 @@ namespace Step31 temperature_solution = tmp[0]; old_temperature_solution = tmp[1]; - // After the solution has been transfered we then enforce the constraints - // on the transfered solution. + // After the solution has been transferred we then enforce the constraints + // on the transferred solution. temperature_constraints.distribute(temperature_solution); temperature_constraints.distribute(old_temperature_solution); diff --git a/examples/step-32/step-32.cc b/examples/step-32/step-32.cc index b7750eda86..bd89b72e72 100644 --- a/examples/step-32/step-32.cc +++ b/examples/step-32/step-32.cc @@ -1171,7 +1171,7 @@ namespace Step32 // The constructor of the problem is very similar to the constructor in // step-31. What is different is the %parallel communication: Trilinos uses // a message passing interface (MPI) for data distribution. When entering - // the BoussinesqFlowProblem class, we have to decide how the parallization + // the BoussinesqFlowProblem class, we have to decide how the parallelization // is to be done. We choose a rather simple strategy and let all processors // that are running the program work together, specified by the communicator // MPI_COMM_WORLD. Next, we create the output stream (as we @@ -1659,7 +1659,7 @@ namespace Step32 // concept). Here we chose to keep things simple (keeping in mind that this // function is also only called once at the beginning of the program, not in // every time step), and generating the right hand side is cheap anyway so - // we won't even notice that this part is not parallized by threads. + // we won't even notice that this part is not parallelized by threads. // // Regarding the implementation of inhomogeneous Dirichlet boundary // conditions: Since we use the temperature ConstraintMatrix, we could apply diff --git a/examples/step-33/doc/results.dox b/examples/step-33/doc/results.dox index f25a9967a7..f728f4d0fd 100644 --- a/examples/step-33/doc/results.dox +++ b/examples/step-33/doc/results.dox @@ -225,7 +225,7 @@ refinement scheme discussed above.

Stabilization

The numerical scheme we have chosen is not particularly -stable when the artificial viscosity is samll while is too diffusive when +stable when the artificial viscosity is small while is too diffusive when the artificial viscosity is large. Furthermore, it is known there are more advanced techniques to stabilize the solution, for example streamline diffusion, least-squares stabilization terms, entropy viscosity. @@ -260,7 +260,7 @@ faster.

Cache the explicit part of residual

-The residual calulated in ConservationLaw::assemble_cell_term function +The residual calculated in ConservationLaw::assemble_cell_term function reads $R_i = \left(\frac{\mathbf{w}^{k}_{n+1} - \mathbf{w}_n}{\delta t} , \mathbf{z}_i \right)_K + diff --git a/examples/step-37/doc/results.dox b/examples/step-37/doc/results.dox index 3af36132dd..789b843e44 100644 --- a/examples/step-37/doc/results.dox +++ b/examples/step-37/doc/results.dox @@ -482,7 +482,7 @@ represents a linear operator. In our matrix-free code, the right hand side computation where the contribution of inhomogeneous conditions ends up is completely decoupled from the matrix operator and handled by a different function above. Thus, we need -to explicity generate the data that enters the right hand side rather than +to explicitly generate the data that enters the right hand side rather than using a byproduct of the matrix assembly. Since we already know how to apply the operator on a vector, we could try to use those facilities for a vector where we only set the Dirichlet values: diff --git a/examples/step-44/step-44.cc b/examples/step-44/step-44.cc index 3ade96dcfb..f232611534 100644 --- a/examples/step-44/step-44.cc +++ b/examples/step-44/step-44.cc @@ -1194,7 +1194,7 @@ namespace Step44 // @sect4{Threading-building-blocks structures} -// The first group of private member functions is related to parallization. +// The first group of private member functions is related to parallelization. // We use the Threading Building Blocks library (TBB) to perform as many // computationally intensive distributed tasks as possible. In particular, we // assemble the tangent matrix and right hand side vector, the static diff --git a/examples/step-57/step-57.cc b/examples/step-57/step-57.cc index bdf3f54f66..0a117cd05b 100644 --- a/examples/step-57/step-57.cc +++ b/examples/step-57/step-57.cc @@ -609,7 +609,7 @@ namespace Step57 BlockVector tmp (dofs_per_block); // Transfer solution from coarse to fine mesh and apply boundary value - // constraints to the new transfered solution. Note that present_solution + // constraints to the new transferred solution. Note that present_solution // is still a vector corresponding to the old mesh. solution_transfer.interpolate(present_solution, tmp); nonzero_constraints.distribute(tmp); diff --git a/examples/step-9/step-9.cc b/examples/step-9/step-9.cc index 0c51bd9893..0129c1e6ad 100644 --- a/examples/step-9/step-9.cc +++ b/examples/step-9/step-9.cc @@ -579,7 +579,7 @@ namespace Step9 // seen that assembling in parallel does not take an incredible // amount of extra code as long as you diligently describe what the // scratch and copy data objects are, and if you define suitable - // functios for the local assembly and the copy operation from local + // functions for the local assembly and the copy operation from local // contributions to global objects. This done, the following will do // all the heavy lifting to get these operations done on multiple // threads on as many cores as you have in your system: diff --git a/include/deal.II/lac/trilinos_solver.h b/include/deal.II/lac/trilinos_solver.h index 014f865fa4..744c9702de 100644 --- a/include/deal.II/lac/trilinos_solver.h +++ b/include/deal.II/lac/trilinos_solver.h @@ -638,14 +638,14 @@ namespace TrilinosWrappers /** * Solve the linear system Ax=b based on the - * package set in intialize(). Note the matrix is not refactorized during + * package set in initialize(). Note the matrix is not refactorized during * this call. */ void solve (MPI::Vector &x, const MPI::Vector &b); /** * Solve the linear system Ax=b based on the package set in - * intialize() for deal.II's own parallel vectors. Note the matrix is not + * initialize() for deal.II's own parallel vectors. Note the matrix is not * refactorized during this call. */ void diff --git a/include/deal.II/lac/vector_view.h b/include/deal.II/lac/vector_view.h index 5e7bf41448..7707fd36d5 100644 --- a/include/deal.II/lac/vector_view.h +++ b/include/deal.II/lac/vector_view.h @@ -312,7 +312,7 @@ template inline void VectorView::swap(Vector &) { - AssertThrow(false, ExcMessage("Cant' swap a VectorView with a Vector!")); + AssertThrow(false, ExcMessage("Can't swap a VectorView with a Vector!")); } #endif diff --git a/source/base/data_out_base.cc b/source/base/data_out_base.cc index 65183d71c6..075f64c05f 100644 --- a/source/base/data_out_base.cc +++ b/source/base/data_out_base.cc @@ -3481,7 +3481,7 @@ namespace DataOutBase } } - // max. and min. heigth of solution + // max. and min. height of solution Assert(patches.size()>0, ExcInternalError()); double hmin=patches[0].data(0,0); double hmax=patches[0].data(0,0); diff --git a/source/base/parameter_acceptor.cc b/source/base/parameter_acceptor.cc index be83e783d3..1da11b6c2b 100644 --- a/source/base/parameter_acceptor.cc +++ b/source/base/parameter_acceptor.cc @@ -187,7 +187,7 @@ ParameterAcceptor::get_section_path() const Utilities::split_string_list(my_section_name, sep); // Split string list removes trailing empty strings, but not - // preceeding ones. Make sure that if we had an absolute path, + // preceding ones. Make sure that if we had an absolute path, // we don't store as first section the empty string. if (is_absolute) sections.erase(sections.begin()); diff --git a/source/distributed/tria.cc b/source/distributed/tria.cc index e343cce94e..24b9171d10 100644 --- a/source/distributed/tria.cc +++ b/source/distributed/tria.cc @@ -491,7 +491,7 @@ namespace { // no, this child is locally not available in the p4est. // delete all its children but, because this may not be - // successfull, make sure to mark all children recursively + // successful, make sure to mark all children recursively // as not local. delete_all_children (dealii_cell->child(c)); dealii_cell->child(c) diff --git a/source/dofs/dof_tools.cc b/source/dofs/dof_tools.cc index 0cbe913a27..19c1edce77 100644 --- a/source/dofs/dof_tools.cc +++ b/source/dofs/dof_tools.cc @@ -1450,7 +1450,7 @@ namespace DoFTools Assert(dof_handler.n_dofs() > 0, ExcInternalError()); // In case this function is executed with parallel::shared::Triangulation - // with possibly artifical cells, we need to take "true" subdomain IDs (i.e. without + // with possibly artificial cells, we need to take "true" subdomain IDs (i.e. without // artificial cells). Otherwise we are good to use subdomain_id as stored // in cell->subdomain_id(). std::vector cell_owners (dof_handler.get_triangulation().n_active_cells()); diff --git a/source/fe/fe_nedelec.cc b/source/fe/fe_nedelec.cc index cb92d69969..cb14e98299 100644 --- a/source/fe/fe_nedelec.cc +++ b/source/fe/fe_nedelec.cc @@ -2013,7 +2013,7 @@ FE_Nedelec::get_dpo_vector (const unsigned int degree, bool dg) // Data field initialization //--------------------------------------------------------------------------- -// Chech wheter a given shape +// Check whether a given shape // function has support on a // given face. diff --git a/source/fe/mapping_q_generic.cc b/source/fe/mapping_q_generic.cc index 4efd7c2480..071b5a5708 100644 --- a/source/fe/mapping_q_generic.cc +++ b/source/fe/mapping_q_generic.cc @@ -98,7 +98,7 @@ namespace internal Assert(spacedim == 2, ExcInternalError()); // For accuracy reasons, we do all arithmetics in extended precision - // (long double). This has a noticable effect on the hit rate for + // (long double). This has a noticeable effect on the hit rate for // borderline cases and thus makes the algorithm more robust. const long double x = p(0); const long double y = p(1); diff --git a/source/grid/grid_in.cc b/source/grid/grid_in.cc index eec85a4729..b1f8029137 100644 --- a/source/grid/grid_in.cc +++ b/source/grid/grid_in.cc @@ -704,7 +704,7 @@ void GridIn::read_ucd (std::istream &i for (unsigned int i=0; i::vertices_per_cell; ++i) in >> cells.back().vertices[i]; - // to make sure that the cast wont fail + // to make sure that the cast won't fail Assert(material_id<= std::numeric_limits::max(), ExcIndexRange(material_id,0,std::numeric_limits::max())); // we use only material_ids in the range from 0 to numbers::invalid_material_id-1 @@ -735,7 +735,7 @@ void GridIn::read_ucd (std::istream &i in >> subcelldata.boundary_lines.back().vertices[0] >> subcelldata.boundary_lines.back().vertices[1]; - // to make sure that the cast wont fail + // to make sure that the cast won't fail Assert(material_id<= std::numeric_limits::max(), ExcIndexRange(material_id,0,std::numeric_limits::max())); // we use only boundary_ids in the range from 0 to numbers::internal_face_boundary_id-1 @@ -776,7 +776,7 @@ void GridIn::read_ucd (std::istream &i >> subcelldata.boundary_quads.back().vertices[2] >> subcelldata.boundary_quads.back().vertices[3]; - // to make sure that the cast wont fail + // to make sure that the cast won't fail Assert(material_id<= std::numeric_limits::max(), ExcIndexRange(material_id,0,std::numeric_limits::max())); // we use only boundary_ids in the range from 0 to numbers::internal_face_boundary_id-1 @@ -1430,7 +1430,7 @@ void GridIn::read_msh (std::istream &in) for (unsigned int i=0; i::vertices_per_cell; ++i) in >> cells.back().vertices[i]; - // to make sure that the cast wont fail + // to make sure that the cast won't fail Assert(material_id<= std::numeric_limits::max(), ExcIndexRange(material_id,0,std::numeric_limits::max())); // we use only material_ids in the range from 0 to numbers::invalid_material_id-1 @@ -1459,7 +1459,7 @@ void GridIn::read_msh (std::istream &in) in >> subcelldata.boundary_lines.back().vertices[0] >> subcelldata.boundary_lines.back().vertices[1]; - // to make sure that the cast wont fail + // to make sure that the cast won't fail Assert(material_id<= std::numeric_limits::max(), ExcIndexRange(material_id,0,std::numeric_limits::max())); // we use only boundary_ids in the range from 0 to numbers::internal_face_boundary_id-1 @@ -1496,7 +1496,7 @@ void GridIn::read_msh (std::istream &in) >> subcelldata.boundary_quads.back().vertices[2] >> subcelldata.boundary_quads.back().vertices[3]; - // to make sure that the cast wont fail + // to make sure that the cast won't fail Assert(material_id<= std::numeric_limits::max(), ExcIndexRange(material_id,0,std::numeric_limits::max())); // we use only boundary_ids in the range from 0 to numbers::internal_face_boundary_id-1 diff --git a/source/grid/grid_tools.cc b/source/grid/grid_tools.cc index 5318d8c146..71535dc695 100644 --- a/source/grid/grid_tools.cc +++ b/source/grid/grid_tools.cc @@ -2024,7 +2024,7 @@ next_cell: #ifndef DEAL_II_WITH_MPI // without MPI, this function doesn't make sense because on cannot - // use parallel::distributed::Triangulation in any meaninful + // use parallel::distributed::Triangulation in any meaningful // way (void)triangulation; Assert (false, ExcMessage ("This function does not make any sense " diff --git a/source/grid/grid_tools_dof_handlers.cc b/source/grid/grid_tools_dof_handlers.cc index a215c4e9d6..516327a040 100644 --- a/source/grid/grid_tools_dof_handlers.cc +++ b/source/grid/grid_tools_dof_handlers.cc @@ -1094,7 +1094,7 @@ next_cell: // to the next } } - //udpate the number of cells searched + //update the number of cells searched cells_searched += adjacent_cells.size(); // if we have not found the cell in // question and have not yet searched every @@ -1392,7 +1392,7 @@ next_cell: // uniqueness of cell iterators. std::set does this // automatically for us. Later after it is all // constructed, we will copy to a map of vectors - // since that is the prefered output for other + // since that is the preferred output for other // functions. std::map< types::global_dof_index,std::set > dof_to_set_of_cells_map; diff --git a/source/grid/tria.cc b/source/grid/tria.cc index 16a67f5242..cc8f7d4c67 100644 --- a/source/grid/tria.cc +++ b/source/grid/tria.cc @@ -2071,7 +2071,7 @@ namespace internal // if we are here, it means that we want to assign a boundary indicator // different from numbers::internal_face_boundary_id to an internal line. // As said, this would be not allowed, and an exception should be immediately - // thrown. Still, there is the possibility that one only wants to specifiy a + // thrown. Still, there is the possibility that one only wants to specify a // manifold_id here. If that is the case (manifold_id != numbers::flat_manifold_id) // the operation is allowed. Otherwise, we really tried to specify a boundary_id // (and not a manifold_id) to an internal face. The exception must be thrown. @@ -5092,7 +5092,7 @@ namespace internal // are not consecutive, we cannot do so and have to // replace them by two lines that are consecutive. we // try to avoid that situation, but it may happen - // nevertheless throug repeated refinement and + // nevertheless through repeated refinement and // coarsening. thus we have to check here, as we will // need some additional space to store those new lines // in case we need them... @@ -9268,13 +9268,13 @@ create_triangulation (const std::vector > &v, /* When the triangulation is a manifold (dim < spacedim), the normal field provided from the map class depends on the order of the vertices. - It may happen that this normal field is discontinous. + It may happen that this normal field is discontinuous. The following code takes care that this is not the case by setting the cell direction flag on those cell that produce the wrong orientation. To determine if 2 neighbours have the same or opposite orientation we use a table of truth. - Its entries are indexes by the local indeces of the common face. + Its entries are indexes by the local indices of the common face. For example if two elements share a face, and this face is face 0 for element 0 and face 1 for element 1, then table(0,1) will tell whether the orientation are the same (true) or diff --git a/source/grid/tria_boundary_lib.cc b/source/grid/tria_boundary_lib.cc index 5f6fde7b10..62b44b7783 100644 --- a/source/grid/tria_boundary_lib.cc +++ b/source/grid/tria_boundary_lib.cc @@ -1420,7 +1420,7 @@ get_intermediate_points_on_line (const Triangulation<2, 3>::line_iterator &lin offset[1]=0; //Take care for periodic conditions & negative angles, see - //get_new_point_on_line() above. Because we dont have a symmetric + //get_new_point_on_line() above. Because we don't have a symmetric //interpolation (just the middle) we need to add 2*Pi to each almost zero //and negative angles. for (unsigned int i=0; i<2; i++) @@ -1474,7 +1474,7 @@ get_intermediate_points_on_quad (const Triangulation< 2, 3 >::quad_iterator &qua offset[1]=0; //Take care for periodic conditions & negative angles, see - //get_new_point_on_line() above. Because we dont have a symmetric + //get_new_point_on_line() above. Because we don't have a symmetric //interpolation (just the middle) we need to add 2*Pi to each almost zero //and negative angles. for (unsigned int i=0; i<2; i++) diff --git a/source/lac/petsc_parallel_sparse_matrix.cc b/source/lac/petsc_parallel_sparse_matrix.cc index 9cee6d4b1e..08ac98f6df 100644 --- a/source/lac/petsc_parallel_sparse_matrix.cc +++ b/source/lac/petsc_parallel_sparse_matrix.cc @@ -472,7 +472,7 @@ namespace PETScWrappers // have to count how many of the // entries in the sparsity pattern lie // in the column area we have locally, - // and how many arent. for this, we + // and how many aren't. for this, we // first have to know which areas are // ours size_type local_row_start = 0; diff --git a/source/lac/petsc_solver.cc b/source/lac/petsc_solver.cc index a6363a9c61..0c60ecb058 100644 --- a/source/lac/petsc_solver.cc +++ b/source/lac/petsc_solver.cc @@ -766,7 +766,7 @@ namespace PETScWrappers /** * get the factored matrix F from the preconditioner context. This - * routine is valid only for LU, ILU, Cholesky, and imcomplete + * routine is valid only for LU, ILU, Cholesky, and incomplete * Cholesky */ ierr = PCFactorGetMatrix(solver_data->pc, &F); diff --git a/source/lac/trilinos_precondition.cc b/source/lac/trilinos_precondition.cc index bd8eefe151..4d8177c450 100644 --- a/source/lac/trilinos_precondition.cc +++ b/source/lac/trilinos_precondition.cc @@ -720,7 +720,7 @@ namespace TrilinosWrappers // What follows just configures a dummy preconditioner that // sets up the domain and range maps, as well as the communicator. // It is never used as the vmult, Tvmult operations are - // given a custom defintion. + // given a custom definition. // Note: This is only required in order to wrap this // preconditioner in a LinearOperator without an exemplar // matrix. diff --git a/source/lac/trilinos_sparse_matrix.cc b/source/lac/trilinos_sparse_matrix.cc index 3b71264424..44f22fd65c 100644 --- a/source/lac/trilinos_sparse_matrix.cc +++ b/source/lac/trilinos_sparse_matrix.cc @@ -2302,7 +2302,7 @@ namespace TrilinosWrappers // As of now, no particularly neat - // ouput is generated in case of + // output is generated in case of // multiple processors. void SparseMatrix::print (std::ostream &out, diff --git a/source/lac/trilinos_sparsity_pattern.cc b/source/lac/trilinos_sparsity_pattern.cc index 51e788b246..7b5c3a432d 100644 --- a/source/lac/trilinos_sparsity_pattern.cc +++ b/source/lac/trilinos_sparsity_pattern.cc @@ -1006,7 +1006,7 @@ namespace TrilinosWrappers // As of now, no particularly neat - // ouput is generated in case of + // output is generated in case of // multiple processors. void SparsityPattern::print (std::ostream &out, diff --git a/source/multigrid/mg_tools.cc b/source/multigrid/mg_tools.cc index 216c9eb45a..6c1882c5b7 100644 --- a/source/multigrid/mg_tools.cc +++ b/source/multigrid/mg_tools.cc @@ -319,7 +319,7 @@ namespace MGTools // We loop over cells and go from // cells to lower dimensional // objects. This is the only way to - // cope withthe fact, that an + // cope with the fact, that an // unknown number of cells may // share an object of dimension // smaller than dim-1. diff --git a/tests/manifold/transfinite_manifold_07.cc b/tests/manifold/transfinite_manifold_07.cc index ceadc2cdb7..fe5687f580 100644 --- a/tests/manifold/transfinite_manifold_07.cc +++ b/tests/manifold/transfinite_manifold_07.cc @@ -54,7 +54,7 @@ void concentric_disks(Triangulation<2> &tria, n_vert = (2 + nlay) * vlayer + 1, n_cell = 3 + (1 + nlay) * lcells + 1; // 19 - int fc = 4; // fv = 1, f: fixed, displacement of index on the vertexes and + int fc = 4; // fv = 1, f: fixed, displacement of index on the vertices and // cells ... inner objects // geometric information----------------------- -- 2.39.5