]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
step:44 minor changes to code and results.dox
authormcbride <mcbride@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 28 Feb 2012 12:35:45 +0000 (12:35 +0000)
committermcbride <mcbride@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 28 Feb 2012 12:35:45 +0000 (12:35 +0000)
git-svn-id: https://svn.dealii.org/trunk@25185 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/examples/step-44/doc/results.dox
deal.II/examples/step-44/step-44.cc

index 7726047dec1b522e8ce8be127f3d4dff01bde08b..648afdaf711d305a7e3754eeae1207e7b11f2ca7 100644 (file)
@@ -128,7 +128,7 @@ The pressure solution is very coarse and has large jumps between adjacent cells.
 It is clear that the volume nearest to the applied traction undergoes compression while the outer extents 
 of the domain are in a state of expansion. 
 The dilatation solution field and pressure field are clearly linked, 
-with positive dilatation indicating regions of positive hyprodstatic pressure and negative showing regions placed in compression.
+with positive dilatation indicating regions of positive pressure and negative showing regions placed in compression.
 As discussed in the Introduction, a compressive pressure has a negative sign 
 while an expansive pressure takes a positive sign. 
 This stems from the definition of the volumetric strain energy function 
index 6473b4a820d8c8fc3f2845ff2917fa23159cd357..4832daaa7bae1de6a2bbeb08cf7656b8c445927b 100644 (file)
@@ -561,7 +561,7 @@ namespace Step44
 
     template <int dim>
     const SymmetricTensor<4, dim>
-    StandardTensors<dim>::dev_P = (II - (1.0 / dim) * IxI);
+    StandardTensors<dim>::dev_P = deviator_tensor<dim>();
   }
 
 // @sect3{Time class}
@@ -706,7 +706,7 @@ namespace Step44
        }
 
                                       // Derivative of the volumetric free
-                                      // energy wrt $\widetilde{J}$ return
+                                      // energy with respect to $\widetilde{J}$ return
                                       // $\frac{\partial
                                       // \Psi_{\text{vol}}(\widetilde{J})}{\partial
                                       // \widetilde{J}}$
@@ -925,15 +925,15 @@ namespace Step44
                                           // and the first and second derivatives
                                           // of the volumetric free energy.
                                           //
-                                          // Finally, we store the inverse of
+                                          // We also store the inverse of
                                           // the deformation gradient since
                                           // we frequently use it:
+         F_inv = invert(F);
          tau = material->get_tau();
-
          Jc = material->get_Jc();
          dPsi_vol_dJ = material->get_dPsi_vol_dJ();
          d2Psi_vol_dJ2 = material->get_d2Psi_vol_dJ2();
-         F_inv = invert(F);
+
        }
 
                                       // We offer an interface to retrieve
@@ -949,7 +949,7 @@ namespace Step44
          return material->get_det_F();
        }
 
-      Tensor<2, dim> get_F_inv() const
+      const Tensor<2, dim>& get_F_inv() const
        {
          return F_inv;
        }
@@ -963,7 +963,7 @@ namespace Step44
          return material->get_p_tilde();
        }
 
-      SymmetricTensor<2, dim> get_tau() const
+     const SymmetricTensor<2, dim>& get_tau() const
        {
          return tau;
        }
@@ -979,7 +979,7 @@ namespace Step44
        }
 
                                       // and finally the tangent
-      SymmetricTensor<4, dim> get_Jc() const
+      const SymmetricTensor<4, dim>& get_Jc() const
        {
          return Jc;
        }
@@ -1678,7 +1678,7 @@ namespace Step44
 // this operation (we could, in principle simply create a new task using
 // Threads::new_task for each cell) but there is not much harm done to doing
 // it this way anyway.
-// Furthermore, should their be different material models associated with a
+// Furthermore, should there be different material models associated with a
 // quadrature point, requiring varying levels of computational expense, then
 // the method used here could be advantageous.
   template <int dim>
@@ -1803,7 +1803,7 @@ namespace Step44
     block_component[p_component] = p_dof; // Pressure
     block_component[J_component] = J_dof; // Dilatation
 
-                                    // DOF handler is then initialised and we
+                                    // The DOF handler is then initialised and we
                                     // renumber the grid in an efficient
                                     // manner. We also record the number of
                                     // DOF's per block.
@@ -1840,8 +1840,6 @@ namespace Step44
       csp.block(J_dof, J_dof).reinit(n_dofs_J, n_dofs_J);
       csp.collect_sizes();
 
-                                      // In order to perform the static condensation efficiently,
-                                      // we choose to exploit the symmetry of the the system matrix.
                                       // The global system matrix initially has the following structure
                                       // @f{align*}
                                                // \underbrace{\begin{bmatrix}
@@ -3025,7 +3023,8 @@ namespace Step44
                                           // preconditioner as it appears to
                                           // provide the fastest solver
                                           // convergence characteristics for this
-                                          // problem.  However, for multicore
+                                          // problem on a single-thread machine.
+                                          // However, for multicore
                                           // computing, the Jacobi preconditioner
                                           // which is multithreaded may converge
                                           // quicker for larger linear systems.
@@ -3293,9 +3292,9 @@ namespace Step44
                                // $
                                     // and
                                // $
-                                       //    \overline{\mathbf{\mathsf{K}}} =
-                                       //     \mathbf{\mathsf{K}}_{\widetilde{J}\widetilde{p}}^{-1} \mathbf{\mathsf{K}}_{\widetilde{J}\widetilde{J}}
-                                       //    \mathbf{\mathsf{K}}_{\widetilde{p}\widetilde{J}}^{-1}
+                                       //    \overline{\mathbf{\mathsf{k}}} =
+                                       //     \mathbf{\mathsf{k}}_{\widetilde{J}\widetilde{p}}^{-1} \mathbf{\mathsf{k}}_{\widetilde{J}\widetilde{J}}
+                                       //    \mathbf{\mathsf{k}}_{\widetilde{p}\widetilde{J}}^{-1}
                                // $.
                                     //
                                     // At this point, we need to take note of

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.