From c2f6a2c0d877a1bb51e90214c899a548712f8f08 Mon Sep 17 00:00:00 2001 From: danieldouglas92 Date: Fri, 25 Oct 2024 12:25:41 -0600 Subject: [PATCH] add test case --- .../tian2019_parameterized_reactions.cc | 390 ----- source/simulator/helper_functions.cc | 7 +- tests/darcy_outflow.prm | 188 +++ tests/darcy_outflow/screen-output | 1405 +++++++++++++++++ tests/darcy_outflow/statistics | 43 + tests/fluid_outflow.prm | 182 +++ tests/fluid_outflow/screen-output | 1405 +++++++++++++++++ tests/fluid_outflow/statistics | 43 + 8 files changed, 3270 insertions(+), 393 deletions(-) delete mode 100644 source/material_model/reaction_model/tian2019_parameterized_reactions.cc create mode 100644 tests/darcy_outflow.prm create mode 100644 tests/darcy_outflow/screen-output create mode 100644 tests/darcy_outflow/statistics create mode 100644 tests/fluid_outflow.prm create mode 100644 tests/fluid_outflow/screen-output create mode 100644 tests/fluid_outflow/statistics diff --git a/source/material_model/reaction_model/tian2019_parameterized_reactions.cc b/source/material_model/reaction_model/tian2019_parameterized_reactions.cc deleted file mode 100644 index d5f313c296b..00000000000 --- a/source/material_model/reaction_model/tian2019_parameterized_reactions.cc +++ /dev/null @@ -1,390 +0,0 @@ -/* - Copyright (C) 2024 by the authors of the ASPECT code. - - This file is part of ASPECT. - - ASPECT is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2, or (at your option) - any later version. - - ASPECT is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License - along with ASPECT; see the file LICENSE. If not see - . -*/ - - -#include -#include -#include -#include -#include - - -namespace aspect -{ - namespace MaterialModel - { - namespace ReactionModel - { - - - template - Tian2019ReactionModel::Tian2019ReactionModel() - = default; - - template - std::vector - ReactiveFluidTransport:: - tian_equilibrium_bound_water_content (const MaterialModel::MaterialModelInputs &in, - unsigned int q) const - { - // Create arrays that will store the values of the polynomials at the current pressure - std::vector LR_values(4); - std::vector csat_values(4); - std::vector Td_values(4); - - // Loop over the four rock types (peridotite, gabbro, MORB, sediment) and the polynomial - // coefficients to fill the vectors defined above. The polynomials for LR are defined in - // equations 13, B2, B10, and B18. csat polynomials are defined in equations 14, B1, B9, and B17. - // Td polynomials are defined in equations 15, B3, B11, and B19. - for (unsigned int i = 0; i eq_bound_water_content(4); - - // Define the maximum bound water content allowed for the four different rock compositions - std::vector max_bound_water_content = {tian_max_peridotite_water, tian_max_gabbro_water, tian_max_MORB_water, tian_max_sediment_water}; - - // Loop over all rock compositions and fill the equilibrium bound water content, divide by 100 to convert - // from percentage to fraction (equation 1) - for (unsigned int k = 0; k - double - Tian2019ReactionModel:: - melt_fraction (const double temperature, - const double pressure) const - { - // The bound fluid content is calculated using parametrized phase - // diagrams for four different rock types: sediment, MORB, gabbro, and - // peridotite. - const unsigned int bound_fluid_idx = this->introspection().compositional_index_for_name("bound_fluid"); - const unsigned int sediment_idx = this->introspection().compositional_index_for_name("sediment"); - const unsigned int MORB_idx = this->introspection().compositional_index_for_name("MORB"); - const unsigned int gabbro_idx = this->introspection().compositional_index_for_name("gabbro"); - const unsigned int peridotite_idx = this->introspection().compositional_index_for_name("peridotite"); - - // Initialize a vector that stores the compositions (mass fractions) for - // the four different rock compositions, - std::vector tracked_rock_mass_fractions(4); - tracked_rock_mass_fractions[0] = (in.composition[q][peridotite_idx]); - tracked_rock_mass_fractions[1] = (in.composition[q][gabbro_idx]); - tracked_rock_mass_fractions[2] = (in.composition[q][MORB_idx]); - tracked_rock_mass_fractions[3] = (in.composition[q][sediment_idx]); - - // The bound water content (water within the solid phase) for the four different rock types - std::vector tian_eq_bound_water_content = tian_equilibrium_bound_water_content(in, q); - - // average the water content between the four different rock types - double average_eq_bound_water_content = MaterialUtilities::average_value (tracked_rock_mass_fractions, tian_eq_bound_water_content, MaterialUtilities::arithmetic); - } - - template - void - Tian2019ReactionModel:: - calculate_reaction_rate_outputs(const typename Interface::MaterialModelInputs &in, - typename Interface::MaterialModelOutputs &out) const - { - ReactionRateOutputs *reaction_rate_out = out.template get_additional_output>(); - - for (unsigned int i=0; iinclude_melt_transport()) - { - const unsigned int porosity_idx = this->introspection().compositional_index_for_name("porosity"); - const unsigned int peridotite_idx = this->introspection().compositional_index_for_name("peridotite"); - const double old_porosity = in.composition[i][porosity_idx]; - const double maximum_melt_fraction = in.composition[i][peridotite_idx]; - - // calculate the melting rate as difference between the equilibrium melt fraction - // and the solution of the previous time step - double porosity_change = 0.0; - if (fractional_melting) - { - // solidus is lowered by previous melting events (fractional melting) - const double solidus_change = (maximum_melt_fraction - old_porosity) * depletion_solidus_change; - const double eq_melt_fraction = melt_fraction(in.temperature[i] - solidus_change, this->get_adiabatic_conditions().pressure(in.position[i])); - porosity_change = eq_melt_fraction - old_porosity; - } - else - { - // batch melting - porosity_change = melt_fraction(in.temperature[i], this->get_adiabatic_conditions().pressure(in.position[i])) - - std::max(maximum_melt_fraction, 0.0); - porosity_change = std::max(porosity_change, 0.0); - - // freezing of melt below the solidus - - // If the porosity is larger than the equilibrium melt fraction, melt should freeze again. - // Because we do not track the melt composition, we have to use a workaround here for freezing of melt: - // We reduce the porosity until either it reaches the equilibrium melt fraction, or the depletion - // (peridotite field), which decreases as melt freezes, reaches the same value as the equilibrium - // melt fraction, whatever happens earlier. An exception is when the melt fraction is zero; in this case - // all melt should freeze. - const double eq_melt_fraction = melt_fraction(in.temperature[i], this->get_adiabatic_conditions().pressure(in.position[i])); - - // If the porosity change is not negative, there is no freezing, and the change in porosity - // is covered by the melting relation above. - - // porosity reaches the equilibrium melt fraction: - const double porosity_change_wrt_melt_fraction = std::min(eq_melt_fraction - old_porosity - porosity_change,0.0); - - // depletion reaches the equilibrium melt fraction: - const double porosity_change_wrt_depletion = std::min((eq_melt_fraction - std::max(maximum_melt_fraction, 0.0)) - * (1.0 - old_porosity) / (1.0 - maximum_melt_fraction),0.0); - double freezing_amount = std::max(porosity_change_wrt_melt_fraction, porosity_change_wrt_depletion); - - if (eq_melt_fraction == 0.0) - freezing_amount = - old_porosity; - - porosity_change += freezing_amount; - - // Adapt time scale of freezing with respect to melting. - // We have to multiply with the melting time scale here to obtain the porosity change - // that happens in the time defined by the melting time scale (as opposed to a rate). - // This is important because we want to perform some checks on this quantity (for example, - // we want to make sure that this change does not lead to a negative porosity, see below). - // Later on, the overall porosity change is then divided again by the melting time scale - // to obtain the rate of melting or freezing, which is used in the operator splitting scheme. - if (porosity_change < 0 ) - porosity_change *= freezing_rate * melting_time_scale; - - } - - // remove melt that gets close to the surface - if (this->get_geometry_model().depth(in.position[i]) < extraction_depth) - porosity_change = -old_porosity * (in.position[i](1) - (this->get_geometry_model().maximal_depth() - extraction_depth))/extraction_depth; - - // do not allow negative porosity - porosity_change = std::max(porosity_change, -old_porosity); - - // because depletion is a volume-based, and not a mass-based property that is advected, - // additional scaling factors on the right hand side apply - for (unsigned int c=0; cget_timestep_number() > 0) - reaction_rate_out->reaction_rates[i][c] = porosity_change / melting_time_scale * (1 - maximum_melt_fraction) / (1 - old_porosity); - else if (c == porosity_idx && this->get_timestep_number() > 0) - reaction_rate_out->reaction_rates[i][c] = porosity_change / melting_time_scale; - else - reaction_rate_out->reaction_rates[i][c] = 0.0; - } - out.reaction_terms[i][c] = 0.0; - } - - out.entropy_derivative_pressure[i] = entropy_change (in.temperature[i], this->get_adiabatic_conditions().pressure(in.position[i]), maximum_melt_fraction, NonlinearDependence::pressure); - out.entropy_derivative_temperature[i] = entropy_change (in.temperature[i], this->get_adiabatic_conditions().pressure(in.position[i]), maximum_melt_fraction, NonlinearDependence::temperature); - } - else - { - out.entropy_derivative_pressure[i] = entropy_change (in.temperature[i], this->get_adiabatic_conditions().pressure(in.position[i]), 0, NonlinearDependence::pressure); - out.entropy_derivative_temperature[i] = entropy_change (in.temperature[i], this->get_adiabatic_conditions().pressure(in.position[i]), 0, NonlinearDependence::temperature); - - // no melting/freezing is used in the model --> set all reactions to zero - for (unsigned int c=0; creaction_rates[i][c] = 0.0; - } - } - } - - } - - - template - void - Tian2019ReactionModel:: - calculate_fluid_outputs(const typename Interface::MaterialModelInputs &in, - typename Interface::MaterialModelOutputs &out, - const double reference_T) const - { - MeltOutputs *melt_out = out.template get_additional_output>(); - const unsigned int porosity_idx = this->introspection().compositional_index_for_name("porosity"); - - if (melt_out != nullptr) - { - - for (unsigned int i=0; ifluid_viscosities[i] = viscosity_fluid; - melt_out->permeabilities[i] = reference_permeability * Utilities::fixed_power<3>(porosity) * Utilities::fixed_power<2>(1.0-porosity); - - // first, calculate temperature dependence of density - double temperature_dependence = 1.0; - if (this->include_adiabatic_heating ()) - { - // temperature dependence is 1 - alpha * (T - T(adiabatic)) - temperature_dependence -= (in.temperature[i] - this->get_adiabatic_conditions().temperature(in.position[i])) - * out.thermal_expansion_coefficients[i]; - } - else - temperature_dependence -= (in.temperature[i] - reference_T) * out.thermal_expansion_coefficients[i]; - - // the fluid compressibility includes two parts, a constant compressibility, and a pressure-dependent one - // this is a simplified formulation, experimental data are often fit to the Birch-Murnaghan equation of state - const double fluid_compressibility = melt_compressibility / (1.0 + in.pressure[i] * melt_bulk_modulus_derivative * melt_compressibility); - - melt_out->fluid_densities[i] = reference_rho_fluid * std::exp(fluid_compressibility * (in.pressure[i] - this->get_surface_pressure())) - * temperature_dependence; - - melt_out->fluid_density_gradients[i] = melt_out->fluid_densities[i] * melt_out->fluid_densities[i] - * fluid_compressibility - * this->get_gravity_model().gravity_vector(in.position[i]); - - const double phi_0 = 0.05; - porosity = std::max(std::min(porosity,0.995),1e-4); - melt_out->compaction_viscosities[i] = xi_0 * phi_0 / porosity; - - double visc_temperature_dependence = 1.0; - if (this->include_adiabatic_heating ()) - { - const double delta_temp = in.temperature[i]-this->get_adiabatic_conditions().temperature(in.position[i]); - visc_temperature_dependence = std::max(std::min(std::exp(-thermal_bulk_viscosity_exponent*delta_temp/this->get_adiabatic_conditions().temperature(in.position[i])),1e4),1e-4); - } - else - { - const double delta_temp = in.temperature[i]-reference_T; - const double T_dependence = (thermal_bulk_viscosity_exponent == 0.0 - ? - 0.0 - : - thermal_bulk_viscosity_exponent*delta_temp/reference_T); - visc_temperature_dependence = std::max(std::min(std::exp(-T_dependence),1e4),1e-4); - } - melt_out->compaction_viscosities[i] *= visc_temperature_dependence; - - - } - } - - if (this->include_melt_transport() && in.requests_property(MaterialProperties::viscosity)) - { - for (unsigned int i=0; i - void - Tian2019ReactionModel::declare_parameters (ParameterHandler &prm) - { - prm.declare_entry ("Maximum weight percent water in sediment", "3", - Patterns::Double (0), - "The maximum allowed weight percent that the sediment composition can hold."); - prm.declare_entry ("Maximum weight percent water in MORB", "2", - Patterns::Double (0), - "The maximum allowed weight percent that the sediment composition can hold."); - prm.declare_entry ("Maximum weight percent water in gabbro", "1", - Patterns::Double (0), - "The maximum allowed weight percent that the sediment composition can hold."); - prm.declare_entry ("Maximum weight percent water in peridotite", "8", - Patterns::Double (0), - "The maximum allowed weight percent that the sediment composition can hold."); - - - } - - - template - void - Tian2019ReactionModel::parse_parameters (ParameterHandler &prm) - { - tian_max_peridotite_water = prm.get_double ("Maximum weight percent water in peridotite"); - tian_max_gabbro_water = prm.get_double ("Maximum weight percent water in gabbro"); - tian_max_MORB_water = prm.get_double ("Maximum weight percent water in MORB"); - tian_max_sediment_water = prm.get_double ("Maximum weight percent water in sediment"); - } - } - } -} - - -// explicit instantiations -namespace aspect -{ - namespace MaterialModel - { -#define INSTANTIATE(dim) \ - namespace ReactionModel \ - { \ - template class Tian2019ReactionModel; \ - } - - ASPECT_INSTANTIATE(INSTANTIATE) - -#undef INSTANTIATE - } -} diff --git a/source/simulator/helper_functions.cc b/source/simulator/helper_functions.cc index 9427a3d4d69..4df327e64a9 100644 --- a/source/simulator/helper_functions.cc +++ b/source/simulator/helper_functions.cc @@ -2331,7 +2331,7 @@ namespace aspect MaterialModel::MaterialModelInputs in(fe_face_values.n_quadrature_points, introspection.n_compositional_fields); MaterialModel::MaterialModelOutputs out(fe_face_values.n_quadrature_points, introspection.n_compositional_fields); MeltHandler::create_material_model_outputs(out); - MaterialModel::MeltOutputs *fluid_out = out.template get_additional_output>(); + MaterialModel::MeltOutputs *fluid_out = nullptr; const auto &tangential_velocity_boundaries = boundary_velocity_manager.get_tangential_boundary_velocity_indicators(); @@ -2366,12 +2366,13 @@ namespace aspect { in.reinit(fe_face_values, cell, introspection, solution); material_model->evaluate(in, out); + fluid_out = out.template get_additional_output>(); } if (consider_fluid_velocity) { - const FEValuesExtractors::Vector ex_u_f = introspection.variable("fluid velocity").extractor_vector(); - fe_face_values[ex_u_f].get_function_values(current_linearization_point, face_current_fluid_velocity_values); + fe_face_values[introspection.variable("fluid velocity").extractor_vector()].get_function_values(current_linearization_point, + face_current_fluid_velocity_values); } // ... check if the face is an outflow boundary by integrating the normal velocities diff --git a/tests/darcy_outflow.prm b/tests/darcy_outflow.prm new file mode 100644 index 00000000000..21cbbbbb334 --- /dev/null +++ b/tests/darcy_outflow.prm @@ -0,0 +1,188 @@ +# This test defines an initial blob of porosity implaced in a solid within a 2D cartesian box. +# Because the porosity blob is less dense, the blob will rise to the surface of the model and +# flow out of the top of the box. This tests the implementation of composition dependent outflow +# boundary conditions for when a composition is advected with the Darcy field advection method. +set Dimension = 2 +set Use years in output instead of seconds = true +set End time = 10e3 +set Pressure normalization = surface +set Maximum time step = 100 +set CFL number = 0.5 +set Surface pressure = 0 +set Use operator splitting = true +set Output directory = output-darcy +set Nonlinear solver scheme = iterated Advection and Stokes +set Max nonlinear iterations = 3 + +# Define a function which +subsection Boundary velocity model + set Prescribed velocity boundary indicators = top:function, bottom:function, right:function, left:function + + subsection Function + set Variable names = x,y, + set Function expression = 0;-0.1 + end +end + +subsection Gravity model + set Model name = vertical + + subsection Vertical + set Magnitude = 10 + end +end + +subsection Formulation + set Formulation = Boussinesq approximation +end + +subsection Solver parameters + set Temperature solver tolerance = 1e-10 + subsection Stokes solver parameters + set Stokes solver type = block GMG + set GMRES solver restart length = 1000 + set Number of cheap Stokes solver steps = 20000 + set Use full A block as preconditioner = true + set Linear solver tolerance = 1e-7 + set Maximum number of expensive Stokes solver steps = 0 + end +end + +# 10 km x 10 km box +subsection Geometry model + set Model name = box + + subsection Box + set X extent = 7.5e3 + set Y extent = 7.5e3 + + set X repetitions = 10 + set Y repetitions = 10 + end +end + +# Uniform temperature of 293 K +subsection Initial temperature model + set Model name = function + + subsection Function + set Function expression = 293 + end +end + +subsection Adiabatic conditions model + set Model name = function + + subsection Function + set Variable names = z + set Function expression = 293; 3.3e4*z; 3300 + end +end + +subsection Boundary temperature model + set Allow fixed temperature on outflow boundaries = false + set List of model names = box + set Fixed temperature boundary indicators = top, bottom, right, left + + subsection Box + set Bottom temperature = 293 + set Top temperature = 293 + set Left temperature = 293 + set Right temperature = 293 + end +end + +subsection Compositional fields + set Number of fields = 3 + set Names of fields = porosity, bound_fluid, solid_phase + set Compositional field methods = darcy field, field, field +end + +subsection Melt settings + set Include melt transport = false +end + +# Initialize a porosity of 1% (0.01) everywhere. +subsection Initial composition model + set Model name = function + + subsection Function + set Variable names = x,y,t + set Function constants = pi=3.1415926, x0=3750, y0=3750, c=1000 + set Function expression = 0.01 * exp(-((x-x0)*(x-x0)+(y-y0)*(y-y0))/(2*c*c)); 0.0; if(y>=7000, 1, 0) + end +end + +subsection Boundary composition model + set Fixed composition boundary indicators = bottom, top + set Allow fixed composition on outflow boundaries = false + set List of model names = initial composition +end + +subsection Material model + set Model name = reactive fluid transport + set Material averaging = geometric average only viscosity + + subsection Reactive Fluid Transport Model + set Base model = visco plastic + set Reference fluid density = 1000 # density of water + set Shear to bulk viscosity ratio = 1 + set Reference fluid viscosity = 10 + set Reference permeability = 1e-6 + set Exponential fluid weakening factor = 0 + set Fluid compressibility = 0 + set Fluid reaction time scale for operator splitting = 1e50 + set Fluid-solid reaction scheme = zero solubility + end + + subsection Visco Plastic + set Viscosity averaging scheme = geometric + set Viscous flow law = diffusion + set Prefactors for diffusion creep = 5e-21 + set Stress exponents for diffusion creep = 1.0 + set Activation energies for diffusion creep = 0 + set Activation volumes for diffusion creep = 0 + set Densities = 3000 + + set Angles of internal friction = 0 + set Cohesions = 1e50 + + set Minimum viscosity = 1e21 + set Maximum viscosity = 1e21 + set Thermal expansivities = 0 + end +end + +# Set the global refinement to 0, 1 km x 1 km mesh. +subsection Mesh refinement + set Coarsening fraction = 0.1 + set Refinement fraction = 0.9 + set Initial adaptive refinement = 2 + set Initial global refinement = 0 + set Strategy = composition threshold, minimum refinement function + set Time steps between mesh refinement = 1 + + # Minimum of 4 global refinements + subsection Minimum refinement function + set Function expression = 0 + end + + # Refine where the porosity is bigger than 1e-6. Other compositions + # are set to 1e50 to ensure that we do not refine based on these + # compositions. + subsection Composition threshold + set Compositional field thresholds = 1e-3, 1e50, 1e50 + end +end + + +# Output the darcy velocity +subsection Postprocess + set List of postprocessors = velocity statistics, visualization + + subsection Visualization + set List of output variables = darcy velocity + set Time between graphical output = 250 + set Output format = vtu + end +end diff --git a/tests/darcy_outflow/screen-output b/tests/darcy_outflow/screen-output new file mode 100644 index 00000000000..c153160f1b8 --- /dev/null +++ b/tests/darcy_outflow/screen-output @@ -0,0 +1,1405 @@ + +Loading shared library <./libno_dirichlet_on_outflow_melt.debug.so> + +Number of active cells: 64 (on 4 levels) +Number of degrees of freedom: 2,377 (578+273+578+81+289+289+289) + +*** Timestep 0: t=0 years, dt=0 years + Solving temperature system... 0 iterations. + Solving porosity system ... 0 iterations. + Solving peridotite system ... 0 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.39226e-16, 2.35269e-16, 2.35269e-16, 0.207036 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.207036 + + Solving temperature system... 0 iterations. + Solving porosity system ... 0 iterations. + Solving peridotite system ... 0 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 0+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.39226e-16, 2.35269e-16, 2.35269e-16, 5.71549e-08 + Relative nonlinear residual (total system) after nonlinear iteration 2: 5.71549e-08 + + + Postprocessing: + RMS, max velocity: 4.12 m/year, 11.6 m/year + Temperature min/avg/max: 0 K, 1567 K, 1600 K + Heat fluxes through boundary parts: 0 W, 0 W, -8.79e-13 W, 3.683e+04 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00000 + +*** Timestep 1: t=39.5348 years, dt=39.5348 years + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 12+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000120448, 0.303486, 0.0807578, 0.402275 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.402275 + + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00686249, 0.172935, 0.0148272, 0.0896193 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.172935 + + Solving temperature system... 5 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.15689e-05, 0.0509123, 0.00264539, 0.0139804 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.0509123 + + Solving temperature system... 5 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 3.32726e-05, 0.0293921, 0.00124907, 0.0142638 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.0293921 + + Solving temperature system... 5 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.05551e-05, 0.0137387, 0.000397403, 0.00661299 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.0137387 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.0646e-05, 0.00614305, 0.000153926, 0.00252927 + Relative nonlinear residual (total system) after nonlinear iteration 6: 0.00614305 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 5.0077e-06, 0.00289545, 9.88066e-05, 0.00127745 + Relative nonlinear residual (total system) after nonlinear iteration 7: 0.00289545 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.38563e-06, 0.00120707, 2.8251e-05, 0.0004316 + Relative nonlinear residual (total system) after nonlinear iteration 8: 0.00120707 + + Solving temperature system... 4 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.18219e-06, 0.000576977, 1.59819e-05, 0.0002269 + Relative nonlinear residual (total system) after nonlinear iteration 9: 0.000576977 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 6.01932e-07, 0.000270765, 5.33723e-06, 0.000101562 + Relative nonlinear residual (total system) after nonlinear iteration 10: 0.000270765 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 3.05736e-07, 0.000135736, 3.067e-06, 5.50291e-05 + Relative nonlinear residual (total system) after nonlinear iteration 11: 0.000135736 + + Solving temperature system... 3 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.49801e-07, 6.53758e-05, 1.13275e-06, 2.5827e-05 + Relative nonlinear residual (total system) after nonlinear iteration 12: 6.53758e-05 + + Solving temperature system... 3 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 4 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 8.1203e-08, 3.23345e-05, 7.0343e-07, 1.34611e-05 + Relative nonlinear residual (total system) after nonlinear iteration 13: 3.23345e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 4 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 3.13223e-08, 1.52135e-05, 2.56776e-07, 6.00965e-06 + Relative nonlinear residual (total system) after nonlinear iteration 14: 1.52135e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 4 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.48608e-08, 7.40323e-06, 1.61634e-07, 3.03815e-06 + Relative nonlinear residual (total system) after nonlinear iteration 15: 7.40323e-06 + + + Postprocessing: + RMS, max velocity: 5.13 m/year, 9 m/year + Temperature min/avg/max: -6.885 K, 1569 K, 1635 K + Heat fluxes through boundary parts: 0 W, 0 W, -8.067e+07 W, 4.997e+06 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00001 + +*** Timestep 2: t=64.6828 years, dt=25.148 years + Solving temperature system... 8 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 14+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00237772, 0.0623492, 0.0108182, 4.93916 + Relative nonlinear residual (total system) after nonlinear iteration 1: 4.93916 + + Solving temperature system... 7 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00208303, 0.0445278, 0.0037039, 0.0265552 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0445278 + + Solving temperature system... 5 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 5.79017e-06, 0.0066142, 0.000302739, 0.00294831 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.0066142 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.02001e-06, 0.00142139, 5.43384e-05, 0.000790997 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.00142139 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.76674e-07, 0.000318851, 5.16655e-06, 0.000168206 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.000318851 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.3817e-08, 5.26137e-05, 1.92522e-06, 2.27865e-05 + Relative nonlinear residual (total system) after nonlinear iteration 6: 5.26137e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 8.3455e-09, 1.23037e-05, 4.10567e-07, 6.70365e-06 + Relative nonlinear residual (total system) after nonlinear iteration 7: 1.23037e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 4 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.25944e-09, 3.0313e-06, 5.20612e-08, 1.51799e-06 + Relative nonlinear residual (total system) after nonlinear iteration 8: 3.0313e-06 + + + Postprocessing: + RMS, max velocity: 4.93 m/year, 9.8 m/year + Temperature min/avg/max: -4.239 K, 1571 K, 1647 K + Heat fluxes through boundary parts: 0 W, 0 W, -6.945e+07 W, 8.138e+06 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00002 + +*** Timestep 3: t=85.5991 years, dt=20.9163 years + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00296577, 0.0628754, 0.00515231, 0.745856 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.745856 + + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000961956, 0.0304563, 0.00198281, 0.0549036 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0549036 + + Solving temperature system... 4 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 8.10161e-06, 0.00753543, 0.000190451, 0.0106505 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.0106505 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.22638e-06, 0.000991616, 2.99366e-05, 0.00141959 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.00141959 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 5.42156e-08, 0.000116867, 3.79575e-06, 0.000160938 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.000160938 + + Solving temperature system... 2 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.45509e-08, 2.35961e-05, 5.56724e-07, 3.07415e-05 + Relative nonlinear residual (total system) after nonlinear iteration 6: 3.07415e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.16796e-09, 3.54154e-06, 1.21641e-07, 5.26297e-06 + Relative nonlinear residual (total system) after nonlinear iteration 7: 5.26297e-06 + + + Postprocessing: + RMS, max velocity: 4.61 m/year, 12.4 m/year + Temperature min/avg/max: 5.152 K, 1571 K, 1645 K + Heat fluxes through boundary parts: 0 W, 0 W, -2.369e+07 W, 4.109e+06 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00003 + +*** Timestep 4: t=105.229 years, dt=19.6297 years + Solving temperature system... 7 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00482291, 0.0658306, 0.00670986, 0.637537 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.637537 + + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00028834, 0.0216717, 0.00103474, 0.0417878 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0417878 + + Solving temperature system... 5 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.2247e-05, 0.00395526, 8.7579e-05, 0.00583143 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.00583143 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.45781e-06, 0.000607299, 1.68679e-05, 0.00106883 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.00106883 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 5.0618e-07, 8.85801e-05, 1.98356e-06, 0.000138052 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.000138052 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 9.50206e-08, 1.30164e-05, 2.91951e-07, 1.89774e-05 + Relative nonlinear residual (total system) after nonlinear iteration 6: 1.89774e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 5 iterations. + Solving peridotite system ... 4 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.5324e-08, 2.12314e-06, 4.64205e-08, 3.06101e-06 + Relative nonlinear residual (total system) after nonlinear iteration 7: 3.06101e-06 + + + Postprocessing: + RMS, max velocity: 6.22 m/year, 15.8 m/year + Temperature min/avg/max: 0 K, 1566 K, 1677 K + Heat fluxes through boundary parts: 0 W, 0 W, 2.982e+07 W, 4.692e+08 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00004 + +*** Timestep 5: t=124.417 years, dt=19.1885 years + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00677427, 0.0606526, 0.00739923, 0.469373 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.469373 + + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000238509, 0.0201089, 0.00114315, 0.0312088 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0312088 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.21482e-05, 0.00269264, 8.635e-05, 0.00282089 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.00282089 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.52029e-06, 0.000436174, 8.29326e-06, 0.000606033 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.000606033 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.23957e-07, 5.0978e-05, 1.58666e-06, 7.55264e-05 + Relative nonlinear residual (total system) after nonlinear iteration 5: 7.55264e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.22689e-08, 6.02431e-06, 1.32273e-07, 7.43268e-06 + Relative nonlinear residual (total system) after nonlinear iteration 6: 7.43268e-06 + + + Postprocessing: + RMS, max velocity: 8.07 m/year, 18.4 m/year + Temperature min/avg/max: 0 K, 1564 K, 1656 K + Heat fluxes through boundary parts: 0 W, 0 W, 7.037e+07 W, -3.462e+07 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00005 + +*** Timestep 6: t=143.756 years, dt=19.3385 years + Solving temperature system... 6 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00294547, 0.0517511, 0.00647987, 0.419438 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.419438 + + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000630857, 0.0156941, 0.00181253, 0.0213795 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0213795 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.0252e-05, 0.00273728, 0.000109876, 0.00301905 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.00301905 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.01674e-07, 0.00026272, 9.8591e-06, 0.000234633 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.00026272 + + Solving temperature system... 2 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.57943e-08, 2.98631e-05, 6.64318e-07, 3.03611e-05 + Relative nonlinear residual (total system) after nonlinear iteration 5: 3.03611e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 7.91751e-09, 4.45462e-06, 1.80242e-07, 5.00038e-06 + Relative nonlinear residual (total system) after nonlinear iteration 6: 5.00038e-06 + + + Postprocessing: + RMS, max velocity: 8.48 m/year, 19.1 m/year + Temperature min/avg/max: 0 K, 1560 K, 1663 K + Heat fluxes through boundary parts: 0 W, 0 W, 8.306e+07 W, 1.164e+08 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00006 + +*** Timestep 7: t=164.211 years, dt=20.4549 years + Solving temperature system... 6 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00131745, 0.0491653, 0.00572342, 0.455233 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.455233 + + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000881618, 0.0158264, 0.00210088, 0.0183464 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0183464 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 6.46373e-06, 0.00345732, 0.000166568, 0.00316867 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.00345732 + + Solving temperature system... 3 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.58982e-07, 0.000516328, 1.88448e-05, 0.000533455 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.000533455 + + Solving temperature system... 2 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 5.36872e-08, 5.75249e-05, 1.37277e-06, 5.91821e-05 + Relative nonlinear residual (total system) after nonlinear iteration 5: 5.91821e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 7.52085e-09, 6.86054e-06, 3.42196e-07, 5.77674e-06 + Relative nonlinear residual (total system) after nonlinear iteration 6: 6.86054e-06 + + + Postprocessing: + RMS, max velocity: 6.89 m/year, 17.4 m/year + Temperature min/avg/max: 0 K, 1557 K, 1669 K + Heat fluxes through boundary parts: 0 W, 0 W, 6.032e+07 W, 1.265e+08 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00007 + +*** Timestep 8: t=186.836 years, dt=22.6249 years + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00135888, 0.0550609, 0.00633394, 0.45446 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.45446 + + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000849024, 0.0153647, 0.00176161, 0.0159056 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0159056 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.38482e-06, 0.0030075, 0.000156467, 0.00192261 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.0030075 + + Solving temperature system... 3 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 7.25921e-07, 0.000547778, 2.38908e-05, 0.000444445 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.000547778 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.33124e-07, 8.59783e-05, 1.89844e-06, 8.79578e-05 + Relative nonlinear residual (total system) after nonlinear iteration 5: 8.79578e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.21323e-08, 1.18237e-05, 4.40986e-07, 1.03545e-05 + Relative nonlinear residual (total system) after nonlinear iteration 6: 1.18237e-05 + + Solving temperature system... 1 iterations. + Solving porosity system ... 5 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 2+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.43406e-09, 1.60598e-06, 8.73893e-08, 9.3246e-07 + Relative nonlinear residual (total system) after nonlinear iteration 7: 1.60598e-06 + + + Postprocessing: + RMS, max velocity: 3.98 m/year, 13.4 m/year + Temperature min/avg/max: 0 K, 1553 K, 1676 K + Heat fluxes through boundary parts: 0 W, 0 W, 4.608e+06 W, 1.391e+08 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00008 + +*** Timestep 9: t=213.252 years, dt=26.4158 years + Solving temperature system... 8 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00767243, 0.0796852, 0.00855338, 0.294792 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.294792 + + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000212632, 0.0254061, 0.00115102, 0.0263561 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0263561 + + Solving temperature system... 5 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.6764e-05, 0.00567828, 0.000357324, 0.00511939 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.00567828 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.03619e-06, 0.000765016, 4.87191e-05, 0.000560492 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.000765016 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 7.13446e-07, 0.000138563, 3.49504e-06, 0.000128993 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.000138563 + + Solving temperature system... 3 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.21721e-07, 3.81917e-05, 2.21216e-06, 3.07289e-05 + Relative nonlinear residual (total system) after nonlinear iteration 6: 3.81917e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.03252e-09, 6.46783e-06, 3.97912e-07, 4.60982e-06 + Relative nonlinear residual (total system) after nonlinear iteration 7: 6.46783e-06 + + + Postprocessing: + RMS, max velocity: 4.1 m/year, 7.79 m/year + Temperature min/avg/max: 11.69 K, 1552 K, 1697 K + Heat fluxes through boundary parts: 0 W, 0 W, -6.122e+07 W, 4.693e+06 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00009 + +*** Timestep 10: t=242.531 years, dt=29.2799 years + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 10 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00595139, 0.0767781, 0.011151, 0.221245 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.221245 + + Solving temperature system... 6 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 10 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00141542, 0.126127, 0.00547035, 0.0698508 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.126127 + + Solving temperature system... 6 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00048581, 0.0732049, 0.00562659, 0.0561899 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.0732049 + + Solving temperature system... 5 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000120482, 0.0275917, 0.00208265, 0.0178494 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.0275917 + + Solving temperature system... 5 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.66033e-05, 0.00838295, 0.00054197, 0.00483206 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.00838295 + + Solving temperature system... 4 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 6.40812e-06, 0.00290462, 8.37169e-05, 0.000996954 + Relative nonlinear residual (total system) after nonlinear iteration 6: 0.00290462 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 5.05777e-06, 0.00103495, 5.06058e-05, 0.000665993 + Relative nonlinear residual (total system) after nonlinear iteration 7: 0.00103495 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.03761e-06, 0.000393196, 2.85426e-05, 0.000294904 + Relative nonlinear residual (total system) after nonlinear iteration 8: 0.000393196 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 5.26447e-07, 0.000136079, 1.02408e-05, 8.99345e-05 + Relative nonlinear residual (total system) after nonlinear iteration 9: 0.000136079 + + Solving temperature system... 2 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 5.29044e-08, 4.21058e-05, 2.40491e-06, 1.80527e-05 + Relative nonlinear residual (total system) after nonlinear iteration 10: 4.21058e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 3.48298e-08, 1.33318e-05, 3.25115e-07, 5.00095e-06 + Relative nonlinear residual (total system) after nonlinear iteration 11: 1.33318e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 2+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.4521e-08, 4.93838e-06, 2.48253e-07, 3.26681e-06 + Relative nonlinear residual (total system) after nonlinear iteration 12: 4.93838e-06 + + + Postprocessing: + RMS, max velocity: 7.53 m/year, 13.4 m/year + Temperature min/avg/max: 39.75 K, 1552 K, 1703 K + Heat fluxes through boundary parts: 0 W, 0 W, -8.112e+07 W, 1.623e+07 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00010 + +*** Timestep 11: t=266.116 years, dt=23.5851 years + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 10 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00364226, 0.153826, 0.00943835, 0.187915 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.187915 + + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00108399, 0.05018, 0.00310755, 0.0319598 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.05018 + + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000244477, 0.0352974, 0.00174915, 0.0305696 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.0352974 + + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000120565, 0.022158, 0.00129764, 0.0210067 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.022158 + + Solving temperature system... 5 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.9953e-05, 0.0109947, 0.000660779, 0.0101789 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.0109947 + + Solving temperature system... 5 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.70912e-05, 0.00446686, 0.000267244, 0.0038555 + Relative nonlinear residual (total system) after nonlinear iteration 6: 0.00446686 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.8492e-06, 0.00156701, 9.09197e-05, 0.00123406 + Relative nonlinear residual (total system) after nonlinear iteration 7: 0.00156701 + + Solving temperature system... 3 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 9.87925e-07, 0.00046424, 2.52018e-05, 0.000309659 + Relative nonlinear residual (total system) after nonlinear iteration 8: 0.00046424 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 5.60478e-08, 0.000114211, 4.93329e-06, 4.83186e-05 + Relative nonlinear residual (total system) after nonlinear iteration 9: 0.000114211 + + Solving temperature system... 3 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.02356e-07, 2.6592e-05, 3.77699e-07, 1.32673e-05 + Relative nonlinear residual (total system) after nonlinear iteration 10: 2.6592e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 6.77087e-08, 1.22265e-05, 6.1493e-07, 1.21856e-05 + Relative nonlinear residual (total system) after nonlinear iteration 11: 1.22265e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 3.01855e-08, 6.41341e-06, 3.80581e-07, 6.27831e-06 + Relative nonlinear residual (total system) after nonlinear iteration 12: 6.41341e-06 + + + Postprocessing: + RMS, max velocity: 8.04 m/year, 17.4 m/year + Temperature min/avg/max: 77.97 K, 1553 K, 1706 K + Heat fluxes through boundary parts: 0 W, 0 W, -4.385e+07 W, 1.247e+07 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00011 + +*** Timestep 12: t=281.972 years, dt=15.855 years + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00155272, 0.104616, 0.00244142, 0.277687 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.277687 + + Solving temperature system... 6 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000325027, 0.0438314, 0.00267879, 0.066923 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.066923 + + Solving temperature system... 5 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.75543e-05, 0.0109321, 0.000543707, 0.0145981 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.0145981 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.63909e-06, 0.00229193, 0.000109111, 0.00263688 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.00263688 + + Solving temperature system... 3 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 9.30085e-07, 0.000381912, 1.2926e-05, 0.000292646 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.000381912 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 5.59725e-07, 9.90118e-05, 2.10982e-06, 0.000125132 + Relative nonlinear residual (total system) after nonlinear iteration 6: 0.000125132 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.32377e-07, 4.89513e-05, 2.12383e-06, 7.35235e-05 + Relative nonlinear residual (total system) after nonlinear iteration 7: 7.35235e-05 + + Solving temperature system... 3 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 8.17916e-08, 2.05567e-05, 9.89589e-07, 3.05673e-05 + Relative nonlinear residual (total system) after nonlinear iteration 8: 3.05673e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.57637e-08, 7.38002e-06, 3.67055e-07, 1.07492e-05 + Relative nonlinear residual (total system) after nonlinear iteration 9: 1.07492e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 5 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 7.50616e-09, 2.35745e-06, 1.21578e-07, 3.38053e-06 + Relative nonlinear residual (total system) after nonlinear iteration 10: 3.38053e-06 + + + Postprocessing: + RMS, max velocity: 6.7 m/year, 16.1 m/year + Temperature min/avg/max: 118.7 K, 1553 K, 1713 K + Heat fluxes through boundary parts: 0 W, 0 W, -2.144e+06 W, 1.934e+05 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00012 + +*** Timestep 13: t=295.928 years, dt=13.957 years + Solving temperature system... 8 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.0116042, 0.0557104, 0.00139306, 0.480105 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.480105 + + Solving temperature system... 6 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000878917, 0.186337, 0.00641076, 0.224627 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.224627 + + Solving temperature system... 5 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 7.34573e-05, 0.0140758, 5.88514e-05, 0.0121005 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.0140758 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.58041e-06, 0.000542499, 4.38681e-06, 0.000503784 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.000542499 + + Solving temperature system... 2 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 7.29704e-08, 2.4477e-05, 1.95923e-07, 1.38337e-05 + Relative nonlinear residual (total system) after nonlinear iteration 5: 2.4477e-05 + + Solving temperature system... 1 iterations. + Solving porosity system ... 5 iterations. + Solving peridotite system ... 4 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 2+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.54758e-09, 1.79023e-06, 5.49933e-09, 1.51311e-06 + Relative nonlinear residual (total system) after nonlinear iteration 6: 1.79023e-06 + + + Postprocessing: + RMS, max velocity: 2.81 m/year, 7.17 m/year + Temperature min/avg/max: 0 K, 1543 K, 1636 K + Heat fluxes through boundary parts: 0 W, 0 W, 3.545e+07 W, 1.209e+09 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00013 + +*** Timestep 14: t=322.586 years, dt=26.6578 years + Solving temperature system... 7 iterations. + Solving porosity system ... 11 iterations. + Solving peridotite system ... 10 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.0375635, 0.36299, 0.0271084, 0.811126 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.811126 + + Solving temperature system... 6 iterations. + Solving porosity system ... 11 iterations. + Solving peridotite system ... 10 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00341465, 0.339301, 0.02061, 0.116431 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.339301 + + Solving temperature system... 5 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000406454, 0.0428874, 0.000315483, 0.0146969 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.0428874 + + Solving temperature system... 4 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.7938e-05, 0.00208932, 2.52874e-05, 0.000784223 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.00208932 + + Solving temperature system... 3 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.12519e-06, 0.00011794, 1.88057e-06, 1.5621e-05 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.00011794 + + Solving temperature system... 2 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 3.77165e-08, 1.41147e-05, 1.05973e-07, 3.44724e-06 + Relative nonlinear residual (total system) after nonlinear iteration 6: 1.41147e-05 + + Solving temperature system... 1 iterations. + Solving porosity system ... 5 iterations. + Solving peridotite system ... 4 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 2+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 3.37423e-09, 1.55498e-06, 7.24657e-09, 4.62034e-07 + Relative nonlinear residual (total system) after nonlinear iteration 7: 1.55498e-06 + + + Postprocessing: + RMS, max velocity: 5.46 m/year, 9.44 m/year + Temperature min/avg/max: 0 K, 1536 K, 1643 K + Heat fluxes through boundary parts: 0 W, 0 W, 8.088e+07 W, -1.994e+08 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00014 + +*** Timestep 15: t=373.503 years, dt=50.9164 years + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 10 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00693167, 0.179581, 0.0140871, 0.904152 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.904152 + + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 10 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00810609, 0.0453294, 0.0167247, 0.035825 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0453294 + + Solving temperature system... 5 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.32948e-05, 0.00762089, 5.16766e-05, 0.00589304 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.00762089 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.99517e-06, 0.00145105, 1.57207e-05, 0.00079421 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.00145105 + + Solving temperature system... 3 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.08589e-07, 0.000317114, 3.25971e-06, 0.000122871 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.000317114 + + Solving temperature system... 2 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.10028e-07, 6.9964e-05, 4.89414e-07, 3.23593e-05 + Relative nonlinear residual (total system) after nonlinear iteration 6: 6.9964e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 3.08038e-08, 1.5724e-05, 7.62308e-08, 8.79795e-06 + Relative nonlinear residual (total system) after nonlinear iteration 7: 1.5724e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 4 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 7.10491e-09, 4.02331e-06, 2.04314e-08, 2.10861e-06 + Relative nonlinear residual (total system) after nonlinear iteration 8: 4.02331e-06 + + + Postprocessing: + RMS, max velocity: 1.12 m/year, 4.12 m/year + Temperature min/avg/max: 0 K, 1529 K, 1656 K + Heat fluxes through boundary parts: 0 W, 0 W, 9.667e+06 W, 5.413e+07 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00015 + +*** Timestep 16: t=470.753 years, dt=97.2503 years + Solving temperature system... 8 iterations. + Solving porosity system ... 11 iterations. + Solving peridotite system ... 10 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.0268999, 0.15647, 0.029386, 0.890046 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.890046 + + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 10 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.0118924, 0.0666144, 0.0237423, 0.0289947 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0666144 + + Solving temperature system... 5 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000167722, 0.0267307, 0.000717407, 0.0258194 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.0267307 + + Solving temperature system... 4 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.29663e-05, 0.00700152, 0.000206393, 0.00404278 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.00700152 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.81891e-06, 0.00124352, 3.3424e-05, 0.000444508 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.00124352 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.59482e-07, 0.000148792, 3.08048e-06, 2.87634e-05 + Relative nonlinear residual (total system) after nonlinear iteration 6: 0.000148792 + + Solving temperature system... 2 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 7.8709e-08, 1.6419e-05, 1.33031e-07, 1.11832e-05 + Relative nonlinear residual (total system) after nonlinear iteration 7: 1.6419e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.33022e-08, 4.22943e-06, 1.03142e-07, 2.86856e-06 + Relative nonlinear residual (total system) after nonlinear iteration 8: 4.22943e-06 + + + Postprocessing: + RMS, max velocity: 0.611 m/year, 2.86 m/year + Temperature min/avg/max: 70.42 K, 1523 K, 1687 K + Heat fluxes through boundary parts: 0 W, 0 W, -1.35e+06 W, -1.147e+05 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00016 + +*** Timestep 17: t=500 years, dt=29.2471 years + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00533205, 0.0308694, 0.00181649, 0.328549 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.328549 + + Solving temperature system... 7 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 10 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00291058, 0.0196465, 0.00625149, 0.0117803 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0196465 + + Solving temperature system... 4 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.60815e-05, 0.00219514, 8.92948e-06, 0.00106148 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.00219514 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 8.38222e-07, 3.53873e-05, 4.24751e-07, 1.42965e-05 + Relative nonlinear residual (total system) after nonlinear iteration 4: 3.53873e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 4 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.19083e-08, 1.96485e-06, 1.05281e-08, 7.17722e-07 + Relative nonlinear residual (total system) after nonlinear iteration 5: 1.96485e-06 + + + Postprocessing: + RMS, max velocity: 4.5 m/year, 7.78 m/year + Temperature min/avg/max: 0 K, 1518 K, 1689 K + Heat fluxes through boundary parts: 0 W, 0 W, 6.82e+07 W, 1.315e+08 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00017 + +Termination requested by criterion: end time + + + diff --git a/tests/darcy_outflow/statistics b/tests/darcy_outflow/statistics new file mode 100644 index 00000000000..b3bd66a169b --- /dev/null +++ b/tests/darcy_outflow/statistics @@ -0,0 +1,43 @@ +# 1: Time step number +# 2: Time (years) +# 3: Time step size (years) +# 4: Number of mesh cells +# 5: Number of Stokes degrees of freedom +# 6: Number of temperature degrees of freedom +# 7: Number of degrees of freedom for all compositions +# 8: Number of nonlinear iterations +# 9: Iterations for temperature solver +# 10: Iterations for composition solver 1 +# 11: Iterations for composition solver 2 +# 12: Iterations for Stokes solver +# 13: Velocity iterations in Stokes preconditioner +# 14: Schur complement iterations in Stokes preconditioner +# 15: RMS velocity (m/year) +# 16: Max. velocity (m/year) +# 17: Minimal temperature (K) +# 18: Average temperature (K) +# 19: Maximal temperature (K) +# 20: Average nondimensional temperature (K) +# 21: Outward heat flux through boundary with indicator 0 ("left") (W) +# 22: Outward heat flux through boundary with indicator 1 ("right") (W) +# 23: Outward heat flux through boundary with indicator 2 ("bottom") (W) +# 24: Outward heat flux through boundary with indicator 3 ("top") (W) +# 25: Visualization file name + 0 0.000000000000e+00 0.000000000000e+00 64 659 289 578 2 0 0 0 6 9 517 4.11692815e+00 1.15978851e+01 0.00000000e+00 1.56666667e+03 1.60000000e+03 9.79166667e-01 0.00000000e+00 0.00000000e+00 -8.78970421e-13 3.68266407e+04 output-no_dirichlet_on_outflow_melt/solution/solution-00000 + 1 3.953477186241e+01 3.953477186241e+01 64 659 289 578 15 60 115 91 81 111 7843 5.13162885e+00 8.99506653e+00 -6.88527805e+00 1.56927894e+03 1.63539142e+03 9.85102639e-01 0.00000000e+00 0.00000000e+00 -8.06711846e+07 4.99656125e+06 output-no_dirichlet_on_outflow_melt/solution/solution-00001 + 2 6.468276034284e+01 2.514798848044e+01 64 659 289 578 8 34 61 54 44 60 3879 4.92727370e+00 9.80304746e+00 -4.23895187e+00 1.57072961e+03 1.64743268e+03 9.84355352e-01 0.00000000e+00 0.00000000e+00 -6.94537972e+07 8.13806130e+06 output-no_dirichlet_on_outflow_melt/solution/solution-00002 + 3 8.559909759444e+01 2.091633725159e+01 64 659 289 578 7 28 56 48 38 52 3170 4.60918708e+00 1.24004107e+01 5.15243116e+00 1.57135338e+03 1.64456318e+03 9.78875591e-01 0.00000000e+00 0.00000000e+00 -2.36896618e+07 4.10920218e+06 output-no_dirichlet_on_outflow_melt/solution/solution-00003 + 4 1.052288151043e+02 1.962971750988e+01 64 659 289 578 7 29 52 46 40 54 3005 6.22209518e+00 1.58221795e+01 0.00000000e+00 1.56594199e+03 1.67713187e+03 9.78713741e-01 0.00000000e+00 0.00000000e+00 2.98226099e+07 4.69202439e+08 output-no_dirichlet_on_outflow_melt/solution/solution-00004 + 5 1.244173201937e+02 1.918850508937e+01 64 659 289 578 6 26 48 43 35 47 2617 8.07043529e+00 1.84379967e+01 0.00000000e+00 1.56365242e+03 1.65577221e+03 9.77282764e-01 0.00000000e+00 0.00000000e+00 7.03672407e+07 -3.46182513e+07 output-no_dirichlet_on_outflow_melt/solution/solution-00005 + 6 1.437558525783e+02 1.933853238460e+01 64 659 289 578 6 23 47 43 31 43 2289 8.48335489e+00 1.91485229e+01 0.00000000e+00 1.56045449e+03 1.66341594e+03 9.75284057e-01 0.00000000e+00 0.00000000e+00 8.30600745e+07 1.16420252e+08 output-no_dirichlet_on_outflow_melt/solution/solution-00006 + 7 1.642107766017e+02 2.045492402338e+01 64 659 289 578 6 23 48 44 32 44 1945 6.88908830e+00 1.74350678e+01 0.00000000e+00 1.55679658e+03 1.66922225e+03 9.72997860e-01 0.00000000e+00 0.00000000e+00 6.03206781e+07 1.26495945e+08 output-no_dirichlet_on_outflow_melt/solution/solution-00007 + 8 1.868356746457e+02 2.262489804402e+01 64 659 289 578 7 26 53 49 32 46 2169 3.97522263e+00 1.34357353e+01 0.00000000e+00 1.55309350e+03 1.67592042e+03 9.70683438e-01 0.00000000e+00 0.00000000e+00 4.60787024e+06 1.39113426e+08 output-no_dirichlet_on_outflow_melt/solution/solution-00008 + 9 2.132515096155e+02 2.641583496978e+01 64 659 289 578 7 31 54 50 38 52 2042 4.10166487e+00 7.78575497e+00 1.16947408e+01 1.55177050e+03 1.69673926e+03 9.62547351e-01 0.00000000e+00 0.00000000e+00 -6.12161176e+07 4.69343433e+06 output-no_dirichlet_on_outflow_melt/solution/solution-00009 +10 2.425314210194e+02 2.927991140392e+01 64 659 289 578 12 50 99 92 70 94 2839 7.52931080e+00 1.34433882e+01 3.97534161e+01 1.55198778e+03 1.70254200e+03 9.45146478e-01 0.00000000e+00 0.00000000e+00 -8.11212590e+07 1.62282634e+07 output-no_dirichlet_on_outflow_melt/solution/solution-00010 +11 2.661164862305e+02 2.358506521108e+01 64 659 289 578 12 52 95 92 68 92 2679 8.03836600e+00 1.73851839e+01 7.79684908e+01 1.55253849e+03 1.70627841e+03 9.21606248e-01 0.00000000e+00 0.00000000e+00 -4.38520070e+07 1.24677649e+07 output-no_dirichlet_on_outflow_melt/solution/solution-00011 +12 2.819715054222e+02 1.585501919170e+01 64 659 289 578 10 38 76 70 48 68 1684 6.69717739e+00 1.61455302e+01 1.18664979e+02 1.55282755e+03 1.71265180e+03 8.96351608e-01 0.00000000e+00 0.00000000e+00 -2.14362204e+06 1.93383428e+05 output-no_dirichlet_on_outflow_melt/solution/solution-00012 +13 2.959284635451e+02 1.395695812296e+01 64 659 289 578 6 26 49 40 32 44 1367 2.80867157e+00 7.17302152e+00 0.00000000e+00 1.54276410e+03 1.63616765e+03 9.64227563e-01 0.00000000e+00 0.00000000e+00 3.54531846e+07 1.20910845e+09 output-no_dirichlet_on_outflow_melt/solution/solution-00013 +14 3.225862535600e+02 2.665779001485e+01 64 659 289 578 7 28 61 50 41 55 1793 5.46205859e+00 9.43627503e+00 0.00000000e+00 1.53626073e+03 1.64278841e+03 9.60162953e-01 0.00000000e+00 0.00000000e+00 8.08810972e+07 -1.99359171e+08 output-no_dirichlet_on_outflow_melt/solution/solution-00014 +15 3.735026324883e+02 5.091637892836e+01 64 659 289 578 8 32 65 55 49 65 2706 1.12037112e+00 4.11742767e+00 0.00000000e+00 1.52904488e+03 1.65585217e+03 9.55653051e-01 0.00000000e+00 0.00000000e+00 9.66722569e+06 5.41328085e+07 output-no_dirichlet_on_outflow_melt/solution/solution-00015 +16 4.707529162415e+02 9.725028375316e+01 64 659 289 578 8 35 68 59 52 68 2439 6.11045672e-01 2.85853948e+00 7.04159636e+01 1.52260846e+03 1.68685446e+03 9.07620313e-01 0.00000000e+00 0.00000000e+00 -1.34953400e+06 -1.14695389e+05 output-no_dirichlet_on_outflow_melt/solution/solution-00016 +17 5.000000000000e+02 2.924708375849e+01 64 659 289 578 5 23 41 36 31 41 1477 4.49517702e+00 7.77740431e+00 0.00000000e+00 1.51776128e+03 1.68926978e+03 9.48600803e-01 0.00000000e+00 0.00000000e+00 6.81955222e+07 1.31470585e+08 output-no_dirichlet_on_outflow_melt/solution/solution-00017 diff --git a/tests/fluid_outflow.prm b/tests/fluid_outflow.prm new file mode 100644 index 00000000000..24d0b5a4435 --- /dev/null +++ b/tests/fluid_outflow.prm @@ -0,0 +1,182 @@ +# This test defines an initial blob of porosity implaced in a solid within a 2D cartesian box. +# Because the porosity blob is less dense, the blob will rise to the surface of the model and +# flow out of the top of the box. This tests the implementation of composition dependent outflow +# boundary conditions when a composition is advected with the fluid velocity. +set Dimension = 2 +set Use years in output instead of seconds = true +set End time = 10e3 +set Pressure normalization = surface +set Maximum time step = 100 +set CFL number = 0.5 +set Surface pressure = 0 +set Use operator splitting = true +set Output directory = output-fluid +set Nonlinear solver scheme = iterated Advection and Stokes +set Max nonlinear iterations = 3 + +# Define a function which +subsection Boundary velocity model + set Prescribed velocity boundary indicators = top:function, bottom:function, right:function, left:function + + subsection Function + set Variable names = x,y, + set Function expression = 0;-0.1 + end +end + +subsection Gravity model + set Model name = vertical + + subsection Vertical + set Magnitude = 10 + end +end + +subsection Formulation + set Formulation = Boussinesq approximation +end + +subsection Solver parameters + set Temperature solver tolerance = 1e-10 +end + +# 10 km x 10 km box +subsection Geometry model + set Model name = box + + subsection Box + set X extent = 7.5e3 + set Y extent = 7.5e3 + + set X repetitions = 10 + set Y repetitions = 10 + end +end + +# Uniform temperature of 293 K +subsection Initial temperature model + set Model name = function + + subsection Function + set Function expression = 293 + end +end + +subsection Adiabatic conditions model + set Model name = function + + subsection Function + set Variable names = z + set Function expression = 293; 3.3e4*z; 3300 + end +end + +subsection Boundary temperature model + set Allow fixed temperature on outflow boundaries = false + set List of model names = box + set Fixed temperature boundary indicators = top, bottom, left, right + + subsection Box + set Bottom temperature = 293 + set Top temperature = 293 + set Left temperature = 293 + set Right temperature = 293 + end +end + +subsection Compositional fields + set Number of fields = 3 + set Names of fields = porosity, bound_fluid, solid_phase + set Compositional field methods = field, field, field +end + +subsection Melt settings + set Include melt transport = true +end + +# Initialize a porosity of 1% (0.01) everywhere. +subsection Initial composition model + set Model name = function + + subsection Function + set Variable names = x,y,t + set Function constants = pi=3.1415926, x0=3750, y0=3750, c=1000 + set Function expression = 0.01 * exp(-((x-x0)*(x-x0)+(y-y0)*(y-y0))/(2*c*c)); 0.0; if(y>=7000, 1, 0) + end +end + +subsection Boundary composition model + set Fixed composition boundary indicators = bottom, top + set Allow fixed composition on outflow boundaries = false + set List of model names = initial composition +end + +subsection Material model + set Model name = reactive fluid transport + set Material averaging = geometric average only viscosity + + subsection Reactive Fluid Transport Model + set Base model = visco plastic + set Reference fluid density = 1000 # density of water + set Shear to bulk viscosity ratio = 1 + set Reference fluid viscosity = 1 + set Reference permeability = 1e-6 + set Exponential fluid weakening factor = 0 + set Fluid compressibility = 0 + set Fluid reaction time scale for operator splitting = 1e50 + set Fluid-solid reaction scheme = zero solubility + + set Maximum compaction viscosity = 1e19 + set Minimum compaction viscosity = 1e19 + end + + subsection Visco Plastic + set Viscosity averaging scheme = geometric + set Viscous flow law = diffusion + set Prefactors for diffusion creep = 5e-19 + set Stress exponents for diffusion creep = 1.0 + set Activation energies for diffusion creep = 0 + set Activation volumes for diffusion creep = 0 + set Densities = 3000 + + set Angles of internal friction = 0 + set Cohesions = 1e50 + + set Minimum viscosity = 1e19 + set Maximum viscosity = 1e19 + set Thermal expansivities = 0 + end +end + +# Set the global refinement to 0, 1 km x 1 km mesh. +subsection Mesh refinement + set Coarsening fraction = 0.1 + set Refinement fraction = 0.9 + set Initial adaptive refinement = 2 + set Initial global refinement = 0 + set Strategy = composition threshold, minimum refinement function + set Time steps between mesh refinement = 1 + + # Minimum of 4 global refinements + subsection Minimum refinement function + set Function expression = 0 + end + + # Refine where the porosity is bigger than 1e-6. Other compositions + # are set to 1e50 to ensure that we do not refine based on these + # compositions. + subsection Composition threshold + set Compositional field thresholds = 1e-3, 1e50, 1e50 + end +end + +# Output the darcy velocity +subsection Postprocess + set List of postprocessors = velocity statistics, visualization + + subsection Visualization + set Time between graphical output = 250 + set Output format = vtu + end +end + diff --git a/tests/fluid_outflow/screen-output b/tests/fluid_outflow/screen-output new file mode 100644 index 00000000000..c153160f1b8 --- /dev/null +++ b/tests/fluid_outflow/screen-output @@ -0,0 +1,1405 @@ + +Loading shared library <./libno_dirichlet_on_outflow_melt.debug.so> + +Number of active cells: 64 (on 4 levels) +Number of degrees of freedom: 2,377 (578+273+578+81+289+289+289) + +*** Timestep 0: t=0 years, dt=0 years + Solving temperature system... 0 iterations. + Solving porosity system ... 0 iterations. + Solving peridotite system ... 0 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.39226e-16, 2.35269e-16, 2.35269e-16, 0.207036 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.207036 + + Solving temperature system... 0 iterations. + Solving porosity system ... 0 iterations. + Solving peridotite system ... 0 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 0+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.39226e-16, 2.35269e-16, 2.35269e-16, 5.71549e-08 + Relative nonlinear residual (total system) after nonlinear iteration 2: 5.71549e-08 + + + Postprocessing: + RMS, max velocity: 4.12 m/year, 11.6 m/year + Temperature min/avg/max: 0 K, 1567 K, 1600 K + Heat fluxes through boundary parts: 0 W, 0 W, -8.79e-13 W, 3.683e+04 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00000 + +*** Timestep 1: t=39.5348 years, dt=39.5348 years + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 12+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000120448, 0.303486, 0.0807578, 0.402275 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.402275 + + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00686249, 0.172935, 0.0148272, 0.0896193 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.172935 + + Solving temperature system... 5 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.15689e-05, 0.0509123, 0.00264539, 0.0139804 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.0509123 + + Solving temperature system... 5 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 3.32726e-05, 0.0293921, 0.00124907, 0.0142638 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.0293921 + + Solving temperature system... 5 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.05551e-05, 0.0137387, 0.000397403, 0.00661299 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.0137387 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.0646e-05, 0.00614305, 0.000153926, 0.00252927 + Relative nonlinear residual (total system) after nonlinear iteration 6: 0.00614305 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 5.0077e-06, 0.00289545, 9.88066e-05, 0.00127745 + Relative nonlinear residual (total system) after nonlinear iteration 7: 0.00289545 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.38563e-06, 0.00120707, 2.8251e-05, 0.0004316 + Relative nonlinear residual (total system) after nonlinear iteration 8: 0.00120707 + + Solving temperature system... 4 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.18219e-06, 0.000576977, 1.59819e-05, 0.0002269 + Relative nonlinear residual (total system) after nonlinear iteration 9: 0.000576977 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 6.01932e-07, 0.000270765, 5.33723e-06, 0.000101562 + Relative nonlinear residual (total system) after nonlinear iteration 10: 0.000270765 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 3.05736e-07, 0.000135736, 3.067e-06, 5.50291e-05 + Relative nonlinear residual (total system) after nonlinear iteration 11: 0.000135736 + + Solving temperature system... 3 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.49801e-07, 6.53758e-05, 1.13275e-06, 2.5827e-05 + Relative nonlinear residual (total system) after nonlinear iteration 12: 6.53758e-05 + + Solving temperature system... 3 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 4 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 8.1203e-08, 3.23345e-05, 7.0343e-07, 1.34611e-05 + Relative nonlinear residual (total system) after nonlinear iteration 13: 3.23345e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 4 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 3.13223e-08, 1.52135e-05, 2.56776e-07, 6.00965e-06 + Relative nonlinear residual (total system) after nonlinear iteration 14: 1.52135e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 4 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.48608e-08, 7.40323e-06, 1.61634e-07, 3.03815e-06 + Relative nonlinear residual (total system) after nonlinear iteration 15: 7.40323e-06 + + + Postprocessing: + RMS, max velocity: 5.13 m/year, 9 m/year + Temperature min/avg/max: -6.885 K, 1569 K, 1635 K + Heat fluxes through boundary parts: 0 W, 0 W, -8.067e+07 W, 4.997e+06 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00001 + +*** Timestep 2: t=64.6828 years, dt=25.148 years + Solving temperature system... 8 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 14+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00237772, 0.0623492, 0.0108182, 4.93916 + Relative nonlinear residual (total system) after nonlinear iteration 1: 4.93916 + + Solving temperature system... 7 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00208303, 0.0445278, 0.0037039, 0.0265552 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0445278 + + Solving temperature system... 5 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 5.79017e-06, 0.0066142, 0.000302739, 0.00294831 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.0066142 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.02001e-06, 0.00142139, 5.43384e-05, 0.000790997 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.00142139 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.76674e-07, 0.000318851, 5.16655e-06, 0.000168206 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.000318851 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.3817e-08, 5.26137e-05, 1.92522e-06, 2.27865e-05 + Relative nonlinear residual (total system) after nonlinear iteration 6: 5.26137e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 8.3455e-09, 1.23037e-05, 4.10567e-07, 6.70365e-06 + Relative nonlinear residual (total system) after nonlinear iteration 7: 1.23037e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 4 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.25944e-09, 3.0313e-06, 5.20612e-08, 1.51799e-06 + Relative nonlinear residual (total system) after nonlinear iteration 8: 3.0313e-06 + + + Postprocessing: + RMS, max velocity: 4.93 m/year, 9.8 m/year + Temperature min/avg/max: -4.239 K, 1571 K, 1647 K + Heat fluxes through boundary parts: 0 W, 0 W, -6.945e+07 W, 8.138e+06 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00002 + +*** Timestep 3: t=85.5991 years, dt=20.9163 years + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00296577, 0.0628754, 0.00515231, 0.745856 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.745856 + + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000961956, 0.0304563, 0.00198281, 0.0549036 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0549036 + + Solving temperature system... 4 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 8.10161e-06, 0.00753543, 0.000190451, 0.0106505 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.0106505 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.22638e-06, 0.000991616, 2.99366e-05, 0.00141959 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.00141959 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 5.42156e-08, 0.000116867, 3.79575e-06, 0.000160938 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.000160938 + + Solving temperature system... 2 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.45509e-08, 2.35961e-05, 5.56724e-07, 3.07415e-05 + Relative nonlinear residual (total system) after nonlinear iteration 6: 3.07415e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.16796e-09, 3.54154e-06, 1.21641e-07, 5.26297e-06 + Relative nonlinear residual (total system) after nonlinear iteration 7: 5.26297e-06 + + + Postprocessing: + RMS, max velocity: 4.61 m/year, 12.4 m/year + Temperature min/avg/max: 5.152 K, 1571 K, 1645 K + Heat fluxes through boundary parts: 0 W, 0 W, -2.369e+07 W, 4.109e+06 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00003 + +*** Timestep 4: t=105.229 years, dt=19.6297 years + Solving temperature system... 7 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00482291, 0.0658306, 0.00670986, 0.637537 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.637537 + + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00028834, 0.0216717, 0.00103474, 0.0417878 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0417878 + + Solving temperature system... 5 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.2247e-05, 0.00395526, 8.7579e-05, 0.00583143 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.00583143 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.45781e-06, 0.000607299, 1.68679e-05, 0.00106883 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.00106883 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 5.0618e-07, 8.85801e-05, 1.98356e-06, 0.000138052 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.000138052 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 9.50206e-08, 1.30164e-05, 2.91951e-07, 1.89774e-05 + Relative nonlinear residual (total system) after nonlinear iteration 6: 1.89774e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 5 iterations. + Solving peridotite system ... 4 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.5324e-08, 2.12314e-06, 4.64205e-08, 3.06101e-06 + Relative nonlinear residual (total system) after nonlinear iteration 7: 3.06101e-06 + + + Postprocessing: + RMS, max velocity: 6.22 m/year, 15.8 m/year + Temperature min/avg/max: 0 K, 1566 K, 1677 K + Heat fluxes through boundary parts: 0 W, 0 W, 2.982e+07 W, 4.692e+08 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00004 + +*** Timestep 5: t=124.417 years, dt=19.1885 years + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00677427, 0.0606526, 0.00739923, 0.469373 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.469373 + + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000238509, 0.0201089, 0.00114315, 0.0312088 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0312088 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.21482e-05, 0.00269264, 8.635e-05, 0.00282089 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.00282089 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.52029e-06, 0.000436174, 8.29326e-06, 0.000606033 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.000606033 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.23957e-07, 5.0978e-05, 1.58666e-06, 7.55264e-05 + Relative nonlinear residual (total system) after nonlinear iteration 5: 7.55264e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.22689e-08, 6.02431e-06, 1.32273e-07, 7.43268e-06 + Relative nonlinear residual (total system) after nonlinear iteration 6: 7.43268e-06 + + + Postprocessing: + RMS, max velocity: 8.07 m/year, 18.4 m/year + Temperature min/avg/max: 0 K, 1564 K, 1656 K + Heat fluxes through boundary parts: 0 W, 0 W, 7.037e+07 W, -3.462e+07 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00005 + +*** Timestep 6: t=143.756 years, dt=19.3385 years + Solving temperature system... 6 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00294547, 0.0517511, 0.00647987, 0.419438 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.419438 + + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000630857, 0.0156941, 0.00181253, 0.0213795 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0213795 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.0252e-05, 0.00273728, 0.000109876, 0.00301905 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.00301905 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.01674e-07, 0.00026272, 9.8591e-06, 0.000234633 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.00026272 + + Solving temperature system... 2 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.57943e-08, 2.98631e-05, 6.64318e-07, 3.03611e-05 + Relative nonlinear residual (total system) after nonlinear iteration 5: 3.03611e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 7.91751e-09, 4.45462e-06, 1.80242e-07, 5.00038e-06 + Relative nonlinear residual (total system) after nonlinear iteration 6: 5.00038e-06 + + + Postprocessing: + RMS, max velocity: 8.48 m/year, 19.1 m/year + Temperature min/avg/max: 0 K, 1560 K, 1663 K + Heat fluxes through boundary parts: 0 W, 0 W, 8.306e+07 W, 1.164e+08 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00006 + +*** Timestep 7: t=164.211 years, dt=20.4549 years + Solving temperature system... 6 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00131745, 0.0491653, 0.00572342, 0.455233 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.455233 + + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000881618, 0.0158264, 0.00210088, 0.0183464 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0183464 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 6.46373e-06, 0.00345732, 0.000166568, 0.00316867 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.00345732 + + Solving temperature system... 3 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.58982e-07, 0.000516328, 1.88448e-05, 0.000533455 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.000533455 + + Solving temperature system... 2 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 5.36872e-08, 5.75249e-05, 1.37277e-06, 5.91821e-05 + Relative nonlinear residual (total system) after nonlinear iteration 5: 5.91821e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 7.52085e-09, 6.86054e-06, 3.42196e-07, 5.77674e-06 + Relative nonlinear residual (total system) after nonlinear iteration 6: 6.86054e-06 + + + Postprocessing: + RMS, max velocity: 6.89 m/year, 17.4 m/year + Temperature min/avg/max: 0 K, 1557 K, 1669 K + Heat fluxes through boundary parts: 0 W, 0 W, 6.032e+07 W, 1.265e+08 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00007 + +*** Timestep 8: t=186.836 years, dt=22.6249 years + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00135888, 0.0550609, 0.00633394, 0.45446 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.45446 + + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000849024, 0.0153647, 0.00176161, 0.0159056 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0159056 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.38482e-06, 0.0030075, 0.000156467, 0.00192261 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.0030075 + + Solving temperature system... 3 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 7.25921e-07, 0.000547778, 2.38908e-05, 0.000444445 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.000547778 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.33124e-07, 8.59783e-05, 1.89844e-06, 8.79578e-05 + Relative nonlinear residual (total system) after nonlinear iteration 5: 8.79578e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.21323e-08, 1.18237e-05, 4.40986e-07, 1.03545e-05 + Relative nonlinear residual (total system) after nonlinear iteration 6: 1.18237e-05 + + Solving temperature system... 1 iterations. + Solving porosity system ... 5 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 2+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.43406e-09, 1.60598e-06, 8.73893e-08, 9.3246e-07 + Relative nonlinear residual (total system) after nonlinear iteration 7: 1.60598e-06 + + + Postprocessing: + RMS, max velocity: 3.98 m/year, 13.4 m/year + Temperature min/avg/max: 0 K, 1553 K, 1676 K + Heat fluxes through boundary parts: 0 W, 0 W, 4.608e+06 W, 1.391e+08 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00008 + +*** Timestep 9: t=213.252 years, dt=26.4158 years + Solving temperature system... 8 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00767243, 0.0796852, 0.00855338, 0.294792 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.294792 + + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000212632, 0.0254061, 0.00115102, 0.0263561 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0263561 + + Solving temperature system... 5 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.6764e-05, 0.00567828, 0.000357324, 0.00511939 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.00567828 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.03619e-06, 0.000765016, 4.87191e-05, 0.000560492 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.000765016 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 7.13446e-07, 0.000138563, 3.49504e-06, 0.000128993 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.000138563 + + Solving temperature system... 3 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.21721e-07, 3.81917e-05, 2.21216e-06, 3.07289e-05 + Relative nonlinear residual (total system) after nonlinear iteration 6: 3.81917e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.03252e-09, 6.46783e-06, 3.97912e-07, 4.60982e-06 + Relative nonlinear residual (total system) after nonlinear iteration 7: 6.46783e-06 + + + Postprocessing: + RMS, max velocity: 4.1 m/year, 7.79 m/year + Temperature min/avg/max: 11.69 K, 1552 K, 1697 K + Heat fluxes through boundary parts: 0 W, 0 W, -6.122e+07 W, 4.693e+06 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00009 + +*** Timestep 10: t=242.531 years, dt=29.2799 years + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 10 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00595139, 0.0767781, 0.011151, 0.221245 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.221245 + + Solving temperature system... 6 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 10 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00141542, 0.126127, 0.00547035, 0.0698508 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.126127 + + Solving temperature system... 6 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00048581, 0.0732049, 0.00562659, 0.0561899 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.0732049 + + Solving temperature system... 5 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000120482, 0.0275917, 0.00208265, 0.0178494 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.0275917 + + Solving temperature system... 5 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.66033e-05, 0.00838295, 0.00054197, 0.00483206 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.00838295 + + Solving temperature system... 4 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 6.40812e-06, 0.00290462, 8.37169e-05, 0.000996954 + Relative nonlinear residual (total system) after nonlinear iteration 6: 0.00290462 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 5.05777e-06, 0.00103495, 5.06058e-05, 0.000665993 + Relative nonlinear residual (total system) after nonlinear iteration 7: 0.00103495 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.03761e-06, 0.000393196, 2.85426e-05, 0.000294904 + Relative nonlinear residual (total system) after nonlinear iteration 8: 0.000393196 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 5.26447e-07, 0.000136079, 1.02408e-05, 8.99345e-05 + Relative nonlinear residual (total system) after nonlinear iteration 9: 0.000136079 + + Solving temperature system... 2 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 5.29044e-08, 4.21058e-05, 2.40491e-06, 1.80527e-05 + Relative nonlinear residual (total system) after nonlinear iteration 10: 4.21058e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 3.48298e-08, 1.33318e-05, 3.25115e-07, 5.00095e-06 + Relative nonlinear residual (total system) after nonlinear iteration 11: 1.33318e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 2+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.4521e-08, 4.93838e-06, 2.48253e-07, 3.26681e-06 + Relative nonlinear residual (total system) after nonlinear iteration 12: 4.93838e-06 + + + Postprocessing: + RMS, max velocity: 7.53 m/year, 13.4 m/year + Temperature min/avg/max: 39.75 K, 1552 K, 1703 K + Heat fluxes through boundary parts: 0 W, 0 W, -8.112e+07 W, 1.623e+07 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00010 + +*** Timestep 11: t=266.116 years, dt=23.5851 years + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 10 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00364226, 0.153826, 0.00943835, 0.187915 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.187915 + + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00108399, 0.05018, 0.00310755, 0.0319598 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.05018 + + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000244477, 0.0352974, 0.00174915, 0.0305696 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.0352974 + + Solving temperature system... 6 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000120565, 0.022158, 0.00129764, 0.0210067 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.022158 + + Solving temperature system... 5 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.9953e-05, 0.0109947, 0.000660779, 0.0101789 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.0109947 + + Solving temperature system... 5 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.70912e-05, 0.00446686, 0.000267244, 0.0038555 + Relative nonlinear residual (total system) after nonlinear iteration 6: 0.00446686 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.8492e-06, 0.00156701, 9.09197e-05, 0.00123406 + Relative nonlinear residual (total system) after nonlinear iteration 7: 0.00156701 + + Solving temperature system... 3 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 9.87925e-07, 0.00046424, 2.52018e-05, 0.000309659 + Relative nonlinear residual (total system) after nonlinear iteration 8: 0.00046424 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 5.60478e-08, 0.000114211, 4.93329e-06, 4.83186e-05 + Relative nonlinear residual (total system) after nonlinear iteration 9: 0.000114211 + + Solving temperature system... 3 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.02356e-07, 2.6592e-05, 3.77699e-07, 1.32673e-05 + Relative nonlinear residual (total system) after nonlinear iteration 10: 2.6592e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 6.77087e-08, 1.22265e-05, 6.1493e-07, 1.21856e-05 + Relative nonlinear residual (total system) after nonlinear iteration 11: 1.22265e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 3.01855e-08, 6.41341e-06, 3.80581e-07, 6.27831e-06 + Relative nonlinear residual (total system) after nonlinear iteration 12: 6.41341e-06 + + + Postprocessing: + RMS, max velocity: 8.04 m/year, 17.4 m/year + Temperature min/avg/max: 77.97 K, 1553 K, 1706 K + Heat fluxes through boundary parts: 0 W, 0 W, -4.385e+07 W, 1.247e+07 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00011 + +*** Timestep 12: t=281.972 years, dt=15.855 years + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00155272, 0.104616, 0.00244142, 0.277687 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.277687 + + Solving temperature system... 6 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000325027, 0.0438314, 0.00267879, 0.066923 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.066923 + + Solving temperature system... 5 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.75543e-05, 0.0109321, 0.000543707, 0.0145981 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.0145981 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.63909e-06, 0.00229193, 0.000109111, 0.00263688 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.00263688 + + Solving temperature system... 3 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 9.30085e-07, 0.000381912, 1.2926e-05, 0.000292646 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.000381912 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 5.59725e-07, 9.90118e-05, 2.10982e-06, 0.000125132 + Relative nonlinear residual (total system) after nonlinear iteration 6: 0.000125132 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.32377e-07, 4.89513e-05, 2.12383e-06, 7.35235e-05 + Relative nonlinear residual (total system) after nonlinear iteration 7: 7.35235e-05 + + Solving temperature system... 3 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 8.17916e-08, 2.05567e-05, 9.89589e-07, 3.05673e-05 + Relative nonlinear residual (total system) after nonlinear iteration 8: 3.05673e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.57637e-08, 7.38002e-06, 3.67055e-07, 1.07492e-05 + Relative nonlinear residual (total system) after nonlinear iteration 9: 1.07492e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 5 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 7.50616e-09, 2.35745e-06, 1.21578e-07, 3.38053e-06 + Relative nonlinear residual (total system) after nonlinear iteration 10: 3.38053e-06 + + + Postprocessing: + RMS, max velocity: 6.7 m/year, 16.1 m/year + Temperature min/avg/max: 118.7 K, 1553 K, 1713 K + Heat fluxes through boundary parts: 0 W, 0 W, -2.144e+06 W, 1.934e+05 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00012 + +*** Timestep 13: t=295.928 years, dt=13.957 years + Solving temperature system... 8 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.0116042, 0.0557104, 0.00139306, 0.480105 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.480105 + + Solving temperature system... 6 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000878917, 0.186337, 0.00641076, 0.224627 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.224627 + + Solving temperature system... 5 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 7.34573e-05, 0.0140758, 5.88514e-05, 0.0121005 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.0140758 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.58041e-06, 0.000542499, 4.38681e-06, 0.000503784 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.000542499 + + Solving temperature system... 2 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 7.29704e-08, 2.4477e-05, 1.95923e-07, 1.38337e-05 + Relative nonlinear residual (total system) after nonlinear iteration 5: 2.4477e-05 + + Solving temperature system... 1 iterations. + Solving porosity system ... 5 iterations. + Solving peridotite system ... 4 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 2+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.54758e-09, 1.79023e-06, 5.49933e-09, 1.51311e-06 + Relative nonlinear residual (total system) after nonlinear iteration 6: 1.79023e-06 + + + Postprocessing: + RMS, max velocity: 2.81 m/year, 7.17 m/year + Temperature min/avg/max: 0 K, 1543 K, 1636 K + Heat fluxes through boundary parts: 0 W, 0 W, 3.545e+07 W, 1.209e+09 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00013 + +*** Timestep 14: t=322.586 years, dt=26.6578 years + Solving temperature system... 7 iterations. + Solving porosity system ... 11 iterations. + Solving peridotite system ... 10 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.0375635, 0.36299, 0.0271084, 0.811126 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.811126 + + Solving temperature system... 6 iterations. + Solving porosity system ... 11 iterations. + Solving peridotite system ... 10 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00341465, 0.339301, 0.02061, 0.116431 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.339301 + + Solving temperature system... 5 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000406454, 0.0428874, 0.000315483, 0.0146969 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.0428874 + + Solving temperature system... 4 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.7938e-05, 0.00208932, 2.52874e-05, 0.000784223 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.00208932 + + Solving temperature system... 3 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.12519e-06, 0.00011794, 1.88057e-06, 1.5621e-05 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.00011794 + + Solving temperature system... 2 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 3.77165e-08, 1.41147e-05, 1.05973e-07, 3.44724e-06 + Relative nonlinear residual (total system) after nonlinear iteration 6: 1.41147e-05 + + Solving temperature system... 1 iterations. + Solving porosity system ... 5 iterations. + Solving peridotite system ... 4 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 2+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 3.37423e-09, 1.55498e-06, 7.24657e-09, 4.62034e-07 + Relative nonlinear residual (total system) after nonlinear iteration 7: 1.55498e-06 + + + Postprocessing: + RMS, max velocity: 5.46 m/year, 9.44 m/year + Temperature min/avg/max: 0 K, 1536 K, 1643 K + Heat fluxes through boundary parts: 0 W, 0 W, 8.088e+07 W, -1.994e+08 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00014 + +*** Timestep 15: t=373.503 years, dt=50.9164 years + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 10 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00693167, 0.179581, 0.0140871, 0.904152 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.904152 + + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 10 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00810609, 0.0453294, 0.0167247, 0.035825 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0453294 + + Solving temperature system... 5 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 9+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.32948e-05, 0.00762089, 5.16766e-05, 0.00589304 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.00762089 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.99517e-06, 0.00145105, 1.57207e-05, 0.00079421 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.00145105 + + Solving temperature system... 3 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.08589e-07, 0.000317114, 3.25971e-06, 0.000122871 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.000317114 + + Solving temperature system... 2 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.10028e-07, 6.9964e-05, 4.89414e-07, 3.23593e-05 + Relative nonlinear residual (total system) after nonlinear iteration 6: 6.9964e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 4+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 3.08038e-08, 1.5724e-05, 7.62308e-08, 8.79795e-06 + Relative nonlinear residual (total system) after nonlinear iteration 7: 1.5724e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 4 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 7.10491e-09, 4.02331e-06, 2.04314e-08, 2.10861e-06 + Relative nonlinear residual (total system) after nonlinear iteration 8: 4.02331e-06 + + + Postprocessing: + RMS, max velocity: 1.12 m/year, 4.12 m/year + Temperature min/avg/max: 0 K, 1529 K, 1656 K + Heat fluxes through boundary parts: 0 W, 0 W, 9.667e+06 W, 5.413e+07 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00015 + +*** Timestep 16: t=470.753 years, dt=97.2503 years + Solving temperature system... 8 iterations. + Solving porosity system ... 11 iterations. + Solving peridotite system ... 10 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 11+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.0268999, 0.15647, 0.029386, 0.890046 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.890046 + + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 10 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.0118924, 0.0666144, 0.0237423, 0.0289947 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0666144 + + Solving temperature system... 5 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.000167722, 0.0267307, 0.000717407, 0.0258194 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.0267307 + + Solving temperature system... 4 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 8 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.29663e-05, 0.00700152, 0.000206393, 0.00404278 + Relative nonlinear residual (total system) after nonlinear iteration 4: 0.00700152 + + Solving temperature system... 4 iterations. + Solving porosity system ... 8 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 7+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.81891e-06, 0.00124352, 3.3424e-05, 0.000444508 + Relative nonlinear residual (total system) after nonlinear iteration 5: 0.00124352 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 6+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 4.59482e-07, 0.000148792, 3.08048e-06, 2.87634e-05 + Relative nonlinear residual (total system) after nonlinear iteration 6: 0.000148792 + + Solving temperature system... 2 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 7.8709e-08, 1.6419e-05, 1.33031e-07, 1.11832e-05 + Relative nonlinear residual (total system) after nonlinear iteration 7: 1.6419e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 5 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.33022e-08, 4.22943e-06, 1.03142e-07, 2.86856e-06 + Relative nonlinear residual (total system) after nonlinear iteration 8: 4.22943e-06 + + + Postprocessing: + RMS, max velocity: 0.611 m/year, 2.86 m/year + Temperature min/avg/max: 70.42 K, 1523 K, 1687 K + Heat fluxes through boundary parts: 0 W, 0 W, -1.35e+06 W, -1.147e+05 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00016 + +*** Timestep 17: t=500 years, dt=29.2471 years + Solving temperature system... 7 iterations. + Solving porosity system ... 10 iterations. + Solving peridotite system ... 9 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00533205, 0.0308694, 0.00181649, 0.328549 + Relative nonlinear residual (total system) after nonlinear iteration 1: 0.328549 + + Solving temperature system... 7 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 10 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 10+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 0.00291058, 0.0196465, 0.00625149, 0.0117803 + Relative nonlinear residual (total system) after nonlinear iteration 2: 0.0196465 + + Solving temperature system... 4 iterations. + Solving porosity system ... 9 iterations. + Solving peridotite system ... 7 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 8+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 1.60815e-05, 0.00219514, 8.92948e-06, 0.00106148 + Relative nonlinear residual (total system) after nonlinear iteration 3: 0.00219514 + + Solving temperature system... 3 iterations. + Solving porosity system ... 7 iterations. + Solving peridotite system ... 6 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 5+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 8.38222e-07, 3.53873e-05, 4.24751e-07, 1.42965e-05 + Relative nonlinear residual (total system) after nonlinear iteration 4: 3.53873e-05 + + Solving temperature system... 2 iterations. + Solving porosity system ... 6 iterations. + Solving peridotite system ... 4 iterations. + Rebuilding Stokes preconditioner... + Solving Stokes system (AMG)... 3+0 iterations. + Solving fluid velocity system... 1 iterations. + Relative nonlinear residuals (temperature, compositional fields, Stokes system): 2.19083e-08, 1.96485e-06, 1.05281e-08, 7.17722e-07 + Relative nonlinear residual (total system) after nonlinear iteration 5: 1.96485e-06 + + + Postprocessing: + RMS, max velocity: 4.5 m/year, 7.78 m/year + Temperature min/avg/max: 0 K, 1518 K, 1689 K + Heat fluxes through boundary parts: 0 W, 0 W, 6.82e+07 W, 1.315e+08 W + Writing graphical output: output-no_dirichlet_on_outflow_melt/solution/solution-00017 + +Termination requested by criterion: end time + + + diff --git a/tests/fluid_outflow/statistics b/tests/fluid_outflow/statistics new file mode 100644 index 00000000000..b3bd66a169b --- /dev/null +++ b/tests/fluid_outflow/statistics @@ -0,0 +1,43 @@ +# 1: Time step number +# 2: Time (years) +# 3: Time step size (years) +# 4: Number of mesh cells +# 5: Number of Stokes degrees of freedom +# 6: Number of temperature degrees of freedom +# 7: Number of degrees of freedom for all compositions +# 8: Number of nonlinear iterations +# 9: Iterations for temperature solver +# 10: Iterations for composition solver 1 +# 11: Iterations for composition solver 2 +# 12: Iterations for Stokes solver +# 13: Velocity iterations in Stokes preconditioner +# 14: Schur complement iterations in Stokes preconditioner +# 15: RMS velocity (m/year) +# 16: Max. velocity (m/year) +# 17: Minimal temperature (K) +# 18: Average temperature (K) +# 19: Maximal temperature (K) +# 20: Average nondimensional temperature (K) +# 21: Outward heat flux through boundary with indicator 0 ("left") (W) +# 22: Outward heat flux through boundary with indicator 1 ("right") (W) +# 23: Outward heat flux through boundary with indicator 2 ("bottom") (W) +# 24: Outward heat flux through boundary with indicator 3 ("top") (W) +# 25: Visualization file name + 0 0.000000000000e+00 0.000000000000e+00 64 659 289 578 2 0 0 0 6 9 517 4.11692815e+00 1.15978851e+01 0.00000000e+00 1.56666667e+03 1.60000000e+03 9.79166667e-01 0.00000000e+00 0.00000000e+00 -8.78970421e-13 3.68266407e+04 output-no_dirichlet_on_outflow_melt/solution/solution-00000 + 1 3.953477186241e+01 3.953477186241e+01 64 659 289 578 15 60 115 91 81 111 7843 5.13162885e+00 8.99506653e+00 -6.88527805e+00 1.56927894e+03 1.63539142e+03 9.85102639e-01 0.00000000e+00 0.00000000e+00 -8.06711846e+07 4.99656125e+06 output-no_dirichlet_on_outflow_melt/solution/solution-00001 + 2 6.468276034284e+01 2.514798848044e+01 64 659 289 578 8 34 61 54 44 60 3879 4.92727370e+00 9.80304746e+00 -4.23895187e+00 1.57072961e+03 1.64743268e+03 9.84355352e-01 0.00000000e+00 0.00000000e+00 -6.94537972e+07 8.13806130e+06 output-no_dirichlet_on_outflow_melt/solution/solution-00002 + 3 8.559909759444e+01 2.091633725159e+01 64 659 289 578 7 28 56 48 38 52 3170 4.60918708e+00 1.24004107e+01 5.15243116e+00 1.57135338e+03 1.64456318e+03 9.78875591e-01 0.00000000e+00 0.00000000e+00 -2.36896618e+07 4.10920218e+06 output-no_dirichlet_on_outflow_melt/solution/solution-00003 + 4 1.052288151043e+02 1.962971750988e+01 64 659 289 578 7 29 52 46 40 54 3005 6.22209518e+00 1.58221795e+01 0.00000000e+00 1.56594199e+03 1.67713187e+03 9.78713741e-01 0.00000000e+00 0.00000000e+00 2.98226099e+07 4.69202439e+08 output-no_dirichlet_on_outflow_melt/solution/solution-00004 + 5 1.244173201937e+02 1.918850508937e+01 64 659 289 578 6 26 48 43 35 47 2617 8.07043529e+00 1.84379967e+01 0.00000000e+00 1.56365242e+03 1.65577221e+03 9.77282764e-01 0.00000000e+00 0.00000000e+00 7.03672407e+07 -3.46182513e+07 output-no_dirichlet_on_outflow_melt/solution/solution-00005 + 6 1.437558525783e+02 1.933853238460e+01 64 659 289 578 6 23 47 43 31 43 2289 8.48335489e+00 1.91485229e+01 0.00000000e+00 1.56045449e+03 1.66341594e+03 9.75284057e-01 0.00000000e+00 0.00000000e+00 8.30600745e+07 1.16420252e+08 output-no_dirichlet_on_outflow_melt/solution/solution-00006 + 7 1.642107766017e+02 2.045492402338e+01 64 659 289 578 6 23 48 44 32 44 1945 6.88908830e+00 1.74350678e+01 0.00000000e+00 1.55679658e+03 1.66922225e+03 9.72997860e-01 0.00000000e+00 0.00000000e+00 6.03206781e+07 1.26495945e+08 output-no_dirichlet_on_outflow_melt/solution/solution-00007 + 8 1.868356746457e+02 2.262489804402e+01 64 659 289 578 7 26 53 49 32 46 2169 3.97522263e+00 1.34357353e+01 0.00000000e+00 1.55309350e+03 1.67592042e+03 9.70683438e-01 0.00000000e+00 0.00000000e+00 4.60787024e+06 1.39113426e+08 output-no_dirichlet_on_outflow_melt/solution/solution-00008 + 9 2.132515096155e+02 2.641583496978e+01 64 659 289 578 7 31 54 50 38 52 2042 4.10166487e+00 7.78575497e+00 1.16947408e+01 1.55177050e+03 1.69673926e+03 9.62547351e-01 0.00000000e+00 0.00000000e+00 -6.12161176e+07 4.69343433e+06 output-no_dirichlet_on_outflow_melt/solution/solution-00009 +10 2.425314210194e+02 2.927991140392e+01 64 659 289 578 12 50 99 92 70 94 2839 7.52931080e+00 1.34433882e+01 3.97534161e+01 1.55198778e+03 1.70254200e+03 9.45146478e-01 0.00000000e+00 0.00000000e+00 -8.11212590e+07 1.62282634e+07 output-no_dirichlet_on_outflow_melt/solution/solution-00010 +11 2.661164862305e+02 2.358506521108e+01 64 659 289 578 12 52 95 92 68 92 2679 8.03836600e+00 1.73851839e+01 7.79684908e+01 1.55253849e+03 1.70627841e+03 9.21606248e-01 0.00000000e+00 0.00000000e+00 -4.38520070e+07 1.24677649e+07 output-no_dirichlet_on_outflow_melt/solution/solution-00011 +12 2.819715054222e+02 1.585501919170e+01 64 659 289 578 10 38 76 70 48 68 1684 6.69717739e+00 1.61455302e+01 1.18664979e+02 1.55282755e+03 1.71265180e+03 8.96351608e-01 0.00000000e+00 0.00000000e+00 -2.14362204e+06 1.93383428e+05 output-no_dirichlet_on_outflow_melt/solution/solution-00012 +13 2.959284635451e+02 1.395695812296e+01 64 659 289 578 6 26 49 40 32 44 1367 2.80867157e+00 7.17302152e+00 0.00000000e+00 1.54276410e+03 1.63616765e+03 9.64227563e-01 0.00000000e+00 0.00000000e+00 3.54531846e+07 1.20910845e+09 output-no_dirichlet_on_outflow_melt/solution/solution-00013 +14 3.225862535600e+02 2.665779001485e+01 64 659 289 578 7 28 61 50 41 55 1793 5.46205859e+00 9.43627503e+00 0.00000000e+00 1.53626073e+03 1.64278841e+03 9.60162953e-01 0.00000000e+00 0.00000000e+00 8.08810972e+07 -1.99359171e+08 output-no_dirichlet_on_outflow_melt/solution/solution-00014 +15 3.735026324883e+02 5.091637892836e+01 64 659 289 578 8 32 65 55 49 65 2706 1.12037112e+00 4.11742767e+00 0.00000000e+00 1.52904488e+03 1.65585217e+03 9.55653051e-01 0.00000000e+00 0.00000000e+00 9.66722569e+06 5.41328085e+07 output-no_dirichlet_on_outflow_melt/solution/solution-00015 +16 4.707529162415e+02 9.725028375316e+01 64 659 289 578 8 35 68 59 52 68 2439 6.11045672e-01 2.85853948e+00 7.04159636e+01 1.52260846e+03 1.68685446e+03 9.07620313e-01 0.00000000e+00 0.00000000e+00 -1.34953400e+06 -1.14695389e+05 output-no_dirichlet_on_outflow_melt/solution/solution-00016 +17 5.000000000000e+02 2.924708375849e+01 64 659 289 578 5 23 41 36 31 41 1477 4.49517702e+00 7.77740431e+00 0.00000000e+00 1.51776128e+03 1.68926978e+03 9.48600803e-01 0.00000000e+00 0.00000000e+00 6.81955222e+07 1.31470585e+08 output-no_dirichlet_on_outflow_melt/solution/solution-00017