deal.II version GIT relicensing-2173-gae8fc9d14b 2024-11-24 06:40:00+00:00
\(\newcommand{\dealvcentcolon}{\mathrel{\mathop{:}}}\) \(\newcommand{\dealcoloneq}{\dealvcentcolon\mathrel{\mkern-1.2mu}=}\) \(\newcommand{\jump}[1]{\left[\!\left[ #1 \right]\!\right]}\) \(\newcommand{\average}[1]{\left\{\!\left\{ #1 \right\}\!\right\}}\)
Loading...
Searching...
No Matches
Nonlinear_PoroViscoelasticity.h
Go to the documentation of this file.
1
594 *  
595 * @endcode
596 *
597 * We start by including all the necessary deal.II header files and some C++
598 * related ones. They have been discussed in detail in previous tutorial
599 * programs, so you need only refer to past tutorials for details.
600 *
601
602 *
603 *
604 * @code
605 *   #include <deal.II/base/function.h>
606 *   #include <deal.II/base/parameter_handler.h>
607 *   #include <deal.II/base/point.h>
608 *   #include <deal.II/base/quadrature_lib.h>
609 *   #include <deal.II/base/symmetric_tensor.h>
610 *   #include <deal.II/base/tensor.h>
611 *   #include <deal.II/base/timer.h>
612 *   #include <deal.II/base/work_stream.h>
613 *   #include <deal.II/base/mpi.h>
614 *   #include <deal.II/base/quadrature_point_data.h>
615 *  
616 *   #include <deal.II/differentiation/ad.h>
617 *  
618 *   #include <deal.II/distributed/shared_tria.h>
619 *  
620 *   #include <deal.II/dofs/dof_renumbering.h>
621 *   #include <deal.II/dofs/dof_tools.h>
622 *   #include <deal.II/dofs/dof_accessor.h>
623 *  
624 *   #include <deal.II/grid/filtered_iterator.h>
625 *   #include <deal.II/grid/grid_generator.h>
626 *   #include <deal.II/grid/grid_tools.h>
627 *   #include <deal.II/grid/grid_in.h>
628 *   #include <deal.II/grid/grid_out.h>
629 *   #include <deal.II/grid/manifold_lib.h>
630 *   #include <deal.II/grid/tria_accessor.h>
631 *   #include <deal.II/grid/tria_iterator.h>
632 *  
633 *   #include <deal.II/fe/fe_dgp_monomial.h>
634 *   #include <deal.II/fe/fe_q.h>
635 *   #include <deal.II/fe/fe_system.h>
636 *   #include <deal.II/fe/fe_tools.h>
637 *   #include <deal.II/fe/fe_values.h>
638 *  
639 *   #include <deal.II/lac/block_sparsity_pattern.h>
640 *   #include <deal.II/lac/affine_constraints.h>
641 *   #include <deal.II/lac/dynamic_sparsity_pattern.h>
642 *   #include <deal.II/lac/full_matrix.h>
643 *   #include <deal.II/lac/linear_operator.h>
644 *   #include <deal.II/lac/packaged_operation.h>
645 *  
646 *   #include <deal.II/lac/trilinos_block_sparse_matrix.h>
647 *   #include <deal.II/lac/trilinos_linear_operator.h>
648 *   #include <deal.II/lac/trilinos_parallel_block_vector.h>
649 *   #include <deal.II/lac/trilinos_precondition.h>
650 *   #include <deal.II/lac/trilinos_sparse_matrix.h>
651 *   #include <deal.II/lac/trilinos_sparsity_pattern.h>
652 *   #include <deal.II/lac/trilinos_solver.h>
653 *   #include <deal.II/lac/trilinos_vector.h>
654 *  
655 *   #include <deal.II/lac/block_vector.h>
656 *   #include <deal.II/lac/vector.h>
657 *  
658 *   #include <deal.II/numerics/data_postprocessor.h>
659 *   #include <deal.II/numerics/data_out.h>
660 *   #include <deal.II/numerics/data_out_faces.h>
661 *   #include <deal.II/numerics/fe_field_function.h>
662 *   #include <deal.II/numerics/vector_tools.h>
663 *  
664 *   #include <deal.II/physics/transformations.h>
665 *   #include <deal.II/physics/elasticity/kinematics.h>
666 *   #include <deal.II/physics/elasticity/standard_tensors.h>
667 *  
668 *   #include <iostream>
669 *   #include <fstream>
670 *   #include <numeric>
671 *   #include <iomanip>
672 *  
673 *  
674 * @endcode
675 *
676 * We create a namespace for everything that relates to
677 * the nonlinear poro-viscoelastic formulation,
678 * and import all the deal.II function and class names into it:
679 *
680 * @code
681 *   namespace NonLinearPoroViscoElasticity
682 *   {
683 *   using namespace dealii;
684 *  
685 * @endcode
686 *
687 *
688 * <a name="nonlinear-poro-viscoelasticity.cc-Runtimeparameters"></a>
689 * <h3>Run-time parameters</h3>
690 *
691
692 *
693 * Set up a ParameterHandler object to read in the parameter choices at run-time
694 * introduced by the user through the file "parameters.prm"
695 *
696 * @code
697 *   namespace Parameters
698 *   {
699 * @endcode
700 *
701 *
702 * <a name="nonlinear-poro-viscoelasticity.cc-FiniteElementsystem"></a>
703 * <h4>Finite Element system</h4>
704 * Here we specify the polynomial order used to approximate the solution,
705 * both for the displacements and pressure unknowns.
706 * The quadrature order should be adjusted accordingly.
707 *
708 * @code
709 *   struct FESystem
710 *   {
711 *   unsigned int poly_degree_displ;
712 *   unsigned int poly_degree_pore;
713 *   unsigned int quad_order;
714 *  
715 *   static void
716 *   declare_parameters(ParameterHandler &prm);
717 *  
718 *   void
719 *   parse_parameters(ParameterHandler &prm);
720 *   };
721 *  
722 *   void FESystem::declare_parameters(ParameterHandler &prm)
723 *   {
724 *   prm.enter_subsection("Finite element system");
725 *   {
726 *   prm.declare_entry("Polynomial degree displ", "2",
727 *   Patterns::Integer(0),
728 *   "Displacement system polynomial order");
729 *  
730 *   prm.declare_entry("Polynomial degree pore", "1",
731 *   Patterns::Integer(0),
732 *   "Pore pressure system polynomial order");
733 *  
734 *   prm.declare_entry("Quadrature order", "3",
735 *   Patterns::Integer(0),
736 *   "Gauss quadrature order");
737 *   }
738 *   prm.leave_subsection();
739 *   }
740 *  
741 *   void FESystem::parse_parameters(ParameterHandler &prm)
742 *   {
743 *   prm.enter_subsection("Finite element system");
744 *   {
745 *   poly_degree_displ = prm.get_integer("Polynomial degree displ");
746 *   poly_degree_pore = prm.get_integer("Polynomial degree pore");
747 *   quad_order = prm.get_integer("Quadrature order");
748 *   }
749 *   prm.leave_subsection();
750 *   }
751 *  
752 * @endcode
753 *
754 *
755 * <a name="nonlinear-poro-viscoelasticity.cc-Geometry"></a>
756 * <h4>Geometry</h4>
757 * These parameters are related to the geometry definition and mesh generation.
758 * We select the type of problem to solve and introduce the desired load values.
759 *
760 * @code
761 *   struct Geometry
762 *   {
763 *   std::string geom_type;
764 *   unsigned int global_refinement;
765 *   double scale;
766 *   std::string load_type;
767 *   double load;
768 *   unsigned int num_cycle_sets;
769 *   double fluid_flow;
770 *   double drained_pressure;
771 *  
772 *   static void
773 *   declare_parameters(ParameterHandler &prm);
774 *  
775 *   void
776 *   parse_parameters(ParameterHandler &prm);
777 *   };
778 *  
779 *   void Geometry::declare_parameters(ParameterHandler &prm)
780 *   {
781 *   prm.enter_subsection("Geometry");
782 *   {
783 *   prm.declare_entry("Geometry type", "Ehlers_tube_step_load",
784 *   Patterns::Selection("Ehlers_tube_step_load"
785 *   "|Ehlers_tube_increase_load"
786 *   "|Ehlers_cube_consolidation"
787 *   "|Franceschini_consolidation"
788 *   "|Budday_cube_tension_compression"
789 *   "|Budday_cube_tension_compression_fully_fixed"
790 *   "|Budday_cube_shear_fully_fixed"),
791 *   "Type of geometry used. "
792 *   "For Ehlers verification examples see Ehlers and Eipper (1999). "
793 *   "For Franceschini brain consolidation see Franceschini et al. (2006)"
794 *   "For Budday brain examples see Budday et al. (2017)");
795 *  
796 *   prm.declare_entry("Global refinement", "1",
797 *   Patterns::Integer(0),
798 *   "Global refinement level");
799 *  
800 *   prm.declare_entry("Grid scale", "1.0",
801 *   Patterns::Double(0.0),
802 *   "Global grid scaling factor");
803 *  
804 *   prm.declare_entry("Load type", "pressure",
805 *   Patterns::Selection("pressure|displacement|none"),
806 *   "Type of loading");
807 *  
808 *   prm.declare_entry("Load value", "-7.5e+6",
809 *   Patterns::Double(),
810 *   "Loading value");
811 *  
812 *   prm.declare_entry("Number of cycle sets", "1",
813 *   Patterns::Integer(1,2),
814 *   "Number of times each set of 3 cycles is repeated, only for "
815 *   "Budday_cube_tension_compression and Budday_cube_tension_compression_fully_fixed. "
816 *   "Load value is doubled in second set, load rate is kept constant."
817 *   "Final time indicates end of second cycle set.");
818 *  
819 *   prm.declare_entry("Fluid flow value", "0.0",
820 *   Patterns::Double(),
821 *   "Prescribed fluid flow. Not implemented in any example yet.");
822 *  
823 *   prm.declare_entry("Drained pressure", "0.0",
824 *   Patterns::Double(),
825 *   "Increase of pressure value at drained boundary w.r.t the atmospheric pressure.");
826 *   }
827 *   prm.leave_subsection();
828 *   }
829 *  
830 *   void Geometry::parse_parameters(ParameterHandler &prm)
831 *   {
832 *   prm.enter_subsection("Geometry");
833 *   {
834 *   geom_type = prm.get("Geometry type");
835 *   global_refinement = prm.get_integer("Global refinement");
836 *   scale = prm.get_double("Grid scale");
837 *   load_type = prm.get("Load type");
838 *   load = prm.get_double("Load value");
839 *   num_cycle_sets = prm.get_integer("Number of cycle sets");
840 *   fluid_flow = prm.get_double("Fluid flow value");
841 *   drained_pressure = prm.get_double("Drained pressure");
842 *   }
843 *   prm.leave_subsection();
844 *   }
845 *  
846 * @endcode
847 *
848 *
849 * <a name="nonlinear-poro-viscoelasticity.cc-Materials"></a>
850 * <h4>Materials</h4>
851 *
852
853 *
854 * Here we select the type of material for the solid component
855 * and define the corresponding material parameters.
856 * Then we define he fluid data, including the type of
857 * seepage velocity definition to use.
858 *
859 * @code
860 *   struct Materials
861 *   {
862 *   std::string mat_type;
863 *   double lambda;
864 *   double mu;
865 *   double mu1_infty;
866 *   double mu2_infty;
867 *   double mu3_infty;
868 *   double alpha1_infty;
869 *   double alpha2_infty;
870 *   double alpha3_infty;
871 *   double mu1_mode_1;
872 *   double mu2_mode_1;
873 *   double mu3_mode_1;
874 *   double alpha1_mode_1;
875 *   double alpha2_mode_1;
876 *   double alpha3_mode_1;
877 *   double viscosity_mode_1;
878 *   std::string fluid_type;
879 *   double solid_vol_frac;
880 *   double kappa_darcy;
881 *   double init_intrinsic_perm;
882 *   double viscosity_FR;
883 *   double init_darcy_coef;
884 *   double weight_FR;
885 *   bool gravity_term;
886 *   int gravity_direction;
887 *   double gravity_value;
888 *   double density_FR;
889 *   double density_SR;
890 *   enum SymmetricTensorEigenvectorMethod eigen_solver;
891 *  
892 *   static void
893 *   declare_parameters(ParameterHandler &prm);
894 *  
895 *   void
896 *   parse_parameters(ParameterHandler &prm);
897 *   };
898 *  
899 *   void Materials::declare_parameters(ParameterHandler &prm)
900 *   {
901 *   prm.enter_subsection("Material properties");
902 *   {
903 *   prm.declare_entry("material", "Neo-Hooke",
904 *   Patterns::Selection("Neo-Hooke|Ogden|visco-Ogden"),
905 *   "Type of material used in the problem");
906 *  
907 *   prm.declare_entry("lambda", "8.375e6",
908 *   Patterns::Double(0,1e100),
909 *   "First Lamé parameter for extension function related to compactation point in solid material [Pa].");
910 *  
911 *   prm.declare_entry("shear modulus", "5.583e6",
912 *   Patterns::Double(0,1e100),
913 *   "shear modulus for Neo-Hooke materials [Pa].");
914 *  
915 *   prm.declare_entry("eigen solver", "QL Implicit Shifts",
916 *   Patterns::Selection("QL Implicit Shifts|Jacobi"),
917 *   "The type of eigen solver to be used for Ogden and visco-Ogden models.");
918 *  
919 *   prm.declare_entry("mu1", "0.0",
920 *   Patterns::Double(),
921 *   "Shear material parameter 'mu1' for Ogden material [Pa].");
922 *  
923 *   prm.declare_entry("mu2", "0.0",
924 *   Patterns::Double(),
925 *   "Shear material parameter 'mu2' for Ogden material [Pa].");
926 *  
927 *   prm.declare_entry("mu3", "0.0",
928 *   Patterns::Double(),
929 *   "Shear material parameter 'mu1' for Ogden material [Pa].");
930 *  
931 *   prm.declare_entry("alpha1", "1.0",
932 *   Patterns::Double(),
933 *   "Stiffness material parameter 'alpha1' for Ogden material [-].");
934 *  
935 *   prm.declare_entry("alpha2", "1.0",
936 *   Patterns::Double(),
937 *   "Stiffness material parameter 'alpha2' for Ogden material [-].");
938 *  
939 *   prm.declare_entry("alpha3", "1.0",
940 *   Patterns::Double(),
941 *   "Stiffness material parameter 'alpha3' for Ogden material [-].");
942 *  
943 *   prm.declare_entry("mu1_1", "0.0",
944 *   Patterns::Double(),
945 *   "Shear material parameter 'mu1' for first viscous mode in Ogden material [Pa].");
946 *  
947 *   prm.declare_entry("mu2_1", "0.0",
948 *   Patterns::Double(),
949 *   "Shear material parameter 'mu2' for first viscous mode in Ogden material [Pa].");
950 *  
951 *   prm.declare_entry("mu3_1", "0.0",
952 *   Patterns::Double(),
953 *   "Shear material parameter 'mu1' for first viscous mode in Ogden material [Pa].");
954 *  
955 *   prm.declare_entry("alpha1_1", "1.0",
956 *   Patterns::Double(),
957 *   "Stiffness material parameter 'alpha1' for first viscous mode in Ogden material [-].");
958 *  
959 *   prm.declare_entry("alpha2_1", "1.0",
960 *   Patterns::Double(),
961 *   "Stiffness material parameter 'alpha2' for first viscous mode in Ogden material [-].");
962 *  
963 *   prm.declare_entry("alpha3_1", "1.0",
964 *   Patterns::Double(),
965 *   "Stiffness material parameter 'alpha3' for first viscous mode in Ogden material [-].");
966 *  
967 *   prm.declare_entry("viscosity_1", "1e-10",
968 *   Patterns::Double(1e-10,1e100),
969 *   "Deformation-independent viscosity parameter 'eta_1' for first viscous mode in Ogden material [-].");
970 *  
971 *   prm.declare_entry("seepage definition", "Ehlers",
972 *   Patterns::Selection("Markert|Ehlers"),
973 *   "Type of formulation used to define the seepage velocity in the problem. "
974 *   "Choose between Markert formulation of deformation-dependent intrinsic permeability "
975 *   "and Ehlers formulation of deformation-dependent Darcy flow coefficient.");
976 *  
977 *   prm.declare_entry("initial solid volume fraction", "0.67",
978 *   Patterns::Double(0.001,0.999),
979 *   "Initial porosity (solid volume fraction, 0 < n_0s < 1)");
980 *  
981 *   prm.declare_entry("kappa", "0.0",
982 *   Patterns::Double(0,100),
983 *   "Deformation-dependency control parameter for specific permeability (kappa >= 0)");
984 *  
985 *   prm.declare_entry("initial intrinsic permeability", "0.0",
986 *   Patterns::Double(0,1e100),
987 *   "Initial intrinsic permeability parameter [m^2] (isotropic permeability). To be used with Markert formulation.");
988 *  
989 *   prm.declare_entry("fluid viscosity", "0.0",
990 *   Patterns::Double(0, 1e100),
991 *   "Effective shear viscosity parameter of the fluid [Pa·s, (N·s)/m^2]. To be used with Markert formulation.");
992 *  
993 *   prm.declare_entry("initial Darcy coefficient", "1.0e-4",
994 *   Patterns::Double(0,1e100),
995 *   "Initial Darcy flow coefficient [m/s] (isotropic permeability). To be used with Ehlers formulation.");
996 *  
997 *   prm.declare_entry("fluid weight", "1.0e4",
998 *   Patterns::Double(0, 1e100),
999 *   "Effective weight of the fluid [N/m^3]. To be used with Ehlers formulation.");
1000 *  
1001 *   prm.declare_entry("gravity term", "false",
1002 *   Patterns::Bool(),
1003 *   "Gravity term considered (true) or neglected (false)");
1004 *  
1005 *   prm.declare_entry("fluid density", "1.0",
1006 *   Patterns::Double(0,1e100),
1007 *   "Real (or effective) density of the fluid");
1008 *  
1009 *   prm.declare_entry("solid density", "1.0",
1010 *   Patterns::Double(0,1e100),
1011 *   "Real (or effective) density of the solid");
1012 *  
1013 *   prm.declare_entry("gravity direction", "2",
1014 *   Patterns::Integer(0,2),
1015 *   "Direction of gravity (unit vector 0 for x, 1 for y, 2 for z)");
1016 *  
1017 *   prm.declare_entry("gravity value", "-9.81",
1018 *   Patterns::Double(),
1019 *   "Value of gravity (be careful to have consistent units!)");
1020 *   }
1021 *   prm.leave_subsection();
1022 *   }
1023 *  
1024 *   void Materials::parse_parameters(ParameterHandler &prm)
1025 *   {
1026 *   prm.enter_subsection("Material properties");
1027 *   {
1028 * @endcode
1029 *
1030 * Solid
1031 *
1032 * @code
1033 *   mat_type = prm.get("material");
1034 *   lambda = prm.get_double("lambda");
1035 *   mu = prm.get_double("shear modulus");
1036 *   mu1_infty = prm.get_double("mu1");
1037 *   mu2_infty = prm.get_double("mu2");
1038 *   mu3_infty = prm.get_double("mu3");
1039 *   alpha1_infty = prm.get_double("alpha1");
1040 *   alpha2_infty = prm.get_double("alpha2");
1041 *   alpha3_infty = prm.get_double("alpha3");
1042 *   mu1_mode_1 = prm.get_double("mu1_1");
1043 *   mu2_mode_1 = prm.get_double("mu2_1");
1044 *   mu3_mode_1 = prm.get_double("mu3_1");
1045 *   alpha1_mode_1 = prm.get_double("alpha1_1");
1046 *   alpha2_mode_1 = prm.get_double("alpha2_1");
1047 *   alpha3_mode_1 = prm.get_double("alpha3_1");
1048 *   viscosity_mode_1 = prm.get_double("viscosity_1");
1049 * @endcode
1050 *
1051 * Fluid
1052 *
1053 * @code
1054 *   fluid_type = prm.get("seepage definition");
1055 *   solid_vol_frac = prm.get_double("initial solid volume fraction");
1056 *   kappa_darcy = prm.get_double("kappa");
1057 *   init_intrinsic_perm = prm.get_double("initial intrinsic permeability");
1058 *   viscosity_FR = prm.get_double("fluid viscosity");
1059 *   init_darcy_coef = prm.get_double("initial Darcy coefficient");
1060 *   weight_FR = prm.get_double("fluid weight");
1061 * @endcode
1062 *
1063 * Gravity effects
1064 *
1065 * @code
1066 *   gravity_term = prm.get_bool("gravity term");
1067 *   density_FR = prm.get_double("fluid density");
1068 *   density_SR = prm.get_double("solid density");
1069 *   gravity_direction = prm.get_integer("gravity direction");
1070 *   gravity_value = prm.get_double("gravity value");
1071 *  
1072 *   if ( (fluid_type == "Markert") && ((init_intrinsic_perm == 0.0) || (viscosity_FR == 0.0)) )
1073 *   AssertThrow(false, ExcMessage("Markert seepage velocity formulation requires the definition of "
1074 *   "'initial intrinsic permeability' and 'fluid viscosity' greater than 0.0."));
1075 *  
1076 *   if ( (fluid_type == "Ehlers") && ((init_darcy_coef == 0.0) || (weight_FR == 0.0)) )
1077 *   AssertThrow(false, ExcMessage("Ehler seepage velocity formulation requires the definition of "
1078 *   "'initial Darcy coefficient' and 'fluid weight' greater than 0.0."));
1079 *  
1080 *   const std::string eigen_solver_type = prm.get("eigen solver");
1081 *   if (eigen_solver_type == "QL Implicit Shifts")
1083 *   else if (eigen_solver_type == "Jacobi")
1084 *   eigen_solver = SymmetricTensorEigenvectorMethod::jacobi;
1085 *   else
1086 *   {
1087 *   AssertThrow(false, ExcMessage("Unknown eigen solver selected."));
1088 *   }
1089 *   }
1090 *   prm.leave_subsection();
1091 *   }
1092 *  
1093 * @endcode
1094 *
1095 *
1096 * <a name="nonlinear-poro-viscoelasticity.cc-Nonlinearsolver"></a>
1097 * <h4>Nonlinear solver</h4>
1098 *
1099
1100 *
1101 * We now define the tolerances and the maximum number of iterations for the
1102 * Newton-Raphson scheme used to solve the nonlinear system of governing equations.
1103 *
1104 * @code
1105 *   struct NonlinearSolver
1106 *   {
1107 *   unsigned int max_iterations_NR;
1108 *   double tol_f;
1109 *   double tol_u;
1110 *   double tol_p_fluid;
1111 *  
1112 *   static void
1113 *   declare_parameters(ParameterHandler &prm);
1114 *  
1115 *   void
1116 *   parse_parameters(ParameterHandler &prm);
1117 *   };
1118 *  
1119 *   void NonlinearSolver::declare_parameters(ParameterHandler &prm)
1120 *   {
1121 *   prm.enter_subsection("Nonlinear solver");
1122 *   {
1123 *   prm.declare_entry("Max iterations Newton-Raphson", "15",
1124 *   Patterns::Integer(0),
1125 *   "Number of Newton-Raphson iterations allowed");
1126 *  
1127 *   prm.declare_entry("Tolerance force", "1.0e-8",
1128 *   Patterns::Double(0.0),
1129 *   "Force residual tolerance");
1130 *  
1131 *   prm.declare_entry("Tolerance displacement", "1.0e-6",
1132 *   Patterns::Double(0.0),
1133 *   "Displacement error tolerance");
1134 *  
1135 *   prm.declare_entry("Tolerance pore pressure", "1.0e-6",
1136 *   Patterns::Double(0.0),
1137 *   "Pore pressure error tolerance");
1138 *   }
1139 *   prm.leave_subsection();
1140 *   }
1141 *  
1142 *   void NonlinearSolver::parse_parameters(ParameterHandler &prm)
1143 *   {
1144 *   prm.enter_subsection("Nonlinear solver");
1145 *   {
1146 *   max_iterations_NR = prm.get_integer("Max iterations Newton-Raphson");
1147 *   tol_f = prm.get_double("Tolerance force");
1148 *   tol_u = prm.get_double("Tolerance displacement");
1149 *   tol_p_fluid = prm.get_double("Tolerance pore pressure");
1150 *   }
1151 *   prm.leave_subsection();
1152 *   }
1153 *  
1154 * @endcode
1155 *
1156 *
1157 * <a name="nonlinear-poro-viscoelasticity.cc-Time"></a>
1158 * <h4>Time</h4>
1159 * Here we set the timestep size @f$ \varDelta t @f$ and the simulation end-time.
1160 *
1161 * @code
1162 *   struct Time
1163 *   {
1164 *   double end_time;
1165 *   double delta_t;
1166 *   static void
1167 *   declare_parameters(ParameterHandler &prm);
1168 *  
1169 *   void
1170 *   parse_parameters(ParameterHandler &prm);
1171 *   };
1172 *  
1173 *   void Time::declare_parameters(ParameterHandler &prm)
1174 *   {
1175 *   prm.enter_subsection("Time");
1176 *   {
1177 *   prm.declare_entry("End time", "10.0",
1178 *   Patterns::Double(),
1179 *   "End time");
1180 *  
1181 *   prm.declare_entry("Time step size", "0.002",
1182 *   Patterns::Double(1.0e-6),
1183 *   "Time step size. The value must be larger than the displacement error tolerance defined.");
1184 *   }
1185 *   prm.leave_subsection();
1186 *   }
1187 *  
1188 *   void Time::parse_parameters(ParameterHandler &prm)
1189 *   {
1190 *   prm.enter_subsection("Time");
1191 *   {
1192 *   end_time = prm.get_double("End time");
1193 *   delta_t = prm.get_double("Time step size");
1194 *   }
1195 *   prm.leave_subsection();
1196 *   }
1197 *  
1198 *  
1199 * @endcode
1200 *
1201 *
1202 * <a name="nonlinear-poro-viscoelasticity.cc-Output"></a>
1203 * <h4>Output</h4>
1204 * We can choose the frequency of the data for the output files.
1205 *
1206 * @code
1207 *   struct OutputParam
1208 *   {
1209 *  
1210 *   std::string outfiles_requested;
1211 *   unsigned int timestep_output;
1212 *   std::string outtype;
1213 *  
1214 *   static void
1215 *   declare_parameters(ParameterHandler &prm);
1216 *  
1217 *   void
1218 *   parse_parameters(ParameterHandler &prm);
1219 *   };
1220 *  
1221 *   void OutputParam::declare_parameters(ParameterHandler &prm)
1222 *   {
1223 *   prm.enter_subsection("Output parameters");
1224 *   {
1225 *   prm.declare_entry("Output files", "true",
1226 *   Patterns::Selection("true|false"),
1227 *   "Paraview output files to generate.");
1228 *   prm.declare_entry("Time step number output", "1",
1229 *   Patterns::Integer(0),
1230 *   "Output data for time steps multiple of the given "
1231 *   "integer value.");
1232 *   prm.declare_entry("Averaged results", "nodes",
1233 *   Patterns::Selection("elements|nodes"),
1234 *   "Output data associated with integration point values"
1235 *   " averaged on elements or on nodes.");
1236 *   }
1237 *   prm.leave_subsection();
1238 *   }
1239 *  
1240 *   void OutputParam::parse_parameters(ParameterHandler &prm)
1241 *   {
1242 *   prm.enter_subsection("Output parameters");
1243 *   {
1244 *   outfiles_requested = prm.get("Output files");
1245 *   timestep_output = prm.get_integer("Time step number output");
1246 *   outtype = prm.get("Averaged results");
1247 *   }
1248 *   prm.leave_subsection();
1249 *   }
1250 *  
1251 * @endcode
1252 *
1253 *
1254 * <a name="nonlinear-poro-viscoelasticity.cc-Allparameters"></a>
1255 * <h4>All parameters</h4>
1256 * We finally consolidate all of the above structures into a single container that holds all the run-time selections.
1257 *
1258 * @code
1259 *   struct AllParameters : public FESystem,
1260 *   public Geometry,
1261 *   public Materials,
1262 *   public NonlinearSolver,
1263 *   public Time,
1264 *   public OutputParam
1265 *   {
1266 *   AllParameters(const std::string &input_file);
1267 *  
1268 *   static void
1269 *   declare_parameters(ParameterHandler &prm);
1270 *  
1271 *   void
1272 *   parse_parameters(ParameterHandler &prm);
1273 *   };
1274 *  
1275 *   AllParameters::AllParameters(const std::string &input_file)
1276 *   {
1277 *   ParameterHandler prm;
1278 *   declare_parameters(prm);
1279 *   prm.parse_input(input_file);
1280 *   parse_parameters(prm);
1281 *   }
1282 *  
1283 *   void AllParameters::declare_parameters(ParameterHandler &prm)
1284 *   {
1285 *   FESystem::declare_parameters(prm);
1286 *   Geometry::declare_parameters(prm);
1287 *   Materials::declare_parameters(prm);
1288 *   NonlinearSolver::declare_parameters(prm);
1289 *   Time::declare_parameters(prm);
1290 *   OutputParam::declare_parameters(prm);
1291 *   }
1292 *  
1293 *   void AllParameters::parse_parameters(ParameterHandler &prm)
1294 *   {
1295 *   FESystem::parse_parameters(prm);
1296 *   Geometry::parse_parameters(prm);
1297 *   Materials::parse_parameters(prm);
1298 *   NonlinearSolver::parse_parameters(prm);
1299 *   Time::parse_parameters(prm);
1300 *   OutputParam::parse_parameters(prm);
1301 *   }
1302 *   }
1303 *  
1304 * @endcode
1305 *
1306 *
1307 * <a name="nonlinear-poro-viscoelasticity.cc-Timeclass"></a>
1308 * <h3>Time class</h3>
1309 * A simple class to store time data.
1310 * For simplicity we assume a constant time step size.
1311 *
1312 * @code
1313 *   class Time
1314 *   {
1315 *   public:
1316 *   Time (const double time_end,
1317 *   const double delta_t)
1318 *   :
1319 *   timestep(0),
1320 *   time_current(0.0),
1321 *   time_end(time_end),
1322 *   delta_t(delta_t)
1323 *   {}
1324 *  
1325 *   virtual ~Time()
1326 *   {}
1327 *  
1328 *   double get_current() const
1329 *   {
1330 *   return time_current;
1331 *   }
1332 *   double get_end() const
1333 *   {
1334 *   return time_end;
1335 *   }
1336 *   double get_delta_t() const
1337 *   {
1338 *   return delta_t;
1339 *   }
1340 *   unsigned int get_timestep() const
1341 *   {
1342 *   return timestep;
1343 *   }
1344 *   void increment_time ()
1345 *   {
1346 *   time_current += delta_t;
1347 *   ++timestep;
1348 *   }
1349 *  
1350 *   private:
1351 *   unsigned int timestep;
1352 *   double time_current;
1353 *   double time_end;
1354 *   const double delta_t;
1355 *   };
1356 *  
1357 * @endcode
1358 *
1359 *
1360 * <a name="nonlinear-poro-viscoelasticity.cc-Constitutiveequationforthesolidcomponentofthebiphasicmaterial"></a>
1361 * <h3>Constitutive equation for the solid component of the biphasic material</h3>
1362 *
1363
1364 *
1365 *
1366 * <a name="nonlinear-poro-viscoelasticity.cc-Baseclassgenerichyperelasticmaterial"></a>
1367 * <h4>Base class: generic hyperelastic material</h4>
1368 * The "extra" Kirchhoff stress in the solid component is the sum of isochoric
1369 * and a volumetric part:
1370 * @f$\mathbf{\tau} = \mathbf{\tau}_E^{(\bullet)} + \mathbf{\tau}^{\textrm{vol}}@f$.
1371 * The deviatoric part changes depending on the type of material model selected:
1372 * Neo-Hooken hyperelasticity, Ogden hyperelasticiy,
1373 * or a single-mode finite viscoelasticity based on the Ogden hyperelastic model.
1374 * In this base class we declare it as a virtual function,
1375 * and it will be defined for each model type in the corresponding derived class.
1376 * We define here the volumetric component, which depends on the
1377 * extension function @f$U(J_S)@f$ selected, and in this case is the same for all models.
1378 * We use the function proposed by
1379 * Ehlers & Eipper 1999 doi:10.1023/A:1006565509095.
1380 * We also define some public functions to access and update the internal variables.
1381 *
1382 * @code
1383 *   template <int dim, typename NumberType = Sacado::Fad::DFad<double> >
1384 *   class Material_Hyperelastic
1385 *   {
1386 *   public:
1387 *   Material_Hyperelastic(const Parameters::AllParameters &parameters,
1388 *   const Time &time)
1389 *   :
1390 *   n_OS (parameters.solid_vol_frac),
1391 *   lambda (parameters.lambda),
1392 *   time(time),
1393 *   det_F (1.0),
1394 *   det_F_converged (1.0),
1395 *   eigen_solver (parameters.eigen_solver)
1396 *   {}
1397 *   ~Material_Hyperelastic()
1398 *   {}
1399 *  
1401 *   get_tau_E(const Tensor<2,dim, NumberType> &F) const
1402 *   {
1403 *   return ( get_tau_E_base(F) + get_tau_E_ext_func(F) );
1404 *   }
1405 *  
1407 *   get_Cauchy_E(const Tensor<2, dim, NumberType> &F) const
1408 *   {
1409 *   const NumberType det_F = determinant(F);
1410 *   Assert(det_F > 0, ExcInternalError());
1411 *   return get_tau_E(F)*NumberType(1/det_F);
1412 *   }
1413 *  
1414 *   double
1415 *   get_converged_det_F() const
1416 *   {
1417 *   return det_F_converged;
1418 *   }
1419 *  
1420 *   virtual void
1421 *   update_end_timestep()
1422 *   {
1423 *   det_F_converged = det_F;
1424 *   }
1425 *  
1426 *   virtual void
1427 *   update_internal_equilibrium( const Tensor<2, dim, NumberType> &F )
1428 *   {
1429 *   det_F = Tensor<0,dim,double>(determinant(F));
1430 *   }
1431 *  
1432 *   virtual double
1433 *   get_viscous_dissipation( ) const = 0;
1434 *  
1435 *   const double n_OS;
1436 *   const double lambda;
1437 *   const Time &time;
1438 *   double det_F;
1439 *   double det_F_converged;
1440 *   const enum SymmetricTensorEigenvectorMethod eigen_solver;
1441 *  
1442 *   protected:
1444 *   get_tau_E_ext_func(const Tensor<2,dim, NumberType> &F) const
1445 *   {
1446 *   const NumberType det_F = determinant(F);
1447 *   Assert(det_F > 0, ExcInternalError());
1448 *  
1449 *   static const SymmetricTensor< 2, dim, double>
1451 *   return ( NumberType(lambda * (1.0-n_OS)*(1.0-n_OS)
1452 *   * (det_F/(1.0-n_OS) - det_F/(det_F-n_OS))) * I );
1453 *   }
1454 *  
1456 *   get_tau_E_base(const Tensor<2,dim, NumberType> &F) const = 0;
1457 *   };
1458 *  
1459 * @endcode
1460 *
1461 *
1462 * <a name="nonlinear-poro-viscoelasticity.cc-DerivedclassNeoHookeanhyperelasticmaterial"></a>
1463 * <h4>Derived class: Neo-Hookean hyperelastic material</h4>
1464 *
1465 * @code
1466 *   template <int dim, typename NumberType = Sacado::Fad::DFad<double> >
1467 *   class NeoHooke : public Material_Hyperelastic < dim, NumberType >
1468 *   {
1469 *   public:
1470 *   NeoHooke(const Parameters::AllParameters &parameters,
1471 *   const Time &time)
1472 *   :
1473 *   Material_Hyperelastic< dim, NumberType > (parameters,time),
1474 *   mu(parameters.mu)
1475 *   {}
1476 *   virtual ~NeoHooke()
1477 *   {}
1478 *  
1479 *   double
1480 *   get_viscous_dissipation() const override
1481 *   {
1482 *   return 0.0;
1483 *   }
1484 *  
1485 *   protected:
1486 *   const double mu;
1487 *  
1489 *   get_tau_E_base(const Tensor<2,dim, NumberType> &F) const override
1490 *   {
1491 *   static const SymmetricTensor< 2, dim, double>
1493 *  
1494 *   const bool use_standard_model = true;
1495 *  
1496 *   if (use_standard_model)
1497 *   {
1498 * @endcode
1499 *
1500 * Standard Neo-Hooke
1501 *
1502 * @code
1503 *   return ( mu * ( symmetrize(F * transpose(F)) - I ) );
1504 *   }
1505 *   else
1506 *   {
1507 * @endcode
1508 *
1509 * Neo-Hooke in terms of principal stretches
1510 *
1511 * @code
1513 *   B = symmetrize(F * transpose(F));
1514 *   const std::array< std::pair< NumberType, Tensor< 1, dim, NumberType > >, dim >
1515 *   eigen_B = eigenvectors(B, this->eigen_solver);
1516 *  
1518 *   for (unsigned int d=0; d<dim; ++d)
1519 *   B_ev += eigen_B[d].first*symmetrize(outer_product(eigen_B[d].second,eigen_B[d].second));
1520 *  
1521 *   return ( mu*(B_ev-I) );
1522 *   }
1523 *   }
1524 *   };
1525 *  
1526 * @endcode
1527 *
1528 *
1529 * <a name="nonlinear-poro-viscoelasticity.cc-DerivedclassOgdenhyperelasticmaterial"></a>
1530 * <h4>Derived class: Ogden hyperelastic material</h4>
1531 *
1532 * @code
1533 *   template <int dim, typename NumberType = Sacado::Fad::DFad<double> >
1534 *   class Ogden : public Material_Hyperelastic < dim, NumberType >
1535 *   {
1536 *   public:
1537 *   Ogden(const Parameters::AllParameters &parameters,
1538 *   const Time &time)
1539 *   :
1540 *   Material_Hyperelastic< dim, NumberType > (parameters,time),
1541 *   mu({parameters.mu1_infty,
1542 *   parameters.mu2_infty,
1543 *   parameters.mu3_infty}),
1544 *   alpha({parameters.alpha1_infty,
1545 *   parameters.alpha2_infty,
1546 *   parameters.alpha3_infty})
1547 *   {}
1548 *   virtual ~Ogden()
1549 *   {}
1550 *  
1551 *   double
1552 *   get_viscous_dissipation() const override
1553 *   {
1554 *   return 0.0;
1555 *   }
1556 *  
1557 *   protected:
1558 *   std::vector<double> mu;
1559 *   std::vector<double> alpha;
1560 *  
1562 *   get_tau_E_base(const Tensor<2,dim, NumberType> &F) const override
1563 *   {
1565 *   B = symmetrize(F * transpose(F));
1566 *  
1567 *   const std::array< std::pair< NumberType, Tensor< 1, dim, NumberType > >, dim >
1568 *   eigen_B = eigenvectors(B, this->eigen_solver);
1569 *  
1571 *   static const SymmetricTensor< 2, dim, double>
1573 *  
1574 *   for (unsigned int i = 0; i < 3; ++i)
1575 *   {
1576 *   for (unsigned int A = 0; A < dim; ++A)
1577 *   {
1579 *   outer_product(eigen_B[A].second,eigen_B[A].second));
1580 *   tau_aux1 *= mu[i]*std::pow(eigen_B[A].first, (alpha[i]/2.) );
1581 *   tau += tau_aux1;
1582 *   }
1583 *   SymmetricTensor<2, dim, NumberType> tau_aux2 (I);
1584 *   tau_aux2 *= mu[i];
1585 *   tau -= tau_aux2;
1586 *   }
1587 *   return tau;
1588 *   }
1589 *   };
1590 *  
1591 * @endcode
1592 *
1593 *
1594 * <a name="nonlinear-poro-viscoelasticity.cc-DerivedclassSinglemodeOgdenviscoelasticmaterial"></a>
1595 * <h4>Derived class: Single-mode Ogden viscoelastic material</h4>
1596 * We use the finite viscoelastic model described in
1597 * Reese & Govindjee (1998) doi:10.1016/S0020-7683(97)00217-5
1598 * The algorithm for the implicit exponential time integration is given in
1599 * Budday et al. (2017) doi: 10.1016/j.actbio.2017.06.024
1600 *
1601 * @code
1602 *   template <int dim, typename NumberType = Sacado::Fad::DFad<double> >
1603 *   class visco_Ogden : public Material_Hyperelastic < dim, NumberType >
1604 *   {
1605 *   public:
1606 *   visco_Ogden(const Parameters::AllParameters &parameters,
1607 *   const Time &time)
1608 *   :
1609 *   Material_Hyperelastic< dim, NumberType > (parameters,time),
1610 *   mu_infty({parameters.mu1_infty,
1611 *   parameters.mu2_infty,
1612 *   parameters.mu3_infty}),
1613 *   alpha_infty({parameters.alpha1_infty,
1614 *   parameters.alpha2_infty,
1615 *   parameters.alpha3_infty}),
1616 *   mu_mode_1({parameters.mu1_mode_1,
1617 *   parameters.mu2_mode_1,
1618 *   parameters.mu3_mode_1}),
1619 *   alpha_mode_1({parameters.alpha1_mode_1,
1620 *   parameters.alpha2_mode_1,
1621 *   parameters.alpha3_mode_1}),
1622 *   viscosity_mode_1(parameters.viscosity_mode_1),
1624 *   Cinv_v_1_converged(Physics::Elasticity::StandardTensors<dim>::I)
1625 *   {}
1626 *   virtual ~visco_Ogden()
1627 *   {}
1628 *  
1629 *   void
1630 *   update_internal_equilibrium( const Tensor<2, dim, NumberType> &F ) override
1631 *   {
1632 *   Material_Hyperelastic < dim, NumberType >::update_internal_equilibrium(F);
1633 *  
1634 *   this->Cinv_v_1 = this->Cinv_v_1_converged;
1635 *   SymmetricTensor<2, dim, NumberType> B_e_1_tr = symmetrize(F * this->Cinv_v_1 * transpose(F));
1636 *  
1637 *   const std::array< std::pair< NumberType, Tensor< 1, dim, NumberType > >, dim >
1638 *   eigen_B_e_1_tr = eigenvectors(B_e_1_tr, this->eigen_solver);
1639 *  
1640 *   Tensor< 1, dim, NumberType > lambdas_e_1_tr;
1641 *   Tensor< 1, dim, NumberType > epsilon_e_1_tr;
1642 *   for (int a = 0; a < dim; ++a)
1643 *   {
1644 *   lambdas_e_1_tr[a] = std::sqrt(eigen_B_e_1_tr[a].first);
1645 *   epsilon_e_1_tr[a] = std::log(lambdas_e_1_tr[a]);
1646 *   }
1647 *  
1648 *   const double tolerance = 1e-8;
1649 *   double residual_check = tolerance*10.0;
1650 *   Tensor< 1, dim, NumberType > residual;
1651 *   Tensor< 2, dim, NumberType > tangent;
1653 *   NumberType J_e_1 = std::sqrt(determinant(B_e_1_tr));
1654 *  
1655 *   std::vector<NumberType> lambdas_e_1_iso(dim);
1657 *   int iteration = 0;
1658 *  
1659 *   Tensor< 1, dim, NumberType > lambdas_e_1;
1660 *   Tensor< 1, dim, NumberType > epsilon_e_1;
1661 *   epsilon_e_1 = epsilon_e_1_tr;
1662 *  
1663 *   while(residual_check > tolerance)
1664 *   {
1665 *   NumberType aux_J_e_1 = 1.0;
1666 *   for (unsigned int a = 0; a < dim; ++a)
1667 *   {
1668 *   lambdas_e_1[a] = std::exp(epsilon_e_1[a]);
1669 *   aux_J_e_1 *= lambdas_e_1[a];
1670 *   }
1671 *  
1672 *   J_e_1 = aux_J_e_1;
1673 *  
1674 *   for (unsigned int a = 0; a < dim; ++a)
1675 *   lambdas_e_1_iso[a] = lambdas_e_1[a]*std::pow(J_e_1,-1.0/dim);
1676 *  
1677 *   for (unsigned int a = 0; a < dim; ++a)
1678 *   {
1679 *   residual[a] = get_beta_mode_1(lambdas_e_1_iso, a);
1680 *   residual[a] *= this->time.get_delta_t()/(2.0*viscosity_mode_1);
1681 *   residual[a] += epsilon_e_1[a];
1682 *   residual[a] -= epsilon_e_1_tr[a];
1683 *  
1684 *   for (unsigned int b = 0; b < dim; ++b)
1685 *   {
1686 *   tangent[a][b] = get_gamma_mode_1(lambdas_e_1_iso, a, b);
1687 *   tangent[a][b] *= this->time.get_delta_t()/(2.0*viscosity_mode_1);
1688 *   tangent[a][b] += I[a][b];
1689 *   }
1690 *  
1691 *   }
1692 *   epsilon_e_1 -= invert(tangent)*residual;
1693 *  
1694 *   residual_check = 0.0;
1695 *   for (unsigned int a = 0; a < dim; ++a)
1696 *   {
1697 *   if ( std::abs(residual[a]) > residual_check)
1698 *   residual_check = std::abs(Tensor<0,dim,double>(residual[a]));
1699 *   }
1700 *   iteration += 1;
1701 *   if (iteration > 15 )
1702 *   AssertThrow(false, ExcMessage("No convergence in local Newton iteration for the "
1703 *   "viscoelastic exponential time integration algorithm."));
1704 *   }
1705 *  
1706 *   NumberType aux_J_e_1 = 1.0;
1707 *   for (unsigned int a = 0; a < dim; ++a)
1708 *   {
1709 *   lambdas_e_1[a] = std::exp(epsilon_e_1[a]);
1710 *   aux_J_e_1 *= lambdas_e_1[a];
1711 *   }
1712 *   J_e_1 = aux_J_e_1;
1713 *  
1714 *   for (unsigned int a = 0; a < dim; ++a)
1715 *   lambdas_e_1_iso[a] = lambdas_e_1[a]*std::pow(J_e_1,-1.0/dim);
1716 *  
1717 *   for (unsigned int a = 0; a < dim; ++a)
1718 *   {
1720 *   B_e_1_aux = symmetrize(outer_product(eigen_B_e_1_tr[a].second,eigen_B_e_1_tr[a].second));
1721 *   B_e_1_aux *= lambdas_e_1[a] * lambdas_e_1[a];
1722 *   B_e_1 += B_e_1_aux;
1723 *   }
1724 *  
1725 *   Tensor<2, dim, NumberType>Cinv_v_1_AD = symmetrize(invert(F) * B_e_1 * invert(transpose(F)));
1726 *  
1727 *   this->tau_neq_1 = 0;
1728 *   for (unsigned int a = 0; a < dim; ++a)
1729 *   {
1731 *   tau_neq_1_aux = symmetrize(outer_product(eigen_B_e_1_tr[a].second,eigen_B_e_1_tr[a].second));
1732 *   tau_neq_1_aux *= get_beta_mode_1(lambdas_e_1_iso, a);
1733 *   this->tau_neq_1 += tau_neq_1_aux;
1734 *   }
1735 *  
1736 * @endcode
1737 *
1738 * Store history
1739 *
1740 * @code
1741 *   for (unsigned int a = 0; a < dim; ++a)
1742 *   for (unsigned int b = 0; b < dim; ++b)
1743 *   this->Cinv_v_1[a][b]= Tensor<0,dim,double>(Cinv_v_1_AD[a][b]);
1744 *   }
1745 *  
1746 *   void update_end_timestep() override
1747 *   {
1748 *   Material_Hyperelastic < dim, NumberType >::update_end_timestep();
1749 *   this->Cinv_v_1_converged = this->Cinv_v_1;
1750 *   }
1751 *  
1752 *   double get_viscous_dissipation() const override
1753 *   {
1754 *   NumberType dissipation_term = get_tau_E_neq() * get_tau_E_neq(); //Double contract the two SymmetricTensor
1755 *   dissipation_term /= (2*viscosity_mode_1);
1756 *  
1757 *   return dissipation_term.val();
1758 *   }
1759 *  
1760 *   protected:
1761 *   std::vector<double> mu_infty;
1762 *   std::vector<double> alpha_infty;
1763 *   std::vector<double> mu_mode_1;
1764 *   std::vector<double> alpha_mode_1;
1765 *   double viscosity_mode_1;
1766 *   SymmetricTensor<2, dim, double> Cinv_v_1;
1767 *   SymmetricTensor<2, dim, double> Cinv_v_1_converged;
1769 *  
1771 *   get_tau_E_base(const Tensor<2,dim, NumberType> &F) const override
1772 *   {
1773 *   return ( get_tau_E_neq() + get_tau_E_eq(F) );
1774 *   }
1775 *  
1777 *   get_tau_E_eq(const Tensor<2,dim, NumberType> &F) const
1778 *   {
1780 *  
1781 *   std::array< std::pair< NumberType, Tensor< 1, dim, NumberType > >, dim > eigen_B;
1782 *   eigen_B = eigenvectors(B, this->eigen_solver);
1783 *  
1785 *   static const SymmetricTensor< 2, dim, double>
1787 *  
1788 *   for (unsigned int i = 0; i < 3; ++i)
1789 *   {
1790 *   for (unsigned int A = 0; A < dim; ++A)
1791 *   {
1793 *   outer_product(eigen_B[A].second,eigen_B[A].second));
1794 *   tau_aux1 *= mu_infty[i]*std::pow(eigen_B[A].first, (alpha_infty[i]/2.) );
1795 *   tau += tau_aux1;
1796 *   }
1797 *   SymmetricTensor<2, dim, NumberType> tau_aux2 (I);
1798 *   tau_aux2 *= mu_infty[i];
1799 *   tau -= tau_aux2;
1800 *   }
1801 *   return tau;
1802 *   }
1803 *  
1805 *   get_tau_E_neq() const
1806 *   {
1807 *   return tau_neq_1;
1808 *   }
1809 *  
1810 *   NumberType
1811 *   get_beta_mode_1(std::vector< NumberType > &lambda, const int &A) const
1812 *   {
1813 *   NumberType beta = 0.0;
1814 *  
1815 *   for (unsigned int i = 0; i < 3; ++i) //3rd-order Ogden model
1816 *   {
1817 *  
1818 *   NumberType aux = 0.0;
1819 *   for (int p = 0; p < dim; ++p)
1820 *   aux += std::pow(lambda[p],alpha_mode_1[i]);
1821 *  
1822 *   aux *= -1.0/dim;
1823 *   aux += std::pow(lambda[A], alpha_mode_1[i]);
1824 *   aux *= mu_mode_1[i];
1825 *  
1826 *   beta += aux;
1827 *   }
1828 *   return beta;
1829 *   }
1830 *  
1831 *   NumberType
1832 *   get_gamma_mode_1(std::vector< NumberType > &lambda,
1833 *   const int &A,
1834 *   const int &B ) const
1835 *   {
1836 *   NumberType gamma = 0.0;
1837 *  
1838 *   if (A==B)
1839 *   {
1840 *   for (unsigned int i = 0; i < 3; ++i)
1841 *   {
1842 *   NumberType aux = 0.0;
1843 *   for (int p = 0; p < dim; ++p)
1844 *   aux += std::pow(lambda[p],alpha_mode_1[i]);
1845 *  
1846 *   aux *= 1.0/(dim*dim);
1847 *   aux += 1.0/dim * std::pow(lambda[A], alpha_mode_1[i]);
1848 *   aux *= mu_mode_1[i]*alpha_mode_1[i];
1849 *  
1850 *   gamma += aux;
1851 *   }
1852 *   }
1853 *   else
1854 *   {
1855 *   for (unsigned int i = 0; i < 3; ++i)
1856 *   {
1857 *   NumberType aux = 0.0;
1858 *   for (int p = 0; p < dim; ++p)
1859 *   aux += std::pow(lambda[p],alpha_mode_1[i]);
1860 *  
1861 *   aux *= 1.0/(dim*dim);
1862 *   aux -= 1.0/dim * std::pow(lambda[A], alpha_mode_1[i]);
1863 *   aux -= 1.0/dim * std::pow(lambda[B], alpha_mode_1[i]);
1864 *   aux *= mu_mode_1[i]*alpha_mode_1[i];
1865 *  
1866 *   gamma += aux;
1867 *   }
1868 *   }
1869 *  
1870 *   return gamma;
1871 *   }
1872 *   };
1873 *  
1874 *  
1875 * @endcode
1876 *
1877 *
1878 * <a name="nonlinear-poro-viscoelasticity.cc-Constitutiveequationforthefluidcomponentofthebiphasicmaterial"></a>
1879 * <h3>Constitutive equation for the fluid component of the biphasic material</h3>
1880 * We consider two slightly different definitions to define the seepage velocity with a Darcy-like law.
1881 * Ehlers & Eipper 1999, doi:10.1023/A:1006565509095
1882 * Markert 2007, doi:10.1007/s11242-007-9107-6
1883 * The selection of one or another is made by the user via the parameters file.
1884 *
1885 * @code
1886 *   template <int dim, typename NumberType = Sacado::Fad::DFad<double> >
1887 *   class Material_Darcy_Fluid
1888 *   {
1889 *   public:
1890 *   Material_Darcy_Fluid(const Parameters::AllParameters &parameters)
1891 *   :
1892 *   fluid_type(parameters.fluid_type),
1893 *   n_OS(parameters.solid_vol_frac),
1894 *   initial_intrinsic_permeability(parameters.init_intrinsic_perm),
1895 *   viscosity_FR(parameters.viscosity_FR),
1896 *   initial_darcy_coefficient(parameters.init_darcy_coef),
1897 *   weight_FR(parameters.weight_FR),
1898 *   kappa_darcy(parameters.kappa_darcy),
1899 *   gravity_term(parameters.gravity_term),
1900 *   density_FR(parameters.density_FR),
1901 *   gravity_direction(parameters.gravity_direction),
1902 *   gravity_value(parameters.gravity_value)
1903 *   {
1904 *   Assert(kappa_darcy >= 0, ExcInternalError());
1905 *   }
1906 *   ~Material_Darcy_Fluid()
1907 *   {}
1908 *  
1909 *   Tensor<1, dim, NumberType> get_seepage_velocity_current
1910 *   (const Tensor<2,dim, NumberType> &F,
1911 *   const Tensor<1,dim, NumberType> &grad_p_fluid) const
1912 *   {
1913 *   const NumberType det_F = determinant(F);
1914 *   Assert(det_F > 0.0, ExcInternalError());
1915 *  
1916 *   Tensor<2, dim, NumberType> permeability_term;
1917 *  
1918 *   if (fluid_type == "Markert")
1919 *   permeability_term = get_instrinsic_permeability_current(F) / viscosity_FR;
1920 *  
1921 *   else if (fluid_type == "Ehlers")
1922 *   permeability_term = get_darcy_flow_current(F) / weight_FR;
1923 *  
1924 *   else
1925 *   AssertThrow(false, ExcMessage(
1926 *   "Material_Darcy_Fluid --> Only Markert "
1927 *   "and Ehlers formulations have been implemented."));
1928 *  
1929 *   return ( -1.0 * permeability_term * det_F
1930 *   * (grad_p_fluid - get_body_force_FR_current()) );
1931 *   }
1932 *  
1933 *   double get_porous_dissipation(const Tensor<2,dim, NumberType> &F,
1934 *   const Tensor<1,dim, NumberType> &grad_p_fluid) const
1935 *   {
1936 *   NumberType dissipation_term;
1937 *   Tensor<1, dim, NumberType> seepage_velocity;
1938 *   Tensor<2, dim, NumberType> permeability_term;
1939 *  
1940 *   const NumberType det_F = determinant(F);
1941 *   Assert(det_F > 0.0, ExcInternalError());
1942 *  
1943 *   if (fluid_type == "Markert")
1944 *   {
1945 *   permeability_term = get_instrinsic_permeability_current(F) / viscosity_FR;
1946 *   seepage_velocity = get_seepage_velocity_current(F,grad_p_fluid);
1947 *   }
1948 *   else if (fluid_type == "Ehlers")
1949 *   {
1950 *   permeability_term = get_darcy_flow_current(F) / weight_FR;
1951 *   seepage_velocity = get_seepage_velocity_current(F,grad_p_fluid);
1952 *   }
1953 *   else
1954 *   AssertThrow(false, ExcMessage(
1955 *   "Material_Darcy_Fluid --> Only Markert and Ehlers "
1956 *   "formulations have been implemented."));
1957 *  
1958 *   dissipation_term = ( invert(permeability_term) * seepage_velocity ) * seepage_velocity;
1959 *   dissipation_term *= 1.0/(det_F*det_F);
1960 *   return Tensor<0,dim,double>(dissipation_term);
1961 *   }
1962 *  
1963 *   protected:
1964 *   const std::string fluid_type;
1965 *   const double n_OS;
1966 *   const double initial_intrinsic_permeability;
1967 *   const double viscosity_FR;
1968 *   const double initial_darcy_coefficient;
1969 *   const double weight_FR;
1970 *   const double kappa_darcy;
1971 *   const bool gravity_term;
1972 *   const double density_FR;
1973 *   const int gravity_direction;
1974 *   const double gravity_value;
1975 *  
1977 *   get_instrinsic_permeability_current(const Tensor<2,dim, NumberType> &F) const
1978 *   {
1979 *   static const SymmetricTensor< 2, dim, double>
1981 *   const Tensor<2, dim, NumberType> initial_instrinsic_permeability_tensor
1982 *   = Tensor<2, dim, double>(initial_intrinsic_permeability * I);
1983 *  
1984 *   const NumberType det_F = determinant(F);
1985 *   Assert(det_F > 0.0, ExcInternalError());
1986 *  
1987 *   const NumberType fraction = (det_F - n_OS)/(1 - n_OS);
1988 *   return ( NumberType (std::pow(fraction, kappa_darcy))
1989 *   * initial_instrinsic_permeability_tensor );
1990 *   }
1991 *  
1993 *   get_darcy_flow_current(const Tensor<2,dim, NumberType> &F) const
1994 *   {
1995 *   static const SymmetricTensor< 2, dim, double>
1997 *   const Tensor<2, dim, NumberType> initial_darcy_flow_tensor
1998 *   = Tensor<2, dim, double>(initial_darcy_coefficient * I);
1999 *  
2000 *   const NumberType det_F = determinant(F);
2001 *   Assert(det_F > 0.0, ExcInternalError());
2002 *  
2003 *   const NumberType fraction = (1.0 - (n_OS / det_F) )/(1.0 - n_OS);
2004 *   return ( NumberType (std::pow(fraction, kappa_darcy))
2005 *   * initial_darcy_flow_tensor);
2006 *   }
2007 *  
2009 *   get_body_force_FR_current() const
2010 *   {
2011 *   Tensor<1, dim, NumberType> body_force_FR_current;
2012 *  
2013 *   if (gravity_term == true)
2014 *   {
2015 *   Tensor<1, dim, NumberType> gravity_vector;
2016 *   gravity_vector[gravity_direction] = gravity_value;
2017 *   body_force_FR_current = density_FR * gravity_vector;
2018 *   }
2019 *   return body_force_FR_current;
2020 *   }
2021 *   };
2022 *  
2023 * @endcode
2024 *
2025 *
2026 * <a name="nonlinear-poro-viscoelasticity.cc-Quadraturepointhistory"></a>
2027 * <h3>Quadrature point history</h3>
2028 * As seen in @ref step_18 "step-18", the <code> PointHistory </code> class offers a method
2029 * for storing data at the quadrature points. Here each quadrature point
2030 * holds a pointer to a material description. Thus, different material models
2031 * can be used in different regions of the domain. Among other data, we
2032 * choose to store the "extra" Kirchhoff stress @f$\boldsymbol{\tau}_E@f$ and
2033 * the dissipation values @f$\mathcal{D}_p@f$ and @f$\mathcal{D}_v@f$.
2034 *
2035 * @code
2036 *   template <int dim, typename NumberType = Sacado::Fad::DFad<double> > //double>
2037 *   class PointHistory
2038 *   {
2039 *   public:
2040 *   PointHistory()
2041 *   {}
2042 *  
2043 *   virtual ~PointHistory()
2044 *   {}
2045 *  
2046 *   void setup_lqp (const Parameters::AllParameters &parameters,
2047 *   const Time &time)
2048 *   {
2049 *   if (parameters.mat_type == "Neo-Hooke")
2050 *   solid_material.reset(new NeoHooke<dim,NumberType>(parameters,time));
2051 *   else if (parameters.mat_type == "Ogden")
2052 *   solid_material.reset(new Ogden<dim,NumberType>(parameters,time));
2053 *   else if (parameters.mat_type == "visco-Ogden")
2054 *   solid_material.reset(new visco_Ogden<dim,NumberType>(parameters,time));
2055 *   else
2056 *   Assert (false, ExcMessage("Material type not implemented"));
2057 *  
2058 *   fluid_material.reset(new Material_Darcy_Fluid<dim,NumberType>(parameters));
2059 *   }
2060 *  
2062 *   get_tau_E(const Tensor<2, dim, NumberType> &F) const
2063 *   {
2064 *   return solid_material->get_tau_E(F);
2065 *   }
2066 *  
2068 *   get_Cauchy_E(const Tensor<2, dim, NumberType> &F) const
2069 *   {
2070 *   return solid_material->get_Cauchy_E(F);
2071 *   }
2072 *  
2073 *   double
2074 *   get_converged_det_F() const
2075 *   {
2076 *   return solid_material->get_converged_det_F();
2077 *   }
2078 *  
2079 *   void
2080 *   update_end_timestep()
2081 *   {
2082 *   solid_material->update_end_timestep();
2083 *   }
2084 *  
2085 *   void
2086 *   update_internal_equilibrium(const Tensor<2, dim, NumberType> &F )
2087 *   {
2088 *   solid_material->update_internal_equilibrium(F);
2089 *   }
2090 *  
2091 *   double
2092 *   get_viscous_dissipation() const
2093 *   {
2094 *   return solid_material->get_viscous_dissipation();
2095 *   }
2096 *  
2098 *   get_seepage_velocity_current (const Tensor<2,dim, NumberType> &F,
2099 *   const Tensor<1,dim, NumberType> &grad_p_fluid) const
2100 *   {
2101 *   return fluid_material->get_seepage_velocity_current(F, grad_p_fluid);
2102 *   }
2103 *  
2104 *   double
2105 *   get_porous_dissipation(const Tensor<2,dim, NumberType> &F,
2106 *   const Tensor<1,dim, NumberType> &grad_p_fluid) const
2107 *   {
2108 *   return fluid_material->get_porous_dissipation(F, grad_p_fluid);
2109 *   }
2110 *  
2112 *   get_overall_body_force (const Tensor<2,dim, NumberType> &F,
2113 *   const Parameters::AllParameters &parameters) const
2114 *   {
2115 *   Tensor<1, dim, NumberType> body_force;
2116 *  
2117 *   if (parameters.gravity_term == true)
2118 *   {
2119 *   const NumberType det_F_AD = determinant(F);
2120 *   Assert(det_F_AD > 0.0, ExcInternalError());
2121 *  
2122 *   const NumberType overall_density_ref
2123 *   = parameters.density_SR * parameters.solid_vol_frac
2124 *   + parameters.density_FR
2125 *   * (det_F_AD - parameters.solid_vol_frac);
2126 *  
2127 *   Tensor<1, dim, NumberType> gravity_vector;
2128 *   gravity_vector[parameters.gravity_direction] = parameters.gravity_value;
2129 *   body_force = overall_density_ref * gravity_vector;
2130 *   }
2131 *  
2132 *   return body_force;
2133 *   }
2134 *   private:
2135 *   std::shared_ptr< Material_Hyperelastic<dim, NumberType> > solid_material;
2136 *   std::shared_ptr< Material_Darcy_Fluid<dim, NumberType> > fluid_material;
2137 *   };
2138 *  
2139 * @endcode
2140 *
2141 *
2142 * <a name="nonlinear-poro-viscoelasticity.cc-Nonlinearporoviscoelasticsolid"></a>
2143 * <h3>Nonlinear poro-viscoelastic solid</h3>
2144 * The Solid class is the central class as it represents the problem at hand:
2145 * the nonlinear poro-viscoelastic solid
2146 *
2147 * @code
2148 *   template <int dim>
2149 *   class Solid
2150 *   {
2151 *   public:
2152 *   Solid(const Parameters::AllParameters &parameters);
2153 *   virtual ~Solid();
2154 *   void run();
2155 *  
2156 *   protected:
2157 *   using ADNumberType = Sacado::Fad::DFad<double>;
2158 *  
2159 *   std::ofstream outfile;
2160 *   std::ofstream pointfile;
2161 *  
2162 *   struct PerTaskData_ASM;
2163 *   template<typename NumberType = double> struct ScratchData_ASM;
2164 *  
2165 * @endcode
2166 *
2167 * Generate mesh
2168 *
2169 * @code
2170 *   virtual void make_grid() = 0;
2171 *  
2172 * @endcode
2173 *
2174 * Define points for post-processing
2175 *
2176 * @code
2177 *   virtual void define_tracked_vertices(std::vector<Point<dim> > &tracked_vertices) = 0;
2178 *  
2179 * @endcode
2180 *
2181 * Set up the finite element system to be solved:
2182 *
2183 * @code
2184 *   void system_setup(TrilinosWrappers::MPI::BlockVector &solution_delta_OUT);
2185 *  
2186 * @endcode
2187 *
2188 * Extract sub-blocks from the global matrix
2189 *
2190 * @code
2191 *   void determine_component_extractors();
2192 *  
2193 * @endcode
2194 *
2195 * Several functions to assemble the system and right hand side matrices using multithreading.
2196 *
2197 * @code
2198 *   void assemble_system
2199 *   (const TrilinosWrappers::MPI::BlockVector &solution_delta_OUT );
2200 *   void assemble_system_one_cell
2201 *   (const typename DoFHandler<dim>::active_cell_iterator &cell,
2202 *   ScratchData_ASM<ADNumberType> &scratch,
2203 *   PerTaskData_ASM &data) const;
2204 *   void copy_local_to_global_system(const PerTaskData_ASM &data);
2205 *  
2206 * @endcode
2207 *
2208 * Define boundary conditions
2209 *
2210 * @code
2211 *   virtual void make_constraints(const int &it_nr);
2212 *   virtual void make_dirichlet_constraints(AffineConstraints<double> &constraints) = 0;
2213 *   virtual Tensor<1,dim> get_neumann_traction
2214 *   (const types::boundary_id &boundary_id,
2215 *   const Point<dim> &pt,
2216 *   const Tensor<1,dim> &N) const = 0;
2217 *   virtual double get_prescribed_fluid_flow
2218 *   (const types::boundary_id &boundary_id,
2219 *   const Point<dim> &pt) const = 0;
2220 *   virtual types::boundary_id
2221 *   get_reaction_boundary_id_for_output () const = 0;
2222 *   virtual std::pair<types::boundary_id,types::boundary_id>
2223 *   get_drained_boundary_id_for_output () const = 0;
2224 *   virtual std::vector<double> get_dirichlet_load
2225 *   (const types::boundary_id &boundary_id,
2226 *   const int &direction) const = 0;
2227 *  
2228 * @endcode
2229 *
2230 * Create and update the quadrature points.
2231 *
2232 * @code
2233 *   void setup_qph();
2234 *  
2235 * @endcode
2236 *
2237 * Solve non-linear system using a Newton-Raphson scheme
2238 *
2239 * @code
2240 *   void solve_nonlinear_timestep(TrilinosWrappers::MPI::BlockVector &solution_delta_OUT);
2241 *  
2242 * @endcode
2243 *
2244 * Solve the linearized equations using a direct solver
2245 *
2246 * @code
2247 *   void solve_linear_system ( TrilinosWrappers::MPI::BlockVector &newton_update_OUT);
2248 *  
2249 * @endcode
2250 *
2251 * Retrieve the solution
2252 *
2253 * @code
2255 *   get_total_solution(const TrilinosWrappers::MPI::BlockVector &solution_delta_IN) const;
2256 *  
2257 * @endcode
2258 *
2259 * Store the converged values of the internal variables at the end of each timestep
2260 *
2261 * @code
2262 *   void update_end_timestep();
2263 *  
2264 * @endcode
2265 *
2266 * Post-processing and writing data to files
2267 *
2268 * @code
2269 *   void output_results_to_vtu(const unsigned int timestep,
2270 *   const double current_time,
2271 *   TrilinosWrappers::MPI::BlockVector solution) const;
2272 *   void output_results_to_plot(const unsigned int timestep,
2273 *   const double current_time,
2275 *   std::vector<Point<dim> > &tracked_vertices,
2276 *   std::ofstream &pointfile) const;
2277 *  
2278 * @endcode
2279 *
2280 * Headers and footer for the output files
2281 *
2282 * @code
2283 *   void print_console_file_header( std::ofstream &outfile) const;
2284 *   void print_plot_file_header(std::vector<Point<dim> > &tracked_vertices,
2285 *   std::ofstream &pointfile) const;
2286 *   void print_console_file_footer(std::ofstream &outfile) const;
2287 *   void print_plot_file_footer( std::ofstream &pointfile) const;
2288 *  
2289 * @endcode
2290 *
2291 * For parallel communication
2292 *
2293 * @code
2294 *   MPI_Comm mpi_communicator;
2295 *   const unsigned int n_mpi_processes;
2296 *   const unsigned int this_mpi_process;
2297 *   mutable ConditionalOStream pcout;
2298 *  
2299 * @endcode
2300 *
2301 * A collection of the parameters used to describe the problem setup
2302 *
2303 * @code
2304 *   const Parameters::AllParameters &parameters;
2305 *  
2306 * @endcode
2307 *
2308 * Declare an instance of dealii Triangulation class (mesh)
2309 *
2310 * @code
2312 *  
2313 * @endcode
2314 *
2315 * Keep track of the current time and the time spent evaluating certain functions
2316 *
2317 * @code
2318 *   Time time;
2319 *   TimerOutput timerconsole;
2320 *   TimerOutput timerfile;
2321 *  
2322 * @endcode
2323 *
2324 * A storage object for quadrature point information.
2325 *
2326 * @code
2327 *   CellDataStorage<typename Triangulation<dim>::cell_iterator, PointHistory<dim,ADNumberType> > quadrature_point_history;
2328 *  
2329 * @endcode
2330 *
2331 * Integers to store polynomial degree (needed for output)
2332 *
2333 * @code
2334 *   const unsigned int degree_displ;
2335 *   const unsigned int degree_pore;
2336 *  
2337 * @endcode
2338 *
2339 * Declare an instance of dealii FESystem class (finite element definition)
2340 *
2341 * @code
2342 *   const FESystem<dim> fe;
2343 *  
2344 * @endcode
2345 *
2346 * Declare an instance of dealii DoFHandler class (assign DoFs to mesh)
2347 *
2348 * @code
2349 *   DoFHandler<dim> dof_handler_ref;
2350 *  
2351 * @endcode
2352 *
2353 * Integer to store DoFs per element (this value will be used often)
2354 *
2355 * @code
2356 *   const unsigned int dofs_per_cell;
2357 *  
2358 * @endcode
2359 *
2360 * Declare an instance of dealii Extractor objects used to retrieve information from the solution vectors
2361 * We will use "u_fe" and "p_fluid_fe"as subscript in operator [] expressions on FEValues and FEFaceValues
2362 * objects to extract the components of the displacement vector and fluid pressure, respectively.
2363 *
2364 * @code
2365 *   const FEValuesExtractors::Vector u_fe;
2366 *   const FEValuesExtractors::Scalar p_fluid_fe;
2367 *  
2368 * @endcode
2369 *
2370 * Description of how the block-system is arranged. There are 3 blocks:
2371 * 0 - vector DOF displacements u
2372 * 1 - scalar DOF fluid pressure p_fluid
2373 *
2374 * @code
2375 *   static const unsigned int n_blocks = 2;
2376 *   static const unsigned int n_components = dim+1;
2377 *   static const unsigned int first_u_component = 0;
2378 *   static const unsigned int p_fluid_component = dim;
2379 *  
2380 *   enum
2381 *   {
2382 *   u_block = 0,
2383 *   p_fluid_block = 1
2384 *   };
2385 *  
2386 * @endcode
2387 *
2388 * Extractors
2389 *
2390 * @code
2391 *   const FEValuesExtractors::Scalar x_displacement;
2392 *   const FEValuesExtractors::Scalar y_displacement;
2393 *   const FEValuesExtractors::Scalar z_displacement;
2394 *   const FEValuesExtractors::Scalar pressure;
2395 *  
2396 * @endcode
2397 *
2398 * Block data
2399 *
2400 * @code
2401 *   std::vector<unsigned int> block_component;
2402 *  
2403 * @endcode
2404 *
2405 * DoF index data
2406 *
2407 * @code
2408 *   std::vector<IndexSet> all_locally_owned_dofs;
2409 *   IndexSet locally_owned_dofs;
2410 *   IndexSet locally_relevant_dofs;
2411 *   std::vector<IndexSet> locally_owned_partitioning;
2412 *   std::vector<IndexSet> locally_relevant_partitioning;
2413 *  
2414 *   std::vector<types::global_dof_index> dofs_per_block;
2415 *   std::vector<types::global_dof_index> element_indices_u;
2416 *   std::vector<types::global_dof_index> element_indices_p_fluid;
2417 *  
2418 * @endcode
2419 *
2420 * Declare an instance of dealii QGauss class (The Gauss-Legendre family of quadrature rules for numerical integration)
2421 * Gauss Points in element, with n quadrature points (in each space direction <dim> )
2422 *
2423 * @code
2424 *   const QGauss<dim> qf_cell;
2425 * @endcode
2426 *
2427 * Gauss Points on element faces (used for definition of BCs)
2428 *
2429 * @code
2430 *   const QGauss<dim - 1> qf_face;
2431 * @endcode
2432 *
2433 * Integer to store num GPs per element (this value will be used often)
2434 *
2435 * @code
2436 *   const unsigned int n_q_points;
2437 * @endcode
2438 *
2439 * Integer to store num GPs per face (this value will be used often)
2440 *
2441 * @code
2442 *   const unsigned int n_q_points_f;
2443 *  
2444 * @endcode
2445 *
2446 * Declare an instance of dealii AffineConstraints class (linear constraints on DoFs due to hanging nodes or BCs)
2447 *
2448 * @code
2449 *   AffineConstraints<double> constraints;
2450 *  
2451 * @endcode
2452 *
2453 * Declare an instance of dealii classes necessary for FE system set-up and assembly
2454 * Store elements of tangent matrix (indicated by SparsityPattern class) as sparse matrix (more efficient)
2455 *
2456 * @code
2457 *   TrilinosWrappers::BlockSparseMatrix tangent_matrix;
2458 *   TrilinosWrappers::BlockSparseMatrix tangent_matrix_preconditioner;
2459 * @endcode
2460 *
2461 * Right hand side vector of forces
2462 *
2463 * @code
2464 *   TrilinosWrappers::MPI::BlockVector system_rhs;
2465 * @endcode
2466 *
2467 * Total displacement values + pressure (accumulated solution to FE system)
2468 *
2469 * @code
2470 *   TrilinosWrappers::MPI::BlockVector solution_n;
2471 *  
2472 * @endcode
2473 *
2474 * Non-block system for the direct solver. We will copy the block system into these to solve the linearized system of equations.
2475 *
2476 * @code
2477 *   TrilinosWrappers::SparseMatrix tangent_matrix_nb;
2478 *   TrilinosWrappers::MPI::Vector system_rhs_nb;
2479 *  
2480 * @endcode
2481 *
2482 * We define variables to store norms and update norms and normalisation factors.
2483 *
2484 * @code
2485 *   struct Errors
2486 *   {
2487 *   Errors()
2488 *   :
2489 *   norm(1.0), u(1.0), p_fluid(1.0)
2490 *   {}
2491 *  
2492 *   void reset()
2493 *   {
2494 *   norm = 1.0;
2495 *   u = 1.0;
2496 *   p_fluid = 1.0;
2497 *   }
2498 *   void normalise(const Errors &rhs)
2499 *   {
2500 *   if (rhs.norm != 0.0)
2501 *   norm /= rhs.norm;
2502 *   if (rhs.u != 0.0)
2503 *   u /= rhs.u;
2504 *   if (rhs.p_fluid != 0.0)
2505 *   p_fluid /= rhs.p_fluid;
2506 *   }
2507 *  
2508 *   double norm, u, p_fluid;
2509 *   };
2510 *  
2511 * @endcode
2512 *
2513 * Declare several instances of the "Error" structure
2514 *
2515 * @code
2516 *   Errors error_residual, error_residual_0, error_residual_norm, error_update,
2517 *   error_update_0, error_update_norm;
2518 *  
2519 * @endcode
2520 *
2521 * Methods to calculate error measures
2522 *
2523 * @code
2524 *   void get_error_residual(Errors &error_residual_OUT);
2525 *   void get_error_update
2526 *   (const TrilinosWrappers::MPI::BlockVector &newton_update_IN,
2527 *   Errors &error_update_OUT);
2528 *  
2529 * @endcode
2530 *
2531 * Print information to screen
2532 *
2533 * @code
2534 *   void print_conv_header();
2535 *   void print_conv_footer();
2536 *  
2537 * @endcode
2538 *
2539 * NOTE: In all functions, we pass by reference (&), so these functions work on the original copy (not a clone copy),
2540 * modifying the input variables inside the functions will change them outside the function.
2541 *
2542 * @code
2543 *   };
2544 *  
2545 * @endcode
2546 *
2547 *
2548 * <a name="nonlinear-poro-viscoelasticity.cc-ImplementationofthecodeSolidcodeclass"></a>
2549 * <h3>Implementation of the <code>Solid</code> class</h3>
2550 *
2551 * <a name="nonlinear-poro-viscoelasticity.cc-Publicinterface"></a>
2552 * <h4>Public interface</h4>
2553 * We initialise the Solid class using data extracted from the parameter file.
2554 *
2555 * @code
2556 *   template <int dim>
2557 *   Solid<dim>::Solid(const Parameters::AllParameters &parameters)
2558 *   :
2559 *   mpi_communicator(MPI_COMM_WORLD),
2560 *   n_mpi_processes (Utilities::MPI::n_mpi_processes(mpi_communicator)),
2561 *   this_mpi_process (Utilities::MPI::this_mpi_process(mpi_communicator)),
2562 *   pcout(std::cout, this_mpi_process == 0),
2563 *   parameters(parameters),
2565 *   time(parameters.end_time, parameters.delta_t),
2566 *   timerconsole( mpi_communicator,
2567 *   pcout,
2570 *   timerfile( mpi_communicator,
2571 *   outfile,
2574 *   degree_displ(parameters.poly_degree_displ),
2575 *   degree_pore(parameters.poly_degree_pore),
2576 *   fe( FE_Q<dim>(parameters.poly_degree_displ), dim,
2577 *   FE_Q<dim>(parameters.poly_degree_pore), 1 ),
2578 *   dof_handler_ref(triangulation),
2579 *   dofs_per_cell (fe.dofs_per_cell),
2580 *   u_fe(first_u_component),
2581 *   p_fluid_fe(p_fluid_component),
2582 *   x_displacement(first_u_component),
2583 *   y_displacement(first_u_component+1),
2584 *   z_displacement(first_u_component+2),
2585 *   pressure(p_fluid_component),
2586 *   dofs_per_block(n_blocks),
2587 *   qf_cell(parameters.quad_order),
2588 *   qf_face(parameters.quad_order),
2589 *   n_q_points (qf_cell.size()),
2590 *   n_q_points_f (qf_face.size())
2591 *   {
2592 *   Assert(dim==3, ExcMessage("This problem only works in 3 space dimensions."));
2593 *   determine_component_extractors();
2594 *   }
2595 *  
2596 * @endcode
2597 *
2598 * The class destructor simply clears the data held by the DOFHandler
2599 *
2600 * @code
2601 *   template <int dim>
2602 *   Solid<dim>::~Solid()
2603 *   {
2604 *   dof_handler_ref.clear();
2605 *   }
2606 *  
2607 * @endcode
2608 *
2609 * Runs the 3D solid problem
2610 *
2611 * @code
2612 *   template <int dim>
2613 *   void Solid<dim>::run()
2614 *   {
2615 * @endcode
2616 *
2617 * The current solution increment is defined as a block vector to reflect the structure
2618 * of the PDE system, with multiple solution components
2619 *
2620 * @code
2621 *   TrilinosWrappers::MPI::BlockVector solution_delta;
2622 *  
2623 * @endcode
2624 *
2625 * Open file
2626 *
2627 * @code
2628 *   if (this_mpi_process == 0)
2629 *   {
2630 *   outfile.open("console-output.sol");
2631 *   print_console_file_header(outfile);
2632 *   }
2633 *  
2634 * @endcode
2635 *
2636 * Generate mesh
2637 *
2638 * @code
2639 *   make_grid();
2640 *  
2641 * @endcode
2642 *
2643 * Assign DOFs and create the stiffness and right-hand-side force vector
2644 *
2645 * @code
2646 *   system_setup(solution_delta);
2647 *  
2648 * @endcode
2649 *
2650 * Define points for post-processing
2651 *
2652 * @code
2653 *   std::vector<Point<dim> > tracked_vertices (2);
2654 *   define_tracked_vertices(tracked_vertices);
2655 *   std::vector<Point<dim>> reaction_force;
2656 *  
2657 *   if (this_mpi_process == 0)
2658 *   {
2659 *   pointfile.open("data-for-gnuplot.sol");
2660 *   print_plot_file_header(tracked_vertices, pointfile);
2661 *   }
2662 *  
2663 * @endcode
2664 *
2665 * Print results to output file
2666 *
2667 * @code
2668 *   if (parameters.outfiles_requested == "true")
2669 *   {
2670 *   output_results_to_vtu(time.get_timestep(),
2671 *   time.get_current(),
2672 *   solution_n );
2673 *   }
2674 *  
2675 *   output_results_to_plot(time.get_timestep(),
2676 *   time.get_current(),
2677 *   solution_n,
2678 *   tracked_vertices,
2679 *   pointfile);
2680 *  
2681 * @endcode
2682 *
2683 * Increment time step (=load step)
2684 * NOTE: In solving the quasi-static problem, the time becomes a loading parameter,
2685 * i.e. we increase the loading linearly with time, making the two concepts interchangeable.
2686 *
2687 * @code
2688 *   time.increment_time();
2689 *  
2690 * @endcode
2691 *
2692 * Print information on screen
2693 *
2694 * @code
2695 *   pcout << "\nSolver:";
2696 *   pcout << "\n CST = make constraints";
2697 *   pcout << "\n ASM_SYS = assemble system";
2698 *   pcout << "\n SLV = linear solver \n";
2699 *  
2700 * @endcode
2701 *
2702 * Print information on file
2703 *
2704 * @code
2705 *   outfile << "\nSolver:";
2706 *   outfile << "\n CST = make constraints";
2707 *   outfile << "\n ASM_SYS = assemble system";
2708 *   outfile << "\n SLV = linear solver \n";
2709 *  
2710 *   while ( (time.get_end() - time.get_current()) > -1.0*parameters.tol_u )
2711 *   {
2712 * @endcode
2713 *
2714 * Initialize the current solution increment to zero
2715 *
2716 * @code
2717 *   solution_delta = 0.0;
2718 *  
2719 * @endcode
2720 *
2721 * Solve the non-linear system using a Newton-Rapshon scheme
2722 *
2723 * @code
2724 *   solve_nonlinear_timestep(solution_delta);
2725 *  
2726 * @endcode
2727 *
2728 * Add the computed solution increment to total solution
2729 *
2730 * @code
2731 *   solution_n += solution_delta;
2732 *  
2733 * @endcode
2734 *
2735 * Store the converged values of the internal variables
2736 *
2737 * @code
2738 *   update_end_timestep();
2739 *  
2740 * @endcode
2741 *
2742 * Output results
2743 *
2744 * @code
2745 *   if (( (time.get_timestep()%parameters.timestep_output) == 0 )
2746 *   && (parameters.outfiles_requested == "true") )
2747 *   {
2748 *   output_results_to_vtu(time.get_timestep(),
2749 *   time.get_current(),
2750 *   solution_n );
2751 *   }
2752 *  
2753 *   output_results_to_plot(time.get_timestep(),
2754 *   time.get_current(),
2755 *   solution_n,
2756 *   tracked_vertices,
2757 *   pointfile);
2758 *  
2759 * @endcode
2760 *
2761 * Increment the time step (=load step)
2762 *
2763 * @code
2764 *   time.increment_time();
2765 *   }
2766 *  
2767 * @endcode
2768 *
2769 * Print the footers and close files
2770 *
2771 * @code
2772 *   if (this_mpi_process == 0)
2773 *   {
2774 *   print_plot_file_footer(pointfile);
2775 *   pointfile.close ();
2776 *   print_console_file_footer(outfile);
2777 *  
2778 * @endcode
2779 *
2780 * NOTE: ideally, we should close the outfile here [ >> outfile.close (); ]
2781 * But if we do, then the timer output will not be printed. That is why we leave it open.
2782 *
2783 * @code
2784 *   }
2785 *   }
2786 *  
2787 * @endcode
2788 *
2789 *
2790 * <a name="nonlinear-poro-viscoelasticity.cc-Privateinterface"></a>
2791 * <h4>Private interface</h4>
2792 * We define the structures needed for parallelization with Threading Building Blocks (TBB)
2793 * Tangent matrix and right-hand side force vector assembly structures.
2794 * PerTaskData_ASM stores local contributions
2795 *
2796 * @code
2797 *   template <int dim>
2798 *   struct Solid<dim>::PerTaskData_ASM
2799 *   {
2801 *   Vector<double> cell_rhs;
2802 *   std::vector<types::global_dof_index> local_dof_indices;
2803 *  
2804 *   PerTaskData_ASM(const unsigned int dofs_per_cell)
2805 *   :
2806 *   cell_matrix(dofs_per_cell, dofs_per_cell),
2807 *   cell_rhs(dofs_per_cell),
2808 *   local_dof_indices(dofs_per_cell)
2809 *   {}
2810 *  
2811 *   void reset()
2812 *   {
2813 *   cell_matrix = 0.0;
2814 *   cell_rhs = 0.0;
2815 *   }
2816 *   };
2817 *  
2818 * @endcode
2819 *
2820 * ScratchData_ASM stores larger objects used during the assembly
2821 *
2822 * @code
2823 *   template <int dim>
2824 *   template <typename NumberType>
2825 *   struct Solid<dim>::ScratchData_ASM
2826 *   {
2827 *   const TrilinosWrappers::MPI::BlockVector &solution_total;
2828 *  
2829 * @endcode
2830 *
2831 * Integration helper
2832 *
2833 * @code
2834 *   FEValues<dim> fe_values_ref;
2835 *   FEFaceValues<dim> fe_face_values_ref;
2836 *  
2837 * @endcode
2838 *
2839 * Quadrature point solution
2840 *
2841 * @code
2842 *   std::vector<NumberType> local_dof_values;
2843 *   std::vector<Tensor<2, dim, NumberType> > solution_grads_u_total;
2844 *   std::vector<NumberType> solution_values_p_fluid_total;
2845 *   std::vector<Tensor<1, dim, NumberType> > solution_grads_p_fluid_total;
2846 *   std::vector<Tensor<1, dim, NumberType> > solution_grads_face_p_fluid_total;
2847 *  
2848 * @endcode
2849 *
2850 * shape function values
2851 *
2852 * @code
2853 *   std::vector<std::vector<Tensor<1,dim>>> Nx;
2854 *   std::vector<std::vector<double>> Nx_p_fluid;
2855 * @endcode
2856 *
2857 * shape function gradients
2858 *
2859 * @code
2860 *   std::vector<std::vector<Tensor<2,dim, NumberType>>> grad_Nx;
2861 *   std::vector<std::vector<SymmetricTensor<2,dim, NumberType>>> symm_grad_Nx;
2862 *   std::vector<std::vector<Tensor<1,dim, NumberType>>> grad_Nx_p_fluid;
2863 *  
2864 *   ScratchData_ASM(const FiniteElement<dim> &fe_cell,
2865 *   const QGauss<dim> &qf_cell, const UpdateFlags uf_cell,
2866 *   const QGauss<dim - 1> & qf_face, const UpdateFlags uf_face,
2867 *   const TrilinosWrappers::MPI::BlockVector &solution_total )
2868 *   :
2869 *   solution_total (solution_total),
2870 *   fe_values_ref(fe_cell, qf_cell, uf_cell),
2871 *   fe_face_values_ref(fe_cell, qf_face, uf_face),
2872 *   local_dof_values(fe_cell.dofs_per_cell),
2873 *   solution_grads_u_total(qf_cell.size()),
2874 *   solution_values_p_fluid_total(qf_cell.size()),
2875 *   solution_grads_p_fluid_total(qf_cell.size()),
2876 *   solution_grads_face_p_fluid_total(qf_face.size()),
2877 *   Nx(qf_cell.size(), std::vector<Tensor<1,dim>>(fe_cell.dofs_per_cell)),
2878 *   Nx_p_fluid(qf_cell.size(), std::vector<double>(fe_cell.dofs_per_cell)),
2879 *   grad_Nx(qf_cell.size(), std::vector<Tensor<2, dim, NumberType>>(fe_cell.dofs_per_cell)),
2880 *   symm_grad_Nx(qf_cell.size(), std::vector<SymmetricTensor<2, dim, NumberType>> (fe_cell.dofs_per_cell)),
2881 *   grad_Nx_p_fluid(qf_cell.size(), std::vector<Tensor<1, dim, NumberType>>(fe_cell.dofs_per_cell))
2882 *   {}
2883 *  
2884 *   ScratchData_ASM(const ScratchData_ASM &rhs)
2885 *   :
2886 *   solution_total (rhs.solution_total),
2887 *   fe_values_ref(rhs.fe_values_ref.get_fe(),
2888 *   rhs.fe_values_ref.get_quadrature(),
2889 *   rhs.fe_values_ref.get_update_flags()),
2890 *   fe_face_values_ref(rhs.fe_face_values_ref.get_fe(),
2891 *   rhs.fe_face_values_ref.get_quadrature(),
2892 *   rhs.fe_face_values_ref.get_update_flags()),
2893 *   local_dof_values(rhs.local_dof_values),
2894 *   solution_grads_u_total(rhs.solution_grads_u_total),
2895 *   solution_values_p_fluid_total(rhs.solution_values_p_fluid_total),
2896 *   solution_grads_p_fluid_total(rhs.solution_grads_p_fluid_total),
2897 *   solution_grads_face_p_fluid_total(rhs.solution_grads_face_p_fluid_total),
2898 *   Nx(rhs.Nx),
2899 *   Nx_p_fluid(rhs.Nx_p_fluid),
2900 *   grad_Nx(rhs.grad_Nx),
2901 *   symm_grad_Nx(rhs.symm_grad_Nx),
2902 *   grad_Nx_p_fluid(rhs.grad_Nx_p_fluid)
2903 *   {}
2904 *  
2905 *   void reset()
2906 *   {
2907 *   const unsigned int n_q_points = Nx_p_fluid.size();
2908 *   const unsigned int n_dofs_per_cell = Nx_p_fluid[0].size();
2909 *  
2910 *   Assert(local_dof_values.size() == n_dofs_per_cell, ExcInternalError());
2911 *  
2912 *   for (unsigned int k = 0; k < n_dofs_per_cell; ++k)
2913 *   {
2914 *   local_dof_values[k] = 0.0;
2915 *   }
2916 *  
2917 *   Assert(solution_grads_u_total.size() == n_q_points, ExcInternalError());
2918 *   Assert(solution_values_p_fluid_total.size() == n_q_points, ExcInternalError());
2919 *   Assert(solution_grads_p_fluid_total.size() == n_q_points, ExcInternalError());
2920 *  
2921 *   Assert(Nx.size() == n_q_points, ExcInternalError());
2922 *   Assert(grad_Nx.size() == n_q_points, ExcInternalError());
2923 *   Assert(symm_grad_Nx.size() == n_q_points, ExcInternalError());
2924 *  
2925 *   for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
2926 *   {
2927 *   Assert( Nx[q_point].size() == n_dofs_per_cell, ExcInternalError());
2928 *   Assert( grad_Nx[q_point].size() == n_dofs_per_cell, ExcInternalError());
2929 *   Assert( symm_grad_Nx[q_point].size() == n_dofs_per_cell, ExcInternalError());
2930 *  
2931 *   solution_grads_u_total[q_point] = 0.0;
2932 *   solution_values_p_fluid_total[q_point] = 0.0;
2933 *   solution_grads_p_fluid_total[q_point] = 0.0;
2934 *  
2935 *   for (unsigned int k = 0; k < n_dofs_per_cell; ++k)
2936 *   {
2937 *   Nx[q_point][k] = 0.0;
2938 *   Nx_p_fluid[q_point][k] = 0.0;
2939 *   grad_Nx[q_point][k] = 0.0;
2940 *   symm_grad_Nx[q_point][k] = 0.0;
2941 *   grad_Nx_p_fluid[q_point][k] = 0.0;
2942 *   }
2943 *   }
2944 *  
2945 *   const unsigned int n_f_q_points = solution_grads_face_p_fluid_total.size();
2946 *   Assert(solution_grads_face_p_fluid_total.size() == n_f_q_points, ExcInternalError());
2947 *  
2948 *   for (unsigned int f_q_point = 0; f_q_point < n_f_q_points; ++f_q_point)
2949 *   solution_grads_face_p_fluid_total[f_q_point] = 0.0;
2950 *   }
2951 *   };
2952 *  
2953 * @endcode
2954 *
2955 * Define the boundary conditions on the mesh
2956 *
2957 * @code
2958 *   template <int dim>
2959 *   void Solid<dim>::make_constraints(const int &it_nr_IN)
2960 *   {
2961 *   pcout << " CST " << std::flush;
2962 *   outfile << " CST " << std::flush;
2963 *  
2964 *   if (it_nr_IN > 1) return;
2965 *  
2966 *   const bool apply_dirichlet_bc = (it_nr_IN == 0);
2967 *  
2968 *   if (apply_dirichlet_bc)
2969 *   {
2970 *   constraints.clear();
2971 *   make_dirichlet_constraints(constraints);
2972 *   }
2973 *   else
2974 *   {
2975 *   for (unsigned int i=0; i<dof_handler_ref.n_dofs(); ++i)
2976 *   if (constraints.is_inhomogeneously_constrained(i) == true)
2977 *   constraints.set_inhomogeneity(i,0.0);
2978 *   }
2979 *   constraints.close();
2980 *   }
2981 *  
2982 * @endcode
2983 *
2984 * Set-up the FE system
2985 *
2986 * @code
2987 *   template <int dim>
2988 *   void Solid<dim>::system_setup(TrilinosWrappers::MPI::BlockVector &solution_delta_OUT)
2989 *   {
2990 *   timerconsole.enter_subsection("Setup system");
2991 *   timerfile.enter_subsection("Setup system");
2992 *  
2993 * @endcode
2994 *
2995 * Determine number of components per block
2996 *
2997 * @code
2998 *   std::vector<unsigned int> block_component(n_components, u_block);
2999 *   block_component[p_fluid_component] = p_fluid_block;
3000 *  
3001 * @endcode
3002 *
3003 * The DOF handler is initialised and we renumber the grid in an efficient manner.
3004 *
3005 * @code
3006 *   dof_handler_ref.distribute_dofs(fe);
3007 *   DoFRenumbering::Cuthill_McKee(dof_handler_ref);
3008 *   DoFRenumbering::component_wise(dof_handler_ref, block_component);
3009 *  
3010 * @endcode
3011 *
3012 * Count the number of DoFs in each block
3013 *
3014 * @code
3015 *   dofs_per_block = DoFTools::count_dofs_per_fe_block(dof_handler_ref, block_component);
3016 *  
3017 * @endcode
3018 *
3019 * Setup the sparsity pattern and tangent matrix
3020 *
3021 * @code
3022 *   all_locally_owned_dofs = DoFTools::locally_owned_dofs_per_subdomain (dof_handler_ref);
3023 *   std::vector<IndexSet> all_locally_relevant_dofs
3024 *   = DoFTools::locally_relevant_dofs_per_subdomain (dof_handler_ref);
3025 *  
3026 *   locally_owned_dofs.clear();
3027 *   locally_owned_partitioning.clear();
3028 *   Assert(all_locally_owned_dofs.size() > this_mpi_process, ExcInternalError());
3029 *   locally_owned_dofs = all_locally_owned_dofs[this_mpi_process];
3030 *  
3031 *   locally_relevant_dofs.clear();
3032 *   locally_relevant_partitioning.clear();
3033 *   Assert(all_locally_relevant_dofs.size() > this_mpi_process, ExcInternalError());
3034 *   locally_relevant_dofs = all_locally_relevant_dofs[this_mpi_process];
3035 *  
3036 *   locally_owned_partitioning.reserve(n_blocks);
3037 *   locally_relevant_partitioning.reserve(n_blocks);
3038 *  
3039 *   for (unsigned int b=0; b<n_blocks; ++b)
3040 *   {
3041 *   const types::global_dof_index idx_begin
3042 *   = std::accumulate(dofs_per_block.begin(),
3043 *   std::next(dofs_per_block.begin(),b), 0);
3044 *   const types::global_dof_index idx_end
3045 *   = std::accumulate(dofs_per_block.begin(),
3046 *   std::next(dofs_per_block.begin(),b+1), 0);
3047 *   locally_owned_partitioning.push_back(locally_owned_dofs.get_view(idx_begin, idx_end));
3048 *   locally_relevant_partitioning.push_back(locally_relevant_dofs.get_view(idx_begin, idx_end));
3049 *   }
3050 *  
3051 * @endcode
3052 *
3053 * Print information on screen
3054 *
3055 * @code
3056 *   pcout << "\nTriangulation:\n"
3057 *   << " Number of active cells: "
3058 *   << triangulation.n_active_cells()
3059 *   << " (by partition:";
3060 *   for (unsigned int p=0; p<n_mpi_processes; ++p)
3061 *   pcout << (p==0 ? ' ' : '+')
3063 *   pcout << ")"
3064 *   << std::endl;
3065 *   pcout << " Number of degrees of freedom: "
3066 *   << dof_handler_ref.n_dofs()
3067 *   << " (by partition:";
3068 *   for (unsigned int p=0; p<n_mpi_processes; ++p)
3069 *   pcout << (p==0 ? ' ' : '+')
3070 *   << (DoFTools::count_dofs_with_subdomain_association (dof_handler_ref,p));
3071 *   pcout << ")"
3072 *   << std::endl;
3073 *   pcout << " Number of degrees of freedom per block: "
3074 *   << "[n_u, n_p_fluid] = ["
3075 *   << dofs_per_block[u_block]
3076 *   << ", "
3077 *   << dofs_per_block[p_fluid_block]
3078 *   << "]"
3079 *   << std::endl;
3080 *  
3081 * @endcode
3082 *
3083 * Print information to file
3084 *
3085 * @code
3086 *   outfile << "\nTriangulation:\n"
3087 *   << " Number of active cells: "
3088 *   << triangulation.n_active_cells()
3089 *   << " (by partition:";
3090 *   for (unsigned int p=0; p<n_mpi_processes; ++p)
3091 *   outfile << (p==0 ? ' ' : '+')
3093 *   outfile << ")"
3094 *   << std::endl;
3095 *   outfile << " Number of degrees of freedom: "
3096 *   << dof_handler_ref.n_dofs()
3097 *   << " (by partition:";
3098 *   for (unsigned int p=0; p<n_mpi_processes; ++p)
3099 *   outfile << (p==0 ? ' ' : '+')
3100 *   << (DoFTools::count_dofs_with_subdomain_association (dof_handler_ref,p));
3101 *   outfile << ")"
3102 *   << std::endl;
3103 *   outfile << " Number of degrees of freedom per block: "
3104 *   << "[n_u, n_p_fluid] = ["
3105 *   << dofs_per_block[u_block]
3106 *   << ", "
3107 *   << dofs_per_block[p_fluid_block]
3108 *   << "]"
3109 *   << std::endl;
3110 *  
3111 * @endcode
3112 *
3113 * We optimise the sparsity pattern to reflect this structure and prevent
3114 * unnecessary data creation for the right-diagonal block components.
3115 *
3116 * @code
3117 *   Table<2, DoFTools::Coupling> coupling(n_components, n_components);
3118 *   for (unsigned int ii = 0; ii < n_components; ++ii)
3119 *   for (unsigned int jj = 0; jj < n_components; ++jj)
3120 *  
3121 * @endcode
3122 *
3123 * Identify "zero" matrix components of FE-system (The two components do not couple)
3124 *
3125 * @code
3126 *   if (((ii == p_fluid_component) && (jj < p_fluid_component))
3127 *   || ((ii < p_fluid_component) && (jj == p_fluid_component)) )
3128 *   coupling[ii][jj] = DoFTools::none;
3129 *  
3130 * @endcode
3131 *
3132 * The rest of components always couple
3133 *
3134 * @code
3135 *   else
3136 *   coupling[ii][jj] = DoFTools::always;
3137 *  
3138 *   TrilinosWrappers::BlockSparsityPattern bsp (locally_owned_partitioning,
3139 *   mpi_communicator);
3140 *  
3141 *   DoFTools::make_sparsity_pattern (dof_handler_ref, bsp, constraints,
3142 *   false, this_mpi_process);
3143 *   bsp.compress();
3144 *  
3145 * @endcode
3146 *
3147 * Reinitialize the (sparse) tangent matrix with the given sparsity pattern.
3148 *
3149 * @code
3150 *   tangent_matrix.reinit (bsp);
3151 *  
3152 * @endcode
3153 *
3154 * Initialize the right hand side and solution vectors with number of DoFs
3155 *
3156 * @code
3157 *   system_rhs.reinit(locally_owned_partitioning, mpi_communicator);
3158 *   solution_n.reinit(locally_owned_partitioning, mpi_communicator);
3159 *   solution_delta_OUT.reinit(locally_owned_partitioning, mpi_communicator);
3160 *  
3161 * @endcode
3162 *
3163 * Non-block system
3164 *
3165 * @code
3166 *   TrilinosWrappers::SparsityPattern sp (locally_owned_dofs,
3167 *   mpi_communicator);
3168 *   DoFTools::make_sparsity_pattern (dof_handler_ref, sp, constraints,
3169 *   false, this_mpi_process);
3170 *   sp.compress();
3171 *   tangent_matrix_nb.reinit (sp);
3172 *   system_rhs_nb.reinit(locally_owned_dofs, mpi_communicator);
3173 *  
3174 * @endcode
3175 *
3176 * Set up the quadrature point history
3177 *
3178 * @code
3179 *   setup_qph();
3180 *  
3181 *   timerconsole.leave_subsection();
3182 *   timerfile.leave_subsection();
3183 *   }
3184 *  
3185 * @endcode
3186 *
3187 * Component extractors: used to extract sub-blocks from the global matrix
3188 * Description of which local element DOFs are attached to which block component
3189 *
3190 * @code
3191 *   template <int dim>
3192 *   void Solid<dim>::determine_component_extractors()
3193 *   {
3194 *   element_indices_u.clear();
3195 *   element_indices_p_fluid.clear();
3196 *  
3197 *   for (unsigned int k = 0; k < fe.dofs_per_cell; ++k)
3198 *   {
3199 *   const unsigned int k_group = fe.system_to_base_index(k).first.first;
3200 *   if (k_group == u_block)
3201 *   element_indices_u.push_back(k);
3202 *   else if (k_group == p_fluid_block)
3203 *   element_indices_p_fluid.push_back(k);
3204 *   else
3205 *   {
3206 *   Assert(k_group <= p_fluid_block, ExcInternalError());
3207 *   }
3208 *   }
3209 *   }
3210 *  
3211 * @endcode
3212 *
3213 * Set-up quadrature point history (QPH) data objects
3214 *
3215 * @code
3216 *   template <int dim>
3217 *   void Solid<dim>::setup_qph()
3218 *   {
3219 *   pcout << "\nSetting up quadrature point data..." << std::endl;
3220 *   outfile << "\nSetting up quadrature point data..." << std::endl;
3221 *  
3222 * @endcode
3223 *
3224 * Create QPH data objects.
3225 *
3226 * @code
3227 *   quadrature_point_history.initialize(triangulation.begin_active(),
3228 *   triangulation.end(), n_q_points);
3229 *  
3230 * @endcode
3231 *
3232 * Setup the initial quadrature point data using the info stored in parameters
3233 *
3234 * @code
3237 *   dof_handler_ref.begin_active()),
3239 *   dof_handler_ref.end());
3240 *   for (; cell!=endc; ++cell)
3241 *   {
3242 *   Assert(cell->is_locally_owned(), ExcInternalError());
3243 *   Assert(cell->subdomain_id() == this_mpi_process, ExcInternalError());
3244 *  
3245 *   const std::vector<std::shared_ptr<PointHistory<dim, ADNumberType> > >
3246 *   lqph = quadrature_point_history.get_data(cell);
3247 *   Assert(lqph.size() == n_q_points, ExcInternalError());
3248 *  
3249 *   for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
3250 *   lqph[q_point]->setup_lqp(parameters, time);
3251 *   }
3252 *   }
3253 *  
3254 * @endcode
3255 *
3256 * Solve the non-linear system using a Newton-Raphson scheme
3257 *
3258 * @code
3259 *   template <int dim>
3260 *   void Solid<dim>::solve_nonlinear_timestep(TrilinosWrappers::MPI::BlockVector &solution_delta_OUT)
3261 *   {
3262 * @endcode
3263 *
3264 * Print the load step
3265 *
3266 * @code
3267 *   pcout << std::endl
3268 *   << "\nTimestep "
3269 *   << time.get_timestep()
3270 *   << " @ "
3271 *   << time.get_current()
3272 *   << "s"
3273 *   << std::endl;
3274 *   outfile << std::endl
3275 *   << "\nTimestep "
3276 *   << time.get_timestep()
3277 *   << " @ "
3278 *   << time.get_current()
3279 *   << "s"
3280 *   << std::endl;
3281 *  
3282 * @endcode
3283 *
3284 * Declare newton_update vector (solution of a Newton iteration),
3285 * which must have as many positions as global DoFs.
3286 *
3287 * @code
3288 *   TrilinosWrappers::MPI::BlockVector newton_update
3289 *   (locally_owned_partitioning, mpi_communicator);
3290 *  
3291 * @endcode
3292 *
3293 * Reset the error storage objects
3294 *
3295 * @code
3296 *   error_residual.reset();
3297 *   error_residual_0.reset();
3298 *   error_residual_norm.reset();
3299 *   error_update.reset();
3300 *   error_update_0.reset();
3301 *   error_update_norm.reset();
3302 *  
3303 *   print_conv_header();
3304 *  
3305 * @endcode
3306 *
3307 * Declare and initialize iterator for the Newton-Raphson algorithm steps
3308 *
3309 * @code
3310 *   unsigned int newton_iteration = 0;
3311 *  
3312 * @endcode
3313 *
3314 * Iterate until error is below tolerance or max number iterations are reached
3315 *
3316 * @code
3317 *   while(newton_iteration < parameters.max_iterations_NR)
3318 *   {
3319 *   pcout << " " << std::setw(2) << newton_iteration << " " << std::flush;
3320 *   outfile << " " << std::setw(2) << newton_iteration << " " << std::flush;
3321 *  
3322 * @endcode
3323 *
3324 * Initialize global stiffness matrix and global force vector to zero
3325 *
3326 * @code
3327 *   tangent_matrix = 0.0;
3328 *   system_rhs = 0.0;
3329 *  
3330 *   tangent_matrix_nb = 0.0;
3331 *   system_rhs_nb = 0.0;
3332 *  
3333 * @endcode
3334 *
3335 * Apply boundary conditions
3336 *
3337 * @code
3338 *   make_constraints(newton_iteration);
3339 *   assemble_system(solution_delta_OUT);
3340 *  
3341 * @endcode
3342 *
3343 * Compute the rhs residual (error between external and internal forces in FE system)
3344 *
3345 * @code
3346 *   get_error_residual(error_residual);
3347 *  
3348 * @endcode
3349 *
3350 * error_residual in first iteration is stored to normalize posterior error measures
3351 *
3352 * @code
3353 *   if (newton_iteration == 0)
3354 *   error_residual_0 = error_residual;
3355 *  
3356 * @endcode
3357 *
3358 * Determine the normalised residual error
3359 *
3360 * @code
3361 *   error_residual_norm = error_residual;
3362 *   error_residual_norm.normalise(error_residual_0);
3363 *  
3364 * @endcode
3365 *
3366 * If both errors are below the tolerances, exit the loop.
3367 * We need to check the residual vector directly for convergence
3368 * in the load steps where no external forces or displacements are imposed.
3369 *
3370 * @code
3371 *   if ( ((newton_iteration > 0)
3372 *   && (error_update_norm.u <= parameters.tol_u)
3373 *   && (error_update_norm.p_fluid <= parameters.tol_p_fluid)
3374 *   && (error_residual_norm.u <= parameters.tol_f)
3375 *   && (error_residual_norm.p_fluid <= parameters.tol_f))
3376 *   || ( (newton_iteration > 0)
3377 *   && system_rhs.l2_norm() <= parameters.tol_f) )
3378 *   {
3379 *   pcout << "\n ***** CONVERGED! ***** "
3380 *   << system_rhs.l2_norm() << " "
3381 *   << " " << error_residual_norm.norm
3382 *   << " " << error_residual_norm.u
3383 *   << " " << error_residual_norm.p_fluid
3384 *   << " " << error_update_norm.norm
3385 *   << " " << error_update_norm.u
3386 *   << " " << error_update_norm.p_fluid
3387 *   << " " << std::endl;
3388 *   outfile << "\n ***** CONVERGED! ***** "
3389 *   << system_rhs.l2_norm() << " "
3390 *   << " " << error_residual_norm.norm
3391 *   << " " << error_residual_norm.u
3392 *   << " " << error_residual_norm.p_fluid
3393 *   << " " << error_update_norm.norm
3394 *   << " " << error_update_norm.u
3395 *   << " " << error_update_norm.p_fluid
3396 *   << " " << std::endl;
3397 *   print_conv_footer();
3398 *  
3399 *   break;
3400 *   }
3401 *  
3402 * @endcode
3403 *
3404 * Solve the linearized system
3405 *
3406 * @code
3407 *   solve_linear_system(newton_update);
3408 *   constraints.distribute(newton_update);
3409 *  
3410 * @endcode
3411 *
3412 * Compute the displacement error
3413 *
3414 * @code
3415 *   get_error_update(newton_update, error_update);
3416 *  
3417 * @endcode
3418 *
3419 * error_update in first iteration is stored to normalize posterior error measures
3420 *
3421 * @code
3422 *   if (newton_iteration == 0)
3423 *   error_update_0 = error_update;
3424 *  
3425 * @endcode
3426 *
3427 * Determine the normalised Newton update error
3428 *
3429 * @code
3430 *   error_update_norm = error_update;
3431 *   error_update_norm.normalise(error_update_0);
3432 *  
3433 * @endcode
3434 *
3435 * Determine the normalised residual error
3436 *
3437 * @code
3438 *   error_residual_norm = error_residual;
3439 *   error_residual_norm.normalise(error_residual_0);
3440 *  
3441 * @endcode
3442 *
3443 * Print error values
3444 *
3445 * @code
3446 *   pcout << " | " << std::fixed << std::setprecision(3)
3447 *   << std::setw(7) << std::scientific
3448 *   << system_rhs.l2_norm()
3449 *   << " " << error_residual_norm.norm
3450 *   << " " << error_residual_norm.u
3451 *   << " " << error_residual_norm.p_fluid
3452 *   << " " << error_update_norm.norm
3453 *   << " " << error_update_norm.u
3454 *   << " " << error_update_norm.p_fluid
3455 *   << " " << std::endl;
3456 *  
3457 *   outfile << " | " << std::fixed << std::setprecision(3)
3458 *   << std::setw(7) << std::scientific
3459 *   << system_rhs.l2_norm()
3460 *   << " " << error_residual_norm.norm
3461 *   << " " << error_residual_norm.u
3462 *   << " " << error_residual_norm.p_fluid
3463 *   << " " << error_update_norm.norm
3464 *   << " " << error_update_norm.u
3465 *   << " " << error_update_norm.p_fluid
3466 *   << " " << std::endl;
3467 *  
3468 * @endcode
3469 *
3470 * Update
3471 *
3472 * @code
3473 *   solution_delta_OUT += newton_update;
3474 *   newton_update = 0.0;
3475 *   newton_iteration++;
3476 *   }
3477 *  
3478 * @endcode
3479 *
3480 * If maximum allowed number of iterations for Newton algorithm are reached, print non-convergence message and abort program
3481 *
3482 * @code
3483 *   AssertThrow (newton_iteration < parameters.max_iterations_NR, ExcMessage("No convergence in nonlinear solver!"));
3484 *   }
3485 *  
3486 * @endcode
3487 *
3488 * Prints the header for convergence info on console
3489 *
3490 * @code
3491 *   template <int dim>
3492 *   void Solid<dim>::print_conv_header()
3493 *   {
3494 *   static const unsigned int l_width = 120;
3495 *  
3496 *   for (unsigned int i = 0; i < l_width; ++i)
3497 *   {
3498 *   pcout << "_";
3499 *   outfile << "_";
3500 *   }
3501 *  
3502 *   pcout << std::endl;
3503 *   outfile << std::endl;
3504 *  
3505 *   pcout << "\n SOLVER STEP | SYS_RES "
3506 *   << "RES_NORM RES_U RES_P "
3507 *   << "NU_NORM NU_U NU_P " << std::endl;
3508 *   outfile << "\n SOLVER STEP | SYS_RES "
3509 *   << "RES_NORM RES_U RES_P "
3510 *   << "NU_NORM NU_U NU_P " << std::endl;
3511 *  
3512 *   for (unsigned int i = 0; i < l_width; ++i)
3513 *   {
3514 *   pcout << "_";
3515 *   outfile << "_";
3516 *   }
3517 *   pcout << std::endl << std::endl;
3518 *   outfile << std::endl << std::endl;
3519 *   }
3520 *  
3521 * @endcode
3522 *
3523 * Prints the footer for convergence info on console
3524 *
3525 * @code
3526 *   template <int dim>
3527 *   void Solid<dim>::print_conv_footer()
3528 *   {
3529 *   static const unsigned int l_width = 120;
3530 *  
3531 *   for (unsigned int i = 0; i < l_width; ++i)
3532 *   {
3533 *   pcout << "_";
3534 *   outfile << "_";
3535 *   }
3536 *   pcout << std::endl << std::endl;
3537 *   outfile << std::endl << std::endl;
3538 *  
3539 *   pcout << "Relative errors:" << std::endl
3540 *   << "Displacement: "
3541 *   << error_update.u / error_update_0.u << std::endl
3542 *   << "Force (displ): "
3543 *   << error_residual.u / error_residual_0.u << std::endl
3544 *   << "Pore pressure: "
3545 *   << error_update.p_fluid / error_update_0.p_fluid << std::endl
3546 *   << "Force (pore): "
3547 *   << error_residual.p_fluid / error_residual_0.p_fluid << std::endl;
3548 *   outfile << "Relative errors:" << std::endl
3549 *   << "Displacement: "
3550 *   << error_update.u / error_update_0.u << std::endl
3551 *   << "Force (displ): "
3552 *   << error_residual.u / error_residual_0.u << std::endl
3553 *   << "Pore pressure: "
3554 *   << error_update.p_fluid / error_update_0.p_fluid << std::endl
3555 *   << "Force (pore): "
3556 *   << error_residual.p_fluid / error_residual_0.p_fluid << std::endl;
3557 *   }
3558 *  
3559 * @endcode
3560 *
3561 * Determine the true residual error for the problem
3562 *
3563 * @code
3564 *   template <int dim>
3565 *   void Solid<dim>::get_error_residual(Errors &error_residual_OUT)
3566 *   {
3567 *   TrilinosWrappers::MPI::BlockVector error_res(system_rhs);
3568 *   constraints.set_zero(error_res);
3569 *  
3570 *   error_residual_OUT.norm = error_res.l2_norm();
3571 *   error_residual_OUT.u = error_res.block(u_block).l2_norm();
3572 *   error_residual_OUT.p_fluid = error_res.block(p_fluid_block).l2_norm();
3573 *   }
3574 *  
3575 * @endcode
3576 *
3577 * Determine the true Newton update error for the problem
3578 *
3579 * @code
3580 *   template <int dim>
3581 *   void Solid<dim>::get_error_update
3582 *   (const TrilinosWrappers::MPI::BlockVector &newton_update_IN,
3583 *   Errors &error_update_OUT)
3584 *   {
3585 *   TrilinosWrappers::MPI::BlockVector error_ud(newton_update_IN);
3586 *   constraints.set_zero(error_ud);
3587 *  
3588 *   error_update_OUT.norm = error_ud.l2_norm();
3589 *   error_update_OUT.u = error_ud.block(u_block).l2_norm();
3590 *   error_update_OUT.p_fluid = error_ud.block(p_fluid_block).l2_norm();
3591 *   }
3592 *  
3593 * @endcode
3594 *
3595 * Compute the total solution, which is valid at any Newton step. This is required as, to reduce
3596 * computational error, the total solution is only updated at the end of the timestep.
3597 *
3598 * @code
3599 *   template <int dim>
3601 *   Solid<dim>::get_total_solution(const TrilinosWrappers::MPI::BlockVector &solution_delta_IN) const
3602 *   {
3603 * @endcode
3604 *
3605 * Cell interpolation -> Ghosted vector
3606 *
3607 * @code
3609 *   solution_total (locally_owned_partitioning,
3610 *   locally_relevant_partitioning,
3611 *   mpi_communicator,
3612 *   /*vector_writable = */ false);
3613 *   TrilinosWrappers::MPI::BlockVector tmp (solution_total);
3614 *   solution_total = solution_n;
3615 *   tmp = solution_delta_IN;
3616 *   solution_total += tmp;
3617 *   return solution_total;
3618 *   }
3619 *  
3620 * @endcode
3621 *
3622 * Compute elemental stiffness tensor and right-hand side force vector, and assemble into global ones
3623 *
3624 * @code
3625 *   template <int dim>
3626 *   void Solid<dim>::assemble_system( const TrilinosWrappers::MPI::BlockVector &solution_delta )
3627 *   {
3628 *   timerconsole.enter_subsection("Assemble system");
3629 *   timerfile.enter_subsection("Assemble system");
3630 *   pcout << " ASM_SYS " << std::flush;
3631 *   outfile << " ASM_SYS " << std::flush;
3632 *  
3633 *   const TrilinosWrappers::MPI::BlockVector solution_total(get_total_solution(solution_delta));
3634 *  
3635 * @endcode
3636 *
3637 * Info given to FEValues and FEFaceValues constructors, to indicate which data will be needed at each element.
3638 *
3639 * @code
3640 *   const UpdateFlags uf_cell(update_values |
3641 *   update_gradients |
3642 *   update_JxW_values);
3643 *   const UpdateFlags uf_face(update_values |
3644 *   update_gradients |
3647 *   update_JxW_values );
3648 *  
3649 * @endcode
3650 *
3651 * Setup a copy of the data structures required for the process and pass them, along with the
3652 * memory addresses of the assembly functions to the WorkStream object for processing
3653 *
3654 * @code
3655 *   PerTaskData_ASM per_task_data(dofs_per_cell);
3656 *   ScratchData_ASM<ADNumberType> scratch_data(fe, qf_cell, uf_cell,
3657 *   qf_face, uf_face,
3658 *   solution_total);
3659 *  
3662 *   dof_handler_ref.begin_active()),
3664 *   dof_handler_ref.end());
3665 *   for (; cell != endc; ++cell)
3666 *   {
3667 *   Assert(cell->is_locally_owned(), ExcInternalError());
3668 *   Assert(cell->subdomain_id() == this_mpi_process, ExcInternalError());
3669 *  
3670 *   assemble_system_one_cell(cell, scratch_data, per_task_data);
3671 *   copy_local_to_global_system(per_task_data);
3672 *   }
3673 *   tangent_matrix.compress(VectorOperation::add);
3674 *   system_rhs.compress(VectorOperation::add);
3675 *  
3676 *   tangent_matrix_nb.compress(VectorOperation::add);
3677 *   system_rhs_nb.compress(VectorOperation::add);
3678 *  
3679 *   timerconsole.leave_subsection();
3680 *   timerfile.leave_subsection();
3681 *   }
3682 *  
3683 * @endcode
3684 *
3685 * Add the local elemental contribution to the global stiffness tensor
3686 * We do it twice, for the block and the non-block systems
3687 *
3688 * @code
3689 *   template <int dim>
3690 *   void Solid<dim>::copy_local_to_global_system (const PerTaskData_ASM &data)
3691 *   {
3692 *   constraints.distribute_local_to_global(data.cell_matrix,
3693 *   data.cell_rhs,
3694 *   data.local_dof_indices,
3695 *   tangent_matrix,
3696 *   system_rhs);
3697 *  
3698 *   constraints.distribute_local_to_global(data.cell_matrix,
3699 *   data.cell_rhs,
3700 *   data.local_dof_indices,
3701 *   tangent_matrix_nb,
3702 *   system_rhs_nb);
3703 *   }
3704 *  
3705 * @endcode
3706 *
3707 * Compute stiffness matrix and corresponding rhs for one element
3708 *
3709 * @code
3710 *   template <int dim>
3711 *   void Solid<dim>::assemble_system_one_cell
3712 *   (const typename DoFHandler<dim>::active_cell_iterator &cell,
3713 *   ScratchData_ASM<ADNumberType> &scratch,
3714 *   PerTaskData_ASM &data) const
3715 *   {
3716 *   Assert(cell->is_locally_owned(), ExcInternalError());
3717 *  
3718 *   data.reset();
3719 *   scratch.reset();
3720 *   scratch.fe_values_ref.reinit(cell);
3721 *   cell->get_dof_indices(data.local_dof_indices);
3722 *  
3723 * @endcode
3724 *
3725 * Setup automatic differentiation
3726 *
3727 * @code
3728 *   for (unsigned int k = 0; k < dofs_per_cell; ++k)
3729 *   {
3730 * @endcode
3731 *
3732 * Initialise the dofs for the cell using the current solution.
3733 *
3734 * @code
3735 *   scratch.local_dof_values[k] = scratch.solution_total[data.local_dof_indices[k]];
3736 * @endcode
3737 *
3738 * Mark this cell DoF as an independent variable
3739 *
3740 * @code
3741 *   scratch.local_dof_values[k].diff(k, dofs_per_cell);
3742 *   }
3743 *  
3744 * @endcode
3745 *
3746 * Update the quadrature point solution
3747 * Compute the values and gradients of the solution in terms of the AD variables
3748 *
3749 * @code
3750 *   for (unsigned int q = 0; q < n_q_points; ++q)
3751 *   {
3752 *   for (unsigned int k = 0; k < dofs_per_cell; ++k)
3753 *   {
3754 *   const unsigned int k_group = fe.system_to_base_index(k).first.first;
3755 *   if (k_group == u_block)
3756 *   {
3757 *   const Tensor<2, dim> Grad_Nx_u =
3758 *   scratch.fe_values_ref[u_fe].gradient(k, q);
3759 *   for (unsigned int dd = 0; dd < dim; ++dd)
3760 *   {
3761 *   for (unsigned int ee = 0; ee < dim; ++ee)
3762 *   {
3763 *   scratch.solution_grads_u_total[q][dd][ee]
3764 *   += scratch.local_dof_values[k] * Grad_Nx_u[dd][ee];
3765 *   }
3766 *   }
3767 *   }
3768 *   else if (k_group == p_fluid_block)
3769 *   {
3770 *   const double Nx_p = scratch.fe_values_ref[p_fluid_fe].value(k, q);
3771 *   const Tensor<1, dim> Grad_Nx_p =
3772 *   scratch.fe_values_ref[p_fluid_fe].gradient(k, q);
3773 *  
3774 *   scratch.solution_values_p_fluid_total[q]
3775 *   += scratch.local_dof_values[k] * Nx_p;
3776 *   for (unsigned int dd = 0; dd < dim; ++dd)
3777 *   {
3778 *   scratch.solution_grads_p_fluid_total[q][dd]
3779 *   += scratch.local_dof_values[k] * Grad_Nx_p[dd];
3780 *   }
3781 *   }
3782 *   else
3783 *   Assert(k_group <= p_fluid_block, ExcInternalError());
3784 *   }
3785 *   }
3786 *  
3787 * @endcode
3788 *
3789 * Set up pointer "lgph" to the PointHistory object of this element
3790 *
3791 * @code
3792 *   const std::vector<std::shared_ptr<const PointHistory<dim, ADNumberType> > >
3793 *   lqph = quadrature_point_history.get_data(cell);
3794 *   Assert(lqph.size() == n_q_points, ExcInternalError());
3795 *  
3796 *  
3797 * @endcode
3798 *
3799 * Precalculate the element shape function values and gradients
3800 *
3801 * @code
3802 *   for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
3803 *   {
3804 *   Tensor<2, dim, ADNumberType> F_AD = scratch.solution_grads_u_total[q_point];
3806 *   Assert(determinant(F_AD) > 0, ExcMessage("Invalid deformation map"));
3807 *   const Tensor<2, dim, ADNumberType> F_inv_AD = invert(F_AD);
3808 *  
3809 *   for (unsigned int i = 0; i < dofs_per_cell; ++i)
3810 *   {
3811 *   const unsigned int i_group = fe.system_to_base_index(i).first.first;
3812 *  
3813 *   if (i_group == u_block)
3814 *   {
3815 *   scratch.Nx[q_point][i] =
3816 *   scratch.fe_values_ref[u_fe].value(i, q_point);
3817 *   scratch.grad_Nx[q_point][i] =
3818 *   scratch.fe_values_ref[u_fe].gradient(i, q_point)*F_inv_AD;
3819 *   scratch.symm_grad_Nx[q_point][i] =
3820 *   symmetrize(scratch.grad_Nx[q_point][i]);
3821 *   }
3822 *   else if (i_group == p_fluid_block)
3823 *   {
3824 *   scratch.Nx_p_fluid[q_point][i] =
3825 *   scratch.fe_values_ref[p_fluid_fe].value(i, q_point);
3826 *   scratch.grad_Nx_p_fluid[q_point][i] =
3827 *   scratch.fe_values_ref[p_fluid_fe].gradient(i, q_point)*F_inv_AD;
3828 *   }
3829 *   else
3830 *   Assert(i_group <= p_fluid_block, ExcInternalError());
3831 *   }
3832 *   }
3833 *  
3834 * @endcode
3835 *
3836 * Assemble the stiffness matrix and rhs vector
3837 *
3838 * @code
3839 *   std::vector<ADNumberType> residual_ad (dofs_per_cell, ADNumberType(0.0));
3840 *   for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
3841 *   {
3842 *   Tensor<2, dim, ADNumberType> F_AD = scratch.solution_grads_u_total[q_point];
3844 *   const ADNumberType det_F_AD = determinant(F_AD);
3845 *  
3846 *   Assert(det_F_AD > 0, ExcInternalError());
3847 *   const Tensor<2, dim, ADNumberType> F_inv_AD = invert(F_AD); //inverse of def. gradient tensor
3848 *  
3849 *   const ADNumberType p_fluid = scratch.solution_values_p_fluid_total[q_point];
3850 *  
3851 *   {
3852 *   PointHistory<dim, ADNumberType> *lqph_q_point_nc =
3853 *   const_cast<PointHistory<dim, ADNumberType>*>(lqph[q_point].get());
3854 *   lqph_q_point_nc->update_internal_equilibrium(F_AD);
3855 *   }
3856 *  
3857 * @endcode
3858 *
3859 * Get some info from constitutive model of solid
3860 *
3861 * @code
3862 *   static const SymmetricTensor< 2, dim, double>
3865 *   tau_E = lqph[q_point]->get_tau_E(F_AD);
3866 *   SymmetricTensor<2, dim, ADNumberType> tau_fluid_vol (I);
3867 *   tau_fluid_vol *= -1.0 * p_fluid * det_F_AD;
3868 *  
3869 * @endcode
3870 *
3871 * Get some info from constitutive model of fluid
3872 *
3873 * @code
3874 *   const ADNumberType det_F_aux = lqph[q_point]->get_converged_det_F();
3875 *   const double det_F_converged = Tensor<0,dim,double>(det_F_aux); //Needs to be double, not AD number
3876 *   const Tensor<1, dim, ADNumberType> overall_body_force
3877 *   = lqph[q_point]->get_overall_body_force(F_AD, parameters);
3878 *  
3879 * @endcode
3880 *
3881 * Define some aliases to make the assembly process easier to follow
3882 *
3883 * @code
3884 *   const std::vector<Tensor<1,dim>> &Nu = scratch.Nx[q_point];
3885 *   const std::vector<SymmetricTensor<2, dim, ADNumberType>>
3886 *   &symm_grad_Nu = scratch.symm_grad_Nx[q_point];
3887 *   const std::vector<double> &Np = scratch.Nx_p_fluid[q_point];
3888 *   const std::vector<Tensor<1, dim, ADNumberType> > &grad_Np
3889 *   = scratch.grad_Nx_p_fluid[q_point];
3890 *   const Tensor<1, dim, ADNumberType> grad_p
3891 *   = scratch.solution_grads_p_fluid_total[q_point]*F_inv_AD;
3892 *   const double JxW = scratch.fe_values_ref.JxW(q_point);
3893 *  
3894 *   for (unsigned int i = 0; i < dofs_per_cell; ++i)
3895 *   {
3896 *   const unsigned int i_group = fe.system_to_base_index(i).first.first;
3897 *  
3898 *   if (i_group == u_block)
3899 *   {
3900 *   residual_ad[i] += symm_grad_Nu[i] * ( tau_E + tau_fluid_vol ) * JxW;
3901 *   residual_ad[i] -= Nu[i] * overall_body_force * JxW;
3902 *   }
3903 *   else if (i_group == p_fluid_block)
3904 *   {
3905 *   const Tensor<1, dim, ADNumberType> seepage_vel_current
3906 *   = lqph[q_point]->get_seepage_velocity_current(F_AD, grad_p);
3907 *   residual_ad[i] += Np[i] * (det_F_AD - det_F_converged) * JxW;
3908 *   residual_ad[i] -= time.get_delta_t() * grad_Np[i]
3909 *   * seepage_vel_current * JxW;
3910 *   }
3911 *   else
3912 *   Assert(i_group <= p_fluid_block, ExcInternalError());
3913 *   }
3914 *   }
3915 *  
3916 * @endcode
3917 *
3918 * Assemble the Neumann contribution (external force contribution).
3919 *
3920 * @code
3921 *   for (unsigned int face = 0; face < GeometryInfo<dim>::faces_per_cell; ++face) //Loop over faces in element
3922 *   {
3923 *   if (cell->face(face)->at_boundary() == true)
3924 *   {
3925 *   scratch.fe_face_values_ref.reinit(cell, face);
3926 *  
3927 *   for (unsigned int f_q_point = 0; f_q_point < n_q_points_f; ++f_q_point)
3928 *   {
3929 *   const Tensor<1, dim> &N
3930 *   = scratch.fe_face_values_ref.normal_vector(f_q_point);
3931 *   const Point<dim> &pt
3932 *   = scratch.fe_face_values_ref.quadrature_point(f_q_point);
3933 *   const Tensor<1, dim> traction
3934 *   = get_neumann_traction(cell->face(face)->boundary_id(), pt, N);
3935 *   const double flow
3936 *   = get_prescribed_fluid_flow(cell->face(face)->boundary_id(), pt);
3937 *  
3938 *   if ( (traction.norm() < 1e-12) && (std::abs(flow) < 1e-12) ) continue;
3939 *  
3940 *   const double JxW_f = scratch.fe_face_values_ref.JxW(f_q_point);
3941 *  
3942 *   for (unsigned int i = 0; i < dofs_per_cell; ++i)
3943 *   {
3944 *   const unsigned int i_group = fe.system_to_base_index(i).first.first;
3945 *  
3946 *   if ((i_group == u_block) && (traction.norm() > 1e-12))
3947 *   {
3948 *   const unsigned int component_i
3949 *   = fe.system_to_component_index(i).first;
3950 *   const double Nu_f
3951 *   = scratch.fe_face_values_ref.shape_value(i, f_q_point);
3952 *   residual_ad[i] -= (Nu_f * traction[component_i]) * JxW_f;
3953 *   }
3954 *   if ((i_group == p_fluid_block) && (std::abs(flow) > 1e-12))
3955 *   {
3956 *   const double Nu_p
3957 *   = scratch.fe_face_values_ref.shape_value(i, f_q_point);
3958 *   residual_ad[i] -= (Nu_p * flow) * JxW_f;
3959 *   }
3960 *   }
3961 *   }
3962 *   }
3963 *   }
3964 *  
3965 * @endcode
3966 *
3967 * Linearise the residual
3968 *
3969 * @code
3970 *   for (unsigned int i = 0; i < dofs_per_cell; ++i)
3971 *   {
3972 *   const ADNumberType &R_i = residual_ad[i];
3973 *  
3974 *   data.cell_rhs(i) -= R_i.val();
3975 *   for (unsigned int j=0; j<dofs_per_cell; ++j)
3976 *   data.cell_matrix(i,j) += R_i.fastAccessDx(j);
3977 *   }
3978 *   }
3979 *  
3980 * @endcode
3981 *
3982 * Store the converged values of the internal variables
3983 *
3984 * @code
3985 *   template <int dim>
3986 *   void Solid<dim>::update_end_timestep()
3987 *   {
3990 *   dof_handler_ref.begin_active()),
3992 *   dof_handler_ref.end());
3993 *   for (; cell!=endc; ++cell)
3994 *   {
3995 *   Assert(cell->is_locally_owned(), ExcInternalError());
3996 *   Assert(cell->subdomain_id() == this_mpi_process, ExcInternalError());
3997 *  
3998 *   const std::vector<std::shared_ptr<PointHistory<dim, ADNumberType> > >
3999 *   lqph = quadrature_point_history.get_data(cell);
4000 *   Assert(lqph.size() == n_q_points, ExcInternalError());
4001 *   for (unsigned int q_point = 0; q_point < n_q_points; ++q_point)
4002 *   lqph[q_point]->update_end_timestep();
4003 *   }
4004 *   }
4005 *  
4006 *  
4007 * @endcode
4008 *
4009 * Solve the linearized equations
4010 *
4011 * @code
4012 *   template <int dim>
4013 *   void Solid<dim>::solve_linear_system( TrilinosWrappers::MPI::BlockVector &newton_update_OUT)
4014 *   {
4015 *  
4016 *   timerconsole.enter_subsection("Linear solver");
4017 *   timerfile.enter_subsection("Linear solver");
4018 *   pcout << " SLV " << std::flush;
4019 *   outfile << " SLV " << std::flush;
4020 *  
4021 *   TrilinosWrappers::MPI::Vector newton_update_nb;
4022 *   newton_update_nb.reinit(locally_owned_dofs, mpi_communicator);
4023 *  
4024 *   SolverControl solver_control (tangent_matrix_nb.m(),
4025 *   1.0e-6 * system_rhs_nb.l2_norm());
4026 *   TrilinosWrappers::SolverDirect solver (solver_control);
4027 *   solver.solve(tangent_matrix_nb, newton_update_nb, system_rhs_nb);
4028 *  
4029 * @endcode
4030 *
4031 * Copy the non-block solution back to block system
4032 *
4033 * @code
4034 *   for (unsigned int i=0; i<locally_owned_dofs.n_elements(); ++i)
4035 *   {
4036 *   const types::global_dof_index idx_i
4037 *   = locally_owned_dofs.nth_index_in_set(i);
4038 *   newton_update_OUT(idx_i) = newton_update_nb(idx_i);
4039 *   }
4040 *   newton_update_OUT.compress(VectorOperation::insert);
4041 *  
4042 *   timerconsole.leave_subsection();
4043 *   timerfile.leave_subsection();
4044 *   }
4045 *  
4046 * @endcode
4047 *
4048 * Class to compute gradient of the pressure
4049 *
4050 * @code
4051 *   template <int dim>
4052 *   class GradientPostprocessor : public DataPostprocessorVector<dim>
4053 *   {
4054 *   public:
4055 *   GradientPostprocessor (const unsigned int p_fluid_component)
4056 *   :
4057 *   DataPostprocessorVector<dim> ("grad_p",
4058 *   update_gradients),
4059 *   p_fluid_component (p_fluid_component)
4060 *   {}
4061 *  
4062 *   virtual ~GradientPostprocessor(){}
4063 *  
4064 *   virtual void
4065 *   evaluate_vector_field
4066 *   (const DataPostprocessorInputs::Vector<dim> &input_data,
4067 *   std::vector<Vector<double> > &computed_quantities) const override
4068 *   {
4069 *   AssertDimension (input_data.solution_gradients.size(),
4070 *   computed_quantities.size());
4071 *   for (unsigned int p=0; p<input_data.solution_gradients.size(); ++p)
4072 *   {
4073 *   AssertDimension (computed_quantities[p].size(), dim);
4074 *   for (unsigned int d=0; d<dim; ++d)
4075 *   computed_quantities[p][d]
4076 *   = input_data.solution_gradients[p][p_fluid_component][d];
4077 *   }
4078 *   }
4079 *  
4080 *   private:
4081 *   const unsigned int p_fluid_component;
4082 *   };
4083 *  
4084 *  
4085 * @endcode
4086 *
4087 * Print results to vtu file
4088 *
4089 * @code
4090 *   template <int dim> void Solid<dim>::output_results_to_vtu
4091 *   (const unsigned int timestep,
4092 *   const double current_time,
4093 *   TrilinosWrappers::MPI::BlockVector solution_IN) const
4094 *   {
4095 *   TrilinosWrappers::MPI::BlockVector solution_total(locally_owned_partitioning,
4096 *   locally_relevant_partitioning,
4097 *   mpi_communicator,
4098 *   false);
4099 *   solution_total = solution_IN;
4101 *   material_id.reinit(triangulation.n_active_cells());
4102 *   std::vector<types::subdomain_id> partition_int(triangulation.n_active_cells());
4103 *   GradientPostprocessor<dim> gradient_postprocessor(p_fluid_component);
4104 *  
4105 * @endcode
4106 *
4107 * Declare local variables with number of stress components
4108 * & assign value according to "dim" value
4109 *
4110 * @code
4111 *   unsigned int num_comp_symm_tensor = 6;
4112 *  
4113 * @endcode
4114 *
4115 * Declare local vectors to store values
4116 * OUTPUT AVERAGED ON ELEMENTS -------------------------------------------
4117 *
4118 * @code
4119 *   std::vector<Vector<double>>cauchy_stresses_total_elements
4120 *   (num_comp_symm_tensor,
4121 *   Vector<double> (triangulation.n_active_cells()));
4122 *   std::vector<Vector<double>>cauchy_stresses_E_elements
4123 *   (num_comp_symm_tensor,
4124 *   Vector<double> (triangulation.n_active_cells()));
4125 *   std::vector<Vector<double>>stretches_elements
4126 *   (dim,
4127 *   Vector<double> (triangulation.n_active_cells()));
4128 *   std::vector<Vector<double>>seepage_velocity_elements
4129 *   (dim,
4130 *   Vector<double> (triangulation.n_active_cells()));
4131 *   Vector<double> porous_dissipation_elements
4132 *   (triangulation.n_active_cells());
4133 *   Vector<double> viscous_dissipation_elements
4134 *   (triangulation.n_active_cells());
4135 *   Vector<double> solid_vol_fraction_elements
4136 *   (triangulation.n_active_cells());
4137 *  
4138 * @endcode
4139 *
4140 * OUTPUT AVERAGED ON NODES ----------------------------------------------
4141 * We need to create a new FE space with a single dof per node to avoid
4142 * duplication of the output on nodes for our problem with dim+1 dofs.
4143 *
4144 * @code
4145 *   FE_Q<dim> fe_vertex(1);
4146 *   DoFHandler<dim> vertex_handler_ref(triangulation);
4147 *   vertex_handler_ref.distribute_dofs(fe_vertex);
4148 *   AssertThrow(vertex_handler_ref.n_dofs() == triangulation.n_vertices(),
4149 *   ExcDimensionMismatch(vertex_handler_ref.n_dofs(),
4150 *   triangulation.n_vertices()));
4151 *  
4152 *   Vector<double> counter_on_vertices_mpi
4153 *   (vertex_handler_ref.n_dofs());
4154 *   Vector<double> sum_counter_on_vertices
4155 *   (vertex_handler_ref.n_dofs());
4156 *  
4157 *   std::vector<Vector<double>>cauchy_stresses_total_vertex_mpi
4158 *   (num_comp_symm_tensor,
4159 *   Vector<double>(vertex_handler_ref.n_dofs()));
4160 *   std::vector<Vector<double>>sum_cauchy_stresses_total_vertex
4161 *   (num_comp_symm_tensor,
4162 *   Vector<double>(vertex_handler_ref.n_dofs()));
4163 *   std::vector<Vector<double>>cauchy_stresses_E_vertex_mpi
4164 *   (num_comp_symm_tensor,
4165 *   Vector<double>(vertex_handler_ref.n_dofs()));
4166 *   std::vector<Vector<double>>sum_cauchy_stresses_E_vertex
4167 *   (num_comp_symm_tensor,
4168 *   Vector<double>(vertex_handler_ref.n_dofs()));
4169 *   std::vector<Vector<double>>stretches_vertex_mpi
4170 *   (dim,
4171 *   Vector<double>(vertex_handler_ref.n_dofs()));
4172 *   std::vector<Vector<double>>sum_stretches_vertex
4173 *   (dim,
4174 *   Vector<double>(vertex_handler_ref.n_dofs()));
4175 *   Vector<double> porous_dissipation_vertex_mpi(vertex_handler_ref.n_dofs());
4176 *   Vector<double> sum_porous_dissipation_vertex(vertex_handler_ref.n_dofs());
4177 *   Vector<double> viscous_dissipation_vertex_mpi(vertex_handler_ref.n_dofs());
4178 *   Vector<double> sum_viscous_dissipation_vertex(vertex_handler_ref.n_dofs());
4179 *   Vector<double> solid_vol_fraction_vertex_mpi(vertex_handler_ref.n_dofs());
4180 *   Vector<double> sum_solid_vol_fraction_vertex(vertex_handler_ref.n_dofs());
4181 *  
4182 * @endcode
4183 *
4184 * We need to create a new FE space with a dim dof per node to
4185 * be able to output data on nodes in vector form
4186 *
4187 * @code
4188 *   FESystem<dim> fe_vertex_vec(FE_Q<dim>(1),dim);
4189 *   DoFHandler<dim> vertex_vec_handler_ref(triangulation);
4190 *   vertex_vec_handler_ref.distribute_dofs(fe_vertex_vec);
4191 *   AssertThrow(vertex_vec_handler_ref.n_dofs() == (dim*triangulation.n_vertices()),
4192 *   ExcDimensionMismatch(vertex_vec_handler_ref.n_dofs(),
4193 *   (dim*triangulation.n_vertices())));
4194 *  
4195 *   Vector<double> seepage_velocity_vertex_vec_mpi(vertex_vec_handler_ref.n_dofs());
4196 *   Vector<double> sum_seepage_velocity_vertex_vec(vertex_vec_handler_ref.n_dofs());
4197 *   Vector<double> counter_on_vertices_vec_mpi(vertex_vec_handler_ref.n_dofs());
4198 *   Vector<double> sum_counter_on_vertices_vec(vertex_vec_handler_ref.n_dofs());
4199 * @endcode
4200 *
4201 * -----------------------------------------------------------------------
4202 *
4203
4204 *
4205 * Declare and initialize local unit vectors (to construct tensor basis)
4206 *
4207 * @code
4208 *   std::vector<Tensor<1,dim>> basis_vectors (dim, Tensor<1,dim>() );
4209 *   for (unsigned int i=0; i<dim; ++i)
4210 *   basis_vectors[i][i] = 1;
4211 *  
4212 * @endcode
4213 *
4214 * Declare an instance of the material class object
4215 *
4216 * @code
4217 *   if (parameters.mat_type == "Neo-Hooke")
4218 *   NeoHooke<dim,ADNumberType> material(parameters,time);
4219 *   else if (parameters.mat_type == "Ogden")
4220 *   Ogden<dim,ADNumberType> material(parameters,time);
4221 *   else if (parameters.mat_type == "visco-Ogden")
4222 *   visco_Ogden <dim,ADNumberType>material(parameters,time);
4223 *   else
4224 *   Assert (false, ExcMessage("Material type not implemented"));
4225 *  
4226 * @endcode
4227 *
4228 * Define a local instance of FEValues to compute updated values required
4229 * to calculate stresses
4230 *
4231 * @code
4232 *   const UpdateFlags uf_cell(update_values | update_gradients |
4233 *   update_JxW_values);
4234 *   FEValues<dim> fe_values_ref (fe, qf_cell, uf_cell);
4235 *  
4236 * @endcode
4237 *
4238 * Iterate through elements (cells) and Gauss Points
4239 *
4240 * @code
4243 *   dof_handler_ref.begin_active()),
4245 *   dof_handler_ref.end()),
4247 *   vertex_handler_ref.begin_active()),
4248 *   cell_v_vec(IteratorFilters::LocallyOwnedCell(),
4249 *   vertex_vec_handler_ref.begin_active());
4250 * @endcode
4251 *
4252 * start cell loop
4253 *
4254 * @code
4255 *   for (; cell!=endc; ++cell, ++cell_v, ++cell_v_vec)
4256 *   {
4257 *   Assert(cell->is_locally_owned(), ExcInternalError());
4258 *   Assert(cell->subdomain_id() == this_mpi_process, ExcInternalError());
4259 *  
4260 *   material_id(cell->active_cell_index())=
4261 *   static_cast<int>(cell->material_id());
4262 *  
4263 *   fe_values_ref.reinit(cell);
4264 *  
4265 *   std::vector<Tensor<2,dim>> solution_grads_u(n_q_points);
4266 *   fe_values_ref[u_fe].get_function_gradients(solution_total,
4267 *   solution_grads_u);
4268 *  
4269 *   std::vector<double> solution_values_p_fluid_total(n_q_points);
4270 *   fe_values_ref[p_fluid_fe].get_function_values(solution_total,
4271 *   solution_values_p_fluid_total);
4272 *  
4273 *   std::vector<Tensor<1,dim>> solution_grads_p_fluid_AD (n_q_points);
4274 *   fe_values_ref[p_fluid_fe].get_function_gradients(solution_total,
4275 *   solution_grads_p_fluid_AD);
4276 *  
4277 * @endcode
4278 *
4279 * start gauss point loop
4280 *
4281 * @code
4282 *   for (unsigned int q_point=0; q_point<n_q_points; ++q_point)
4283 *   {
4285 *   F_AD = Physics::Elasticity::Kinematics::F(solution_grads_u[q_point]);
4286 *   ADNumberType det_F_AD = determinant(F_AD);
4287 *   const double det_F = Tensor<0,dim,double>(det_F_AD);
4288 *  
4289 *   const std::vector<std::shared_ptr<const PointHistory<dim,ADNumberType>>>
4290 *   lqph = quadrature_point_history.get_data(cell);
4291 *   Assert(lqph.size() == n_q_points, ExcInternalError());
4292 *  
4293 *   const double p_fluid = solution_values_p_fluid_total[q_point];
4294 *  
4295 * @endcode
4296 *
4297 * Cauchy stress
4298 *
4299 * @code
4300 *   static const SymmetricTensor<2,dim,double>
4302 *   SymmetricTensor<2,dim> sigma_E;
4303 *   const SymmetricTensor<2,dim,ADNumberType> sigma_E_AD =
4304 *   lqph[q_point]->get_Cauchy_E(F_AD);
4305 *  
4306 *   for (unsigned int i=0; i<dim; ++i)
4307 *   for (unsigned int j=0; j<dim; ++j)
4308 *   sigma_E[i][j] = Tensor<0,dim,double>(sigma_E_AD[i][j]);
4309 *  
4310 *   SymmetricTensor<2,dim> sigma_fluid_vol (I);
4311 *   sigma_fluid_vol *= -p_fluid;
4312 *   const SymmetricTensor<2,dim> sigma = sigma_E + sigma_fluid_vol;
4313 *  
4314 * @endcode
4315 *
4316 * Volumes
4317 *
4318 * @code
4319 *   const double solid_vol_fraction = (parameters.solid_vol_frac)/det_F;
4320 *  
4321 * @endcode
4322 *
4323 * Green-Lagrange strain
4324 *
4325 * @code
4326 *   const Tensor<2,dim> E_strain = 0.5*(transpose(F_AD)*F_AD - I);
4327 *  
4328 * @endcode
4329 *
4330 * Seepage velocity
4331 *
4332 * @code
4333 *   const Tensor<2,dim,ADNumberType> F_inv = invert(F_AD);
4334 *   const Tensor<1,dim,ADNumberType> grad_p_fluid_AD =
4335 *   solution_grads_p_fluid_AD[q_point]*F_inv;
4336 *   const Tensor<1,dim,ADNumberType> seepage_vel_AD =
4337 *   lqph[q_point]->get_seepage_velocity_current(F_AD, grad_p_fluid_AD);
4338 *  
4339 * @endcode
4340 *
4341 * Dissipations
4342 *
4343 * @code
4344 *   const double porous_dissipation =
4345 *   lqph[q_point]->get_porous_dissipation(F_AD, grad_p_fluid_AD);
4346 *   const double viscous_dissipation =
4347 *   lqph[q_point]->get_viscous_dissipation();
4348 *  
4349 * @endcode
4350 *
4351 * OUTPUT AVERAGED ON ELEMENTS -------------------------------------------
4352 * Both average on elements and on nodes is NOT weighted with the
4353 * integration point volume, i.e., we assume equal contribution of each
4354 * integration point to the average. Ideally, it should be weighted,
4355 * but I haven't invested time in getting it to work properly.
4356 *
4357 * @code
4358 *   if (parameters.outtype == "elements")
4359 *   {
4360 *   for (unsigned int j=0; j<dim; ++j)
4361 *   {
4362 *   cauchy_stresses_total_elements[j](cell->active_cell_index())
4363 *   += ((sigma*basis_vectors[j])*basis_vectors[j])/n_q_points;
4364 *   cauchy_stresses_E_elements[j](cell->active_cell_index())
4365 *   += ((sigma_E*basis_vectors[j])*basis_vectors[j])/n_q_points;
4366 *   stretches_elements[j](cell->active_cell_index())
4367 *   += std::sqrt(1.0+2.0*Tensor<0,dim,double>(E_strain[j][j]))
4368 *   /n_q_points;
4369 *   seepage_velocity_elements[j](cell->active_cell_index())
4370 *   += Tensor<0,dim,double>(seepage_vel_AD[j])/n_q_points;
4371 *   }
4372 *  
4373 *   porous_dissipation_elements(cell->active_cell_index())
4374 *   += porous_dissipation/n_q_points;
4375 *   viscous_dissipation_elements(cell->active_cell_index())
4376 *   += viscous_dissipation/n_q_points;
4377 *   solid_vol_fraction_elements(cell->active_cell_index())
4378 *   += solid_vol_fraction/n_q_points;
4379 *  
4380 *   cauchy_stresses_total_elements[3](cell->active_cell_index())
4381 *   += ((sigma*basis_vectors[0])*basis_vectors[1])/n_q_points; //sig_xy
4382 *   cauchy_stresses_total_elements[4](cell->active_cell_index())
4383 *   += ((sigma*basis_vectors[0])*basis_vectors[2])/n_q_points;//sig_xz
4384 *   cauchy_stresses_total_elements[5](cell->active_cell_index())
4385 *   += ((sigma*basis_vectors[1])*basis_vectors[2])/n_q_points;//sig_yz
4386 *  
4387 *   cauchy_stresses_E_elements[3](cell->active_cell_index())
4388 *   += ((sigma_E*basis_vectors[0])* basis_vectors[1])/n_q_points; //sig_xy
4389 *   cauchy_stresses_E_elements[4](cell->active_cell_index())
4390 *   += ((sigma_E*basis_vectors[0])* basis_vectors[2])/n_q_points;//sig_xz
4391 *   cauchy_stresses_E_elements[5](cell->active_cell_index())
4392 *   += ((sigma_E*basis_vectors[1])* basis_vectors[2])/n_q_points;//sig_yz
4393 *  
4394 *   }
4395 * @endcode
4396 *
4397 * OUTPUT AVERAGED ON NODES -------------------------------------------
4398 *
4399 * @code
4400 *   else if (parameters.outtype == "nodes")
4401 *   {
4402 *   for (unsigned int v=0; v<(GeometryInfo<dim>::vertices_per_cell); ++v)
4403 *   {
4404 *   types::global_dof_index local_vertex_indices =
4405 *   cell_v->vertex_dof_index(v, 0);
4406 *   counter_on_vertices_mpi(local_vertex_indices) += 1;
4407 *   for (unsigned int k=0; k<dim; ++k)
4408 *   {
4409 *   cauchy_stresses_total_vertex_mpi[k](local_vertex_indices)
4410 *   += (sigma*basis_vectors[k])*basis_vectors[k];
4411 *   cauchy_stresses_E_vertex_mpi[k](local_vertex_indices)
4412 *   += (sigma_E*basis_vectors[k])*basis_vectors[k];
4413 *   stretches_vertex_mpi[k](local_vertex_indices)
4414 *   += std::sqrt(1.0+2.0*Tensor<0,dim,double>(E_strain[k][k]));
4415 *  
4416 *   types::global_dof_index local_vertex_vec_indices =
4417 *   cell_v_vec->vertex_dof_index(v, k);
4418 *   counter_on_vertices_vec_mpi(local_vertex_vec_indices) += 1;
4419 *   seepage_velocity_vertex_vec_mpi(local_vertex_vec_indices)
4420 *   += Tensor<0,dim,double>(seepage_vel_AD[k]);
4421 *   }
4422 *  
4423 *   porous_dissipation_vertex_mpi(local_vertex_indices)
4424 *   += porous_dissipation;
4425 *   viscous_dissipation_vertex_mpi(local_vertex_indices)
4426 *   += viscous_dissipation;
4427 *   solid_vol_fraction_vertex_mpi(local_vertex_indices)
4428 *   += solid_vol_fraction;
4429 *  
4430 *   cauchy_stresses_total_vertex_mpi[3](local_vertex_indices)
4431 *   += (sigma*basis_vectors[0])*basis_vectors[1]; //sig_xy
4432 *   cauchy_stresses_total_vertex_mpi[4](local_vertex_indices)
4433 *   += (sigma*basis_vectors[0])*basis_vectors[2];//sig_xz
4434 *   cauchy_stresses_total_vertex_mpi[5](local_vertex_indices)
4435 *   += (sigma*basis_vectors[1])*basis_vectors[2]; //sig_yz
4436 *  
4437 *   cauchy_stresses_E_vertex_mpi[3](local_vertex_indices)
4438 *   += (sigma_E*basis_vectors[0])*basis_vectors[1]; //sig_xy
4439 *   cauchy_stresses_E_vertex_mpi[4](local_vertex_indices)
4440 *   += (sigma_E*basis_vectors[0])*basis_vectors[2];//sig_xz
4441 *   cauchy_stresses_E_vertex_mpi[5](local_vertex_indices)
4442 *   += (sigma_E*basis_vectors[1])*basis_vectors[2]; //sig_yz
4443 *   }
4444 *   }
4445 * @endcode
4446 *
4447 * ---------------------------------------------------------------
4448 *
4449 * @code
4450 *   } //end gauss point loop
4451 *   }//end cell loop
4452 *  
4453 * @endcode
4454 *
4455 * Different nodes might have different amount of contributions, e.g.,
4456 * corner nodes have less integration points contributing to the averaged.
4457 * This is why we need a counter and divide at the end, outside the cell loop.
4458 *
4459 * @code
4460 *   if (parameters.outtype == "nodes")
4461 *   {
4462 *   for (unsigned int d=0; d<(vertex_handler_ref.n_dofs()); ++d)
4463 *   {
4464 *   sum_counter_on_vertices[d] =
4465 *   Utilities::MPI::sum(counter_on_vertices_mpi[d],
4466 *   mpi_communicator);
4467 *   sum_porous_dissipation_vertex[d] =
4468 *   Utilities::MPI::sum(porous_dissipation_vertex_mpi[d],
4469 *   mpi_communicator);
4470 *   sum_viscous_dissipation_vertex[d] =
4471 *   Utilities::MPI::sum(viscous_dissipation_vertex_mpi[d],
4472 *   mpi_communicator);
4473 *   sum_solid_vol_fraction_vertex[d] =
4474 *   Utilities::MPI::sum(solid_vol_fraction_vertex_mpi[d],
4475 *   mpi_communicator);
4476 *  
4477 *   for (unsigned int k=0; k<num_comp_symm_tensor; ++k)
4478 *   {
4479 *   sum_cauchy_stresses_total_vertex[k][d] =
4480 *   Utilities::MPI::sum(cauchy_stresses_total_vertex_mpi[k][d],
4481 *   mpi_communicator);
4482 *   sum_cauchy_stresses_E_vertex[k][d] =
4483 *   Utilities::MPI::sum(cauchy_stresses_E_vertex_mpi[k][d],
4484 *   mpi_communicator);
4485 *   }
4486 *   for (unsigned int k=0; k<dim; ++k)
4487 *   {
4488 *   sum_stretches_vertex[k][d] =
4489 *   Utilities::MPI::sum(stretches_vertex_mpi[k][d],
4490 *   mpi_communicator);
4491 *   }
4492 *   }
4493 *  
4494 *   for (unsigned int d=0; d<(vertex_vec_handler_ref.n_dofs()); ++d)
4495 *   {
4496 *   sum_counter_on_vertices_vec[d] =
4497 *   Utilities::MPI::sum(counter_on_vertices_vec_mpi[d],
4498 *   mpi_communicator);
4499 *   sum_seepage_velocity_vertex_vec[d] =
4500 *   Utilities::MPI::sum(seepage_velocity_vertex_vec_mpi[d],
4501 *   mpi_communicator);
4502 *   }
4503 *  
4504 *   for (unsigned int d=0; d<(vertex_handler_ref.n_dofs()); ++d)
4505 *   {
4506 *   if (sum_counter_on_vertices[d]>0)
4507 *   {
4508 *   for (unsigned int i=0; i<num_comp_symm_tensor; ++i)
4509 *   {
4510 *   sum_cauchy_stresses_total_vertex[i][d] /= sum_counter_on_vertices[d];
4511 *   sum_cauchy_stresses_E_vertex[i][d] /= sum_counter_on_vertices[d];
4512 *   }
4513 *   for (unsigned int i=0; i<dim; ++i)
4514 *   {
4515 *   sum_stretches_vertex[i][d] /= sum_counter_on_vertices[d];
4516 *   }
4517 *   sum_porous_dissipation_vertex[d] /= sum_counter_on_vertices[d];
4518 *   sum_viscous_dissipation_vertex[d] /= sum_counter_on_vertices[d];
4519 *   sum_solid_vol_fraction_vertex[d] /= sum_counter_on_vertices[d];
4520 *   }
4521 *   }
4522 *  
4523 *   for (unsigned int d=0; d<(vertex_vec_handler_ref.n_dofs()); ++d)
4524 *   {
4525 *   if (sum_counter_on_vertices_vec[d]>0)
4526 *   {
4527 *   sum_seepage_velocity_vertex_vec[d] /= sum_counter_on_vertices_vec[d];
4528 *   }
4529 *   }
4530 *  
4531 *   }
4532 *  
4533 * @endcode
4534 *
4535 * Add the results to the solution to create the output file for Paraview
4536 *
4537 * @code
4538 *   DataOut<dim> data_out;
4539 *   std::vector<DataComponentInterpretation::DataComponentInterpretation>
4540 *   comp_type(dim,
4541 *   DataComponentInterpretation::component_is_part_of_vector);
4542 *   comp_type.push_back(DataComponentInterpretation::component_is_scalar);
4543 *  
4544 *   GridTools::get_subdomain_association(triangulation, partition_int);
4545 *  
4546 *   std::vector<std::string> solution_name(dim, "displacement");
4547 *   solution_name.push_back("pore_pressure");
4548 *  
4549 *   data_out.attach_dof_handler(dof_handler_ref);
4550 *   data_out.add_data_vector(solution_total,
4551 *   solution_name,
4552 *   DataOut<dim>::type_dof_data,
4553 *   comp_type);
4554 *  
4555 *   data_out.add_data_vector(solution_total,
4556 *   gradient_postprocessor);
4557 *  
4558 *   const Vector<double> partitioning(partition_int.begin(),
4559 *   partition_int.end());
4560 *  
4561 *   data_out.add_data_vector(partitioning, "partitioning");
4562 *   data_out.add_data_vector(material_id, "material_id");
4563 *  
4564 * @endcode
4565 *
4566 * Integration point results -----------------------------------------------------------
4567 *
4568 * @code
4569 *   if (parameters.outtype == "elements")
4570 *   {
4571 *   data_out.add_data_vector(cauchy_stresses_total_elements[0], "cauchy_xx");
4572 *   data_out.add_data_vector(cauchy_stresses_total_elements[1], "cauchy_yy");
4573 *   data_out.add_data_vector(cauchy_stresses_total_elements[2], "cauchy_zz");
4574 *   data_out.add_data_vector(cauchy_stresses_total_elements[3], "cauchy_xy");
4575 *   data_out.add_data_vector(cauchy_stresses_total_elements[4], "cauchy_xz");
4576 *   data_out.add_data_vector(cauchy_stresses_total_elements[5], "cauchy_yz");
4577 *  
4578 *   data_out.add_data_vector(cauchy_stresses_E_elements[0], "cauchy_E_xx");
4579 *   data_out.add_data_vector(cauchy_stresses_E_elements[1], "cauchy_E_yy");
4580 *   data_out.add_data_vector(cauchy_stresses_E_elements[2], "cauchy_E_zz");
4581 *   data_out.add_data_vector(cauchy_stresses_E_elements[3], "cauchy_E_xy");
4582 *   data_out.add_data_vector(cauchy_stresses_E_elements[4], "cauchy_E_xz");
4583 *   data_out.add_data_vector(cauchy_stresses_E_elements[5], "cauchy_E_yz");
4584 *  
4585 *   data_out.add_data_vector(stretches_elements[0], "stretch_xx");
4586 *   data_out.add_data_vector(stretches_elements[1], "stretch_yy");
4587 *   data_out.add_data_vector(stretches_elements[2], "stretch_zz");
4588 *  
4589 *   data_out.add_data_vector(seepage_velocity_elements[0], "seepage_vel_x");
4590 *   data_out.add_data_vector(seepage_velocity_elements[1], "seepage_vel_y");
4591 *   data_out.add_data_vector(seepage_velocity_elements[2], "seepage_vel_z");
4592 *  
4593 *   data_out.add_data_vector(porous_dissipation_elements, "dissipation_porous");
4594 *   data_out.add_data_vector(viscous_dissipation_elements, "dissipation_viscous");
4595 *   data_out.add_data_vector(solid_vol_fraction_elements, "solid_vol_fraction");
4596 *   }
4597 *   else if (parameters.outtype == "nodes")
4598 *   {
4599 *   data_out.add_data_vector(vertex_handler_ref,
4600 *   sum_cauchy_stresses_total_vertex[0],
4601 *   "cauchy_xx");
4602 *   data_out.add_data_vector(vertex_handler_ref,
4603 *   sum_cauchy_stresses_total_vertex[1],
4604 *   "cauchy_yy");
4605 *   data_out.add_data_vector(vertex_handler_ref,
4606 *   sum_cauchy_stresses_total_vertex[2],
4607 *   "cauchy_zz");
4608 *   data_out.add_data_vector(vertex_handler_ref,
4609 *   sum_cauchy_stresses_total_vertex[3],
4610 *   "cauchy_xy");
4611 *   data_out.add_data_vector(vertex_handler_ref,
4612 *   sum_cauchy_stresses_total_vertex[4],
4613 *   "cauchy_xz");
4614 *   data_out.add_data_vector(vertex_handler_ref,
4615 *   sum_cauchy_stresses_total_vertex[5],
4616 *   "cauchy_yz");
4617 *  
4618 *   data_out.add_data_vector(vertex_handler_ref,
4619 *   sum_cauchy_stresses_E_vertex[0],
4620 *   "cauchy_E_xx");
4621 *   data_out.add_data_vector(vertex_handler_ref,
4622 *   sum_cauchy_stresses_E_vertex[1],
4623 *   "cauchy_E_yy");
4624 *   data_out.add_data_vector(vertex_handler_ref,
4625 *   sum_cauchy_stresses_E_vertex[2],
4626 *   "cauchy_E_zz");
4627 *   data_out.add_data_vector(vertex_handler_ref,
4628 *   sum_cauchy_stresses_E_vertex[3],
4629 *   "cauchy_E_xy");
4630 *   data_out.add_data_vector(vertex_handler_ref,
4631 *   sum_cauchy_stresses_E_vertex[4],
4632 *   "cauchy_E_xz");
4633 *   data_out.add_data_vector(vertex_handler_ref,
4634 *   sum_cauchy_stresses_E_vertex[5],
4635 *   "cauchy_E_yz");
4636 *  
4637 *   data_out.add_data_vector(vertex_handler_ref,
4638 *   sum_stretches_vertex[0],
4639 *   "stretch_xx");
4640 *   data_out.add_data_vector(vertex_handler_ref,
4641 *   sum_stretches_vertex[1],
4642 *   "stretch_yy");
4643 *   data_out.add_data_vector(vertex_handler_ref,
4644 *   sum_stretches_vertex[2],
4645 *   "stretch_zz");
4646 *  
4647 *   std::vector<DataComponentInterpretation::DataComponentInterpretation>
4648 *   comp_type_vec(dim,
4649 *   DataComponentInterpretation::component_is_part_of_vector);
4650 *   std::vector<std::string> solution_name_vec(dim,"seepage_velocity");
4651 *  
4652 *   data_out.add_data_vector(vertex_vec_handler_ref,
4653 *   sum_seepage_velocity_vertex_vec,
4654 *   solution_name_vec,
4655 *   comp_type_vec);
4656 *  
4657 *   data_out.add_data_vector(vertex_handler_ref,
4658 *   sum_porous_dissipation_vertex,
4659 *   "dissipation_porous");
4660 *   data_out.add_data_vector(vertex_handler_ref,
4661 *   sum_viscous_dissipation_vertex,
4662 *   "dissipation_viscous");
4663 *   data_out.add_data_vector(vertex_handler_ref,
4664 *   sum_solid_vol_fraction_vertex,
4665 *   "solid_vol_fraction");
4666 *   }
4667 * @endcode
4668 *
4669 * ---------------------------------------------------------------------
4670 *
4671
4672 *
4673 *
4674 * @code
4675 *   data_out.build_patches(degree_displ);
4676 *  
4677 *   struct Filename
4678 *   {
4679 *   static std::string get_filename_vtu(unsigned int process,
4680 *   unsigned int timestep,
4681 *   const unsigned int n_digits = 5)
4682 *   {
4683 *   std::ostringstream filename_vtu;
4684 *   filename_vtu
4685 *   << "solution."
4686 *   << Utilities::int_to_string(process, n_digits)
4687 *   << "."
4688 *   << Utilities::int_to_string(timestep, n_digits)
4689 *   << ".vtu";
4690 *   return filename_vtu.str();
4691 *   }
4692 *  
4693 *   static std::string get_filename_pvtu(unsigned int timestep,
4694 *   const unsigned int n_digits = 5)
4695 *   {
4696 *   std::ostringstream filename_vtu;
4697 *   filename_vtu
4698 *   << "solution."
4699 *   << Utilities::int_to_string(timestep, n_digits)
4700 *   << ".pvtu";
4701 *   return filename_vtu.str();
4702 *   }
4703 *  
4704 *   static std::string get_filename_pvd (void)
4705 *   {
4706 *   std::ostringstream filename_vtu;
4707 *   filename_vtu
4708 *   << "solution.pvd";
4709 *   return filename_vtu.str();
4710 *   }
4711 *   };
4712 *  
4713 *   const std::string filename_vtu = Filename::get_filename_vtu(this_mpi_process,
4714 *   timestep);
4715 *   std::ofstream output(filename_vtu.c_str());
4716 *   data_out.write_vtu(output);
4717 *  
4718 * @endcode
4719 *
4720 * We have a collection of files written in parallel
4721 * This next set of steps should only be performed by master process
4722 *
4723 * @code
4724 *   if (this_mpi_process == 0)
4725 *   {
4726 * @endcode
4727 *
4728 * List of all files written out at this timestep by all processors
4729 *
4730 * @code
4731 *   std::vector<std::string> parallel_filenames_vtu;
4732 *   for (unsigned int p=0; p<n_mpi_processes; ++p)
4733 *   {
4734 *   parallel_filenames_vtu.push_back(Filename::get_filename_vtu(p, timestep));
4735 *   }
4736 *  
4737 *   const std::string filename_pvtu(Filename::get_filename_pvtu(timestep));
4738 *   std::ofstream pvtu_master(filename_pvtu.c_str());
4739 *   data_out.write_pvtu_record(pvtu_master,
4740 *   parallel_filenames_vtu);
4741 *  
4742 * @endcode
4743 *
4744 * Time dependent data master file
4745 *
4746 * @code
4747 *   static std::vector<std::pair<double,std::string>> time_and_name_history;
4748 *   time_and_name_history.push_back(std::make_pair(current_time,
4749 *   filename_pvtu));
4750 *   const std::string filename_pvd(Filename::get_filename_pvd());
4751 *   std::ofstream pvd_output(filename_pvd.c_str());
4752 *   DataOutBase::write_pvd_record(pvd_output, time_and_name_history);
4753 *   }
4754 *   }
4755 *  
4756 *  
4757 * @endcode
4758 *
4759 * Print results to plotting file
4760 *
4761 * @code
4762 *   template <int dim>
4763 *   void Solid<dim>::output_results_to_plot(
4764 *   const unsigned int timestep,
4765 *   const double current_time,
4766 *   TrilinosWrappers::MPI::BlockVector solution_IN,
4767 *   std::vector<Point<dim> > &tracked_vertices_IN,
4768 *   std::ofstream &plotpointfile) const
4769 *   {
4770 *   TrilinosWrappers::MPI::BlockVector solution_total(locally_owned_partitioning,
4771 *   locally_relevant_partitioning,
4772 *   mpi_communicator,
4773 *   false);
4774 *  
4775 *   (void) timestep;
4776 *   solution_total = solution_IN;
4777 *  
4778 * @endcode
4779 *
4780 * Variables needed to print the solution file for plotting
4781 *
4782 * @code
4783 *   Point<dim> reaction_force;
4784 *   Point<dim> reaction_force_pressure;
4785 *   Point<dim> reaction_force_extra;
4786 *   double total_fluid_flow = 0.0;
4787 *   double total_porous_dissipation = 0.0;
4788 *   double total_viscous_dissipation = 0.0;
4789 *   double total_solid_vol = 0.0;
4790 *   double total_vol_current = 0.0;
4791 *   double total_vol_reference = 0.0;
4792 *   std::vector<Point<dim+1>> solution_vertices(tracked_vertices_IN.size());
4793 *  
4794 * @endcode
4795 *
4796 * Auxiliary variables needed for mpi processing
4797 *
4798 * @code
4799 *   Tensor<1,dim> sum_reaction_mpi;
4800 *   Tensor<1,dim> sum_reaction_pressure_mpi;
4801 *   Tensor<1,dim> sum_reaction_extra_mpi;
4802 *   sum_reaction_mpi = 0.0;
4803 *   sum_reaction_pressure_mpi = 0.0;
4804 *   sum_reaction_extra_mpi = 0.0;
4805 *   double sum_total_flow_mpi = 0.0;
4806 *   double sum_porous_dissipation_mpi = 0.0;
4807 *   double sum_viscous_dissipation_mpi = 0.0;
4808 *   double sum_solid_vol_mpi = 0.0;
4809 *   double sum_vol_current_mpi = 0.0;
4810 *   double sum_vol_reference_mpi = 0.0;
4811 *  
4812 * @endcode
4813 *
4814 * Declare an instance of the material class object
4815 *
4816 * @code
4817 *   if (parameters.mat_type == "Neo-Hooke")
4818 *   NeoHooke<dim,ADNumberType> material(parameters,time);
4819 *   else if (parameters.mat_type == "Ogden")
4820 *   Ogden<dim,ADNumberType> material(parameters, time);
4821 *   else if (parameters.mat_type == "visco-Ogden")
4822 *   visco_Ogden <dim,ADNumberType>material(parameters,time);
4823 *   else
4824 *   Assert (false, ExcMessage("Material type not implemented"));
4825 *  
4826 * @endcode
4827 *
4828 * Define a local instance of FEValues to compute updated values required
4829 * to calculate stresses
4830 *
4831 * @code
4832 *   const UpdateFlags uf_cell(update_values | update_gradients |
4833 *   update_JxW_values);
4834 *   FEValues<dim> fe_values_ref (fe, qf_cell, uf_cell);
4835 *  
4836 * @endcode
4837 *
4838 * Iterate through elements (cells) and Gauss Points
4839 *
4840 * @code
4841 *   FilteredIterator<typename DoFHandler<dim>::active_cell_iterator>
4842 *   cell(IteratorFilters::LocallyOwnedCell(),
4843 *   dof_handler_ref.begin_active()),
4844 *   endc(IteratorFilters::LocallyOwnedCell(),
4845 *   dof_handler_ref.end());
4846 * @endcode
4847 *
4848 * start cell loop
4849 *
4850 * @code
4851 *   for (; cell!=endc; ++cell)
4852 *   {
4853 *   Assert(cell->is_locally_owned(), ExcInternalError());
4854 *   Assert(cell->subdomain_id() == this_mpi_process, ExcInternalError());
4855 *  
4856 *   fe_values_ref.reinit(cell);
4857 *  
4858 *   std::vector<Tensor<2,dim>> solution_grads_u(n_q_points);
4859 *   fe_values_ref[u_fe].get_function_gradients(solution_total,
4860 *   solution_grads_u);
4861 *  
4862 *   std::vector<double> solution_values_p_fluid_total(n_q_points);
4863 *   fe_values_ref[p_fluid_fe].get_function_values(solution_total,
4864 *   solution_values_p_fluid_total);
4865 *  
4866 *   std::vector<Tensor<1,dim >> solution_grads_p_fluid_AD(n_q_points);
4867 *   fe_values_ref[p_fluid_fe].get_function_gradients(solution_total,
4868 *   solution_grads_p_fluid_AD);
4869 *  
4870 * @endcode
4871 *
4872 * start gauss point loop
4873 *
4874 * @code
4875 *   for (unsigned int q_point=0; q_point<n_q_points; ++q_point)
4876 *   {
4877 *   const Tensor<2,dim,ADNumberType>
4878 *   F_AD = Physics::Elasticity::Kinematics::F(solution_grads_u[q_point]);
4879 *   ADNumberType det_F_AD = determinant(F_AD);
4880 *   const double det_F = Tensor<0,dim,double>(det_F_AD);
4881 *  
4882 *   const std::vector<std::shared_ptr<const PointHistory<dim,ADNumberType>>>
4883 *   lqph = quadrature_point_history.get_data(cell);
4884 *   Assert(lqph.size() == n_q_points, ExcInternalError());
4885 *  
4886 *   double JxW = fe_values_ref.JxW(q_point);
4887 *  
4888 * @endcode
4889 *
4890 * Volumes
4891 *
4892 * @code
4893 *   sum_vol_current_mpi += det_F * JxW;
4894 *   sum_vol_reference_mpi += JxW;
4895 *   sum_solid_vol_mpi += parameters.solid_vol_frac * JxW * det_F;
4896 *  
4897 * @endcode
4898 *
4899 * Seepage velocity
4900 *
4901 * @code
4902 *   const Tensor<2,dim,ADNumberType> F_inv = invert(F_AD);
4903 *   const Tensor<1,dim,ADNumberType>
4904 *   grad_p_fluid_AD = solution_grads_p_fluid_AD[q_point]*F_inv;
4905 *   const Tensor<1,dim,ADNumberType> seepage_vel_AD
4906 *   = lqph[q_point]->get_seepage_velocity_current(F_AD, grad_p_fluid_AD);
4907 *  
4908 * @endcode
4909 *
4910 * Dissipations
4911 *
4912 * @code
4913 *   const double porous_dissipation =
4914 *   lqph[q_point]->get_porous_dissipation(F_AD, grad_p_fluid_AD);
4915 *   sum_porous_dissipation_mpi += porous_dissipation * det_F * JxW;
4916 *  
4917 *   const double viscous_dissipation = lqph[q_point]->get_viscous_dissipation();
4918 *   sum_viscous_dissipation_mpi += viscous_dissipation * det_F * JxW;
4919 *  
4920 * @endcode
4921 *
4922 * ---------------------------------------------------------------
4923 *
4924 * @code
4925 *   } //end gauss point loop
4926 *  
4927 * @endcode
4928 *
4929 * Compute reaction force on load boundary & total fluid flow across
4930 * drained boundary.
4931 * Define a local instance of FEFaceValues to compute values required
4932 * to calculate reaction force
4933 *
4934 * @code
4935 *   const UpdateFlags uf_face( update_values | update_gradients |
4936 *   update_normal_vectors | update_JxW_values );
4937 *   FEFaceValues<dim> fe_face_values_ref(fe, qf_face, uf_face);
4938 *  
4939 * @endcode
4940 *
4941 * start face loop
4942 *
4943 * @code
4944 *   for (unsigned int face=0; face<GeometryInfo<dim>::faces_per_cell; ++face)
4945 *   {
4946 * @endcode
4947 *
4948 * Reaction force
4949 *
4950 * @code
4951 *   if (cell->face(face)->at_boundary() == true &&
4952 *   cell->face(face)->boundary_id() == get_reaction_boundary_id_for_output() )
4953 *   {
4954 *   fe_face_values_ref.reinit(cell, face);
4955 *  
4956 * @endcode
4957 *
4958 * Get displacement gradients for current face
4959 *
4960 * @code
4961 *   std::vector<Tensor<2,dim> > solution_grads_u_f(n_q_points_f);
4962 *   fe_face_values_ref[u_fe].get_function_gradients
4963 *   (solution_total,
4964 *   solution_grads_u_f);
4965 *  
4966 * @endcode
4967 *
4968 * Get pressure for current element
4969 *
4970 * @code
4971 *   std::vector< double > solution_values_p_fluid_total_f(n_q_points_f);
4972 *   fe_face_values_ref[p_fluid_fe].get_function_values
4973 *   (solution_total,
4974 *   solution_values_p_fluid_total_f);
4975 *  
4976 * @endcode
4977 *
4978 * start gauss points on faces loop
4979 *
4980 * @code
4981 *   for (unsigned int f_q_point=0; f_q_point<n_q_points_f; ++f_q_point)
4982 *   {
4983 *   const Tensor<1,dim> &N = fe_face_values_ref.normal_vector(f_q_point);
4984 *   const double JxW_f = fe_face_values_ref.JxW(f_q_point);
4985 *  
4986 * @endcode
4987 *
4988 * Compute deformation gradient from displacements gradient
4989 * (present configuration)
4990 *
4991 * @code
4992 *   const Tensor<2,dim,ADNumberType> F_AD =
4993 *   Physics::Elasticity::Kinematics::F(solution_grads_u_f[f_q_point]);
4994 *  
4995 *   const std::vector<std::shared_ptr<const PointHistory<dim,ADNumberType>>>
4996 *   lqph = quadrature_point_history.get_data(cell);
4997 *   Assert(lqph.size() == n_q_points, ExcInternalError());
4998 *  
4999 *   const double p_fluid = solution_values_p_fluid_total[f_q_point];
5000 *  
5001 * @endcode
5002 *
5003 * Cauchy stress
5004 *
5005 * @code
5006 *   static const SymmetricTensor<2,dim,double>
5007 *   I (Physics::Elasticity::StandardTensors<dim>::I);
5008 *   SymmetricTensor<2,dim> sigma_E;
5009 *   const SymmetricTensor<2,dim,ADNumberType> sigma_E_AD =
5010 *   lqph[f_q_point]->get_Cauchy_E(F_AD);
5011 *  
5012 *   for (unsigned int i=0; i<dim; ++i)
5013 *   for (unsigned int j=0; j<dim; ++j)
5014 *   sigma_E[i][j] = Tensor<0,dim,double>(sigma_E_AD[i][j]);
5015 *  
5016 *   SymmetricTensor<2,dim> sigma_fluid_vol(I);
5017 *   sigma_fluid_vol *= -1.0*p_fluid;
5018 *   const SymmetricTensor<2,dim> sigma = sigma_E+sigma_fluid_vol;
5019 *   sum_reaction_mpi += sigma * N * JxW_f;
5020 *   sum_reaction_pressure_mpi += sigma_fluid_vol * N * JxW_f;
5021 *   sum_reaction_extra_mpi += sigma_E * N * JxW_f;
5022 *   }//end gauss points on faces loop
5023 *   }
5024 *  
5025 * @endcode
5026 *
5027 * Fluid flow
5028 *
5029 * @code
5030 *   if (cell->face(face)->at_boundary() == true &&
5031 *   (cell->face(face)->boundary_id() ==
5032 *   get_drained_boundary_id_for_output().first ||
5033 *   cell->face(face)->boundary_id() ==
5034 *   get_drained_boundary_id_for_output().second ) )
5035 *   {
5036 *   fe_face_values_ref.reinit(cell, face);
5037 *  
5038 * @endcode
5039 *
5040 * Get displacement gradients for current face
5041 *
5042 * @code
5043 *   std::vector<Tensor<2,dim>> solution_grads_u_f(n_q_points_f);
5044 *   fe_face_values_ref[u_fe].get_function_gradients
5045 *   (solution_total,
5046 *   solution_grads_u_f);
5047 *  
5048 * @endcode
5049 *
5050 * Get pressure gradients for current face
5051 *
5052 * @code
5053 *   std::vector<Tensor<1,dim>> solution_grads_p_f(n_q_points_f);
5054 *   fe_face_values_ref[p_fluid_fe].get_function_gradients
5055 *   (solution_total,
5056 *   solution_grads_p_f);
5057 *  
5058 * @endcode
5059 *
5060 * start gauss points on faces loop
5061 *
5062 * @code
5063 *   for (unsigned int f_q_point=0; f_q_point<n_q_points_f; ++f_q_point)
5064 *   {
5065 *   const Tensor<1,dim> &N =
5066 *   fe_face_values_ref.normal_vector(f_q_point);
5067 *   const double JxW_f = fe_face_values_ref.JxW(f_q_point);
5068 *  
5069 * @endcode
5070 *
5071 * Deformation gradient and inverse from displacements gradient
5072 * (present configuration)
5073 *
5074 * @code
5075 *   const Tensor<2,dim,ADNumberType> F_AD
5076 *   = Physics::Elasticity::Kinematics::F(solution_grads_u_f[f_q_point]);
5077 *  
5078 *   const Tensor<2,dim,ADNumberType> F_inv_AD = invert(F_AD);
5079 *   ADNumberType det_F_AD = determinant(F_AD);
5080 *  
5081 *   const std::vector<std::shared_ptr<const PointHistory<dim,ADNumberType>>>
5082 *   lqph = quadrature_point_history.get_data(cell);
5083 *   Assert(lqph.size() == n_q_points, ExcInternalError());
5084 *  
5085 * @endcode
5086 *
5087 * Seepage velocity
5088 *
5089 * @code
5090 *   Tensor<1,dim> seepage;
5091 *   double det_F = Tensor<0,dim,double>(det_F_AD);
5092 *   const Tensor<1,dim,ADNumberType> grad_p
5093 *   = solution_grads_p_f[f_q_point]*F_inv_AD;
5094 *   const Tensor<1,dim,ADNumberType> seepage_AD
5095 *   = lqph[f_q_point]->get_seepage_velocity_current(F_AD, grad_p);
5096 *  
5097 *   for (unsigned int i=0; i<dim; ++i)
5098 *   seepage[i] = Tensor<0,dim,double>(seepage_AD[i]);
5099 *  
5100 *   sum_total_flow_mpi += (seepage/det_F) * N * JxW_f;
5101 *   }//end gauss points on faces loop
5102 *   }
5103 *   }//end face loop
5104 *   }//end cell loop
5105 *  
5106 * @endcode
5107 *
5108 * Sum the results from different MPI process and then add to the reaction_force vector
5109 * In theory, the solution on each surface (each cell) only exists in one MPI process
5110 * so, we add all MPI process, one will have the solution and the others will be zero
5111 *
5112 * @code
5113 *   for (unsigned int d=0; d<dim; ++d)
5114 *   {
5115 *   reaction_force[d] = Utilities::MPI::sum(sum_reaction_mpi[d],
5116 *   mpi_communicator);
5117 *   reaction_force_pressure[d] = Utilities::MPI::sum(sum_reaction_pressure_mpi[d],
5118 *   mpi_communicator);
5119 *   reaction_force_extra[d] = Utilities::MPI::sum(sum_reaction_extra_mpi[d],
5120 *   mpi_communicator);
5121 *   }
5122 *  
5123 * @endcode
5124 *
5125 * Same for total fluid flow, and for porous and viscous dissipations
5126 *
5127 * @code
5128 *   total_fluid_flow = Utilities::MPI::sum(sum_total_flow_mpi,
5129 *   mpi_communicator);
5130 *   total_porous_dissipation = Utilities::MPI::sum(sum_porous_dissipation_mpi,
5131 *   mpi_communicator);
5132 *   total_viscous_dissipation = Utilities::MPI::sum(sum_viscous_dissipation_mpi,
5133 *   mpi_communicator);
5134 *   total_solid_vol = Utilities::MPI::sum(sum_solid_vol_mpi,
5135 *   mpi_communicator);
5136 *   total_vol_current = Utilities::MPI::sum(sum_vol_current_mpi,
5137 *   mpi_communicator);
5138 *   total_vol_reference = Utilities::MPI::sum(sum_vol_reference_mpi,
5139 *   mpi_communicator);
5140 *  
5141 * @endcode
5142 *
5143 * Extract solution for tracked vectors
5144 * Copying an MPI::BlockVector into MPI::Vector is not possible,
5145 * so we copy each block of MPI::BlockVector into an MPI::Vector
5146 * And then we copy the MPI::Vector into "normal" Vectors
5147 *
5148 * @code
5149 *   TrilinosWrappers::MPI::Vector solution_vector_u_MPI(solution_total.block(u_block));
5150 *   TrilinosWrappers::MPI::Vector solution_vector_p_MPI(solution_total.block(p_fluid_block));
5151 *   Vector<double> solution_u_vector(solution_vector_u_MPI);
5152 *   Vector<double> solution_p_vector(solution_vector_p_MPI);
5153 *  
5154 *   if (this_mpi_process == 0)
5155 *   {
5156 * @endcode
5157 *
5158 * Append the pressure solution vector to the displacement solution vector,
5159 * creating a single solution vector equivalent to the original BlockVector
5160 * so FEFieldFunction will work with the dof_handler_ref.
5161 *
5162 * @code
5163 *   Vector<double> solution_vector(solution_p_vector.size()
5164 *   +solution_u_vector.size());
5165 *  
5166 *   for (unsigned int d=0; d<(solution_u_vector.size()); ++d)
5167 *   solution_vector[d] = solution_u_vector[d];
5168 *  
5169 *   for (unsigned int d=0; d<(solution_p_vector.size()); ++d)
5170 *   solution_vector[solution_u_vector.size()+d] = solution_p_vector[d];
5171 *  
5172 *   Functions::FEFieldFunction<dim,Vector<double>>
5173 *   find_solution(dof_handler_ref, solution_vector);
5174 *  
5175 *   for (unsigned int p=0; p<tracked_vertices_IN.size(); ++p)
5176 *   {
5177 *   Vector<double> update(dim+1);
5178 *   Point<dim> pt_ref;
5179 *  
5180 *   pt_ref[0]= tracked_vertices_IN[p][0];
5181 *   pt_ref[1]= tracked_vertices_IN[p][1];
5182 *   pt_ref[2]= tracked_vertices_IN[p][2];
5183 *  
5184 *   find_solution.vector_value(pt_ref, update);
5185 *  
5186 *   for (unsigned int d=0; d<(dim+1); ++d)
5187 *   {
5188 * @endcode
5189 *
5190 * For values close to zero, set to 0.0
5191 *
5192 * @code
5193 *   if (abs(update[d])<1.5*parameters.tol_u)
5194 *   update[d] = 0.0;
5195 *   solution_vertices[p][d] = update[d];
5196 *   }
5197 *   }
5198 * @endcode
5199 *
5200 * Write the results to the plotting file.
5201 * Add two blank lines between cycles in the cyclic loading examples so GNUPLOT can detect each cycle as a different block
5202 *
5203 * @code
5204 *   if (( (parameters.geom_type == "Budday_cube_tension_compression_fully_fixed")||
5205 *   (parameters.geom_type == "Budday_cube_tension_compression")||
5206 *   (parameters.geom_type == "Budday_cube_shear_fully_fixed") ) &&
5207 *   ( (abs(current_time - parameters.end_time/3.) <0.9*parameters.delta_t)||
5208 *   (abs(current_time - 2.*parameters.end_time/3.)<0.9*parameters.delta_t) ) &&
5209 *   parameters.num_cycle_sets == 1 )
5210 *   {
5211 *   plotpointfile << std::endl<< std::endl;
5212 *   }
5213 *   if (( (parameters.geom_type == "Budday_cube_tension_compression_fully_fixed")||
5214 *   (parameters.geom_type == "Budday_cube_tension_compression")||
5215 *   (parameters.geom_type == "Budday_cube_shear_fully_fixed") ) &&
5216 *   ( (abs(current_time - parameters.end_time/9.) <0.9*parameters.delta_t)||
5217 *   (abs(current_time - 2.*parameters.end_time/9.)<0.9*parameters.delta_t)||
5218 *   (abs(current_time - 3.*parameters.end_time/9.)<0.9*parameters.delta_t)||
5219 *   (abs(current_time - 5.*parameters.end_time/9.)<0.9*parameters.delta_t)||
5220 *   (abs(current_time - 7.*parameters.end_time/9.)<0.9*parameters.delta_t) ) &&
5221 *   parameters.num_cycle_sets == 2 )
5222 *   {
5223 *   plotpointfile << std::endl<< std::endl;
5224 *   }
5225 *  
5226 *   plotpointfile << std::setprecision(6) << std::scientific;
5227 *   plotpointfile << std::setw(16) << current_time << ","
5228 *   << std::setw(15) << total_vol_reference << ","
5229 *   << std::setw(15) << total_vol_current << ","
5230 *   << std::setw(15) << total_solid_vol << ",";
5231 *  
5232 *   if (current_time == 0.0)
5233 *   {
5234 *   for (unsigned int p=0; p<tracked_vertices_IN.size(); ++p)
5235 *   {
5236 *   for (unsigned int d=0; d<dim; ++d)
5237 *   plotpointfile << std::setw(15) << 0.0 << ",";
5238 *  
5239 *   plotpointfile << std::setw(15) << parameters.drained_pressure << ",";
5240 *   }
5241 *   for (unsigned int d=0; d<(3*dim+2); ++d)
5242 *   plotpointfile << std::setw(15) << 0.0 << ",";
5243 *  
5244 *   plotpointfile << std::setw(15) << 0.0;
5245 *   }
5246 *   else
5247 *   {
5248 *   for (unsigned int p=0; p<tracked_vertices_IN.size(); ++p)
5249 *   for (unsigned int d=0; d<(dim+1); ++d)
5250 *   plotpointfile << std::setw(15) << solution_vertices[p][d]<< ",";
5251 *  
5252 *   for (unsigned int d=0; d<dim; ++d)
5253 *   plotpointfile << std::setw(15) << reaction_force[d] << ",";
5254 *  
5255 *   for (unsigned int d=0; d<dim; ++d)
5256 *   plotpointfile << std::setw(15) << reaction_force_pressure[d] << ",";
5257 *  
5258 *   for (unsigned int d=0; d<dim; ++d)
5259 *   plotpointfile << std::setw(15) << reaction_force_extra[d] << ",";
5260 *  
5261 *   plotpointfile << std::setw(15) << total_fluid_flow << ","
5262 *   << std::setw(15) << total_porous_dissipation<< ","
5263 *   << std::setw(15) << total_viscous_dissipation;
5264 *   }
5265 *   plotpointfile << std::endl;
5266 *   }
5267 *   }
5268 *  
5269 * @endcode
5270 *
5271 * Header for console output file
5272 *
5273 * @code
5274 *   template <int dim>
5275 *   void Solid<dim>::print_console_file_header(std::ofstream &outputfile) const
5276 *   {
5277 *   outputfile << "/*-----------------------------------------------------------------------------------------";
5278 *   outputfile << "\n\n Poro-viscoelastic formulation to solve nonlinear solid mechanics problems using deal.ii";
5279 *   outputfile << "\n\n Problem setup by E Comellas and J-P Pelteret, University of Erlangen-Nuremberg, 2018";
5280 *   outputfile << "\n\n/*-----------------------------------------------------------------------------------------";
5281 *   outputfile << "\n\nCONSOLE OUTPUT: \n\n";
5282 *   }
5283 *  
5284 * @endcode
5285 *
5286 * Header for plotting output file
5287 *
5288 * @code
5289 *   template <int dim>
5290 *   void Solid<dim>::print_plot_file_header(std::vector<Point<dim> > &tracked_vertices,
5291 *   std::ofstream &plotpointfile) const
5292 *   {
5293 *   plotpointfile << "#\n# *** Solution history for tracked vertices -- DOF: 0 = Ux, 1 = Uy, 2 = Uz, 3 = P ***"
5294 *   << std::endl;
5295 *  
5296 *   for (unsigned int p=0; p<tracked_vertices.size(); ++p)
5297 *   {
5298 *   plotpointfile << "# Point " << p << " coordinates: ";
5299 *   for (unsigned int d=0; d<dim; ++d)
5300 *   {
5301 *   plotpointfile << tracked_vertices[p][d];
5302 *   if (!( (p == tracked_vertices.size()-1) && (d == dim-1) ))
5303 *   plotpointfile << ", ";
5304 *   }
5305 *   plotpointfile << std::endl;
5306 *   }
5307 *   plotpointfile << "# The reaction force is the integral over the loaded surfaces in the "
5308 *   << "undeformed configuration of the Cauchy stress times the normal surface unit vector.\n"
5309 *   << "# reac(p) corresponds to the volumetric part of the Cauchy stress due to the pore fluid pressure"
5310 *   << " and reac(E) corresponds to the extra part of the Cauchy stress due to the solid contribution."
5311 *   << std::endl
5312 *   << "# The fluid flow is the integral over the drained surfaces in the "
5313 *   << "undeformed configuration of the seepage velocity times the normal surface unit vector."
5314 *   << std::endl
5315 *   << "# Column number:"
5316 *   << std::endl
5317 *   << "#";
5318 *  
5319 *   unsigned int columns = 24;
5320 *   for (unsigned int d=1; d<columns; ++d)
5321 *   plotpointfile << std::setw(15)<< d <<",";
5322 *  
5323 *   plotpointfile << std::setw(15)<< columns
5324 *   << std::endl
5325 *   << "#"
5326 *   << std::right << std::setw(16) << "Time,"
5327 *   << std::right << std::setw(16) << "ref vol,"
5328 *   << std::right << std::setw(16) << "def vol,"
5329 *   << std::right << std::setw(16) << "solid vol,";
5330 *   for (unsigned int p=0; p<tracked_vertices.size(); ++p)
5331 *   for (unsigned int d=0; d<(dim+1); ++d)
5332 *   plotpointfile << std::right<< std::setw(11)
5333 *   <<"P" << p << "[" << d << "],";
5334 *  
5335 *   for (unsigned int d=0; d<dim; ++d)
5336 *   plotpointfile << std::right<< std::setw(13)
5337 *   << "reaction [" << d << "],";
5338 *  
5339 *   for (unsigned int d=0; d<dim; ++d)
5340 *   plotpointfile << std::right<< std::setw(13)
5341 *   << "reac(p) [" << d << "],";
5342 *  
5343 *   for (unsigned int d=0; d<dim; ++d)
5344 *   plotpointfile << std::right<< std::setw(13)
5345 *   << "reac(E) [" << d << "],";
5346 *  
5347 *   plotpointfile << std::right<< std::setw(16)<< "fluid flow,"
5348 *   << std::right<< std::setw(16)<< "porous dissip,"
5349 *   << std::right<< std::setw(15)<< "viscous dissip"
5350 *   << std::endl;
5351 *   }
5352 *  
5353 * @endcode
5354 *
5355 * Footer for console output file
5356 *
5357 * @code
5358 *   template <int dim>
5359 *   void Solid<dim>::print_console_file_footer(std::ofstream &outputfile) const
5360 *   {
5361 * @endcode
5362 *
5363 * Copy "parameters" file at end of output file.
5364 *
5365 * @code
5366 *   std::ifstream infile("parameters.prm");
5367 *   std::string content = "";
5368 *   int i;
5369 *  
5370 *   for(i=0 ; infile.eof()!=true ; i++)
5371 *   {
5372 *   char aux = infile.get();
5373 *   content += aux;
5374 *   if(aux=='\n') content += '#';
5375 *   }
5376 *  
5377 *   i--;
5378 *   content.erase(content.end()-1);
5379 *   infile.close();
5380 *  
5381 *   outputfile << "\n\n\n\n PARAMETERS FILE USED IN THIS COMPUTATION: \n#"
5382 *   << std::endl
5383 *   << content;
5384 *   }
5385 *  
5386 * @endcode
5387 *
5388 * Footer for plotting output file
5389 *
5390 * @code
5391 *   template <int dim>
5392 *   void Solid<dim>::print_plot_file_footer(std::ofstream &plotpointfile) const
5393 *   {
5394 * @endcode
5395 *
5396 * Copy "parameters" file at end of output file.
5397 *
5398 * @code
5399 *   std::ifstream infile("parameters.prm");
5400 *   std::string content = "";
5401 *   int i;
5402 *  
5403 *   for(i=0 ; infile.eof()!=true ; i++)
5404 *   {
5405 *   char aux = infile.get();
5406 *   content += aux;
5407 *   if(aux=='\n') content += '#';
5408 *   }
5409 *  
5410 *   i--;
5411 *   content.erase(content.end()-1);
5412 *   infile.close();
5413 *  
5414 *   plotpointfile << "#"<< std::endl
5415 *   << "#"<< std::endl
5416 *   << "# PARAMETERS FILE USED IN THIS COMPUTATION:" << std::endl
5417 *   << "#"<< std::endl
5418 *   << content;
5419 *   }
5420 *  
5421 *  
5422 * @endcode
5423 *
5424 *
5425 * <a name="nonlinear-poro-viscoelasticity.cc-VerificationexamplesfromEhlersandEipper1999"></a>
5426 * <h3>Verification examples from Ehlers and Eipper 1999</h3>
5427 * We group the definition of the geometry, boundary and loading conditions specific to
5428 * the verification examples from Ehlers and Eipper 1999 into specific classes.
5429 *
5430
5431 *
5432 *
5433 * <a name="nonlinear-poro-viscoelasticity.cc-BaseclassTubegeometryandboundaryconditions"></a>
5434 * <h4>Base class: Tube geometry and boundary conditions</h4>
5435 *
5436 * @code
5437 *   template <int dim>
5438 *   class VerificationEhlers1999TubeBase
5439 *   : public Solid<dim>
5440 *   {
5441 *   public:
5442 *   VerificationEhlers1999TubeBase (const Parameters::AllParameters &parameters)
5443 *   : Solid<dim> (parameters)
5444 *   {}
5445 *  
5446 *   virtual ~VerificationEhlers1999TubeBase () {}
5447 *  
5448 *   private:
5449 *   virtual void make_grid() override
5450 *   {
5451 *   GridGenerator::cylinder( this->triangulation,
5452 *   0.1,
5453 *   0.5);
5454 *  
5455 *   const double rot_angle = 3.0*numbers::PI/2.0;
5456 *   GridTools::rotate( Point<3>::unit_vector(1), rot_angle, this->triangulation);
5457 *  
5458 *   this->triangulation.reset_manifold(0);
5459 *   static const CylindricalManifold<dim> manifold_description_3d(2);
5460 *   this->triangulation.set_manifold (0, manifold_description_3d);
5461 *   GridTools::scale(this->parameters.scale, this->triangulation);
5462 *   this->triangulation.refine_global(std::max (1U, this->parameters.global_refinement));
5463 *   this->triangulation.reset_manifold(0);
5464 *   }
5465 *  
5466 *   virtual void define_tracked_vertices(std::vector<Point<dim> > &tracked_vertices) override
5467 *   {
5468 *   tracked_vertices[0][0] = 0.0*this->parameters.scale;
5469 *   tracked_vertices[0][1] = 0.0*this->parameters.scale;
5470 *   tracked_vertices[0][2] = 0.5*this->parameters.scale;
5471 *  
5472 *   tracked_vertices[1][0] = 0.0*this->parameters.scale;
5473 *   tracked_vertices[1][1] = 0.0*this->parameters.scale;
5474 *   tracked_vertices[1][2] = -0.5*this->parameters.scale;
5475 *   }
5476 *  
5477 *   virtual void make_dirichlet_constraints(AffineConstraints<double> &constraints) override
5478 *   {
5479 *   if (this->time.get_timestep() < 2)
5480 *   {
5481 *   VectorTools::interpolate_boundary_values(this->dof_handler_ref,
5482 *   2,
5483 *   Functions::ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),
5484 *   constraints,
5485 *   (this->fe.component_mask(this->pressure)));
5486 *   }
5487 *   else
5488 *   {
5489 *   VectorTools::interpolate_boundary_values(this->dof_handler_ref,
5490 *   2,
5491 *   Functions::ZeroFunction<dim>(this->n_components),
5492 *   constraints,
5493 *   (this->fe.component_mask(this->pressure)));
5494 *   }
5495 *  
5496 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
5497 *   0,
5498 *   Functions::ZeroFunction<dim>(this->n_components),
5499 *   constraints,
5500 *   (this->fe.component_mask(this->x_displacement)|
5501 *   this->fe.component_mask(this->y_displacement) ) );
5502 *  
5503 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
5504 *   1,
5505 *   Functions::ZeroFunction<dim>(this->n_components),
5506 *   constraints,
5507 *   (this->fe.component_mask(this->x_displacement) |
5508 *   this->fe.component_mask(this->y_displacement) |
5509 *   this->fe.component_mask(this->z_displacement) ));
5510 *   }
5511 *  
5512 *   virtual double
5513 *   get_prescribed_fluid_flow (const types::boundary_id &boundary_id,
5514 *   const Point<dim> &pt) const override
5515 *   {
5516 *   (void)pt;
5517 *   (void)boundary_id;
5518 *   return 0.0;
5519 *   }
5520 *  
5521 *   virtual types::boundary_id
5522 *   get_reaction_boundary_id_for_output() const override
5523 *   {
5524 *   return 2;
5525 *   }
5526 *  
5527 *   virtual std::pair<types::boundary_id,types::boundary_id>
5528 *   get_drained_boundary_id_for_output() const override
5529 *   {
5530 *   return std::make_pair(2,2);
5531 *   }
5532 *  
5533 *   virtual std::vector<double>
5534 *   get_dirichlet_load(const types::boundary_id &boundary_id,
5535 *   const int &direction) const override
5536 *   {
5537 *   std::vector<double> displ_incr(dim, 0.0);
5538 *   (void)boundary_id;
5539 *   (void)direction;
5540 *   AssertThrow(false, ExcMessage("Displacement loading not implemented for Ehlers verification examples."));
5541 *  
5542 *   return displ_incr;
5543 *   }
5544 *   };
5545 *  
5546 * @endcode
5547 *
5548 *
5549 * <a name="nonlinear-poro-viscoelasticity.cc-DerivedclassSteploadexample"></a>
5550 * <h4>Derived class: Step load example</h4>
5551 *
5552 * @code
5553 *   template <int dim>
5554 *   class VerificationEhlers1999StepLoad
5555 *   : public VerificationEhlers1999TubeBase<dim>
5556 *   {
5557 *   public:
5558 *   VerificationEhlers1999StepLoad (const Parameters::AllParameters &parameters)
5559 *   : VerificationEhlers1999TubeBase<dim> (parameters)
5560 *   {}
5561 *  
5562 *   virtual ~VerificationEhlers1999StepLoad () {}
5563 *  
5564 *   private:
5565 *   virtual Tensor<1,dim>
5566 *   get_neumann_traction (const types::boundary_id &boundary_id,
5567 *   const Point<dim> &pt,
5568 *   const Tensor<1,dim> &N) const override
5569 *   {
5570 *   if (this->parameters.load_type == "pressure")
5571 *   {
5572 *   if (boundary_id == 2)
5573 *   {
5574 *   return this->parameters.load * N;
5575 *   }
5576 *   }
5577 *  
5578 *   (void)pt;
5579 *  
5580 *   return Tensor<1,dim>();
5581 *   }
5582 *   };
5583 *  
5584 * @endcode
5585 *
5586 *
5587 * <a name="nonlinear-poro-viscoelasticity.cc-DerivedclassLoadincreasingexample"></a>
5588 * <h4>Derived class: Load increasing example</h4>
5589 *
5590 * @code
5591 *   template <int dim>
5592 *   class VerificationEhlers1999IncreaseLoad
5593 *   : public VerificationEhlers1999TubeBase<dim>
5594 *   {
5595 *   public:
5596 *   VerificationEhlers1999IncreaseLoad (const Parameters::AllParameters &parameters)
5597 *   : VerificationEhlers1999TubeBase<dim> (parameters)
5598 *   {}
5599 *  
5600 *   virtual ~VerificationEhlers1999IncreaseLoad () {}
5601 *  
5602 *   private:
5603 *   virtual Tensor<1,dim>
5604 *   get_neumann_traction (const types::boundary_id &boundary_id,
5605 *   const Point<dim> &pt,
5606 *   const Tensor<1,dim> &N) const override
5607 *   {
5608 *   if (this->parameters.load_type == "pressure")
5609 *   {
5610 *   if (boundary_id == 2)
5611 *   {
5612 *   const double initial_load = this->parameters.load;
5613 *   const double final_load = 20.0*initial_load;
5614 *   const double initial_time = this->time.get_delta_t();
5615 *   const double final_time = this->time.get_end();
5616 *   const double current_time = this->time.get_current();
5617 *   const double load = initial_load + (final_load-initial_load)*(current_time-initial_time)/(final_time-initial_time);
5618 *   return load * N;
5619 *   }
5620 *   }
5621 *  
5622 *   (void)pt;
5623 *  
5624 *   return Tensor<1,dim>();
5625 *   }
5626 *   };
5627 *  
5628 * @endcode
5629 *
5630 *
5631 * <a name="nonlinear-poro-viscoelasticity.cc-ClassConsolidationcube"></a>
5632 * <h4>Class: Consolidation cube</h4>
5633 *
5634 * @code
5635 *   template <int dim>
5636 *   class VerificationEhlers1999CubeConsolidation
5637 *   : public Solid<dim>
5638 *   {
5639 *   public:
5640 *   VerificationEhlers1999CubeConsolidation (const Parameters::AllParameters &parameters)
5641 *   : Solid<dim> (parameters)
5642 *   {}
5643 *  
5644 *   virtual ~VerificationEhlers1999CubeConsolidation () {}
5645 *  
5646 *   private:
5647 *   virtual void
5648 *   make_grid() override
5649 *   {
5650 *   GridGenerator::hyper_rectangle(this->triangulation,
5651 *   Point<dim>(0.0, 0.0, 0.0),
5652 *   Point<dim>(1.0, 1.0, 1.0),
5653 *   true);
5654 *  
5655 *   GridTools::scale(this->parameters.scale, this->triangulation);
5656 *   this->triangulation.refine_global(std::max (1U, this->parameters.global_refinement));
5657 *  
5658 *   typename Triangulation<dim>::active_cell_iterator cell =
5659 *   this->triangulation.begin_active(), endc = this->triangulation.end();
5660 *   for (; cell != endc; ++cell)
5661 *   {
5662 *   for (unsigned int face = 0; face < GeometryInfo<dim>::faces_per_cell; ++face)
5663 *   if (cell->face(face)->at_boundary() == true &&
5664 *   cell->face(face)->center()[2] == 1.0 * this->parameters.scale)
5665 *   {
5666 *   if (cell->face(face)->center()[0] < 0.5 * this->parameters.scale &&
5667 *   cell->face(face)->center()[1] < 0.5 * this->parameters.scale)
5668 *   cell->face(face)->set_boundary_id(100);
5669 *   else
5670 *   cell->face(face)->set_boundary_id(101);
5671 *   }
5672 *   }
5673 *   }
5674 *  
5675 *   virtual void
5676 *   define_tracked_vertices(std::vector<Point<dim> > &tracked_vertices) override
5677 *   {
5678 *   tracked_vertices[0][0] = 0.0*this->parameters.scale;
5679 *   tracked_vertices[0][1] = 0.0*this->parameters.scale;
5680 *   tracked_vertices[0][2] = 1.0*this->parameters.scale;
5681 *  
5682 *   tracked_vertices[1][0] = 0.0*this->parameters.scale;
5683 *   tracked_vertices[1][1] = 0.0*this->parameters.scale;
5684 *   tracked_vertices[1][2] = 0.0*this->parameters.scale;
5685 *   }
5686 *  
5687 *   virtual void
5688 *   make_dirichlet_constraints(AffineConstraints<double> &constraints) override
5689 *   {
5690 *   if (this->time.get_timestep() < 2)
5691 *   {
5692 *   VectorTools::interpolate_boundary_values(this->dof_handler_ref,
5693 *   101,
5694 *   Functions::ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),
5695 *   constraints,
5696 *   (this->fe.component_mask(this->pressure)));
5697 *   }
5698 *   else
5699 *   {
5700 *   VectorTools::interpolate_boundary_values(this->dof_handler_ref,
5701 *   101,
5702 *   Functions::ZeroFunction<dim>(this->n_components),
5703 *   constraints,
5704 *   (this->fe.component_mask(this->pressure)));
5705 *   }
5706 *  
5707 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
5708 *   0,
5709 *   Functions::ZeroFunction<dim>(this->n_components),
5710 *   constraints,
5711 *   this->fe.component_mask(this->x_displacement));
5712 *  
5713 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
5714 *   1,
5715 *   Functions::ZeroFunction<dim>(this->n_components),
5716 *   constraints,
5717 *   this->fe.component_mask(this->x_displacement));
5718 *  
5719 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
5720 *   2,
5721 *   Functions::ZeroFunction<dim>(this->n_components),
5722 *   constraints,
5723 *   this->fe.component_mask(this->y_displacement));
5724 *  
5725 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
5726 *   3,
5727 *   Functions::ZeroFunction<dim>(this->n_components),
5728 *   constraints,
5729 *   this->fe.component_mask(this->y_displacement));
5730 *  
5731 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
5732 *   4,
5733 *   Functions::ZeroFunction<dim>(this->n_components),
5734 *   constraints,
5735 *   ( this->fe.component_mask(this->x_displacement) |
5736 *   this->fe.component_mask(this->y_displacement) |
5737 *   this->fe.component_mask(this->z_displacement) ));
5738 *   }
5739 *  
5740 *   virtual Tensor<1,dim>
5741 *   get_neumann_traction (const types::boundary_id &boundary_id,
5742 *   const Point<dim> &pt,
5743 *   const Tensor<1,dim> &N) const override
5744 *   {
5745 *   if (this->parameters.load_type == "pressure")
5746 *   {
5747 *   if (boundary_id == 100)
5748 *   {
5749 *   return this->parameters.load * N;
5750 *   }
5751 *   }
5752 *  
5753 *   (void)pt;
5754 *  
5755 *   return Tensor<1,dim>();
5756 *   }
5757 *  
5758 *   virtual double
5759 *   get_prescribed_fluid_flow (const types::boundary_id &boundary_id,
5760 *   const Point<dim> &pt) const override
5761 *   {
5762 *   (void)pt;
5763 *   (void)boundary_id;
5764 *   return 0.0;
5765 *   }
5766 *  
5767 *   virtual types::boundary_id
5768 *   get_reaction_boundary_id_for_output() const override
5769 *   {
5770 *   return 100;
5771 *   }
5772 *  
5773 *   virtual std::pair<types::boundary_id,types::boundary_id>
5774 *   get_drained_boundary_id_for_output() const override
5775 *   {
5776 *   return std::make_pair(101,101);
5777 *   }
5778 *  
5779 *   virtual std::vector<double>
5780 *   get_dirichlet_load(const types::boundary_id &boundary_id,
5781 *   const int &direction) const override
5782 *   {
5783 *   std::vector<double> displ_incr(dim, 0.0);
5784 *   (void)boundary_id;
5785 *   (void)direction;
5786 *   AssertThrow(false, ExcMessage("Displacement loading not implemented for Ehlers verification examples."));
5787 *  
5788 *   return displ_incr;
5789 *   }
5790 *   };
5791 *  
5792 * @endcode
5793 *
5794 *
5795 * <a name="nonlinear-poro-viscoelasticity.cc-Franceschiniexperiments"></a>
5796 * <h4>Franceschini experiments</h4>
5797 *
5798 * @code
5799 *   template <int dim>
5800 *   class Franceschini2006Consolidation
5801 *   : public Solid<dim>
5802 *   {
5803 *   public:
5804 *   Franceschini2006Consolidation (const Parameters::AllParameters &parameters)
5805 *   : Solid<dim> (parameters)
5806 *   {}
5807 *  
5808 *   virtual ~Franceschini2006Consolidation () {}
5809 *  
5810 *   private:
5811 *   virtual void make_grid() override
5812 *   {
5813 *   const Point<dim-1> mesh_center(0.0, 0.0);
5814 *   const double radius = 0.5;
5815 * @endcode
5816 *
5817 * const double height = 0.27; //8.1 mm for 30 mm radius
5818 *
5819 * @code
5820 *   const double height = 0.23; //6.9 mm for 30 mm radius
5821 *   Triangulation<dim-1> triangulation_in;
5822 *   GridGenerator::hyper_ball( triangulation_in,
5823 *   mesh_center,
5824 *   radius);
5825 *  
5826 *   GridGenerator::extrude_triangulation(triangulation_in,
5827 *   2,
5828 *   height,
5829 *   this->triangulation);
5830 *  
5831 *   const CylindricalManifold<dim> cylinder_3d(2);
5832 *   const types::manifold_id cylinder_id = 0;
5833 *  
5834 *  
5835 *   this->triangulation.set_manifold(cylinder_id, cylinder_3d);
5836 *  
5837 *   for (auto cell : this->triangulation.active_cell_iterators())
5838 *   {
5839 *   for (unsigned int face = 0; face < GeometryInfo<dim>::faces_per_cell; ++face)
5840 *   {
5841 *   if (cell->face(face)->at_boundary() == true)
5842 *   {
5843 *   if (cell->face(face)->center()[2] == 0.0)
5844 *   cell->face(face)->set_boundary_id(1);
5845 *  
5846 *   else if (cell->face(face)->center()[2] == height)
5847 *   cell->face(face)->set_boundary_id(2);
5848 *  
5849 *   else
5850 *   {
5851 *   cell->face(face)->set_boundary_id(0);
5852 *   cell->face(face)->set_all_manifold_ids(cylinder_id);
5853 *   }
5854 *   }
5855 *   }
5856 *   }
5857 *  
5858 *   GridTools::scale(this->parameters.scale, this->triangulation);
5859 *   this->triangulation.refine_global(std::max (1U, this->parameters.global_refinement));
5860 *   }
5861 *  
5862 *   virtual void define_tracked_vertices(std::vector<Point<dim> > &tracked_vertices) override
5863 *   {
5864 *   tracked_vertices[0][0] = 0.0*this->parameters.scale;
5865 *   tracked_vertices[0][1] = 0.0*this->parameters.scale;
5866 * @endcode
5867 *
5868 * tracked_vertices[0][2] = 0.27*this->parameters.scale;
5869 *
5870 * @code
5871 *   tracked_vertices[0][2] = 0.23*this->parameters.scale;
5872 *  
5873 *   tracked_vertices[1][0] = 0.0*this->parameters.scale;
5874 *   tracked_vertices[1][1] = 0.0*this->parameters.scale;
5875 *   tracked_vertices[1][2] = 0.0*this->parameters.scale;
5876 *   }
5877 *  
5878 *   virtual void make_dirichlet_constraints(AffineConstraints<double> &constraints) override
5879 *   {
5880 *   if (this->time.get_timestep() < 2)
5881 *   {
5882 *   VectorTools::interpolate_boundary_values(this->dof_handler_ref,
5883 *   1,
5884 *   Functions::ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),
5885 *   constraints,
5886 *   (this->fe.component_mask(this->pressure)));
5887 *  
5888 *   VectorTools::interpolate_boundary_values(this->dof_handler_ref,
5889 *   2,
5890 *   Functions::ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),
5891 *   constraints,
5892 *   (this->fe.component_mask(this->pressure)));
5893 *   }
5894 *   else
5895 *   {
5896 *   VectorTools::interpolate_boundary_values(this->dof_handler_ref,
5897 *   1,
5898 *   Functions::ZeroFunction<dim>(this->n_components),
5899 *   constraints,
5900 *   (this->fe.component_mask(this->pressure)));
5901 *  
5902 *   VectorTools::interpolate_boundary_values(this->dof_handler_ref,
5903 *   2,
5904 *   Functions::ZeroFunction<dim>(this->n_components),
5905 *   constraints,
5906 *   (this->fe.component_mask(this->pressure)));
5907 *   }
5908 *  
5909 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
5910 *   0,
5911 *   Functions::ZeroFunction<dim>(this->n_components),
5912 *   constraints,
5913 *   (this->fe.component_mask(this->x_displacement)|
5914 *   this->fe.component_mask(this->y_displacement) ) );
5915 *  
5916 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
5917 *   1,
5918 *   Functions::ZeroFunction<dim>(this->n_components),
5919 *   constraints,
5920 *   (this->fe.component_mask(this->x_displacement) |
5921 *   this->fe.component_mask(this->y_displacement) |
5922 *   this->fe.component_mask(this->z_displacement) ));
5923 *  
5924 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
5925 *   2,
5926 *   Functions::ZeroFunction<dim>(this->n_components),
5927 *   constraints,
5928 *   (this->fe.component_mask(this->x_displacement) |
5929 *   this->fe.component_mask(this->y_displacement) ));
5930 *   }
5931 *  
5932 *   virtual double
5933 *   get_prescribed_fluid_flow (const types::boundary_id &boundary_id,
5934 *   const Point<dim> &pt) const override
5935 *   {
5936 *   (void)pt;
5937 *   (void)boundary_id;
5938 *   return 0.0;
5939 *   }
5940 *  
5941 *   virtual types::boundary_id
5942 *   get_reaction_boundary_id_for_output() const override
5943 *   {
5944 *   return 2;
5945 *   }
5946 *  
5947 *   virtual std::pair<types::boundary_id,types::boundary_id>
5948 *   get_drained_boundary_id_for_output() const override
5949 *   {
5950 *   return std::make_pair(1,2);
5951 *   }
5952 *  
5953 *   virtual std::vector<double>
5954 *   get_dirichlet_load(const types::boundary_id &boundary_id,
5955 *   const int &direction) const override
5956 *   {
5957 *   std::vector<double> displ_incr(dim, 0.0);
5958 *   (void)boundary_id;
5959 *   (void)direction;
5960 *   AssertThrow(false, ExcMessage("Displacement loading not implemented for Franceschini examples."));
5961 *  
5962 *   return displ_incr;
5963 *   }
5964 *  
5965 *   virtual Tensor<1,dim>
5966 *   get_neumann_traction (const types::boundary_id &boundary_id,
5967 *   const Point<dim> &pt,
5968 *   const Tensor<1,dim> &N) const override
5969 *   {
5970 *   if (this->parameters.load_type == "pressure")
5971 *   {
5972 *   if (boundary_id == 2)
5973 *   {
5974 *   return (this->parameters.load * N);
5975 *   /*
5976 *   const double final_load = this->parameters.load;
5977 *   const double final_load_time = 10 * this->time.get_delta_t();
5978 *   const double current_time = this->time.get_current();
5979 *  
5980 *  
5981 *   const double c = final_load_time / 2.0;
5982 *   const double r = 200.0 * 0.03 / c;
5983 *  
5984 *   const double load = final_load * std::exp(r * current_time)
5985 *   / ( std::exp(c * current_time) + std::exp(r * current_time));
5986 *   return load * N;
5987 *   */
5988 *   }
5989 *   }
5990 *  
5991 *   (void)pt;
5992 *  
5993 *   return Tensor<1,dim>();
5994 *   }
5995 *   };
5996 *  
5997 * @endcode
5998 *
5999 *
6000 * <a name="nonlinear-poro-viscoelasticity.cc-ExamplestoreproduceexperimentsbyBuddayetal2017"></a>
6001 * <h3>Examples to reproduce experiments by Budday et al. 2017</h3>
6002 * We group the definition of the geometry, boundary and loading conditions specific to
6003 * the examples to reproduce experiments by Budday et al. 2017 into specific classes.
6004 *
6005
6006 *
6007 *
6008 * <a name="nonlinear-poro-viscoelasticity.cc-BaseclassCubegeometryandloadingpattern"></a>
6009 * <h4>Base class: Cube geometry and loading pattern</h4>
6010 *
6011 * @code
6012 *   template <int dim>
6013 *   class BrainBudday2017BaseCube
6014 *   : public Solid<dim>
6015 *   {
6016 *   public:
6017 *   BrainBudday2017BaseCube (const Parameters::AllParameters &parameters)
6018 *   : Solid<dim> (parameters)
6019 *   {}
6020 *  
6021 *   virtual ~BrainBudday2017BaseCube () {}
6022 *  
6023 *   private:
6024 *   virtual void
6025 *   make_grid() override
6026 *   {
6027 *   GridGenerator::hyper_cube(this->triangulation,
6028 *   0.0,
6029 *   1.0,
6030 *   true);
6031 *  
6032 *   typename Triangulation<dim>::active_cell_iterator cell =
6033 *   this->triangulation.begin_active(), endc = this->triangulation.end();
6034 *   for (; cell != endc; ++cell)
6035 *   {
6036 *   for (unsigned int face = 0; face < GeometryInfo<dim>::faces_per_cell; ++face)
6037 *   if (cell->face(face)->at_boundary() == true &&
6038 *   ( cell->face(face)->boundary_id() == 0 ||
6039 *   cell->face(face)->boundary_id() == 1 ||
6040 *   cell->face(face)->boundary_id() == 2 ||
6041 *   cell->face(face)->boundary_id() == 3 ) )
6042 *  
6043 *   cell->face(face)->set_boundary_id(100);
6044 *  
6045 *   }
6046 *  
6047 *   GridTools::scale(this->parameters.scale, this->triangulation);
6048 *   this->triangulation.refine_global(std::max (1U, this->parameters.global_refinement));
6049 *   }
6050 *  
6051 *   virtual double
6052 *   get_prescribed_fluid_flow (const types::boundary_id &boundary_id,
6053 *   const Point<dim> &pt) const override
6054 *   {
6055 *   (void)pt;
6056 *   (void)boundary_id;
6057 *   return 0.0;
6058 *   }
6059 *  
6060 *   virtual std::pair<types::boundary_id,types::boundary_id>
6061 *   get_drained_boundary_id_for_output() const override
6062 *   {
6063 *   return std::make_pair(100,100);
6064 *   }
6065 *   };
6066 *  
6067 * @endcode
6068 *
6069 *
6070 * <a name="nonlinear-poro-viscoelasticity.cc-DerivedclassUniaxialboundaryconditions"></a>
6071 * <h4>Derived class: Uniaxial boundary conditions</h4>
6072 *
6073 * @code
6074 *   template <int dim>
6075 *   class BrainBudday2017CubeTensionCompression
6076 *   : public BrainBudday2017BaseCube<dim>
6077 *   {
6078 *   public:
6079 *   BrainBudday2017CubeTensionCompression (const Parameters::AllParameters &parameters)
6080 *   : BrainBudday2017BaseCube<dim> (parameters)
6081 *   {}
6082 *  
6083 *   virtual ~BrainBudday2017CubeTensionCompression () {}
6084 *  
6085 *   private:
6086 *   virtual void
6087 *   define_tracked_vertices(std::vector<Point<dim> > &tracked_vertices) override
6088 *   {
6089 *   tracked_vertices[0][0] = 0.5*this->parameters.scale;
6090 *   tracked_vertices[0][1] = 0.5*this->parameters.scale;
6091 *   tracked_vertices[0][2] = 1.0*this->parameters.scale;
6092 *  
6093 *   tracked_vertices[1][0] = 0.5*this->parameters.scale;
6094 *   tracked_vertices[1][1] = 0.5*this->parameters.scale;
6095 *   tracked_vertices[1][2] = 0.5*this->parameters.scale;
6096 *   }
6097 *  
6098 *   virtual void
6099 *   make_dirichlet_constraints(AffineConstraints<double> &constraints) override
6100 *   {
6101 *   if (this->time.get_timestep() < 2)
6102 *   {
6103 *   VectorTools::interpolate_boundary_values(this->dof_handler_ref,
6104 *   100,
6105 *   Functions::ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),
6106 *   constraints,
6107 *   (this->fe.component_mask(this->pressure)));
6108 *   }
6109 *   else
6110 *   {
6111 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
6112 *   100,
6113 *   Functions::ZeroFunction<dim>(this->n_components),
6114 *   constraints,
6115 *   (this->fe.component_mask(this->pressure)));
6116 *   }
6117 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
6118 *   4,
6119 *   Functions::ZeroFunction<dim>(this->n_components),
6120 *   constraints,
6121 *   this->fe.component_mask(this->z_displacement) );
6122 *  
6123 *   Point<dim> fix_node(0.5*this->parameters.scale, 0.5*this->parameters.scale, 0.0);
6124 *   typename DoFHandler<dim>::active_cell_iterator
6125 *   cell = this->dof_handler_ref.begin_active(), endc = this->dof_handler_ref.end();
6126 *   for (; cell != endc; ++cell)
6127 *   for (unsigned int node = 0; node < GeometryInfo<dim>::vertices_per_cell; ++node)
6128 *   {
6129 *   if ( (abs(cell->vertex(node)[2]-fix_node[2]) < (1e-6 * this->parameters.scale))
6130 *   && (abs(cell->vertex(node)[0]-fix_node[0]) < (1e-6 * this->parameters.scale)))
6131 *   constraints.add_line(cell->vertex_dof_index(node, 0));
6132 *  
6133 *   if ( (abs(cell->vertex(node)[2]-fix_node[2]) < (1e-6 * this->parameters.scale))
6134 *   && (abs(cell->vertex(node)[1]-fix_node[1]) < (1e-6 * this->parameters.scale)))
6135 *   constraints.add_line(cell->vertex_dof_index(node, 1));
6136 *   }
6137 *  
6138 *   if (this->parameters.load_type == "displacement")
6139 *   {
6140 *   const std::vector<double> value = get_dirichlet_load(5,2);
6141 *   const FEValuesExtractors::Scalar direction(this->z_displacement);
6142 *  
6143 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
6144 *   5,
6145 *   Functions::ConstantFunction<dim>(value[2],this->n_components),
6146 *   constraints,
6147 *   this->fe.component_mask(direction));
6148 *   }
6149 *   }
6150 *  
6151 *   virtual Tensor<1,dim>
6152 *   get_neumann_traction (const types::boundary_id &boundary_id,
6153 *   const Point<dim> &pt,
6154 *   const Tensor<1,dim> &N) const override
6155 *   {
6156 *   if (this->parameters.load_type == "pressure")
6157 *   {
6158 *   if (boundary_id == 5)
6159 *   {
6160 *   const double final_load = this->parameters.load;
6161 *   const double current_time = this->time.get_current();
6162 *   const double final_time = this->time.get_end();
6163 *   const double num_cycles = 3.0;
6164 *  
6165 *   return final_load/2.0 * (1.0 - std::sin(numbers::PI * (2.0*num_cycles*current_time/final_time + 0.5))) * N;
6166 *   }
6167 *   }
6168 *  
6169 *   (void)pt;
6170 *  
6171 *   return Tensor<1,dim>();
6172 *   }
6173 *  
6174 *   virtual types::boundary_id
6175 *   get_reaction_boundary_id_for_output() const override
6176 *   {
6177 *   return 5;
6178 *   }
6179 *  
6180 *   virtual std::vector<double>
6181 *   get_dirichlet_load(const types::boundary_id &boundary_id,
6182 *   const int &direction) const override
6183 *   {
6184 *   std::vector<double> displ_incr(dim,0.0);
6185 *  
6186 *   if ( (boundary_id == 5) && (direction == 2) )
6187 *   {
6188 *   const double final_displ = this->parameters.load;
6189 *   const double current_time = this->time.get_current();
6190 *   const double final_time = this->time.get_end();
6191 *   const double delta_time = this->time.get_delta_t();
6192 *   const double num_cycles = 3.0;
6193 *   double current_displ = 0.0;
6194 *   double previous_displ = 0.0;
6195 *  
6196 *   if (this->parameters.num_cycle_sets == 1)
6197 *   {
6198 *   current_displ = final_displ/2.0 * (1.0
6199 *   - std::sin(numbers::PI * (2.0*num_cycles*current_time/final_time + 0.5)));
6200 *   previous_displ = final_displ/2.0 * (1.0
6201 *   - std::sin(numbers::PI * (2.0*num_cycles*(current_time-delta_time)/final_time + 0.5)));
6202 *   }
6203 *   else
6204 *   {
6205 *   if ( current_time <= (final_time*1.0/3.0) )
6206 *   {
6207 *   current_displ = final_displ/2.0 * (1.0 - std::sin(numbers::PI *
6208 *   (2.0*num_cycles*current_time/(final_time*1.0/3.0) + 0.5)));
6209 *   previous_displ = final_displ/2.0 * (1.0 - std::sin(numbers::PI *
6210 *   (2.0*num_cycles*(current_time-delta_time)/(final_time*1.0/3.0) + 0.5)));
6211 *   }
6212 *   else
6213 *   {
6214 *   current_displ = final_displ * (1.0 - std::sin(numbers::PI *
6215 *   (2.0*num_cycles*current_time / (final_time*2.0/3.0)
6216 *   - (num_cycles - 0.5) )));
6217 *   previous_displ = final_displ * (1.0 - std::sin(numbers::PI *
6218 *   (2.0*num_cycles*(current_time-delta_time) / (final_time*2.0/3.0)
6219 *   - (num_cycles - 0.5))));
6220 *   }
6221 *   }
6222 *   displ_incr[2] = current_displ - previous_displ;
6223 *   }
6224 *   return displ_incr;
6225 *   }
6226 *   };
6227 *  
6228 * @endcode
6229 *
6230 *
6231 * <a name="nonlinear-poro-viscoelasticity.cc-DerivedclassNolateraldisplacementinloadingsurfaces"></a>
6232 * <h4>Derived class: No lateral displacement in loading surfaces</h4>
6233 *
6234 * @code
6235 *   template <int dim>
6236 *   class BrainBudday2017CubeTensionCompressionFullyFixed
6237 *   : public BrainBudday2017BaseCube<dim>
6238 *   {
6239 *   public:
6240 *   BrainBudday2017CubeTensionCompressionFullyFixed (const Parameters::AllParameters &parameters)
6241 *   : BrainBudday2017BaseCube<dim> (parameters)
6242 *   {}
6243 *  
6244 *   virtual ~BrainBudday2017CubeTensionCompressionFullyFixed () {}
6245 *  
6246 *   private:
6247 *   virtual void
6248 *   define_tracked_vertices(std::vector<Point<dim> > &tracked_vertices) override
6249 *   {
6250 *   tracked_vertices[0][0] = 0.5*this->parameters.scale;
6251 *   tracked_vertices[0][1] = 0.5*this->parameters.scale;
6252 *   tracked_vertices[0][2] = 1.0*this->parameters.scale;
6253 *  
6254 *   tracked_vertices[1][0] = 0.5*this->parameters.scale;
6255 *   tracked_vertices[1][1] = 0.5*this->parameters.scale;
6256 *   tracked_vertices[1][2] = 0.5*this->parameters.scale;
6257 *   }
6258 *  
6259 *   virtual void
6260 *   make_dirichlet_constraints(AffineConstraints<double> &constraints) override
6261 *   {
6262 *   if (this->time.get_timestep() < 2)
6263 *   {
6264 *   VectorTools::interpolate_boundary_values(this->dof_handler_ref,
6265 *   100,
6266 *   Functions::ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),
6267 *   constraints,
6268 *   (this->fe.component_mask(this->pressure)));
6269 *   }
6270 *   else
6271 *   {
6272 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
6273 *   100,
6274 *   Functions::ZeroFunction<dim>(this->n_components),
6275 *   constraints,
6276 *   (this->fe.component_mask(this->pressure)));
6277 *   }
6278 *  
6279 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
6280 *   4,
6281 *   Functions::ZeroFunction<dim>(this->n_components),
6282 *   constraints,
6283 *   (this->fe.component_mask(this->x_displacement) |
6284 *   this->fe.component_mask(this->y_displacement) |
6285 *   this->fe.component_mask(this->z_displacement) ));
6286 *  
6287 *  
6288 *   if (this->parameters.load_type == "displacement")
6289 *   {
6290 *   const std::vector<double> value = get_dirichlet_load(5,2);
6291 *   const FEValuesExtractors::Scalar direction(this->z_displacement);
6292 *  
6293 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
6294 *   5,
6295 *   Functions::ConstantFunction<dim>(value[2],this->n_components),
6296 *   constraints,
6297 *   this->fe.component_mask(direction) );
6298 *  
6299 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
6300 *   5,
6301 *   Functions::ZeroFunction<dim>(this->n_components),
6302 *   constraints,
6303 *   (this->fe.component_mask(this->x_displacement) |
6304 *   this->fe.component_mask(this->y_displacement) ));
6305 *   }
6306 *   }
6307 *  
6308 *   virtual Tensor<1,dim>
6309 *   get_neumann_traction (const types::boundary_id &boundary_id,
6310 *   const Point<dim> &pt,
6311 *   const Tensor<1,dim> &N) const override
6312 *   {
6313 *   if (this->parameters.load_type == "pressure")
6314 *   {
6315 *   if (boundary_id == 5)
6316 *   {
6317 *   const double final_load = this->parameters.load;
6318 *   const double current_time = this->time.get_current();
6319 *   const double final_time = this->time.get_end();
6320 *   const double num_cycles = 3.0;
6321 *  
6322 *   return final_load/2.0 * (1.0 - std::sin(numbers::PI * (2.0*num_cycles*current_time/final_time + 0.5))) * N;
6323 *   }
6324 *   }
6325 *  
6326 *   (void)pt;
6327 *  
6328 *   return Tensor<1,dim>();
6329 *   }
6330 *  
6331 *   virtual types::boundary_id
6332 *   get_reaction_boundary_id_for_output() const override
6333 *   {
6334 *   return 5;
6335 *   }
6336 *  
6337 *   virtual std::vector<double>
6338 *   get_dirichlet_load(const types::boundary_id &boundary_id,
6339 *   const int &direction) const override
6340 *   {
6341 *   std::vector<double> displ_incr(dim,0.0);
6342 *  
6343 *   if ( (boundary_id == 5) && (direction == 2) )
6344 *   {
6345 *   const double final_displ = this->parameters.load;
6346 *   const double current_time = this->time.get_current();
6347 *   const double final_time = this->time.get_end();
6348 *   const double delta_time = this->time.get_delta_t();
6349 *   const double num_cycles = 3.0;
6350 *   double current_displ = 0.0;
6351 *   double previous_displ = 0.0;
6352 *  
6353 *   if (this->parameters.num_cycle_sets == 1)
6354 *   {
6355 *   current_displ = final_displ/2.0 * (1.0 - std::sin(numbers::PI * (2.0*num_cycles*current_time/final_time + 0.5)));
6356 *   previous_displ = final_displ/2.0 * (1.0 - std::sin(numbers::PI * (2.0*num_cycles*(current_time-delta_time)/final_time + 0.5)));
6357 *   }
6358 *   else
6359 *   {
6360 *   if ( current_time <= (final_time*1.0/3.0) )
6361 *   {
6362 *   current_displ = final_displ/2.0 * (1.0 - std::sin(numbers::PI *
6363 *   (2.0*num_cycles*current_time/(final_time*1.0/3.0) + 0.5)));
6364 *   previous_displ = final_displ/2.0 * (1.0 - std::sin(numbers::PI *
6365 *   (2.0*num_cycles*(current_time-delta_time)/(final_time*1.0/3.0) + 0.5)));
6366 *   }
6367 *   else
6368 *   {
6369 *   current_displ = final_displ * (1.0 - std::sin(numbers::PI *
6370 *   (2.0*num_cycles*current_time / (final_time*2.0/3.0)
6371 *   - (num_cycles - 0.5) )));
6372 *   previous_displ = final_displ * (1.0 - std::sin(numbers::PI *
6373 *   (2.0*num_cycles*(current_time-delta_time) / (final_time*2.0/3.0)
6374 *   - (num_cycles - 0.5))));
6375 *   }
6376 *   }
6377 *   displ_incr[2] = current_displ - previous_displ;
6378 *   }
6379 *   return displ_incr;
6380 *   }
6381 *   };
6382 *  
6383 * @endcode
6384 *
6385 *
6386 * <a name="nonlinear-poro-viscoelasticity.cc-DerivedclassNolateralorverticaldisplacementinloadingsurface"></a>
6387 * <h4>Derived class: No lateral or vertical displacement in loading surface</h4>
6388 *
6389 * @code
6390 *   template <int dim>
6391 *   class BrainBudday2017CubeShearFullyFixed
6392 *   : public BrainBudday2017BaseCube<dim>
6393 *   {
6394 *   public:
6395 *   BrainBudday2017CubeShearFullyFixed (const Parameters::AllParameters &parameters)
6396 *   : BrainBudday2017BaseCube<dim> (parameters)
6397 *   {}
6398 *  
6399 *   virtual ~BrainBudday2017CubeShearFullyFixed () {}
6400 *  
6401 *   private:
6402 *   virtual void
6403 *   define_tracked_vertices(std::vector<Point<dim> > &tracked_vertices) override
6404 *   {
6405 *   tracked_vertices[0][0] = 0.75*this->parameters.scale;
6406 *   tracked_vertices[0][1] = 0.5*this->parameters.scale;
6407 *   tracked_vertices[0][2] = 0.0*this->parameters.scale;
6408 *  
6409 *   tracked_vertices[1][0] = 0.25*this->parameters.scale;
6410 *   tracked_vertices[1][1] = 0.5*this->parameters.scale;
6411 *   tracked_vertices[1][2] = 0.0*this->parameters.scale;
6412 *   }
6413 *  
6414 *   virtual void
6415 *   make_dirichlet_constraints(AffineConstraints<double> &constraints) override
6416 *   {
6417 *   if (this->time.get_timestep() < 2)
6418 *   {
6419 *   VectorTools::interpolate_boundary_values(this->dof_handler_ref,
6420 *   100,
6421 *   Functions::ConstantFunction<dim>(this->parameters.drained_pressure,this->n_components),
6422 *   constraints,
6423 *   (this->fe.component_mask(this->pressure)));
6424 *   }
6425 *   else
6426 *   {
6427 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
6428 *   100,
6429 *   Functions::ZeroFunction<dim>(this->n_components),
6430 *   constraints,
6431 *   (this->fe.component_mask(this->pressure)));
6432 *   }
6433 *  
6434 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
6435 *   5,
6436 *   Functions::ZeroFunction<dim>(this->n_components),
6437 *   constraints,
6438 *   (this->fe.component_mask(this->x_displacement) |
6439 *   this->fe.component_mask(this->y_displacement) |
6440 *   this->fe.component_mask(this->z_displacement) ));
6441 *  
6442 *  
6443 *   if (this->parameters.load_type == "displacement")
6444 *   {
6445 *   const std::vector<double> value = get_dirichlet_load(4,0);
6446 *   const FEValuesExtractors::Scalar direction(this->x_displacement);
6447 *  
6448 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
6449 *   4,
6450 *   Functions::ConstantFunction<dim>(value[0],this->n_components),
6451 *   constraints,
6452 *   this->fe.component_mask(direction));
6453 *  
6454 *   VectorTools::interpolate_boundary_values( this->dof_handler_ref,
6455 *   4,
6456 *   Functions::ZeroFunction<dim>(this->n_components),
6457 *   constraints,
6458 *   (this->fe.component_mask(this->y_displacement) |
6459 *   this->fe.component_mask(this->z_displacement) ));
6460 *   }
6461 *   }
6462 *  
6463 *   virtual Tensor<1,dim>
6464 *   get_neumann_traction (const types::boundary_id &boundary_id,
6465 *   const Point<dim> &pt,
6466 *   const Tensor<1,dim> &N) const override
6467 *   {
6468 *   if (this->parameters.load_type == "pressure")
6469 *   {
6470 *   if (boundary_id == 4)
6471 *   {
6472 *   const double final_load = this->parameters.load;
6473 *   const double current_time = this->time.get_current();
6474 *   const double final_time = this->time.get_end();
6475 *   const double num_cycles = 3.0;
6476 *   const Tensor<1,3> axis ({0.0,1.0,0.0});
6477 *   const double angle = numbers::PI;
6478 *   static const Tensor< 2, dim, double> R(Physics::Transformations::Rotations::rotation_matrix_3d(axis,angle));
6479 *  
6480 *   return (final_load * (std::sin(2.0*(numbers::PI)*num_cycles*current_time/final_time)) * (R * N));
6481 *   }
6482 *   }
6483 *  
6484 *   (void)pt;
6485 *  
6486 *   return Tensor<1,dim>();
6487 *   }
6488 *  
6489 *   virtual types::boundary_id
6490 *   get_reaction_boundary_id_for_output() const override
6491 *   {
6492 *   return 4;
6493 *   }
6494 *  
6495 *   virtual std::vector<double>
6496 *   get_dirichlet_load(const types::boundary_id &boundary_id,
6497 *   const int &direction) const override
6498 *   {
6499 *   std::vector<double> displ_incr (dim, 0.0);
6500 *  
6501 *   if ( (boundary_id == 4) && (direction == 0) )
6502 *   {
6503 *   const double final_displ = this->parameters.load;
6504 *   const double current_time = this->time.get_current();
6505 *   const double final_time = this->time.get_end();
6506 *   const double delta_time = this->time.get_delta_t();
6507 *   const double num_cycles = 3.0;
6508 *   double current_displ = 0.0;
6509 *   double previous_displ = 0.0;
6510 *  
6511 *   if (this->parameters.num_cycle_sets == 1)
6512 *   {
6513 *   current_displ = final_displ * (std::sin(2.0*(numbers::PI)*num_cycles*current_time/final_time));
6514 *   previous_displ = final_displ * (std::sin(2.0*(numbers::PI)*num_cycles*(current_time-delta_time)/final_time));
6515 *   }
6516 *   else
6517 *   {
6518 *   AssertThrow(false, ExcMessage("Problem type not defined. Budday shear experiments implemented only for one set of cycles."));
6519 *   }
6520 *   displ_incr[0] = current_displ - previous_displ;
6521 *   }
6522 *   return displ_incr;
6523 *   }
6524 *   };
6525 *  
6526 *   }
6527 *  
6528 * @endcode
6529 *
6530 *
6531 * <a name="nonlinear-poro-viscoelasticity.cc-Mainfunction"></a>
6532 * <h3>Main function</h3>
6533 * Lastly we provide the main driver function which is similar to the other tutorials.
6534 *
6535 * @code
6536 *   int main (int argc, char *argv[])
6537 *   {
6538 *   using namespace dealii;
6539 *   using namespace NonLinearPoroViscoElasticity;
6540 *  
6541 *   const unsigned int n_tbb_processes = 1;
6542 *   Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, n_tbb_processes);
6543 *  
6544 *   try
6545 *   {
6546 *   Parameters::AllParameters parameters ("parameters.prm");
6547 *   if (parameters.geom_type == "Ehlers_tube_step_load")
6548 *   {
6549 *   VerificationEhlers1999StepLoad<3> solid_3d(parameters);
6550 *   solid_3d.run();
6551 *   }
6552 *   else if (parameters.geom_type == "Ehlers_tube_increase_load")
6553 *   {
6554 *   VerificationEhlers1999IncreaseLoad<3> solid_3d(parameters);
6555 *   solid_3d.run();
6556 *   }
6557 *   else if (parameters.geom_type == "Ehlers_cube_consolidation")
6558 *   {
6559 *   VerificationEhlers1999CubeConsolidation<3> solid_3d(parameters);
6560 *   solid_3d.run();
6561 *   }
6562 *   else if (parameters.geom_type == "Franceschini_consolidation")
6563 *   {
6564 *   Franceschini2006Consolidation<3> solid_3d(parameters);
6565 *   solid_3d.run();
6566 *   }
6567 *   else if (parameters.geom_type == "Budday_cube_tension_compression")
6568 *   {
6569 *   BrainBudday2017CubeTensionCompression<3> solid_3d(parameters);
6570 *   solid_3d.run();
6571 *   }
6572 *   else if (parameters.geom_type == "Budday_cube_tension_compression_fully_fixed")
6573 *   {
6574 *   BrainBudday2017CubeTensionCompressionFullyFixed<3> solid_3d(parameters);
6575 *   solid_3d.run();
6576 *   }
6577 *   else if (parameters.geom_type == "Budday_cube_shear_fully_fixed")
6578 *   {
6579 *   BrainBudday2017CubeShearFullyFixed<3> solid_3d(parameters);
6580 *   solid_3d.run();
6581 *   }
6582 *   else
6583 *   {
6584 *   AssertThrow(false, ExcMessage("Problem type not defined. Current setting: " + parameters.geom_type));
6585 *   }
6586 *  
6587 *   }
6588 *   catch (std::exception &exc)
6589 *   {
6590 *   if (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD) == 0)
6591 *   {
6592 *   std::cerr << std::endl << std::endl
6593 *   << "----------------------------------------------------"
6594 *   << std::endl;
6595 *   std::cerr << "Exception on processing: " << std::endl << exc.what()
6596 *   << std::endl << "Aborting!" << std::endl
6597 *   << "----------------------------------------------------"
6598 *   << std::endl;
6599 *  
6600 *   return 1;
6601 *   }
6602 *   }
6603 *   catch (...)
6604 *   {
6605 *   if (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD) == 0)
6606 *   {
6607 *   std::cerr << std::endl << std::endl
6608 *   << "----------------------------------------------------"
6609 *   << std::endl;
6610 *   std::cerr << "Unknown exception!" << std::endl << "Aborting!"
6611 *   << std::endl
6612 *   << "----------------------------------------------------"
6613 *   << std::endl;
6614 *   return 1;
6615 *   }
6616 *   }
6617 *   return 0;
6618 *   }
6619 * @endcode
6620
6621
6622*/
Definition fe_q.h:554
Definition point.h:111
@ wall_times
Definition timer.h:651
void reinit(const Vector &v, const bool omit_zeroing_entries=false, const bool allow_different_maps=false)
DerivativeForm< 1, spacedim, dim, Number > transpose(const DerivativeForm< 1, dim, spacedim, Number > &DF)
Point< 2 > second
Definition grid_out.cc:4624
Point< 2 > first
Definition grid_out.cc:4623
#define Assert(cond, exc)
#define AssertDimension(dim1, dim2)
#define AssertThrow(cond, exc)
typename ActiveSelector::active_cell_iterator active_cell_iterator
LinearOperator< Range, Domain, Payload > linear_operator(const OperatorExemplar &, const Matrix &)
void loop(IteratorType begin, std_cxx20::type_identity_t< IteratorType > end, DOFINFO &dinfo, INFOBOX &info, const std::function< void(std_cxx20::type_identity_t< DOFINFO > &, typename INFOBOX::CellInfo &)> &cell_worker, const std::function< void(std_cxx20::type_identity_t< DOFINFO > &, typename INFOBOX::CellInfo &)> &boundary_worker, const std::function< void(std_cxx20::type_identity_t< DOFINFO > &, std_cxx20::type_identity_t< DOFINFO > &, typename INFOBOX::CellInfo &, typename INFOBOX::CellInfo &)> &face_worker, AssemblerType &assembler, const LoopControl &lctrl=LoopControl())
Definition loop.h:564
void make_sparsity_pattern(const DoFHandler< dim, spacedim > &dof_handler, SparsityPatternBase &sparsity_pattern, const AffineConstraints< number > &constraints={}, const bool keep_constrained_dofs=true, const types::subdomain_id subdomain_id=numbers::invalid_subdomain_id)
UpdateFlags
@ update_values
Shape function values.
@ update_normal_vectors
Normal vectors.
@ update_JxW_values
Transformed quadrature weights.
@ update_gradients
Shape function gradients.
@ update_quadrature_points
Transformed quadrature points.
std::vector< index_type > data
Definition mpi.cc:735
std::size_t size
Definition mpi.cc:734
const Event initial
Definition event.cc:64
void approximate(const SynchronousIterators< std::tuple< typename DoFHandler< dim, spacedim >::active_cell_iterator, Vector< float >::iterator > > &cell, const Mapping< dim, spacedim > &mapping, const DoFHandler< dim, spacedim > &dof_handler, const InputVector &solution, const unsigned int component)
void component_wise(DoFHandler< dim, spacedim > &dof_handler, const std::vector< unsigned int > &target_component=std::vector< unsigned int >())
void Cuthill_McKee(DoFHandler< dim, spacedim > &dof_handler, const bool reversed_numbering=false, const bool use_constraints=false, const std::vector< types::global_dof_index > &starting_indices=std::vector< types::global_dof_index >())
std::vector< IndexSet > locally_owned_dofs_per_subdomain(const DoFHandler< dim, spacedim > &dof_handler)
std::vector< types::global_dof_index > count_dofs_per_fe_block(const DoFHandler< dim, spacedim > &dof, const std::vector< unsigned int > &target_block=std::vector< unsigned int >())
std::vector< IndexSet > locally_relevant_dofs_per_subdomain(const DoFHandler< dim, spacedim > &dof_handler)
unsigned int count_dofs_with_subdomain_association(const DoFHandler< dim, spacedim > &dof_handler, const types::subdomain_id subdomain)
void scale(const double scaling_factor, Triangulation< dim, spacedim > &triangulation)
unsigned int count_cells_with_subdomain_association(const Triangulation< dim, spacedim > &triangulation, const types::subdomain_id subdomain)
double volume(const Triangulation< dim, spacedim > &tria)
@ valid
Iterator points to a valid object.
@ matrix
Contents is actually a matrix.
@ diagonal
Matrix is diagonal.
void cell_matrix(FullMatrix< double > &M, const FEValuesBase< dim > &fe, const FEValuesBase< dim > &fetest, const ArrayView< const std::vector< double > > &velocity, const double factor=1.)
Definition advection.h:74
double norm(const FEValuesBase< dim > &fe, const ArrayView< const std::vector< Tensor< 1, dim > > > &Du)
Definition divergence.h:471
std::enable_if_t< IsBlockVector< VectorType >::value, unsigned int > n_blocks(const VectorType &vector)
Definition operators.h:49
Point< spacedim > point(const gp_Pnt &p, const double tolerance=1e-10)
Definition utilities.cc:191
SymmetricTensor< 2, dim, Number > C(const Tensor< 2, dim, Number > &F)
SymmetricTensor< 2, dim, Number > e(const Tensor< 2, dim, Number > &F)
SymmetricTensor< 2, dim, Number > b(const Tensor< 2, dim, Number > &F)
SymmetricTensor< 2, dim, Number > d(const Tensor< 2, dim, Number > &F, const Tensor< 2, dim, Number > &dF_dt)
Tensor< 2, dim, Number > F(const Tensor< 2, dim, Number > &Grad_u)
constexpr ReturnType< rank, T >::value_type & extract(T &t, const ArrayType &indices)
VectorType::value_type * end(VectorType &V)
T sum(const T &t, const MPI_Comm mpi_communicator)
unsigned int n_mpi_processes(const MPI_Comm mpi_communicator)
Definition mpi.cc:92
unsigned int this_mpi_process(const MPI_Comm mpi_communicator)
Definition mpi.cc:107
T reduce(const T &local_value, const MPI_Comm comm, const std::function< T(const T &, const T &)> &combiner, const unsigned int root_process=0)
void run(const Iterator &begin, const std_cxx20::type_identity_t< Iterator > &end, Worker worker, Copier copier, const ScratchData &sample_scratch_data, const CopyData &sample_copy_data, const unsigned int queue_length, const unsigned int chunk_size)
void abort(const ExceptionBase &exc) noexcept
bool check(const ConstraintKinds kind_in, const unsigned int dim)
long double gamma(const unsigned int n)
void copy(const T *begin, const T *end, U *dest)
int(&) functions(const void *v1, const void *v2)
void assemble(const MeshWorker::DoFInfoBox< dim, DOFINFO > &dinfo, A *assembler)
Definition loop.h:70
::VectorizedArray< Number, width > log(const ::VectorizedArray< Number, width > &)
::VectorizedArray< Number, width > exp(const ::VectorizedArray< Number, width > &)
::VectorizedArray< Number, width > sqrt(const ::VectorizedArray< Number, width > &)
::VectorizedArray< Number, width > pow(const ::VectorizedArray< Number, width > &, const Number p)
::VectorizedArray< Number, width > abs(const ::VectorizedArray< Number, width > &)
unsigned int material_id
Definition types.h:167
const ::parallel::distributed::Triangulation< dim, spacedim > * triangulation
DEAL_II_HOST constexpr Number determinant(const SymmetricTensor< 2, dim, Number > &)
DEAL_II_HOST constexpr SymmetricTensor< 2, dim, Number > symmetrize(const Tensor< 2, dim, Number > &t)
DEAL_II_HOST constexpr SymmetricTensor< 2, dim, Number > invert(const SymmetricTensor< 2, dim, Number > &)
std::array< std::pair< Number, Tensor< 1, dim, Number > >, dim > eigenvectors(const SymmetricTensor< 2, dim, Number > &T, const SymmetricTensorEigenvectorMethod method=SymmetricTensorEigenvectorMethod::ql_implicit_shifts)
DEAL_II_HOST constexpr SymmetricTensor< 4, dim, Number > outer_product(const SymmetricTensor< 2, dim, Number > &t1, const SymmetricTensor< 2, dim, Number > &t2)
SymmetricTensorEigenvectorMethod