From: Peter Munch Date: Tue, 8 Oct 2024 05:39:11 +0000 (+0200) Subject: Fix typo: jacobian -> Jacobian X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=refs%2Fpull%2F17758%2Fhead;p=dealii.git Fix typo: jacobian -> Jacobian --- diff --git a/include/deal.II/base/derivative_form.h b/include/deal.II/base/derivative_form.h index e688462da8..47aa195bfe 100644 --- a/include/deal.II/base/derivative_form.h +++ b/include/deal.II/base/derivative_form.h @@ -140,7 +140,7 @@ public: norm() const; /** - * Compute the volume element associated with the jacobian of the + * Compute the volume element associated with the Jacobian of the * transformation $\mathbf F$. That is to say if $DF$ is square, it computes * $\det(DF)$, in case DF is not square returns $\sqrt{\det(DF^T \,DF)}$. */ diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index a9f0a96d23..39edec0237 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -417,7 +417,7 @@ namespace GridTools *

* * The four cells that were originally the corners of a square will give you - * some troubles during computations, as the jacobian of the transformation + * some troubles during computations, as the Jacobian of the transformation * from the reference cell to those cells will go to zero, affecting the error * constants of the finite element estimates. * @@ -434,7 +434,7 @@ namespace GridTools * GridTools::regularize_corner_cells(tria); * tria.refine_global(2); * @endcode - * generates a mesh that has a much better behavior w.r.t. the jacobian of + * generates a mesh that has a much better behavior w.r.t. the Jacobian of * the Mapping: * *

diff --git a/include/deal.II/matrix_free/fe_evaluation_data.h b/include/deal.II/matrix_free/fe_evaluation_data.h index e743a535de..de010f39ab 100644 --- a/include/deal.II/matrix_free/fe_evaluation_data.h +++ b/include/deal.II/matrix_free/fe_evaluation_data.h @@ -765,7 +765,7 @@ protected: const Tensor<1, dim, Number> *normal_vectors; /** - * A pointer to the normal vectors times the jacobian at faces. + * A pointer to the normal vectors times the Jacobian at faces. */ const Tensor<1, dim, Number> *normal_x_jacobian; diff --git a/include/deal.II/matrix_free/mapping_info.templates.h b/include/deal.II/matrix_free/mapping_info.templates.h index a4bd97a9b2..00eacaf94e 100644 --- a/include/deal.II/matrix_free/mapping_info.templates.h +++ b/include/deal.II/matrix_free/mapping_info.templates.h @@ -259,13 +259,13 @@ namespace internal // For second derivatives on the real cell, we need the gradient of the // inverse Jacobian J. This involves some calculus and is done - // vectorized. If L is the gradient of the jacobian on the unit cell, + // vectorized. If L is the gradient of the Jacobian on the unit cell, // the gradient of the inverse is given by (multidimensional calculus) - // J * (J * L) * J (the third J is because we need to transform the // gradient L from the unit to the real cell, and then apply the inverse // Jacobian). Compare this with 1d with j(x) = 1/k(phi(x)), where j = - // phi' is the inverse of the jacobian and k is the derivative of the - // jacobian on the unit cell. Then j' = phi' k'/k^2 = j k' j^2. + // phi' is the inverse of the Jacobian and k is the derivative of the + // Jacobian on the unit cell. Then j' = phi' k'/k^2 = j k' j^2. template Tensor<1, dim *(dim + 1) / 2, Tensor<1, dim, Number>> process_jacobian_gradient(const Tensor<2, dim, Number> &inv_jac_permut, @@ -1330,7 +1330,7 @@ namespace internal vv, my_data.jacobian_gradients[0][idx][d][e]); - // Also store the non-inverse jacobian gradient. + // Also store the non-inverse Jacobian gradient. // the diagonal part of Jacobian gradient comes // first for (unsigned int d = 0; d < dim; ++d) @@ -2038,10 +2038,10 @@ namespace internal face_data.general_jac[n_q_points][d][e][v]; // we need to add the normal vector here because we // store both the inverse jacobian and the normal vector - // times the jacobian; of course, there will be + // times the Jacobian; of course, there will be // different values in their product for normal vectors // oriented in different ways (the memory saving is - // still significant); we need to divide by the jacobian + // still significant); we need to divide by the Jacobian // size to get the right scaling for (unsigned int d = 0; d < dim; ++d) for (unsigned int v = 0; @@ -2252,7 +2252,7 @@ namespace internal [offset + q][d][e]); } - // Also store the non-inverse jacobian gradient. + // Also store the non-inverse Jacobian gradient. // the diagonal part of Jacobian gradient comes first. // jac_grad already has its derivatives reordered, // so no need to compensate for this here diff --git a/include/deal.II/matrix_free/matrix_free.templates.h b/include/deal.II/matrix_free/matrix_free.templates.h index 570b629a03..401d6802ce 100644 --- a/include/deal.II/matrix_free/matrix_free.templates.h +++ b/include/deal.II/matrix_free/matrix_free.templates.h @@ -817,7 +817,7 @@ MatrixFree::internal_reinit( } // Will the piola transform be used? If so we need to update - // the jacobian gradients in case of update_gradients on general cells. + // the Jacobian gradients in case of update_gradients on general cells. bool piola_transform = false; for (unsigned int no = 0, c = 0; no < dof_handler.size(); ++no) for (unsigned int b = 0; diff --git a/include/deal.II/trilinos/nox.templates.h b/include/deal.II/trilinos/nox.templates.h index f59a73d2ce..8a8e076106 100644 --- a/include/deal.II/trilinos/nox.templates.h +++ b/include/deal.II/trilinos/nox.templates.h @@ -354,7 +354,7 @@ namespace TrilinosWrappers public: /** * Constructor. The class is initialized by the solution vector and - * functions to compute the residual, to set up the jacobian, and + * functions to compute the residual, to set up the Jacobian, and * to solve the Jacobian. */ Group(