]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix typo: jacobian -> Jacobian 17758/head
authorPeter Munch <peterrmuench@gmail.com>
Tue, 8 Oct 2024 05:39:11 +0000 (07:39 +0200)
committerPeter Munch <peterrmuench@gmail.com>
Tue, 8 Oct 2024 05:39:11 +0000 (07:39 +0200)
include/deal.II/base/derivative_form.h
include/deal.II/grid/grid_tools.h
include/deal.II/matrix_free/fe_evaluation_data.h
include/deal.II/matrix_free/mapping_info.templates.h
include/deal.II/matrix_free/matrix_free.templates.h
include/deal.II/trilinos/nox.templates.h

index e688462da8982847f123cac743244794a63ff912..47aa195bfeefe41da725ef6f43f76f14da7f2b39 100644 (file)
@@ -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)}$.
    */
index a9f0a96d235b81fa757ab596d408371a3ee46ebd..39edec023717c2f30be48c6ebe47f7b30c232dc1 100644 (file)
@@ -417,7 +417,7 @@ namespace GridTools
    * </p>
    *
    * 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:
    *
    * <p ALIGN="center">
index e743a535de1107888e6d715b8d39f76b4f4d9dc0..de010f39ab073b147b03628ec488b13d447e761d 100644 (file)
@@ -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;
 
index a4bd97a9b2d5db9067d106b5ac784ac0c1bd7e74..00eacaf94ec78d968103dd7de89467c4147313a8 100644 (file)
@@ -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 <int dim, typename Number>
     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
index 570b629a034be32c4d5e02afb6ece5325c0d0e7a..401d6802ce650326cb34ee8ac1acb9619fde3d7e 100644 (file)
@@ -817,7 +817,7 @@ MatrixFree<dim, Number, VectorizedArrayType>::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;
index f59a73d2ce212158f51ae8e4eb47c562bce8a57a..8a8e076106c4410939f005b7810638861dcd31fb 100644 (file)
@@ -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(

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.