155 * #include <deal.II/base/quadrature_lib.h>
156 * #include <deal.II/base/logstream.h>
157 * #include <deal.II/base/function.h>
158 * #include <deal.II/base/utilities.h>
160 * #include <deal.II/lac/block_vector.h>
161 * #include <deal.II/lac/full_matrix.h>
162 * #include <deal.II/lac/block_sparse_matrix.h>
163 * #include <deal.II/lac/solver_cg.h>
164 * #include <deal.II/lac/precondition.h>
165 * #include <deal.II/lac/affine_constraints.h>
167 * #include <deal.II/grid/tria.h>
168 * #include <deal.II/grid/grid_generator.h>
169 * #include <deal.II/grid/tria_accessor.h>
170 * #include <deal.II/grid/tria_iterator.h>
171 * #include <deal.II/grid/grid_tools.h>
172 * #include <deal.II/grid/manifold_lib.h>
173 * #include <deal.II/grid/grid_refinement.h>
174 * #include <deal.II/grid/grid_in.h>
176 * #include <deal.II/dofs/dof_handler.h>
177 * #include <deal.II/dofs/dof_renumbering.h>
178 * #include <deal.II/dofs/dof_accessor.h>
179 * #include <deal.II/dofs/dof_tools.h>
181 * #include <deal.II/fe/fe_q.h>
182 * #include <deal.II/fe/fe_system.h>
183 * #include <deal.II/fe/fe_values.h>
185 * #include <deal.II/numerics/vector_tools.h>
186 * #include <deal.II/numerics/matrix_tools.h>
187 * #include <deal.II/numerics/data_out.h>
188 * #include <deal.II/numerics/error_estimator.h>
189 * #include <deal.II/numerics/derivative_approximation.h>
190 * #include <deal.II/numerics/fe_field_function.h>
192 * #include <deal.II/lac/sparse_direct.h>
193 * #include <deal.II/lac/sparse_ilu.h>
195 * #include <iostream>
203 * #include <armadillo>
206 * #include
"../support_code/ellipsoid_grav.h"
207 * #include
"../support_code/ellipsoid_fit.h"
208 * #include
"../support_code/config_in.h"
212 * As in all programs, the
namespace dealii
220 *
using namespace arma;
223 *
struct InnerPreconditioner;
226 *
struct InnerPreconditioner<2>
232 *
struct InnerPreconditioner<3>
256 *
const double curl = (grad_u[1][0] - grad_u[0][1]);
260 *
const double t[2][2] = { {
cos(angle),
sin(angle) }, {
270 * Class
for remembering material state/properties at each quadrature
point
277 *
struct PointHistory
280 *
double old_phiphi_stress;
288 * Primary
class of this problem
295 *
class StokesProblem
298 * StokesProblem(
const unsigned int degree);
303 *
void assemble_system();
305 *
void output_results()
const;
306 *
void refine_mesh();
307 *
void solution_stesses();
308 *
void smooth_eta_field(std::vector<bool> failing_cells);
310 *
void setup_initial_mesh();
311 *
void do_elastic_steps();
312 *
void do_flow_step();
313 *
void update_time_interval();
314 *
void initialize_eta_and_G();
316 *
void do_ellipse_fits();
317 *
void append_physical_times(
int max_plastic);
318 *
void write_vertices(
unsigned char);
320 *
void setup_quadrature_point_history();
321 *
void update_quadrature_point_history();
323 *
const unsigned int degree;
329 *
unsigned int n_u = 0, n_p = 0;
330 *
unsigned int plastic_iteration = 0;
331 *
unsigned int last_max_plasticity = 0;
334 * std::vector< std::vector <Vector<double> > > quad_viscosities;
335 * std::vector<double> cell_viscosities;
336 * std::vector<PointHistory<dim> > quadrature_point_history;
346 * std::shared_ptr<typename InnerPreconditioner<dim>::type> A_preconditioner;
348 * ellipsoid_fit<dim> ellipsoid;
353 * Class
for boundary conditions and rhs
360 *
class BoundaryValuesP:
public Function<dim>
363 * BoundaryValuesP() :
369 * const unsigned
int component = 0) const override;
375 *
double BoundaryValuesP<dim>::value(
const Point<dim> &p,
376 *
const unsigned int component)
const
378 *
Assert(component < this->n_components,
379 * ExcIndexRange (component, 0, this->n_components));
383 *
Assert(p[0] >= -10.0, ExcLowerRangeType<double>(p[0], -10.0));
389 *
void BoundaryValuesP<dim>::vector_value(
const Point<dim> &p,
392 *
for (
unsigned int c = 0; c < this->n_components; ++c)
393 * values(c) = BoundaryValuesP<dim>::value(p, c);
397 *
class RightHandSide:
public Function<dim>
400 * RightHandSide () :
Function<dim>(dim+1) {}
406 *
virtual double value(
const Point<dim> &p,
const unsigned int component,
407 * A_Grav_namespace::AnalyticGravity<dim> *aGrav)
const;
410 * A_Grav_namespace::AnalyticGravity<dim> *aGrav)
const;
414 * A_Grav_namespace::AnalyticGravity<dim> *aGrav)
const;
419 *
double RightHandSide<dim>::value(
const Point<dim> &p,
420 *
const unsigned int component,
421 * A_Grav_namespace::AnalyticGravity<dim> *aGrav)
const
424 * std::vector<double> temp_vector(2);
425 * aGrav->get_gravity(p, temp_vector);
427 *
if (component == 0)
429 *
return temp_vector[0] + system_parameters::omegasquared * p[0];
433 *
if (component == 1)
434 *
return temp_vector[1];
441 *
void RightHandSide<dim>::vector_value(
const Point<dim> &p,
443 * A_Grav_namespace::AnalyticGravity<dim> *aGrav)
const
445 *
for (
unsigned int c = 0; c < this->n_components; ++c)
446 * values(c) = RightHandSide<dim>::value(p, c, aGrav);
450 *
void RightHandSide<dim>::vector_value_list(
453 * A_Grav_namespace::AnalyticGravity<dim> *aGrav)
const
457 *
check whether component is in
458 * the
valid range is up to the
462 *
Assert(values.size() == points.size(),
463 * ExcDimensionMismatch(values.size(), points.size()));
465 *
for (
unsigned int i = 0; i < points.size(); ++i)
466 * this->vector_value(points[i], values[i], aGrav);
471 * Class
for linear solvers and preconditioners
477 *
template<
class Matrix,
class Preconditioner>
481 * InverseMatrix(
const Matrix &m,
const Preconditioner &preconditioner);
490 *
template<
class Matrix,
class Preconditioner>
491 * InverseMatrix<Matrix, Preconditioner>::InverseMatrix(
const Matrix &m,
492 *
const Preconditioner &preconditioner) :
493 *
matrix(&m), preconditioner(&preconditioner)
497 * template<class Matrix, class Preconditioner>
498 * void InverseMatrix<Matrix, Preconditioner>::vmult(
Vector<double> &dst,
499 * const
Vector<double> &src) const
507 * cg.solve(*matrix, dst, src, *preconditioner);
512 * Class
for the SchurComplement
518 *
template<
class Preconditioner>
534 *
template<
class Preconditioner>
535 * SchurComplement<Preconditioner>::SchurComplement(
538 * system_matrix(&system_matrix), A_inverse(&A_inverse), tmp1(
539 * system_matrix.block(0, 0).m()), tmp2(
540 * system_matrix.block(0, 0).m())
544 * template<class Preconditioner>
545 * void SchurComplement<Preconditioner>::vmult(
Vector<double> &dst,
546 * const
Vector<double> &src) const
548 * system_matrix->block(0, 1).vmult(tmp1, src);
549 * A_inverse->vmult(tmp2, tmp1);
550 * system_matrix->block(1, 0).vmult(dst, tmp2);
555 * StokesProblem::StokesProblem
562 * StokesProblem<dim>::StokesProblem(
const unsigned int degree) :
566 * fe(
FE_Q<dim>(degree + 1), dim,
FE_Q<dim>(degree), 1),
568 * quadrature_formula(degree + 2),
581 * void StokesProblem<dim>::setup_dofs()
583 * A_preconditioner.reset();
584 * system_matrix.clear();
586 * dof_handler.distribute_dofs(fe);
589 * std::vector<unsigned int> block_component(dim + 1, 0);
590 * block_component[dim] = 1;
595 * ========================================Apply Boundary Conditions=====================================
599 * constraints.clear();
600 * std::vector<bool> component_maskP(dim + 1,
false);
601 * component_maskP[dim] =
true;
604 * BoundaryValuesP<dim>(), constraints, component_maskP);
607 * std::set<types::boundary_id> no_normal_flux_boundaries;
608 * no_normal_flux_boundaries.insert(99);
610 * no_normal_flux_boundaries, constraints);
613 * constraints.close();
616 * n_u = dofs_per_block[0];
617 * n_p = dofs_per_block[1];
620 * << std::endl <<
" Number of degrees of freedom: "
621 * << dof_handler.n_dofs() <<
" (" << n_u <<
'+' << n_p <<
')'
627 * csp.block(0, 0).reinit(n_u, n_u);
628 * csp.block(1, 0).reinit(n_p, n_u);
629 * csp.block(0, 1).reinit(n_u, n_p);
630 * csp.block(1, 1).reinit(n_p, n_p);
632 * csp.collect_sizes();
635 * sparsity_pattern.copy_from(csp);
638 * system_matrix.reinit(sparsity_pattern);
640 * solution.reinit(2);
641 * solution.block(0).reinit(n_u);
642 * solution.block(1).reinit(n_p);
643 * solution.collect_sizes();
645 * system_rhs.reinit(2);
646 * system_rhs.block(0).reinit(n_u);
647 * system_rhs.block(1).reinit(n_p);
648 * system_rhs.collect_sizes();
664 *
double get_eta(
double &r,
double &z);
665 *
double get_G(
unsigned int mat_id);
668 * std::vector<double> get_manual_eta_profile();
673 * std::vector<double> Rheology<dim>::get_manual_eta_profile()
675 * vector<double> etas;
677 *
for (
unsigned int i=0; i < system_parameters::sizeof_depths_eta; ++i)
679 * etas.push_back(system_parameters::depths_eta[i]);
680 * etas.push_back(system_parameters::eta_kinks[i]);
686 *
double Rheology<dim>::get_eta(
double &r,
double &z)
690 * compute local
depth
693 *
double ecc = system_parameters::q_axes[0] / system_parameters::p_axes[0];
694 *
double Rminusr = system_parameters::q_axes[0] - system_parameters::p_axes[0];
695 *
double approx_a =
std::sqrt(r * r + z * z * ecc * ecc);
696 *
double group1 = r * r + z * z - Rminusr * Rminusr;
698 *
double a0 = approx_a;
699 *
double error = 10000;
702 * While
loop finds the a axis of the
"isodepth" ellipse
for which the input
point is on the surface.
703 * An
"isodepth" ellipse is defined as one whose axes a,
b are related to the global axes A, B by: A-h = B-h
709 *
if ((r > system_parameters::q_axes[0] - system_parameters::depths_eta.back()) ||
710 * (z > system_parameters::p_axes[0] - system_parameters::depths_eta.back()))
714 *
while (error >= eps)
716 *
double a02 = a0 * a0;
717 *
double a03 = a0 * a02;
718 *
double a04 = a0 * a03;
719 *
double fofa = a04 - (2 * Rminusr * a03) - (group1 * a02)
720 * + (2 * r * r * Rminusr * a0) - (r * r * Rminusr * Rminusr);
721 *
double fprimeofa = 4 * a03 - (6 * Rminusr * a02) - (2 * group1 * a0)
722 * + (2 * r * r * Rminusr);
723 *
double deltaa = -fofa / fprimeofa;
728 * cout <<
"error = " << error << endl;
738 *
double local_depth = system_parameters::q_axes[0] - a0;
739 *
if (local_depth < 0)
742 *
if (local_depth > system_parameters::depths_eta.back())
744 *
if (system_parameters::eta_kinks.back() < system_parameters::eta_floor)
745 *
return system_parameters::eta_floor;
746 *
else if (system_parameters::eta_kinks.back() > system_parameters::eta_ceiling)
747 *
return system_parameters::eta_ceiling;
749 *
return system_parameters::eta_kinks.back();
752 * std::vector<double> viscosity_function = get_manual_eta_profile();
754 *
unsigned int n_visc_kinks = viscosity_function.size() / 2;
758 * find the correct interval to
do the interpolation in
761 *
int n_minus_one = -1;
762 *
for (
unsigned int n = 1; n <= n_visc_kinks; ++n)
764 *
unsigned int ndeep = 2 * n - 2;
765 *
unsigned int nshallow = 2 * n;
766 *
if (local_depth >= viscosity_function[ndeep] && local_depth <= viscosity_function[nshallow])
767 * n_minus_one = ndeep;
772 * find the viscosity interpolation
775 *
if (n_minus_one == -1)
776 *
return system_parameters::eta_ceiling;
779 *
double visc_exponent =
780 * (viscosity_function[n_minus_one]
782 * / (viscosity_function[n_minus_one]
783 * - viscosity_function[n_minus_one + 2]);
784 *
double visc_base = viscosity_function[n_minus_one + 3]
785 * / viscosity_function[n_minus_one + 1];
788 * This is the
true viscosity given the thermal profile
791 *
double true_eta = viscosity_function[n_minus_one + 1] *
std::pow(visc_base, visc_exponent);
795 * Implement latitude-dependence viscosity
798 *
if (system_parameters::lat_dependence)
800 *
double lat = 180 / PI *
std::atan(z / r);
805 *
double taper_depth = 40000;
806 *
double surface_taper = (taper_depth - local_depth) / taper_depth;
807 *
if (surface_taper < 0)
809 *
double log_eta_contrast = surface_taper * system_parameters::eta_Ea * 52.5365 * (T_eq - T_surf) / T_eq / T_surf;
810 * true_eta *=
std::pow(10, log_eta_contrast);
813 *
if (true_eta > system_parameters::eta_ceiling)
814 *
return system_parameters::eta_ceiling;
815 *
else if (true_eta < system_parameters::eta_floor)
816 *
return system_parameters::eta_floor;
824 *
double Rheology<dim>::get_G(
unsigned int mat_id)
826 *
return system_parameters::G[mat_id];
832 * Initialize the eta and G parts of the quadrature_point_history
object
839 *
void StokesProblem<dim>::initialize_eta_and_G()
843 *
const unsigned int n_q_points = quadrature_formula.size();
844 * Rheology<dim> rheology;
847 * dof_handler.begin_active(); cell != dof_handler.end(); ++cell)
849 * PointHistory<dim> *local_quadrature_points_history =
850 *
reinterpret_cast<PointHistory<dim> *
>(cell->user_pointer());
852 * local_quadrature_points_history >= &quadrature_point_history.front(),
853 * ExcInternalError());
855 * local_quadrature_points_history < &quadrature_point_history.back(),
856 * ExcInternalError());
857 * fe_values.reinit(cell);
859 *
for (
unsigned int q = 0; q < n_q_points; ++q)
862 *
double r_value = fe_values.quadrature_point(q)[0];
863 *
double z_value = fe_values.quadrature_point(q)[1];
867 * defines local viscosity
870 *
double local_viscosity = 0;
872 * local_viscosity = rheology.get_eta(r_value, z_value);
874 * local_quadrature_points_history[q].first_eta = local_viscosity;
875 * local_quadrature_points_history[q].new_eta = local_viscosity;
879 * defines local shear modulus
882 *
double local_G = 0;
884 *
unsigned int mat_id = cell->material_id();
886 * local_G = rheology.get_G(mat_id);
887 * local_quadrature_points_history[q].G = local_G;
891 * initializes the phi-phi stress
894 * local_quadrature_points_history[q].old_phiphi_stress = 0;
901 * ====================== ASSEMBLE THE SYSTEM ======================
908 *
void StokesProblem<dim>::assemble_system()
917 *
const unsigned int dofs_per_cell = fe.dofs_per_cell;
919 *
const unsigned int n_q_points = quadrature_formula.size();
924 * std::vector<types::global_dof_index> local_dof_indices(dofs_per_cell);
928 * runs the gravity script function
931 *
const RightHandSide<dim> right_hand_side;
933 * A_Grav_namespace::AnalyticGravity<dim> *aGrav =
934 *
new A_Grav_namespace::AnalyticGravity<dim>;
935 * std::vector<double> grav_parameters;
936 * grav_parameters.push_back(system_parameters::q_axes[system_parameters::present_timestep * 2 + 0]);
937 * grav_parameters.push_back(system_parameters::p_axes[system_parameters::present_timestep * 2 + 0]);
938 * grav_parameters.push_back(system_parameters::q_axes[system_parameters::present_timestep * 2 + 1]);
939 * grav_parameters.push_back(system_parameters::p_axes[system_parameters::present_timestep * 2 + 1]);
940 * grav_parameters.push_back(system_parameters::rho[0]);
941 * grav_parameters.push_back(system_parameters::rho[1]);
943 * std::cout <<
"Body parameters are: " ;
944 *
for (
int i=0; i<6; ++i)
945 * std::cout << grav_parameters[i] <<
" ";
948 * aGrav->setup_vars(grav_parameters);
950 * std::vector<Vector<double> > rhs_values(n_q_points,
956 * std::vector<SymmetricTensor<2, dim> > phi_grads_u(dofs_per_cell);
957 * std::vector<double> div_phi_u(dofs_per_cell);
958 * std::vector<Tensor<1, dim> > phi_u(dofs_per_cell);
959 * std::vector<double> phi_p(dofs_per_cell);
962 * dof_handler.begin_active(), first_cell = dof_handler.begin_active(),
963 * endc = dof_handler.end();
965 *
for (; cell != endc; ++cell)
967 * PointHistory<dim> *local_quadrature_points_history =
968 *
reinterpret_cast<PointHistory<dim> *
>(cell->user_pointer());
970 * local_quadrature_points_history >= &quadrature_point_history.front(),
971 * ExcInternalError());
973 * local_quadrature_points_history < &quadrature_point_history.back(),
974 * ExcInternalError());
976 *
double cell_area = cell->measure();
979 * append_physical_times(-1);
982 * ExcInternalError());
985 *
unsigned int m_id = cell->material_id();
989 * initializes the rhs vector to the correct g values
992 * fe_values.reinit(cell);
993 * right_hand_side.vector_value_list(fe_values.get_quadrature_points(),
994 * rhs_values, aGrav);
996 * std::vector<Vector<double> > new_viscosities(quadrature_formula.size(),
Vector<double>(dim + 1));
1000 * Finds
vertices where the radius is zero DIM
1003 *
bool is_singular =
false;
1004 *
for (
unsigned int f = 0; f < GeometryInfo<dim>::faces_per_cell; ++f)
1005 *
if (cell->face(f)->center()[0] == 0)
1006 * is_singular =
true;
1008 *
if (is_singular ==
false || system_parameters::cylindrical ==
false)
1015 * ===== outputs the local gravity
1018 * std::vector<Point<dim> > quad_points_list(n_q_points);
1019 * quad_points_list = fe_values.get_quadrature_points();
1021 *
if (plastic_iteration
1022 * == (system_parameters::max_plastic_iterations - 1))
1024 *
if (cell != first_cell)
1026 * std::ofstream fout(
"gravity_field.txt", std::ios::app);
1027 * fout << quad_points_list[0] <<
" " << rhs_values[0];
1032 * std::ofstream fout(
"gravity_field.txt");
1033 * fout << quad_points_list[0] <<
" " << rhs_values[0];
1038 *
for (
unsigned int q = 0; q < n_q_points; ++q)
1041 * local_quadrature_points_history[q].old_stress;
1042 *
double &local_old_phiphi_stress =
1043 * local_quadrature_points_history[q].old_phiphi_stress;
1044 *
double r_value = fe_values.quadrature_point(q)[0];
1048 * get local density based on mat
id
1051 *
double local_density = system_parameters::rho[m_id];
1055 * defines local viscosities
1058 *
double local_viscosity = 0;
1059 *
if (plastic_iteration == 0)
1060 * local_viscosity = local_quadrature_points_history[q].first_eta;
1062 * local_viscosity = local_quadrature_points_history[q].new_eta;
1066 * Define the local viscoelastic constants
1069 *
double local_eta_ve = 2
1070 * / ((1 / local_viscosity)
1071 * + (1 / local_quadrature_points_history[q].G
1072 * / system_parameters::current_time_interval));
1073 *
double local_chi_ve = 1
1075 * + (local_quadrature_points_history[q].G
1076 * * system_parameters::current_time_interval
1077 * / local_viscosity));
1079 *
for (
unsigned int k = 0; k < dofs_per_cell; ++k)
1081 * phi_grads_u[k] = fe_values[velocities].symmetric_gradient(k,
1083 * div_phi_u[k] = (fe_values[velocities].divergence(k, q));
1084 * phi_u[k] = (fe_values[velocities].value(k, q));
1085 *
if (system_parameters::cylindrical ==
true)
1087 * div_phi_u[k] *= (r_value);
1088 * div_phi_u[k] += (phi_u[k][0]);
1090 * phi_p[k] = fe_values[pressure].value(k, q);
1093 *
for (
unsigned int i = 0; i < dofs_per_cell; ++i)
1095 *
for (
unsigned int j = 0; j <= i; ++j)
1097 *
if (system_parameters::cylindrical ==
true)
1099 * local_matrix(i, j) += (phi_grads_u[i]
1100 * * phi_grads_u[j] * 2 * local_eta_ve
1102 * + 2 * phi_u[i][0] * phi_u[j][0]
1103 * * local_eta_ve / r_value
1104 * - div_phi_u[i] * phi_p[j]
1105 * * system_parameters::pressure_scale
1106 * - phi_p[i] * div_phi_u[j]
1107 * * system_parameters::pressure_scale
1108 * + phi_p[i] * phi_p[j] * r_value
1109 * * system_parameters::pressure_scale)
1110 * * fe_values.JxW(q);
1114 * local_matrix(i, j) += (phi_grads_u[i]
1115 * * phi_grads_u[j] * 2 * local_eta_ve
1116 * - div_phi_u[i] * phi_p[j]
1117 * * system_parameters::pressure_scale
1118 * - phi_p[i] * div_phi_u[j]
1119 * * system_parameters::pressure_scale
1120 * + phi_p[i] * phi_p[j]) * fe_values.JxW(q);
1123 *
if (system_parameters::cylindrical ==
true)
1125 *
const unsigned int component_i =
1126 * fe.system_to_component_index(i).first;
1127 * local_rhs(i) += (fe_values.shape_value(i, q)
1128 * * rhs_values[q](component_i) * r_value
1130 * - local_chi_ve * phi_grads_u[i] * old_stress
1132 * - local_chi_ve * phi_u[i][0]
1133 * * local_old_phiphi_stress)
1134 * * fe_values.JxW(q);
1138 *
const unsigned int component_i =
1139 * fe.system_to_component_index(i).first;
1140 * local_rhs(i) += fe_values.shape_value(i, q)
1141 * * rhs_values[q](component_i) * fe_values.JxW(q)
1154 * ===== outputs the local gravity
1157 * std::vector<Point<dim> > quad_points_list(n_q_points);
1158 * quad_points_list = fe_values.get_quadrature_points();
1160 *
for (
unsigned int q = 0; q < n_q_points; ++q)
1163 * local_quadrature_points_history[q].old_stress;
1164 *
double &local_old_phiphi_stress =
1165 * local_quadrature_points_history[q].old_phiphi_stress;
1166 *
double r_value = fe_values.quadrature_point(q)[0];
1168 *
double local_density = system_parameters::rho[m_id];
1172 * defines local viscosities
1175 *
double local_viscosity = 0;
1176 *
if (plastic_iteration == 0)
1178 * local_viscosity = local_quadrature_points_history[q].first_eta;
1181 * local_viscosity = local_quadrature_points_history[q].new_eta;
1185 * Define the local viscoelastic constants
1188 *
double local_eta_ve = 2
1189 * / ((1 / local_viscosity)
1190 * + (1 / local_quadrature_points_history[q].G
1191 * / system_parameters::current_time_interval));
1192 *
double local_chi_ve = 1
1194 * + (local_quadrature_points_history[q].G
1195 * * system_parameters::current_time_interval
1196 * / local_viscosity));
1198 *
for (
unsigned int k = 0; k < dofs_per_cell; ++k)
1200 * phi_grads_u[k] = fe_values[velocities].symmetric_gradient(k,
1202 * div_phi_u[k] = (fe_values[velocities].divergence(k, q));
1203 * phi_u[k] = (fe_values[velocities].value(k, q));
1204 *
if (system_parameters::cylindrical ==
true)
1206 * div_phi_u[k] *= (r_value);
1207 * div_phi_u[k] += (phi_u[k][0]);
1209 * phi_p[k] = fe_values[pressure].value(k, q);
1212 *
for (
unsigned int i = 0; i < dofs_per_cell; ++i)
1214 *
for (
unsigned int j = 0; j <= i; ++j)
1216 *
if (system_parameters::cylindrical ==
true)
1218 * local_matrix(i, j) += (phi_grads_u[i]
1219 * * phi_grads_u[j] * 2 * local_eta_ve
1221 * + 2 * phi_u[i][0] * phi_u[j][0]
1222 * * local_eta_ve / r_value
1223 * - div_phi_u[i] * phi_p[j]
1224 * * system_parameters::pressure_scale
1225 * - phi_p[i] * div_phi_u[j]
1226 * * system_parameters::pressure_scale
1227 * + phi_p[i] * phi_p[j] * r_value
1228 * * system_parameters::pressure_scale)
1229 * * fe_values.JxW(q);
1233 * local_matrix(i, j) += (phi_grads_u[i]
1234 * * phi_grads_u[j] * 2 * local_eta_ve
1235 * - div_phi_u[i] * phi_p[j]
1236 * * system_parameters::pressure_scale
1237 * - phi_p[i] * div_phi_u[j]
1238 * * system_parameters::pressure_scale
1239 * + phi_p[i] * phi_p[j]) * fe_values.JxW(q);
1242 *
if (system_parameters::cylindrical ==
true)
1244 *
const unsigned int component_i =
1245 * fe.system_to_component_index(i).first;
1246 * local_rhs(i) += (fe_values.shape_value(i, q)
1247 * * rhs_values[q](component_i) * r_value
1249 * - local_chi_ve * phi_grads_u[i] * old_stress
1251 * - local_chi_ve * phi_u[i][0]
1252 * * local_old_phiphi_stress)
1253 * * fe_values.JxW(q);
1257 *
const unsigned int component_i =
1258 * fe.system_to_component_index(i).first;
1259 * local_rhs(i) += fe_values.shape_value(i, q)
1260 * * rhs_values[q](component_i) * fe_values.JxW(q)
1267 *
for (
unsigned int i = 0; i < dofs_per_cell; ++i)
1268 *
for (
unsigned int j = i + 1; j < dofs_per_cell; ++j)
1269 * local_matrix(i, j) = local_matrix(j, i);
1271 * cell->get_dof_indices(local_dof_indices);
1272 * constraints.distribute_local_to_global(local_matrix, local_rhs,
1273 * local_dof_indices, system_matrix, system_rhs);
1276 * std::cout <<
" Computing preconditioner..." << std::endl << std::flush;
1278 * A_preconditioner = std::shared_ptr<
1279 *
typename InnerPreconditioner<dim>::type>(
1280 *
new typename InnerPreconditioner<dim>::type());
1281 * A_preconditioner->initialize(system_matrix.block(0, 0),
1282 *
typename InnerPreconditioner<dim>::type::AdditionalData());
1289 * ====================== SOLVER ======================
1296 *
void StokesProblem<dim>::solve()
1298 *
const InverseMatrix<SparseMatrix<double>,
1299 *
typename InnerPreconditioner<dim>::type> A_inverse(
1300 * system_matrix.block(0, 0), *A_preconditioner);
1305 * A_inverse.vmult(tmp, system_rhs.block(0));
1306 * system_matrix.block(1, 0).vmult(schur_rhs, tmp);
1307 * schur_rhs -= system_rhs.block(1);
1309 * SchurComplement<typename InnerPreconditioner<dim>::type>
schur_complement(
1310 * system_matrix, A_inverse);
1312 *
int n_iterations = system_parameters::iteration_coefficient
1313 * * solution.block(1).size();
1314 *
double tolerance_goal = system_parameters::tolerance_coefficient
1315 * * schur_rhs.l2_norm();
1317 *
SolverControl solver_control(n_iterations, tolerance_goal);
1320 * std::cout <<
"\nMax iterations and tolerance are: " << n_iterations
1321 * <<
" and " << tolerance_goal << std::endl;
1324 * preconditioner.
initialize(system_matrix.block(1, 1),
1328 * system_matrix.block(1, 1), preconditioner);
1332 * constraints.distribute(solution);
1335 * std::cout <<
" " << solver_control.last_step()
1336 * <<
" outer CG Schur complement iterations for pressure"
1341 * system_matrix.block(0, 1).vmult(tmp, solution.block(1));
1343 * tmp += system_rhs.block(0);
1345 * A_inverse.vmult(solution.block(0), tmp);
1346 * constraints.distribute(solution);
1347 * solution.block(1) *= (system_parameters::pressure_scale);
1353 * ====================== OUTPUT RESULTS ======================
1357 *
void StokesProblem<dim>::output_results() const
1359 * std::vector < std::string > solution_names(dim,
"velocity");
1360 * solution_names.push_back(
"pressure");
1362 * std::vector<DataComponentInterpretation::DataComponentInterpretation> data_component_interpretation(
1364 * data_component_interpretation.push_back(
1369 * data_out.add_data_vector(solution, solution_names,
1371 * data_out.build_patches();
1373 * std::ostringstream filename;
1374 *
if (system_parameters::present_timestep < system_parameters::initial_elastic_iterations)
1376 * filename << system_parameters::output_folder <<
"/time"
1378 * <<
"_elastic_displacements" <<
".txt";
1382 * filename << system_parameters::output_folder <<
"/time"
1387 * std::ofstream output(filename.str().c_str());
1388 * data_out.write_gnuplot(output);
1393 * ====================== FIND AND WRITE TO FILE THE STRESS TENSOR; IMPLEMENT PLASTICITY ======================
1400 *
void StokesProblem<dim>::solution_stesses()
1404 * note most of
this section only works with dim=2
1408 * name the output text files
1411 * std::ostringstream stress_output;
1412 * stress_output << system_parameters::output_folder <<
"/time"
1416 * std::ofstream fout_snew(stress_output.str().c_str());
1417 * fout_snew.close();
1419 * std::ostringstream stresstensor_output;
1420 * stresstensor_output << system_parameters::output_folder <<
"/time"
1424 * std::ofstream fout_sfull(stresstensor_output.str().c_str());
1425 * fout_sfull.close();
1427 * std::ostringstream failed_cells_output;
1428 * failed_cells_output << system_parameters::output_folder <<
"/time"
1432 * std::ofstream fout_failed_cells(failed_cells_output.str().c_str());
1433 * fout_failed_cells.close();
1435 * std::ostringstream plastic_eta_output;
1436 * plastic_eta_output << system_parameters::output_folder <<
"/time"
1440 * std::ofstream fout_vrnew(plastic_eta_output.str().c_str());
1441 * fout_vrnew.close();
1443 * std::ostringstream initial_eta_output;
1444 *
if (plastic_iteration == 0)
1446 * initial_eta_output << system_parameters::output_folder <<
"/time"
1448 * <<
"_baseviscosities.txt";
1449 * std::ofstream fout_baseeta(initial_eta_output.str().c_str());
1450 * fout_baseeta.close();
1453 * std::cout <<
"Running stress calculations for plasticity iteration "
1454 * << plastic_iteration <<
"...\n";
1458 * This makes the
set of points at which the stress tensor is calculated
1461 * std::vector<Point<dim> > points_list(0);
1462 * std::vector<unsigned int> material_list(0);
1464 * dof_handler.begin_active(), endc = dof_handler.end();
1467 * This
loop gets the
gradients of the velocity field and saves it in the tensor_gradient_? objects DIM
1470 *
for (; cell != endc; ++cell)
1472 * points_list.push_back(cell->center());
1473 * material_list.push_back(cell->material_id());
1477 * Make the
FEValues object to evaluate values and derivatives at quadrature points
1485 * Make the
object that will hold the velocities and velocity
gradients at the quadrature points
1488 * std::vector < std::vector<Tensor<1, dim> >> velocity_grads(quadrature_formula.size(),
1490 * std::vector<Vector<double> > velocities(quadrature_formula.size(),
1494 * Make the
object to find rheology
1497 * Rheology<dim> rheology;
1501 * Write the solution flow velocity and derivative
for each cell
1504 * std::vector<Vector<double> > vector_values(0);
1505 * std::vector < std::vector<Tensor<1, dim> > > gradient_values(0);
1506 * std::vector<bool> failing_cells;
1509 * Write the stresses from the previous step into vectors
1512 * std::vector<SymmetricTensor<2, dim>> old_stress;
1513 * std::vector<double> old_phiphi_stress;
1514 * std::vector<double> cell_Gs;
1516 * dof_handler.begin_active(); cell != dof_handler.end(); ++cell)
1520 * Makes pointer to data in quadrature_point_history
1523 * PointHistory<dim> *local_quadrature_points_history =
1524 *
reinterpret_cast<PointHistory<dim> *
>(cell->user_pointer());
1526 * fe_values.reinit(cell);
1527 * fe_values.get_function_gradients(solution, velocity_grads);
1528 * fe_values.get_function_values(solution, velocities);
1530 * std::vector<Tensor<1, dim>> current_cell_grads(dim+1);
1532 * current_cell_old_stress = 0;
1533 *
double current_cell_old_phiphi_stress = 0;
1534 *
double cell_area = 0;
1538 * Averages across each cell to find
mean velocities,
gradients, and old stresses
1541 *
for (
unsigned int q = 0; q < quadrature_formula.size(); ++q)
1543 * cell_area += fe_values.JxW(q);
1544 * velocities[q] *= fe_values.JxW(q);
1545 * current_cell_velocity += velocities[q];
1546 *
for (
unsigned int i = 0; i < (dim+1); ++i)
1548 * velocity_grads[q][i] *= fe_values.JxW(q);
1549 * current_cell_grads[i] += velocity_grads[q][i];
1551 * current_cell_old_stress += local_quadrature_points_history[q].old_stress * fe_values.JxW(q);
1552 * current_cell_old_phiphi_stress += local_quadrature_points_history[q].old_phiphi_stress * fe_values.JxW(q);
1554 * current_cell_velocity /= cell_area;
1555 *
for (
unsigned int i = 0; i < (dim+1); ++i)
1556 * current_cell_grads[i] /= cell_area;
1557 * current_cell_old_stress /= cell_area;
1558 * current_cell_old_phiphi_stress /= cell_area;
1560 * vector_values.push_back(current_cell_velocity);
1561 * gradient_values.push_back(current_cell_grads);
1562 * old_stress.push_back(current_cell_old_stress);
1563 * old_phiphi_stress.push_back(current_cell_old_phiphi_stress);
1567 * Get cell shear modulus: assumes it
's constant for the cell
1570 * unsigned int mat_id = cell->material_id();
1571 * double local_G = rheology.get_G(mat_id);
1572 * cell_Gs.push_back(local_G);
1577 * tracks where failure occurred
1580 * std::vector<double> reduction_factor;
1581 * unsigned int total_fails = 0;
1582 * if (plastic_iteration == 0)
1583 * cell_viscosities.resize(0);
1586 * loop across all the cells to find and adjust eta of failing cells
1589 * for (unsigned int i = 0; i < triangulation.n_active_cells(); ++i)
1591 * double current_cell_viscosity = 0;
1595 * Fill viscosities vector, analytically if plastic_iteration == 0 and from previous viscosities for later iteration
1598 * if (plastic_iteration == 0)
1600 * double local_viscosity;
1601 * local_viscosity = rheology.get_eta(points_list[i][0], points_list[i][1]);
1602 * current_cell_viscosity = local_viscosity;
1603 * cell_viscosities.push_back(current_cell_viscosity);
1607 * current_cell_viscosity = cell_viscosities[i];
1611 * double cell_eta_ve = 2
1612 * / ((1 / current_cell_viscosity)
1614 * / system_parameters::current_time_interval));
1615 * double cell_chi_ve = 1
1618 * * system_parameters::current_time_interval
1619 * / current_cell_viscosity));
1623 * find local pressure
1626 * double cell_p = vector_values[i].operator()(2);
1629 * find stresses tensor
1630 * makes non-diagonalized local matrix A
1633 * double sigma13 = 0.5
1634 * * (gradient_values[i][0][1] + gradient_values[i][1][0]);
1636 * A << gradient_values[i][0][0] << 0 << sigma13 << endr
1637 * << 0 << vector_values[i].operator()(0) / points_list[i].operator()(0)<< 0 << endr
1638 * << sigma13 << 0 << gradient_values[i][1][1] << endr;
1640 * olddevstress << old_stress[i][0][0] << 0 << old_stress[i][0][1] << endr
1641 * << 0 << old_phiphi_stress[i] << 0 << endr
1642 * << old_stress[i][0][1] << 0 << old_stress[i][1][1] << endr;
1644 * P << cell_p << cell_p << cell_p;
1645 * mat Pmat = diagmat(P);
1647 * B = (cell_eta_ve * A + cell_chi_ve * olddevstress) - Pmat;
1651 * finds principal stresses
1656 * eig_sym(eigval, eigvec, B);
1657 * double sigma1 = -min(eigval);
1658 * double sigma3 = -max(eigval);
1662 * Writes text files for principal stresses, full stress tensor, base viscosities
1665 * std::ofstream fout_snew(stress_output.str().c_str(), std::ios::app);
1666 * fout_snew << " " << sigma1 << " " << sigma3 << "\n";
1667 * fout_snew.close();
1669 * std::ofstream fout_sfull(stresstensor_output.str().c_str(), std::ios::app);
1670 * fout_sfull << A(0,0) << " " << A(1,1) << " " << A(2,2) << " " << A(0,2) << "\n";
1671 * fout_sfull.close();
1673 * if (plastic_iteration == 0)
1675 * std::ofstream fout_baseeta(initial_eta_output.str().c_str(), std::ios::app);
1676 * fout_baseeta << points_list[i]<< " " << current_cell_viscosity << "\n";
1677 * fout_baseeta.close();
1682 * Finds adjusted effective viscosity
1685 * if (system_parameters::plasticity_on)
1687 * if (system_parameters::failure_criterion == 0) //Apply Byerlee's rule
1689 *
if (sigma1 >= 5 * sigma3)
1691 * failing_cells.push_back(
true);
1692 *
double temp_reductionfactor = 1;
1694 * temp_reductionfactor = 100;
1696 * temp_reductionfactor = 1.9 * sigma1 / 5 / sigma3;
1698 * reduction_factor.push_back(temp_reductionfactor);
1703 * Text file of all failure locations
1706 * std::ofstream fout_failed_cells(failed_cells_output.str().c_str(), std::ios::app);
1707 * fout_failed_cells << points_list[i] <<
"\n";
1708 * fout_failed_cells.close();
1712 * reduction_factor.push_back(1);
1713 * failing_cells.push_back(
false);
1718 *
if (system_parameters::failure_criterion == 1)
1720 *
double temp_reductionfactor = 1;
1721 *
if (sigma3 < -114037)
1725 * std::cout <<
" ext ";
1728 * failing_cells.push_back(
true);
1729 * temp_reductionfactor = 10;
1730 * reduction_factor.push_back(temp_reductionfactor);
1735 * Text file of all failure locations
1738 * std::ofstream fout_failed_cells(failed_cells_output.str().c_str(), std::ios::app);
1739 * fout_failed_cells << points_list[i] <<
"\n";
1740 * fout_failed_cells.close();
1744 *
double sigma_c = 160e6;
1745 *
double yield_sigma1 = sigma3 +
std::sqrt( (3.086 * sigma_c * sigma3) + (0.002 * sigma3 * sigma3) );
1746 *
if (sigma1 >= yield_sigma1)
1750 * std::cout <<
" comp ";
1753 * failing_cells.push_back(
true);
1754 * temp_reductionfactor = 1.0 * sigma1 / 5 / sigma3;
1756 * reduction_factor.push_back(temp_reductionfactor);
1761 * Text file of all failure locations
1764 * std::ofstream fout_failed_cells(failed_cells_output.str().c_str(), std::ios::app);
1765 * fout_failed_cells << points_list[i] <<
"\n";
1766 * fout_failed_cells.close();
1770 * reduction_factor.push_back(1);
1771 * failing_cells.push_back(
false);
1777 * std::cout <<
"Specified failure criterion not found\n";
1782 * reduction_factor.push_back(1);
1787 * If there are enough failed cells, update eta at all quadrature points and perform smoothing
1790 * std::cout <<
" Number of failing cells: " << total_fails <<
"\n";
1791 *
double last_max_plasticity_double = last_max_plasticity;
1792 *
double total_fails_double = total_fails;
1793 *
double decrease_in_plasticity = ((last_max_plasticity_double - total_fails_double) / last_max_plasticity_double);
1794 *
if (plastic_iteration == 0)
1795 * decrease_in_plasticity = 1;
1796 * last_max_plasticity = total_fails;
1797 *
if (total_fails <= 100 || decrease_in_plasticity <= 0.2)
1799 * system_parameters::continue_plastic_iterations =
false;
1804 * Writes to file the undisturbed cell viscosities
1807 * std::ofstream fout_vrnew(plastic_eta_output.str().c_str(), std::ios::app);
1808 * fout_vrnew <<
" " << cell_viscosities[j] <<
"\n";
1809 * fout_vrnew.close();
1817 * Decrease the eta at quadrature points in failing cells
1820 *
unsigned int cell_no = 0;
1822 * dof_handler.begin_active(); cell != dof_handler.end(); ++cell)
1824 * fe_values.reinit(cell);
1827 * Make local_quadrature_points_history pointer to the cell data
1830 * PointHistory<dim> *local_quadrature_points_history =
1831 *
reinterpret_cast<PointHistory<dim> *
>(cell->user_pointer());
1833 * local_quadrature_points_history >= &quadrature_point_history.front(),
1834 * ExcInternalError());
1836 * local_quadrature_points_history < &quadrature_point_history.back(),
1837 * ExcInternalError());
1839 * quad_viscosities[cell_no].resize(quadrature_formula.size());
1841 *
for (
unsigned int q = 0; q < quadrature_formula.size(); ++q)
1843 *
if (plastic_iteration == 0)
1844 * local_quadrature_points_history[q].new_eta = local_quadrature_points_history[q].first_eta;
1845 * local_quadrature_points_history[q].new_eta /= reduction_factor[cell_no];
1848 * Prevents viscosities from dropping below the
floor necessary
for numerical stability
1851 *
if (local_quadrature_points_history[q].new_eta < system_parameters::eta_floor)
1852 * local_quadrature_points_history[q].new_eta = system_parameters::eta_floor;
1854 * quad_viscosities[cell_no][q].reinit(dim+1);
1855 *
for (
unsigned int ii=0; ii<dim; ++ii)
1856 * quad_viscosities[cell_no][q](ii) = fe_values.quadrature_point(q)[ii];
1857 * quad_viscosities[cell_no][q](dim) = local_quadrature_points_history[q].new_eta;
1861 * smooth_eta_field(failing_cells);
1865 * Writes to file the smoothed eta field (which is defined at each quadrature point)
for each cell
1875 * dof_handler.begin_active(); cell != dof_handler.end(); ++cell)
1877 *
if (failing_cells[cell_no])
1879 * fe_values.reinit(cell);
1882 * Averages across each cell to find
mean eta
1885 *
double cell_area = 0;
1886 *
for (
unsigned int q = 0; q < quadrature_formula.size(); ++q)
1888 * cell_area += fe_values.JxW(q);
1889 * cell_viscosities[cell_no] += quad_viscosities[cell_no][q][dim] * fe_values.JxW(q);
1891 * cell_viscosities[cell_no] /= cell_area;
1898 * std::ofstream fout_vrnew(plastic_eta_output.str().c_str(), std::ios::app);
1899 * fout_vrnew <<
" " << cell_viscosities[cell_no] <<
"\n";
1900 * fout_vrnew.close();
1904 * std::ofstream fout_vrnew(plastic_eta_output.str().c_str(), std::ios::app);
1905 * fout_vrnew <<
" " << cell_viscosities[cell_no] <<
"\n";
1906 * fout_vrnew.close();
1915 * ====================== SMOOTHES THE VISCOSITY FIELD AT ALL QUADRATURE POINTS ======================
1922 *
void StokesProblem<dim>::smooth_eta_field(std::vector<bool> failing_cells)
1924 * std::cout <<
" Smoothing viscosity field...\n";
1925 *
unsigned int cell_no = 0;
1927 * dof_handler.begin_active(); cell != dof_handler.end(); ++cell)
1929 *
if (failing_cells[cell_no])
1932 * PointHistory<dim> *local_quadrature_points_history =
1933 *
reinterpret_cast<PointHistory<dim> *
>(cell->user_pointer());
1937 * Currently
this algorithm does not permit refinement. To permit refinement, daughter cells of neighbors must be identified
1938 * Find pointers and indices of all cells within certain radius
1941 *
bool find_more_cells =
true;
1943 * std::vector< TriaIterator< CellAccessor<dim> > > neighbor_cells;
1944 * std::vector<int> neighbor_indices;
1945 *
unsigned int start_cell = 0;
1946 *
int new_cells_found = 0;
1947 * neighbor_cells.push_back(cell);
1948 * neighbor_indices.push_back(cell_no);
1949 * cell_touched[cell_no] =
true;
1950 *
while (find_more_cells)
1952 * new_cells_found = 0;
1953 *
for (
unsigned int i = start_cell; i<neighbor_cells.size(); ++i)
1955 *
for (
unsigned int f = 0; f < GeometryInfo<dim>::faces_per_cell; ++f)
1957 *
if (!neighbor_cells[i]->face(f)->at_boundary())
1959 *
int test_cell_no = neighbor_cells[i]->neighbor_index(f);
1960 *
if (!cell_touched[test_cell_no])
1961 *
if (cell->center().distance(neighbor_cells[i]->neighbor(f)->center()) < 2 * system_parameters::smoothing_radius)
1965 * What to
do if another nearby cell is found that hasn
't been found before
1968 * neighbor_cells.push_back(neighbor_cells[i]->neighbor(f));
1969 * neighbor_indices.push_back(test_cell_no);
1970 * cell_touched[test_cell_no] = true;
1972 * new_cells_found++;
1977 * if (new_cells_found == 0)
1979 * find_more_cells = false;
1982 * start_cell = neighbor_cells.size() - new_cells_found;
1985 * fe_values.reinit(cell);
1988 * Collect the viscosities at nearby quadrature points
1991 * for (unsigned int q = 0; q < quadrature_formula.size(); ++q)
1993 * std::vector<double> nearby_etas_q;
1994 * for (unsigned int i = 0; i<neighbor_indices.size(); ++i)
1995 * for (unsigned int j=0; j<quadrature_formula.size(); ++j)
1997 * Point<dim> test_q;
1998 * for (unsigned int d=0; d<dim; ++d)
1999 * test_q(d) = quad_viscosities[neighbor_indices[i]][j][d];
2000 * double qq_distance = fe_values.quadrature_point(q).distance(test_q);
2001 * if (qq_distance < system_parameters::smoothing_radius)
2002 * nearby_etas_q.push_back(quad_viscosities[neighbor_indices[i]][j][dim]);
2006 * Write smoothed viscosities to quadrature_points_history; simple boxcar function is the smoothing kernel
2009 * double mean_eta = 0;
2010 * for (unsigned int l = 0; l<nearby_etas_q.size(); ++l)
2012 * mean_eta += nearby_etas_q[l];
2014 * mean_eta /= nearby_etas_q.size();
2015 * local_quadrature_points_history[q].new_eta = mean_eta;
2018 * std::cout << local_quadrature_points_history[q].new_eta << " ";
2029 * ====================== SAVE STRESS TENSOR AT QUADRATURE POINTS ======================
2036 * void StokesProblem<dim>::update_quadrature_point_history()
2038 * std::cout << " Updating stress field...";
2040 * FEValues<dim> fe_values(fe, quadrature_formula,
2041 * update_values | update_gradients | update_quadrature_points);
2045 * Make the object that will hold the velocity gradients
2048 * std::vector < std::vector<Tensor<1, dim> >> velocity_grads(quadrature_formula.size(),
2049 * std::vector < Tensor<1, dim> > (dim + 1));
2050 * std::vector<Vector<double> > velocities(quadrature_formula.size(),
2051 * Vector<double>(dim + 1));
2053 * for (typename DoFHandler<dim>::active_cell_iterator cell =
2054 * dof_handler.begin_active(); cell != dof_handler.end(); ++cell)
2056 * PointHistory<dim> *local_quadrature_points_history =
2057 * reinterpret_cast<PointHistory<dim> *>(cell->user_pointer());
2059 * local_quadrature_points_history >= &quadrature_point_history.front(),
2060 * ExcInternalError());
2062 * local_quadrature_points_history < &quadrature_point_history.back(),
2063 * ExcInternalError());
2065 * fe_values.reinit(cell);
2066 * fe_values.get_function_gradients(solution, velocity_grads);
2067 * fe_values.get_function_values(solution, velocities);
2069 * for (unsigned int q = 0; q < quadrature_formula.size(); ++q)
2073 * Define the local viscoelastic constants
2076 * double local_eta_ve = 2
2077 * / ((1 / local_quadrature_points_history[q].new_eta)
2078 * + (1 / local_quadrature_points_history[q].G
2079 * / system_parameters::current_time_interval));
2080 * double local_chi_ve =
2083 * + (local_quadrature_points_history[q].G
2084 * * system_parameters::current_time_interval
2085 * / local_quadrature_points_history[q].new_eta));
2089 * Compute new stress at each quadrature point
2092 * SymmetricTensor<2, dim> new_stress;
2093 * for (unsigned int i = 0; i < dim; ++i)
2094 * new_stress[i][i] =
2095 * local_eta_ve * velocity_grads[q][i][i]
2097 * * local_quadrature_points_history[q].old_stress[i][i];
2099 * for (unsigned int i = 0; i < dim; ++i)
2100 * for (unsigned int j = i + 1; j < dim; ++j)
2101 * new_stress[i][j] =
2103 * * (velocity_grads[q][i][j]
2104 * + velocity_grads[q][j][i]) / 2
2106 * * local_quadrature_points_history[q].old_stress[i][j];
2113 * AuxFunctions<dim> rotation_object;
2114 * const Tensor<2, dim> rotation = rotation_object.get_rotation_matrix(
2115 * velocity_grads[q]);
2116 * const SymmetricTensor<2, dim> rotated_new_stress = symmetrize(
2117 * transpose(rotation)
2118 * * static_cast<Tensor<2, dim> >(new_stress)
2120 * local_quadrature_points_history[q].old_stress = rotated_new_stress;
2124 * For axisymmetric case, make the phi-phi element of stress tensor
2127 * local_quadrature_points_history[q].old_phiphi_stress =
2128 * (2 * local_eta_ve * velocities[q](0)
2129 * / fe_values.quadrature_point(q)[0]
2131 * * local_quadrature_points_history[q].old_phiphi_stress);
2138 * ====================== REDEFINE THE TIME INTERVAL FOR THE VISCOUS STEPS ======================
2142 * void StokesProblem<dim>::update_time_interval()
2144 * double move_goal_per_step = system_parameters::initial_disp_target;
2145 * if (system_parameters::present_timestep > system_parameters::initial_elastic_iterations)
2147 * move_goal_per_step = system_parameters::initial_disp_target -
2148 * ((system_parameters::initial_disp_target - system_parameters::final_disp_target) /
2149 * system_parameters::total_viscous_steps *
2150 * (system_parameters::present_timestep - system_parameters::initial_elastic_iterations));
2153 * double zero_tolerance = 1e-3;
2154 * double max_velocity = 0;
2155 * for (typename DoFHandler<dim>::active_cell_iterator cell =
2156 * dof_handler.begin_active(); cell != dof_handler.end(); ++cell)// loop over all cells
2158 * if (cell->at_boundary())
2160 * int zero_faces = 0;
2161 * for (unsigned int f=0; f<GeometryInfo<dim>::faces_per_cell; ++f)
2162 * for (unsigned int i=0; i<dim; ++i)
2163 * if (fabs(cell->face(f)->center()[i]) < zero_tolerance)
2165 * if (zero_faces==0)
2167 * for (unsigned int v = 0; v < GeometryInfo<dim>::vertices_per_cell; ++v)
2169 * Point<dim> vertex_velocity;
2170 * Point<dim> vertex_position;
2171 * for (unsigned int d = 0; d < dim; ++d)
2173 * vertex_velocity[d] = solution(cell->vertex_dof_index(v, d));
2174 * vertex_position[d] = cell->vertex(v)[d];
2178 * velocity to be evaluated is the radial component of a surface vertex
2181 * double local_velocity = 0;
2182 * for (unsigned int d = 0; d < dim; ++d)
2184 * local_velocity += vertex_velocity[d] * vertex_position [d];
2186 * local_velocity /= std::sqrt( vertex_position.square() );
2187 * if (local_velocity < 0)
2188 * local_velocity *= -1;
2189 * if (local_velocity > max_velocity)
2191 * max_velocity = local_velocity;
2199 * NOTE: It is possible for this time interval to be very different from that used in the viscoelasticity calculation.
2202 * system_parameters::current_time_interval = move_goal_per_step / max_velocity;
2203 * double step_time_yr = system_parameters::current_time_interval / SECSINYEAR;
2204 * std::cout << "Timestep interval changed to: "
2211 * ====================== MOVE MESH ======================
2218 * void StokesProblem<dim>::move_mesh()
2221 * std::cout << "\n" << " Moving mesh...\n";
2222 * std::vector<bool> vertex_touched(triangulation.n_vertices(), false);
2223 * for (typename DoFHandler<dim>::active_cell_iterator cell =
2224 * dof_handler.begin_active(); cell != dof_handler.end(); ++cell)
2225 * for (unsigned int v = 0; v < GeometryInfo<dim>::vertices_per_cell; ++v)
2226 * if (vertex_touched[cell->vertex_index(v)] == false)
2228 * vertex_touched[cell->vertex_index(v)] = true;
2230 * Point<dim> vertex_displacement;
2231 * for (unsigned int d = 0; d < dim; ++d)
2232 * vertex_displacement[d] = solution(
2233 * cell->vertex_dof_index(v, d));
2234 * cell->vertex(v) += vertex_displacement
2235 * * system_parameters::current_time_interval;
2241 * ====================== WRITE MESH TO FILE ======================
2248 * void StokesProblem<dim>::write_mesh()
2252 * output mesh in ucd
2255 * std::ostringstream initial_mesh_file;
2256 * initial_mesh_file << system_parameters::output_folder << "/time" <<
2257 * Utilities::int_to_string(system_parameters::present_timestep, 2) <<
2259 * std::ofstream out_ucd (initial_mesh_file.str().c_str());
2261 * grid_out.write_ucd (triangulation, out_ucd);
2266 * ====================== FIT ELLIPSE TO SURFACE AND WRITE RADII TO FILE ======================
2273 * void StokesProblem<dim>::do_ellipse_fits()
2275 * std::ostringstream ellipses_filename;
2276 * ellipses_filename << system_parameters::output_folder << "/ellipse_fits.txt";
2279 * Find ellipsoidal axes for all layers
2282 * std::vector<double> ellipse_axes(0);
2285 * compute fit to boundary 0, 1, 2 ...
2288 * std::cout << endl;
2289 * for (unsigned int i = 0; i<system_parameters::sizeof_material_id; ++i)
2291 * ellipsoid.compute_fit(ellipse_axes, system_parameters::material_id[i]);
2292 * system_parameters::q_axes.push_back(ellipse_axes[0]);
2293 * system_parameters::p_axes.push_back(ellipse_axes[1]);
2295 * std::cout << "a_"<< system_parameters::material_id[i] <<" = " << ellipse_axes[0]
2296 * << " " << " c_"<< system_parameters::material_id[i] <<" = " << ellipse_axes[1] << std::endl;
2297 * ellipse_axes.clear();
2299 * std::ofstream fout_ellipses(ellipses_filename.str().c_str(), std::ios::app);
2300 * fout_ellipses << system_parameters::present_timestep << " a_"<< system_parameters::material_id[i] <<" = " << ellipse_axes[0]
2301 * << " " << " c_"<< system_parameters::material_id[i] <<" = " << ellipse_axes[1] << endl;
2302 * fout_ellipses.close();
2308 * ====================== APPEND LINE TO PHYSICAL_TIMES.TXT FILE WITH STEP NUMBER, PHYSICAL TIME, AND # PLASTIC ITERATIONS ======================
2315 * void StokesProblem<dim>::append_physical_times(int max_plastic)
2317 * std::ostringstream times_filename;
2318 * times_filename << system_parameters::output_folder << "/physical_times.txt";
2319 * std::ofstream fout_times(times_filename.str().c_str(), std::ios::app);
2320 * fout_times << system_parameters::present_timestep << " "
2321 * << system_parameters::present_time/SECSINYEAR << " "
2322 * << max_plastic << "\n";
2325 * << system_parameters::q_axes[0] << " " << system_parameters::p_axes[0] << " "
2326 * << system_parameters::q_axes[1] << " " << system_parameters::p_axes[1] << "\n";
2329 * fout_times.close();
2334 * ====================== WRITE VERTICES TO FILE ======================
2341 * void StokesProblem<dim>::write_vertices(unsigned char boundary_that_we_need)
2343 * std::ostringstream vertices_output;
2344 * vertices_output << system_parameters::output_folder << "/time" <<
2345 * Utilities::int_to_string(system_parameters::present_timestep, 2) << "_" <<
2346 * Utilities::int_to_string(boundary_that_we_need, 2) <<
2348 * std::ofstream fout_final_vertices(vertices_output.str().c_str());
2349 * fout_final_vertices.close();
2351 * std::vector<bool> vertex_touched(triangulation.n_vertices(), false);
2353 * if (boundary_that_we_need == 0)
2357 * Figure out if the vertex is on the boundary of the domain
2360 * for (typename Triangulation<dim>::active_cell_iterator cell =
2361 * triangulation.begin_active(); cell != triangulation.end(); ++cell)
2362 * for (unsigned int f = 0; f < GeometryInfo<dim>::faces_per_cell; ++f)
2364 * unsigned char boundary_ids = cell->face(f)->boundary_id();
2365 * if (boundary_ids == boundary_that_we_need)
2367 * for (unsigned int v=0; v<GeometryInfo<dim>::vertices_per_face; ++v)
2368 * if (vertex_touched[cell->face(f)->vertex_index(v)] == false)
2370 * vertex_touched[cell->face(f)->vertex_index(v)] = true;
2371 * std::ofstream fout_final_vertices(vertices_output.str().c_str(), std::ios::app);
2372 * fout_final_vertices << cell->face(f)->vertex(v) << "\n";
2373 * fout_final_vertices.close();
2382 * Figure out if the vertex is on an internal boundary
2385 * for (typename Triangulation<dim>::active_cell_iterator cell =
2386 * triangulation.begin_active(); cell != triangulation.end(); ++cell)
2387 * for (unsigned int f = 0; f < GeometryInfo<dim>::faces_per_cell; ++f)
2389 * if (cell->neighbor(f) != triangulation.end())
2391 * if (cell->material_id() != cell->neighbor(f)->material_id()) //finds face is at internal boundary
2393 * int high_mat_id = std::max(cell->material_id(),
2394 * cell->neighbor(f)->material_id());
2395 * if (high_mat_id == boundary_that_we_need) //finds faces at the correct internal boundary
2397 * for (unsigned int v = 0;
2398 * v < GeometryInfo<dim>::vertices_per_face;
2400 * if (vertex_touched[cell->face(f)->vertex_index(
2403 * vertex_touched[cell->face(f)->vertex_index(
2405 * std::ofstream fout_final_vertices(vertices_output.str().c_str(), std::ios::app);
2406 * fout_final_vertices << cell->face(f)->vertex(v) << "\n";
2407 * fout_final_vertices.close();
2418 * ====================== SETUP INITIAL MESH ======================
2425 * void StokesProblem<dim>::setup_initial_mesh()
2427 * GridIn<dim> grid_in;
2428 * grid_in.attach_triangulation(triangulation);
2429 * std::ifstream mesh_stream(system_parameters::mesh_filename,
2430 * std::ifstream::in);
2431 * grid_in.read_ucd(mesh_stream);
2435 * output initial mesh in eps
2438 * std::ostringstream initial_mesh_file;
2439 * initial_mesh_file << system_parameters::output_folder << "/initial_mesh.eps";
2440 * std::ofstream out_eps (initial_mesh_file.str().c_str());
2442 * grid_out.write_eps (triangulation, out_eps);
2448 * boundary indicator 0 is outer free surface; 1, 2, 3 ... is boundary between layers, 99 is flat boundaries
2451 * typename Triangulation<dim>::active_cell_iterator
2452 * cell=triangulation.begin_active(), endc=triangulation.end();
2454 * unsigned int how_many; // how many components away from cardinal planes
2456 * std::ostringstream boundaries_file;
2457 * boundaries_file << system_parameters::output_folder << "/boundaries.txt";
2458 * std::ofstream fout_boundaries(boundaries_file.str().c_str());
2459 * fout_boundaries.close();
2461 * double zero_tolerance = 1e-3;
2462 * for (; cell != endc; ++cell) // loop over all cells
2464 * for (unsigned int f = 0; f < GeometryInfo<dim>::faces_per_cell; ++f) // loop over all vertices
2466 * if (cell->face(f)->at_boundary())
2473 * std::ofstream fout_boundaries(boundaries_file.str().c_str(), std::ios::app);
2474 * fout_boundaries << cell->face(f)->center()[0] << " " << cell->face(f)->center()[1]<< "\n";
2475 * fout_boundaries.close();
2478 * for (unsigned int i=0; i<dim; ++i)
2479 * if (fabs(cell->face(f)->center()[i]) > zero_tolerance)
2481 * if (how_many==dim)
2482 * cell->face(f)->set_all_boundary_ids(0); // if face center coordinates > zero_tol, set bnry indicators to 0
2484 * cell->face(f)->set_all_boundary_ids(99);
2489 * std::ostringstream ellipses_filename;
2490 * ellipses_filename << system_parameters::output_folder << "/ellipse_fits.txt";
2491 * std::ofstream fout_ellipses(ellipses_filename.str().c_str());
2492 * fout_ellipses.close();
2496 * Find ellipsoidal axes for all layers
2499 * std::vector<double> ellipse_axes(0);
2502 * compute fit to boundary 0, 1, 2 ...
2505 * std::cout << endl;
2506 * for (unsigned int i = 0; i<system_parameters::sizeof_material_id; ++i)
2508 * ellipsoid.compute_fit(ellipse_axes, system_parameters::material_id[i]);
2509 * system_parameters::q_axes.push_back(ellipse_axes[0]);
2510 * system_parameters::p_axes.push_back(ellipse_axes[1]);
2512 * std::cout << "a_"<< system_parameters::material_id[i] <<" = " << ellipse_axes[0]
2513 * << " " << " c_"<< system_parameters::material_id[i] <<" = " << ellipse_axes[1] << std::endl;
2514 * ellipse_axes.clear();
2516 * std::ofstream fout_ellipses(ellipses_filename.str().c_str(), std::ios::app);
2517 * fout_ellipses << system_parameters::present_timestep << " a_"<< system_parameters::material_id[i] <<" = " << ellipse_axes[0]
2518 * << " " << " c_"<< system_parameters::material_id[i] <<" = " << ellipse_axes[1] << endl;
2519 * fout_ellipses.close();
2522 * triangulation.refine_global(system_parameters::global_refinement);
2527 * refines crustal region
2530 * if (system_parameters::crustal_refinement != 0)
2532 * double a = system_parameters::q_axes[0] - system_parameters::crust_refine_region;
2533 * double b = system_parameters::p_axes[0] - system_parameters::crust_refine_region;
2536 * for (unsigned int step = 0;
2537 * step < system_parameters::crustal_refinement; ++step)
2539 * typename ::Triangulation<dim>::active_cell_iterator cell =
2540 * triangulation.begin_active(), endc = triangulation.end();
2541 * for (; cell != endc; ++cell)
2542 * for (unsigned int v = 0;
2543 * v < GeometryInfo<dim>::vertices_per_cell; ++v)
2545 * Point<dim> current_vertex = cell->vertex(v);
2547 * const double x_coord = current_vertex.operator()(0);
2548 * const double y_coord = current_vertex.operator()(1);
2549 * double expected_z = -1;
2551 * if ((x_coord - a) < -1e-10)
2553 * * std::sqrt(1 - (x_coord * x_coord / a / a));
2555 * if (y_coord >= expected_z)
2557 * cell->set_refine_flag();
2561 * triangulation.execute_coarsening_and_refinement();
2568 * output initial mesh in eps
2571 * std::ostringstream refined_mesh_file;
2572 * refined_mesh_file << system_parameters::output_folder << "/refined_mesh.eps";
2573 * std::ofstream out_eps_refined (refined_mesh_file.str().c_str());
2574 * GridOut grid_out_refined;
2575 * grid_out_refined.write_eps (triangulation, out_eps_refined);
2576 * out_eps_refined.close();
2577 * write_vertices(0);
2578 * write_vertices(1);
2584 * ====================== REFINE MESH ======================
2591 * void StokesProblem<dim>::refine_mesh()
2593 * using FunctionMap = std::map<types::boundary_id, const Function<dim> *>;
2594 * Vector<float> estimated_error_per_cell(triangulation.n_active_cells());
2596 * std::vector<bool> component_mask(dim + 1, false);
2597 * component_mask[dim] = true;
2598 * KellyErrorEstimator<dim>::estimate(dof_handler, QGauss<dim - 1>(degree + 1),
2599 * FunctionMap(), solution,
2600 * estimated_error_per_cell, component_mask);
2602 * GridRefinement::refine_and_coarsen_fixed_number(triangulation,
2603 * estimated_error_per_cell, 0.3, 0.0);
2604 * triangulation.execute_coarsening_and_refinement();
2609 * ====================== SET UP THE DATA STRUCTURES TO REMEMBER STRESS FIELD ======================
2613 * void StokesProblem<dim>::setup_quadrature_point_history()
2615 * unsigned int our_cells = 0;
2616 * for (typename Triangulation<dim>::active_cell_iterator cell =
2617 * triangulation.begin_active(); cell != triangulation.end(); ++cell)
2620 * triangulation.clear_user_data();
2622 * quadrature_point_history.resize(our_cells * quadrature_formula.size());
2624 * unsigned int history_index = 0;
2625 * for (typename Triangulation<dim>::active_cell_iterator cell =
2626 * triangulation.begin_active(); cell != triangulation.end(); ++cell)
2628 * cell->set_user_pointer(&quadrature_point_history[history_index]);
2629 * history_index += quadrature_formula.size();
2632 * Assert(history_index == quadrature_point_history.size(), ExcInternalError());
2637 * ====================== DOES ELASTIC STEPS ======================
2641 * void StokesProblem<dim>::do_elastic_steps()
2643 * unsigned int elastic_iteration = 0;
2645 * while (elastic_iteration < system_parameters::initial_elastic_iterations)
2648 * std::cout << "\n\nElastic iteration " << elastic_iteration
2652 * if (system_parameters::present_timestep == 0)
2653 * initialize_eta_and_G();
2655 * if (elastic_iteration == 0)
2656 * system_parameters::current_time_interval =
2657 * system_parameters::viscous_time; //This is the time interval needed in assembling the problem
2659 * std::cout << " Assembling..." << std::endl << std::flush;
2660 * assemble_system();
2662 * std::cout << " Solving..." << std::flush;
2666 * update_quadrature_point_history();
2668 * append_physical_times(0);
2669 * elastic_iteration++;
2670 * system_parameters::present_timestep++;
2671 * do_ellipse_fits();
2672 * write_vertices(0);
2673 * write_vertices(1);
2675 * update_time_interval();
2681 * ====================== DO A SINGLE VISCOELASTOPLASTIC TIMESTEP ======================
2685 * void StokesProblem<dim>::do_flow_step()
2687 * plastic_iteration = 0;
2688 * while (plastic_iteration < system_parameters::max_plastic_iterations)
2690 * if (system_parameters::continue_plastic_iterations == true)
2692 * std::cout << "Plasticity iteration " << plastic_iteration << "\n";
2695 * std::cout << " Assembling..." << std::endl << std::flush;
2696 * assemble_system();
2698 * std::cout << " Solving..." << std::flush;
2702 * solution_stesses();
2704 * if (system_parameters::continue_plastic_iterations == false)
2707 * plastic_iteration++;
2714 * ====================== RUN ======================
2721 * void StokesProblem<dim>::run()
2725 * Sets up mesh and data structure for viscosity and stress at quadrature points
2728 * setup_initial_mesh();
2729 * setup_quadrature_point_history();
2733 * Makes the physical_times.txt file
2736 * std::ostringstream times_filename;
2737 * times_filename << system_parameters::output_folder << "/physical_times.txt";
2738 * std::ofstream fout_times(times_filename.str().c_str());
2739 * fout_times.close();
2743 * Computes elastic timesteps
2746 * do_elastic_steps();
2749 * Computes viscous timesteps
2752 * unsigned int VEPstep = 0;
2753 * while (system_parameters::present_timestep
2754 * < (system_parameters::initial_elastic_iterations
2755 * + system_parameters::total_viscous_steps))
2758 * if (system_parameters::continue_plastic_iterations == false)
2759 * system_parameters::continue_plastic_iterations = true;
2760 * std::cout << "\n\nViscoelastoplastic iteration " << VEPstep << "\n\n";
2763 * Computes plasticity
2767 * update_quadrature_point_history();
2769 * append_physical_times(plastic_iteration);
2770 * system_parameters::present_timestep++;
2771 * system_parameters::present_time = system_parameters::present_time + system_parameters::current_time_interval;
2772 * do_ellipse_fits();
2773 * write_vertices(0);
2774 * write_vertices(1);
2778 * append_physical_times(-1);
2785 * ====================== MAIN ======================
2791 * int main(int argc, char *argv[])
2796 * output program name
2799 * std::cout << "Running: " << argv[0] << std::endl;
2801 * char *cfg_filename = new char[120];
2803 * if (argc == 1) // if no input parameters (as if launched from eclipse)
2805 * std::strcpy(cfg_filename,"config/sample_CeresFE_config.cfg");
2808 * std::strcpy(cfg_filename,argv[1]);
2812 * using namespace dealii;
2813 * using namespace Step22;
2814 * config_in cfg(cfg_filename);
2818 * t1 = std::clock();
2820 * deallog.depth_console(0);
2822 * StokesProblem<2> flow_problem(1);
2823 * flow_problem.run();
2825 * std::cout << std::endl << "\a";
2827 * t2 = std::clock();
2828 * float diff (((float)t2 - (float)t1) / (float)CLOCKS_PER_SEC);
2829 * std::cout << "\n Program run in: " << diff << " seconds" << endl;
2831 * catch (std::exception &exc)
2833 * std::cerr << std::endl << std::endl
2834 * << "----------------------------------------------------"
2836 * std::cerr << "Exception on processing: " << std::endl << exc.what()
2837 * << std::endl << "Aborting!" << std::endl
2838 * << "----------------------------------------------------"
2845 * std::cerr << std::endl << std::endl
2846 * << "----------------------------------------------------"
2848 * std::cerr << "Unknown exception!" << std::endl << "Aborting!"
2850 * << "----------------------------------------------------"
2860<a name="ann-support_code/config_in.h"></a>
2861<h1>Annotated version of support_code/config_in.h</h1>
2870 * * Created on: Aug 17, 2015
2871 * * Author: antonermakov
2875 * #include <iostream>
2876 * #include <iomanip>
2877 * #include <cstdlib>
2879 * #include <libconfig.h++>
2881 * #include "local_math.h"
2883 * using namespace std;
2884 * using namespace libconfig;
2888 * namespace system_parameters
2896 * string mesh_filename;
2897 * string output_folder;
2906 * double omegasquared;
2912 * Rheology parameters
2915 * vector<double> depths_eta;
2916 * vector<double> eta_kinks;
2917 * vector<double> depths_rho;
2918 * vector<double> rho;
2919 * vector<int> material_id;
2922 * double eta_ceiling;
2925 * bool lat_dependence;
2927 * unsigned int sizeof_depths_eta;
2928 * unsigned int sizeof_depths_rho;
2929 * unsigned int sizeof_rho;
2930 * unsigned int sizeof_eta_kinks;
2931 * unsigned int sizeof_material_id;
2932 * unsigned int sizeof_G;
2934 * double pressure_scale;
2937 * bool continue_plastic_iterations;
2941 * plasticity variables
2944 * bool plasticity_on;
2945 * unsigned int failure_criterion;
2946 * unsigned int max_plastic_iterations;
2947 * double smoothing_radius;
2951 * viscoelasticity variables
2954 * unsigned int initial_elastic_iterations;
2955 * double elastic_time;
2956 * double viscous_time;
2957 * double initial_disp_target;
2958 * double final_disp_target;
2959 * double current_time_interval;
2963 * mesh refinement variables
2966 * unsigned int global_refinement;
2967 * unsigned int small_r_refinement;
2968 * unsigned int crustal_refinement;
2969 * double crust_refine_region;
2970 * unsigned int surface_refinement;
2977 * int iteration_coefficient;
2978 * double tolerance_coefficient;
2982 * time step variables
2985 * double present_time;
2986 * unsigned int present_timestep;
2987 * unsigned int total_viscous_steps;
2995 * vector<double> q_axes;
2996 * vector<double> p_axes;
3003 * config_in(char *);
3006 * void write_config();
3009 * void config_in::write_config()
3011 * std::ostringstream config_parameters;
3012 * config_parameters << system_parameters::output_folder << "/run_parameters.txt";
3013 * std::ofstream fout_config(config_parameters.str().c_str());
3020 * fout_config << "mesh filename: " << system_parameters::mesh_filename << endl << endl;
3027 * fout_config << "r_mean = " << system_parameters::r_mean << endl;
3028 * fout_config << "period = " << system_parameters::period << endl;
3029 * fout_config << "omegasquared = " << system_parameters::omegasquared << endl;
3030 * fout_config << "beta = " << system_parameters::beta << endl;
3031 * fout_config << "intercept = " << system_parameters::intercept << endl;
3035 * rheology parameters
3041 * for (unsigned int i=0; i<system_parameters::sizeof_depths_eta; ++i)
3042 * fout_config << "depths_eta[" << i << "] = " << system_parameters::depths_eta[i] << endl;
3044 * for (unsigned int i=0; i<system_parameters::sizeof_eta_kinks; ++i)
3045 * fout_config << "eta_kinks[" << i << "] = " << system_parameters::eta_kinks[i] << endl;
3047 * for (unsigned int i=0; i<system_parameters::sizeof_depths_rho; ++i)
3048 * fout_config << "depths_rho[" << i << "] = " << system_parameters::depths_rho[i] << endl;
3050 * for (unsigned int i=0; i<system_parameters::sizeof_rho; ++i)
3051 * fout_config << "rho[" << i << "] = " << system_parameters::rho[i] << endl;
3053 * for (unsigned int i=0; i<system_parameters::sizeof_material_id; ++i)
3054 * fout_config << "material_id[" << i << "] = " << system_parameters::material_id[i] << endl;
3056 * for (unsigned int i=0; i<system_parameters::sizeof_G; ++i)
3057 * fout_config << "G[" << i << "] = " << system_parameters::G[i] << endl;
3059 * fout_config << "eta_ceiling = " << system_parameters::eta_ceiling << endl;
3060 * fout_config << "eta_floor = " << system_parameters::eta_floor << endl;
3061 * fout_config << "eta_Ea = " << system_parameters::eta_Ea << endl;
3062 * fout_config << "lat_dependence = " << system_parameters::lat_dependence << endl;
3063 * fout_config << "pressure_scale = " << system_parameters::pressure_scale << endl;
3064 * fout_config << "q = " << system_parameters::q << endl;
3065 * fout_config << "cylindrical = " << system_parameters::cylindrical << endl;
3066 * fout_config << "continue_plastic_iterations = " << system_parameters::continue_plastic_iterations << endl;
3070 * Plasticity parameters
3073 * fout_config << "plasticity_on = " << system_parameters::plasticity_on << endl;
3074 * fout_config << "failure_criterion = " << system_parameters::failure_criterion << endl;
3075 * fout_config << "max_plastic_iterations = " << system_parameters::max_plastic_iterations << endl;
3076 * fout_config << "smoothing_radius = " << system_parameters::smoothing_radius << endl;
3080 * Viscoelasticity parameters
3083 * fout_config << "initial_elastic_iterations = " << system_parameters::initial_elastic_iterations << endl;
3084 * fout_config << "elastic_time = " << system_parameters::elastic_time << endl;
3085 * fout_config << "viscous_time = " << system_parameters::viscous_time << endl;
3086 * fout_config << "initial_disp_target = " << system_parameters::initial_disp_target << endl;
3087 * fout_config << "final_disp_target = " << system_parameters::final_disp_target << endl;
3088 * fout_config << "current_time_interval = " << system_parameters::current_time_interval << endl;
3092 * Mesh refinement parameters
3095 * fout_config << "global_refinement = " << system_parameters::global_refinement << endl;
3096 * fout_config << "small_r_refinement = " << system_parameters::small_r_refinement << endl;
3097 * fout_config << "crustal_refinement = " << system_parameters::crustal_refinement << endl;
3098 * fout_config << "crust_refine_region = " << system_parameters::crust_refine_region << endl;
3099 * fout_config << "surface_refinement = " << system_parameters::surface_refinement << endl;
3106 * fout_config << "iteration_coefficient = " << system_parameters::iteration_coefficient << endl;
3107 * fout_config << "tolerance_coefficient = " << system_parameters::tolerance_coefficient << endl;
3111 * Time step parameters
3114 * fout_config << "present_time = " << system_parameters::present_time << endl;
3115 * fout_config << "present_timestep = " << system_parameters::present_timestep << endl;
3116 * fout_config << "total_viscous_steps = " << system_parameters::total_viscous_steps << endl;
3118 * fout_config.close();
3121 * config_in::config_in(char *filename)
3126 * This example reads the configuration file 'example.cfg
' and displays
3127 * some of its contents.
3137 * Read the file. If there is an error, report it and exit.
3142 * cfg.readFile(filename);
3144 * catch (const FileIOException &fioex)
3146 * std::cerr << "I/O error while reading file:" << filename << std::endl;
3148 * catch (const ParseException &pex)
3150 * std::cerr << "Parse error at " << pex.getFile() << ":" << pex.getLine()
3151 * << " - " << pex.getError() << std::endl;
3161 * string msh = cfg.lookup("mesh_filename");
3162 * system_parameters::mesh_filename = msh;
3164 * catch (const SettingNotFoundException &nfex)
3166 * cerr << "No 'mesh_filename
' setting in configuration file." << endl;
3179 * string output = cfg.lookup("output_folder");
3180 * system_parameters::output_folder = output;
3182 * std::cout << "Writing to folder: " << output << endl;
3184 * catch (const SettingNotFoundException &nfex)
3186 * cerr << "No 'output_folder
' setting in configuration file." << endl;
3197 * const Setting &root = cfg.getRoot();
3202 * get body parameters
3207 * const Setting &body_parameters = root["body_parameters"];
3209 * body_parameters.lookupValue("period", system_parameters::period);
3210 * system_parameters::omegasquared = pow(TWOPI / 3600.0 / system_parameters::period, 2.0);
3211 * body_parameters.lookupValue("r_mean", system_parameters::r_mean);
3212 * body_parameters.lookupValue("beta", system_parameters::beta);
3213 * body_parameters.lookupValue("intercept", system_parameters::intercept);
3215 * catch (const SettingNotFoundException &nfex)
3217 * cerr << "We've got a problem in the body parameters block
" << endl;
3223 * Rheology parameters
3233 * get depths_eta ---------------------
3236 * const Setting &set_depths_eta = cfg.lookup("rheology_parameters.depths_eta
");
3238 * unsigned int ndepths_eta = set_depths_eta.getLength();
3239 * system_parameters::sizeof_depths_eta = ndepths_eta;
3241 * for (unsigned int i=0; i<ndepths_eta; ++i)
3243 * system_parameters::depths_eta.push_back(set_depths_eta[i]);
3244 * cout << "depth_eta[
" << i << "] =
" << system_parameters::depths_eta[i] << endl;
3249 * get eta_kinks -------------------------
3252 * const Setting &set_eta_kinks = cfg.lookup("rheology_parameters.eta_kinks
");
3254 * unsigned int neta_kinks = set_eta_kinks.getLength();
3255 * system_parameters::sizeof_eta_kinks = neta_kinks;
3259 * cout << "Number of
depth =
" << ndepths << endl;
3265 * for (unsigned int i=0; i<neta_kinks; ++i)
3267 * system_parameters::eta_kinks.push_back(set_eta_kinks[i]);
3268 * cout << "eta_kinks[
" << i << "] =
" << system_parameters::eta_kinks[i] << endl;
3273 * get depths_rho -------------------------
3276 * const Setting &set_depths_rho = cfg.lookup("rheology_parameters.depths_rho
");
3278 * unsigned int ndepths_rho = set_depths_rho.getLength();
3279 * system_parameters::sizeof_depths_rho = ndepths_rho;
3283 * cout << "Number of
depth =
" << ndepths << endl;
3289 * for (unsigned int i=0; i<ndepths_rho; ++i)
3291 * system_parameters::depths_rho.push_back(set_depths_rho[i]);
3292 * cout << "depths_rho[
" << i << "] =
" << system_parameters::depths_rho[i] << endl;
3297 * get rho -------------------------
3300 * const Setting &set_rho = cfg.lookup("rheology_parameters.rho
");
3302 * unsigned int nrho = set_rho.getLength();
3303 * system_parameters::sizeof_rho = nrho;
3307 * cout << "Number of
depth =
" << ndepths << endl;
3313 * for (unsigned int i=0; i<nrho; ++i)
3315 * system_parameters::rho.push_back(set_rho[i]);
3316 * cout << "rho[
" << i << "] =
" << system_parameters::rho[i] << endl;
3321 * get material_id -------------------------
3324 * const Setting &set_material_id = cfg.lookup("rheology_parameters.material_id
");
3326 * unsigned int nmaterial_id = set_material_id.getLength();
3327 * system_parameters::sizeof_material_id = nmaterial_id;
3331 * cout << "Number of
depth =
" << ndepths << endl;
3337 * for (unsigned int i=0; i<nmaterial_id; ++i)
3339 * system_parameters::material_id.push_back(set_material_id[i]);
3340 * cout << "material_id[
" << i << "] =
" << system_parameters::material_id[i] << endl;
3345 * get G -------------------------
3348 * const Setting &set_G = cfg.lookup("rheology_parameters.G
");
3350 * unsigned int nG = set_G.getLength();
3351 * system_parameters::sizeof_G = nG;
3355 * cout << "Number of
depth =
" << ndepths << endl;
3361 * for (unsigned int i=0; i<nG; ++i)
3363 * system_parameters::G.push_back(set_G[i]);
3364 * cout << "G[
" << i << "] =
" << system_parameters::G[i] << endl;
3367 * const Setting &rheology_parameters = root["rheology_parameters
"];
3368 * rheology_parameters.lookupValue("eta_ceiling
", system_parameters::eta_ceiling);
3369 * rheology_parameters.lookupValue("eta_floor
", system_parameters::eta_floor);
3370 * rheology_parameters.lookupValue("eta_Ea
", system_parameters::eta_Ea);
3371 * rheology_parameters.lookupValue("lat_dependence
", system_parameters::lat_dependence);
3372 * rheology_parameters.lookupValue("pressure_scale
", system_parameters::pressure_scale);
3373 * rheology_parameters.lookupValue("q
", system_parameters::q);
3374 * rheology_parameters.lookupValue("cylindrical
", system_parameters::cylindrical);
3375 * rheology_parameters.lookupValue("continue_plastic_iterations
", system_parameters::continue_plastic_iterations);
3377 * catch (const SettingNotFoundException &nfex)
3379 * cerr << "We
've got a problem in the rheology parameters block" << endl;
3384 * Plasticity parameters
3390 * const Setting &plasticity_parameters = root["plasticity_parameters"];
3391 * plasticity_parameters.lookupValue("plasticity_on", system_parameters::plasticity_on);
3392 * plasticity_parameters.lookupValue("failure_criterion", system_parameters::failure_criterion);
3393 * plasticity_parameters.lookupValue("max_plastic_iterations", system_parameters::max_plastic_iterations);
3394 * plasticity_parameters.lookupValue("smoothing_radius", system_parameters::smoothing_radius);
3396 * catch (const SettingNotFoundException &nfex)
3398 * cerr << "We've got a problem in the plasticity parameters block
" << endl;
3403 * Viscoelasticity parameters
3412 * const Setting &viscoelasticity_parameters = root["viscoelasticity_parameters
"];
3413 * viscoelasticity_parameters.lookupValue("initial_elastic_iterations
", system_parameters::initial_elastic_iterations);
3414 * viscoelasticity_parameters.lookupValue("elastic_time
", system_parameters::elastic_time);
3415 * viscoelasticity_parameters.lookupValue("viscous_time
", system_parameters::viscous_time);
3416 * viscoelasticity_parameters.lookupValue("initial_disp_target
", system_parameters::initial_disp_target);
3417 * viscoelasticity_parameters.lookupValue("final_disp_target
", system_parameters::final_disp_target);
3418 * viscoelasticity_parameters.lookupValue("current_time_interval
", system_parameters::current_time_interval);
3420 * system_parameters::viscous_time *= SECSINYEAR;
3422 * catch (const SettingNotFoundException &nfex)
3424 * cerr << "We
've got a problem in the viscoelasticity parameters block" << endl;
3429 * Mesh refinement parameters
3435 * const Setting &mesh_refinement_parameters = root["mesh_refinement_parameters"];
3436 * mesh_refinement_parameters.lookupValue("global_refinement", system_parameters::global_refinement);
3437 * mesh_refinement_parameters.lookupValue("small_r_refinement", system_parameters::small_r_refinement);
3438 * mesh_refinement_parameters.lookupValue("crustal_refinement", system_parameters::crustal_refinement);
3439 * mesh_refinement_parameters.lookupValue("crust_refine_region", system_parameters::crust_refine_region);
3440 * mesh_refinement_parameters.lookupValue("surface_refinement", system_parameters::surface_refinement);
3442 * catch (const SettingNotFoundException &nfex)
3444 * cerr << "We've got a problem in the mesh refinement parameters block
" << endl;
3454 * const Setting &solve_parameters = root["solve_parameters
"];
3455 * solve_parameters.lookupValue("iteration_coefficient
", system_parameters::iteration_coefficient);
3456 * solve_parameters.lookupValue("tolerance_coefficient
", system_parameters::tolerance_coefficient);
3460 * catch (const SettingNotFoundException &nfex)
3462 * cerr << "We
've got a problem in the solver parameters block" << endl;
3467 * Time step parameters
3472 * const Setting &time_step_parameters = root["time_step_parameters"];
3473 * time_step_parameters.lookupValue("present_time", system_parameters::present_time);
3474 * time_step_parameters.lookupValue("present_timestep", system_parameters::present_timestep);
3475 * time_step_parameters.lookupValue("total_viscous_steps", system_parameters::total_viscous_steps);
3477 * catch (const SettingNotFoundException &nfex)
3479 * cerr << "We've got a problem in the time step parameters block
" << endl;
3493<a name="ann-support_code/ellipsoid_fit.h
"></a>
3494<h1>Annotated version of support_code/ellipsoid_fit.h</h1>
3503 * * Created on: Jul 24, 2015
3504 * * Author: antonermakov
3507 * #include <deal.II/base/quadrature_lib.h>
3508 * #include <deal.II/base/function.h>
3509 * #include <deal.II/base/logstream.h>
3510 * #include <deal.II/lac/vector.h>
3511 * #include <deal.II/lac/full_matrix.h>
3512 * #include <deal.II/lac/sparse_matrix.h>
3513 * #include <deal.II/lac/solver_cg.h>
3514 * #include <deal.II/lac/precondition.h>
3515 * #include <deal.II/grid/tria.h>
3516 * #include <deal.II/dofs/dof_handler.h>
3517 * #include <deal.II/grid/tria_accessor.h>
3518 * #include <deal.II/grid/tria_iterator.h>
3519 * #include <deal.II/dofs/dof_accessor.h>
3520 * #include <deal.II/dofs/dof_tools.h>
3521 * #include <deal.II/fe/fe_q.h>
3522 * #include <deal.II/fe/fe_values.h>
3523 * #include <deal.II/numerics/vector_tools.h>
3524 * #include <deal.II/numerics/matrix_tools.h>
3525 * #include <deal.II/numerics/data_out.h>
3526 * #include <deal.II/grid/grid_in.h>
3527 * #include <deal.II/grid/grid_out.h>
3528 * #include <deal.II/base/point.h>
3529 * #include <deal.II/grid/grid_generator.h>
3531 * #include <fstream>
3532 * #include <sstream>
3533 * #include <iostream>
3534 * #include <iomanip>
3535 * #include <cstdlib>
3538 * #include "local_math.h
"
3540 * using namespace dealii;
3542 * template <int dim>
3543 * class ellipsoid_fit
3546 * inline ellipsoid_fit (Triangulation<dim,dim> *pi)
3548 * p_triangulation = pi;
3550 * void compute_fit(std::vector<double> &ell, unsigned char bndry);
3554 * Triangulation<dim,dim> *p_triangulation;
3561 * This function computes ellipsoid fit to a set of vertices that lie on the
3562 * boundary_that_we_need
3565 * template <int dim>
3566 * void ellipsoid_fit<dim>::compute_fit(std::vector<double> &ell, unsigned char boundary_that_we_need)
3568 * typename Triangulation<dim>::active_cell_iterator cell = p_triangulation->begin_active();
3569 * typename Triangulation<dim>::active_cell_iterator endc = p_triangulation->end();
3571 * FullMatrix<double> A(p_triangulation->n_vertices(),dim);
3572 * Vector<double> x(dim);
3573 * Vector<double> b(p_triangulation->n_vertices());
3575 * std::vector<bool> vertex_touched (p_triangulation->n_vertices(),
3578 * unsigned int j = 0;
3579 * unsigned char boundary_ids;
3580 * std::vector<unsigned int> ind_bnry_row;
3581 * std::vector<unsigned int> ind_bnry_col;
3585 * assemble the sensitivity matrix and r.h.s.
3588 * for (; cell != endc; ++cell)
3590 * if (boundary_that_we_need != 0)
3591 * cell->set_manifold_id(cell->material_id());
3592 * for (unsigned int f = 0; f < GeometryInfo<dim>::faces_per_cell; ++f)
3594 * if (boundary_that_we_need == 0) //if this is the outer surface, then look for boundary ID 0; otherwise look for material ID change.
3596 * boundary_ids = cell->face(f)->boundary_id();
3597 * if (boundary_ids == boundary_that_we_need)
3599 * for (unsigned int v = 0;
3600 * v < GeometryInfo<dim>::vertices_per_face; ++v)
3601 * if (vertex_touched[cell->face(f)->vertex_index(v)]
3604 * vertex_touched[cell->face(f)->vertex_index(v)] =
3606 * for (unsigned int i = 0; i < dim; ++i)
3610 * stiffness matrix entry
3613 * A(j, i) = pow(cell->face(f)->vertex(v)[i], 2);
3622 * if mesh if not full: set the indicator
3626 * ind_bnry_row.push_back(j);
3631 * else //find the faces that are at the boundary between materials, get the vertices, and write them into the stiffness matrix
3633 * if (cell->neighbor(f) != endc)
3635 * if (cell->material_id() != cell->neighbor(f)->material_id()) //finds face is at internal boundary
3637 * int high_mat_id = std::max(cell->material_id(),
3638 * cell->neighbor(f)->material_id());
3639 * if (high_mat_id == boundary_that_we_need) //finds faces at the correct internal boundary
3641 * for (unsigned int v = 0;
3642 * v < GeometryInfo<dim>::vertices_per_face;
3644 * if (vertex_touched[cell->face(f)->vertex_index(
3647 * vertex_touched[cell->face(f)->vertex_index(
3649 * for (unsigned int i = 0; i < dim; ++i)
3653 * stiffness matrix entry
3657 * cell->face(f)->vertex(v)[i], 2);
3666 * if mesh if not full: set the indicator
3670 * ind_bnry_row.push_back(j);
3679 * if (ind_bnry_row.size()>0)
3684 * maxtrix A'*A and vector A'*b; A'*A*x = A'*b -- normal system of equations
3687 * FullMatrix<double> AtA(dim,dim);
3688 * Vector<double> Atb(dim);
3690 * FullMatrix<double> A_out(ind_bnry_row.size(),dim);
3691 * Vector<double> b_out(ind_bnry_row.size());
3693 * for (unsigned int i=0; i<dim; ++i)
3694 * ind_bnry_col.push_back(i);
3696 * for (unsigned int i=0; i<ind_bnry_row.size(); ++i)
3699 * A_out.extract_submatrix_from(A, ind_bnry_row, ind_bnry_col);
3700 * A_out.Tmmult(AtA,A_out,true);
3701 * A_out.Tvmult(Atb,b_out,true);
3705 * solve normal system of equations
3708 * SolverControl solver_control (1000, 1e-12);
3709 * SolverCG<> solver (solver_control);
3710 * solver.solve (AtA, x, Atb, PreconditionIdentity());
3714 * find ellipsoidal axes
3717 * for (unsigned int i=0; i<dim; ++i)
3718 * ell.push_back(sqrt(1.0/x[i]));
3721 * std::cerr << "fit_ellipsoid: no points to fit
" << std::endl;
3728<a name="ann-support_code/ellipsoid_grav.h
"></a>
3729<h1>Annotated version of support_code/ellipsoid_grav.h</h1>
3735 * /* -----------------------------------------------------------------------------
3737 * * SPDX-License-Identifier: LGPL-2.1-or-later
3738 * * Copyright (C) 2012 by Roger R. Fu
3740 * * This file is part of the deal.II code gallery.
3742 * * -----------------------------------------------------------------------------
3744 * * Author: Roger R. Fu
3745 * * Reference Pohanka 2011, Contrib. Geophys. Geodes.
3749 * #include <deal.II/base/point.h>
3750 * #include <fstream>
3751 * #include <iostream>
3753 * namespace A_Grav_namespace
3755 * namespace system_parameters
3757 * double mantle_rho;
3759 * double excess_rho;
3764 * double r_core_polar;
3767 * template <int dim>
3768 * class AnalyticGravity
3771 * void setup_vars (std::vector<double> v);
3772 * void get_gravity (const ::Point<dim> &p, std::vector<double> &g);
3791 * template <int dim>
3792 * void AnalyticGravity<dim>::get_gravity (const ::Point<dim> &p, std::vector<double> &g)
3794 * double rsph = std::sqrt(p[0] * p[0] + p[1] * p[1]);
3795 * double thetasph = std::atan2(p[0], p[1]);
3796 * double costhetasph = std::cos(thetasph);
3800 * convert to elliptical coordinates for silicates
3803 * double stemp = std::sqrt((rsph * rsph - eV * eV + std::sqrt((rsph * rsph - eV * eV) * (rsph * rsph - eV * eV)
3804 * + 4 * eV * eV * rsph * rsph * costhetasph *costhetasph)) / 2);
3805 * double vout = stemp / system_parameters::r_eq / std::sqrt(1 - ecc * ecc);
3806 * double eout = std::acos(rsph * costhetasph / stemp);
3810 * convert to elliptical coordinates for core correction
3813 * double stemp_c = std::sqrt((rsph * rsph - eV_c * eV_c + std::sqrt((rsph * rsph - eV_c * eV_c) * (rsph * rsph - eV_c * eV_c)
3814 * + 4 * eV_c * eV_c * rsph * rsph * costhetasph *costhetasph)) / 2);
3815 * double vout_c = stemp_c / system_parameters::r_core_eq / std::sqrt(1 - ecc_c * ecc_c);
3816 * double eout_c = std::acos(rsph * costhetasph / stemp_c);
3820 * shell contribution
3823 * g[0] = g_coeff * r11 * std::sqrt((1 - ecc * ecc) * vout * vout + ecc * ecc) * std::sin(eout);
3824 * g[1] = g_coeff * r01 * vout * std::cos(eout) / std::sqrt(1 - ecc * ecc);
3831 * double expected_y = system_parameters::r_core_polar * std::sqrt(1 -
3832 * (p[0] * p[0] / system_parameters::r_core_eq / system_parameters::r_core_eq));
3835 * if (p[1] <= expected_y)
3837 * g[0] += g_coeff_c * r11_c * std::sqrt((1 - ecc_c * ecc_c) * vout_c * vout_c + ecc_c * ecc_c) * std::sin(eout_c);
3838 * g[1] += g_coeff_c * r01_c * vout_c * std::cos(eout_c) / std::sqrt(1 - ecc_c * ecc_c);
3842 * double g_coeff_co = - 2.795007963255562e-10 * system_parameters::excess_rho * system_parameters::r_core_eq
3843 * / vout_c / vout_c;
3844 * double r00_co = 0;
3845 * double r01_co = 0;
3846 * double r11_co = 0;
3848 * if (system_parameters::r_core_polar == system_parameters::r_core_eq)
3856 * r00_co = ke_c * vout_c * std::atan2(1, ke_c * vout_c);
3857 * double ke_co2 = ke_c * ke_c * vout_c * vout_c;
3858 * r01_co = 3 * ke_co2 * (1 - r00_co);
3859 * r11_co = 3 * ((ke_co2 + 1) * r00_co - ke_co2) / 2;
3861 * g[0] += g_coeff_co * vout_c * r11_co / std::sqrt((1 - ecc_c* ecc_c) * vout_c * vout_c + ecc_c * ecc_c) * std::sin(eout_c);
3862 * g[1] += g_coeff_co * r01_co * std::cos(eout_c) / std::sqrt(1 - ecc_c * ecc_c);
3866 * template <int dim>
3867 * void AnalyticGravity<dim>::setup_vars (std::vector<double> v)
3869 * system_parameters::r_eq = v[0];
3870 * system_parameters::r_polar = v[1];
3871 * system_parameters::r_core_eq = v[2];
3872 * system_parameters::r_core_polar = v[3];
3873 * system_parameters::mantle_rho = v[4];
3874 * system_parameters::core_rho = v[5];
3875 * system_parameters::excess_rho = system_parameters::core_rho - system_parameters::mantle_rho;
3883 * if (system_parameters::r_polar > system_parameters::r_eq)
3887 * This makes the gravity field nearly that of a sphere in case the body becomes prolate
3890 * std::cout << "\nWarning: The model body has become prolate. \n
";
3895 * ecc = std::sqrt(1 - (system_parameters::r_polar * system_parameters::r_polar / system_parameters::r_eq / system_parameters::r_eq));
3898 * eV = ecc * system_parameters::r_eq;
3899 * ke = std::sqrt(1 - (ecc * ecc)) / ecc;
3900 * r00 = ke * std::atan2(1, ke);
3901 * double ke2 = ke * ke;
3902 * r01 = 3 * ke2 * (1 - r00);
3903 * r11 = 3 * ((ke2 + 1) * r00 - ke2) / 2;
3904 * g_coeff = - 2.795007963255562e-10 * system_parameters::mantle_rho * system_parameters::r_eq;
3911 * if (system_parameters::r_core_polar > system_parameters::r_core_eq)
3913 * std::cout << "\nWarning: The model core has become prolate. \n
";
3918 * ecc_c = std::sqrt(1 - (system_parameters::r_core_polar * system_parameters::r_core_polar / system_parameters::r_core_eq / system_parameters::r_core_eq));
3920 * eV_c = ecc_c * system_parameters::r_core_eq;
3921 * if (system_parameters::r_core_polar == system_parameters::r_core_eq)
3927 * g_coeff_c = - 2.795007963255562e-10 * system_parameters::excess_rho * system_parameters::r_core_eq;
3931 * ke_c = std::sqrt(1 - (ecc_c * ecc_c)) / ecc_c;
3932 * r00_c = ke_c * std::atan2(1, ke_c);
3933 * double ke2_c = ke_c * ke_c;
3934 * r01_c = 3 * ke2_c * (1 - r00_c);
3935 * r11_c = 3 * ((ke2_c + 1) * r00_c - ke2_c) / 2;
3936 * g_coeff_c = - 2.795007963255562e-10 * system_parameters::excess_rho * system_parameters::r_core_eq;
3940 * std::cout << "Loaded variables: ecc =
" << ecc_c << " ke =
" << ke_c << " r00 =
" << r00_c << " r01 =
" << r01_c << " r11 =
" << r11_c << "\n
";
3948<a name="ann-support_code/local_math.h
"></a>
3949<h1>Annotated version of support_code/local_math.h</h1>
3956 * * File: localmath.h
3957 * * Author: antonermakov
3959 * * Created on September 21, 2013, 7:14 PM
3962 * #ifndef LOCAL_MATH_
3963 * #define LOCAL_MATH_
3965 * #define PI 3.14159265358979323846
3966 * #define TWOPI 6.283185307179586476925287
3967 * #define SECSINYEAR 3.155692608e+07
3970 * #define ABS(a) ((a) < 0 ? -(a) : (a))
3974 * double factorial(int n)
3978 * } else if(n == 1) {
3980 * } else if(n == 2) {
3982 * } else if(n == 3) {
3984 * } else if(n == 4) {
3993 * double fudge(int m)
4007 * double sign(double x)
4011 * } else if(x < 0.0) {
4020 * double pv0(double x)
4026 * ans = x - TWOPI*floor(x/TWOPI);
4027 * if(ans > TWOPI/2.0) {
4028 * ans = ans - TWOPI;
4043 * double System::Plm(int m, double x)
4046 * return(1.5*x*x - 0.5);
4047 * } else if(m == 1) {
4048 * return(3.0*x*sqrt(1.0 - x*x));
4049 * } else if(m == 2) {
4050 * return(3.0 - 3.0*x*x);
4058 * double System::DP(int m, double x)
4062 * } else if(m == 1) {
4063 * return((3.0 - 6.0*x*x)/sqrt(1.0 - x*x));
4064 * } else if(m == 2) {
4078 * #endif /* LOCALMATH_H */
void attach_dof_handler(const DoFHandler< dim, spacedim > &)
virtual void vector_value_list(const std::vector< Point< dim > > &points, std::vector< Vector< RangeNumberType > > &values) const
virtual RangeNumberType value(const Point< dim > &p, const unsigned int component=0) const
virtual void vector_value(const Point< dim > &p, Vector< RangeNumberType > &values) const
typename SparseLUDecomposition< number >::AdditionalData AdditionalData
void initialize(const SparseMatrix< somenumber > &matrix, const AdditionalData ¶meters=AdditionalData())
unsigned int n_active_cells() const
#define DEAL_II_DISABLE_EXTRA_DIAGNOSTICS
#define DEAL_II_ENABLE_EXTRA_DIAGNOSTICS
__global__ void set(Number *val, const Number s, const size_type N)
#define Assert(cond, exc)
#define AssertThrow(cond, exc)
typename ActiveSelector::active_cell_iterator active_cell_iterator
LinearOperator< Range_2, Domain_2, Payload > schur_complement(const LinearOperator< Domain_1, Range_1, Payload > &A_inv, const LinearOperator< Range_1, Domain_2, Payload > &B, const LinearOperator< Range_2, Domain_1, Payload > &C, const LinearOperator< Range_2, Domain_2, Payload > &D)
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())
void make_hanging_node_constraints(const DoFHandler< dim, spacedim > &dof_handler, AffineConstraints< number > &constraints)
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)
void compute_no_normal_flux_constraints(const DoFHandler< dim, spacedim > &dof_handler, const unsigned int first_vector_component, const std::set< types::boundary_id > &boundary_ids, AffineConstraints< number > &constraints, const Mapping< dim, spacedim > &mapping=(ReferenceCells::get_hypercube< dim >() .template get_default_linear_mapping< dim, spacedim >()), const bool use_manifold_for_normal=true)
@ update_values
Shape function values.
@ update_JxW_values
Transformed quadrature weights.
@ update_gradients
Shape function gradients.
@ update_quadrature_points
Transformed quadrature points.
std::vector< value_type > l2_norm(const typename ::Triangulation< dim, spacedim >::cell_iterator &parent, const value_type parent_value)
@ component_is_part_of_vector
Expression floor(const Expression &x)
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 >())
@ valid
Iterator points to a valid object.
@ matrix
Contents is actually a matrix.
Point< spacedim > point(const gp_Pnt &p, const double tolerance=1e-10)
SymmetricTensor< 2, dim, Number > e(const Tensor< 2, dim, Number > &F)
SymmetricTensor< 2, dim, Number > b(const Tensor< 2, dim, Number > &F)
Number angle(const Tensor< 1, spacedim, Number > &a, const Tensor< 1, spacedim, Number > &b)
std::string int_to_string(const unsigned int value, const unsigned int digits=numbers::invalid_unsigned_int)
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)
bool check(const ConstraintKinds kind_in, const unsigned int dim)
int(& functions)(const void *v1, const void *v2)
::VectorizedArray< Number, width > cos(const ::VectorizedArray< Number, width > &)
::VectorizedArray< Number, width > sin(const ::VectorizedArray< Number, width > &)
::VectorizedArray< Number, width > sqrt(const ::VectorizedArray< Number, width > &)
::VectorizedArray< Number, width > pow(const ::VectorizedArray< Number, width > &, const Number p)
inline ::VectorizedArray< Number, width > atan(const ::VectorizedArray< Number, width > &x)
::VectorizedArray< Number, width > abs(const ::VectorizedArray< Number, width > &)
const ::parallel::distributed::Triangulation< dim, spacedim > * triangulation