63 output_fields += eq_data;
73 "SPECIAL PURPOSE. Computes error norms of the solution, particulary suited for non-compatible coupling models.")
75 "Output file with raw data from MH module.")
80 "Flow_Darcy_MH_specific",
91 .
description(
"Pressure solution - P0 interpolation.");
94 .
description(
"Pressure solution - P1 interpolation.");
97 .
description(
"Piezo head solution - P0 interpolation.");
100 .
description(
"Velocity solution - P0 interpolation.");
104 .
description(
"Subdomain ids of the domain decomposition.");
117 .
description(
"Error norm of the pressure solution. [Experimental]");
120 .
description(
"Error norm of the velocity solution. [Experimental]");
123 .
description(
"Error norm of the divergence of the velocity solution. [Experimental]");
141 if (in_rec_specific) {
150 if (in_rec_specific->opt_val(
"raw_flow_output", raw_output_file_path)) {
151 MessageOut() <<
"Opening raw flow output: " << raw_output_file_path <<
"\n";
154 }
INPUT_CATCH(FilePath::ExcFileOpen, FilePath::EI_Address_String, (*in_rec_specific))
158 auto fields_array = in_rec_specific->val<
Input::Array>(
"fields");
159 if(fields_array.size() > 0){
182 dh_par.distribute_dofs(
ds);
183 dh_ = dh_par.sequential();
186 auto corner_ptr = make_shared< FieldFE<3, FieldValue<3>::Scalar> >();
324 START_TIMER(
"DarcyFlowMHOutput::make_element_scalar");
325 unsigned int sol_size;
330 for(
unsigned int i_ele : element_indices) {
345 START_TIMER(
"DarcyFlowMHOutput::make_element_vector");
349 auto multidim_assembler = AssemblyBase::create< AssemblyMH >(
darcy_flow->
data_);
351 for(
unsigned int i_ele : element_indices) {
354 flux_in_center = multidim_assembler[ele->
dim() -1]->make_element_vector(ele);
357 for(
unsigned int j=0; j<3; j++)
ele_flux[3*i_ele + j]=flux_in_center[j];
364 START_TIMER(
"DarcyFlowMHOutput::make_corner_scalar");
365 unsigned int ndofs =
dh_->max_elem_dofs();
376 dh_->cell_accessor_from_element(ele.idx()).get_dof_indices(indices);
377 for (i_node=0; i_node<ele->n_nodes(); i_node++)
379 corner_pressure[indices[i_node]] = node_scalar[ ele.node_accessor(i_node).idx() ];
400 START_TIMER(
"DarcyFlowMHOutput::make_node_scalar_param");
412 int* sum_elements =
new int [n_nodes];
413 int* sum_sides =
new int [n_nodes];
414 double* sum_ele_dist =
new double [n_nodes];
415 double* sum_side_dist =
new double [n_nodes];
419 bool count_elements =
true;
420 bool count_sides =
true;
426 for (
int i = 0; i < n_nodes; i++){
429 sum_ele_dist[i] = 0.0;
430 sum_side_dist[i] = 0.0;
437 for (
unsigned int li = 0; li < ele->n_nodes(); li++) {
438 node = ele.node_accessor(li);
439 node_index = node.
idx();
442 ((node->
getX() - ele.centre()[ 0 ])*(node->
getX() - ele.centre()[ 0 ])) +
443 ((node->
getY() - ele.centre()[ 1 ])*(node->
getY() - ele.centre()[ 1 ])) +
444 ((node->
getZ() - ele.centre()[ 2 ])*(node->
getZ() - ele.centre()[ 2 ]))
446 sum_ele_dist[node_index] += dist;
447 sum_elements[node_index]++;
452 for(
SideIter side = ele.side(0); side->
side_idx() < ele->n_sides(); ++side) {
453 for (
unsigned int li = 0; li < side->n_nodes(); li++) {
454 node = side->node(li);
455 node_index = node.
idx();
457 ((node->
getX() - side->centre()[ 0 ])*(node->
getX() - side->centre()[ 0 ])) +
458 ((node->
getY() - side->centre()[ 1 ])*(node->
getY() - side->centre()[ 1 ])) +
459 ((node->
getZ() - side->centre()[ 2 ])*(node->
getZ() - side->centre()[ 2 ]))
462 sum_side_dist[node_index] += dist;
463 sum_sides[node_index]++;
471 for (
unsigned int li = 0; li < ele->n_nodes(); li++) {
472 node = ele.node_accessor(li);
473 node_index = ele.node_accessor(li).
idx();
477 ((node->
getX() - ele.centre()[ 0 ])*(node->
getX() - ele.centre()[ 0 ])) +
478 ((node->
getY() - ele.centre()[ 1 ])*(node->
getY() - ele.centre()[ 1 ])) +
479 ((node->
getZ() - ele.centre()[ 2 ])*(node->
getZ() - ele.centre()[ 2 ]))
482 (1 - dist / (sum_ele_dist[node_index] + sum_side_dist[node_index])) /
483 (sum_elements[node_index] + sum_sides[node_index] - 1);
488 for(
SideIter side = ele.side(0); side->
side_idx() < ele->n_sides(); ++side) {
489 for (
unsigned int li = 0; li < side->n_nodes(); li++) {
490 node = side->node(li);
491 node_index = node.
idx();
495 ((node->
getX() - side->centre()[ 0 ])*(node->
getX() - side->centre()[ 0 ])) +
496 ((node->
getY() - side->centre()[ 1 ])*(node->
getY() - side->centre()[ 1 ])) +
497 ((node->
getZ() - side->centre()[ 2 ])*(node->
getZ() - side->centre()[ 2 ]))
502 (1 - dist / (sum_ele_dist[node_index] + sum_side_dist[node_index])) /
503 (sum_sides[node_index] + sum_elements[node_index] - 1);
509 delete [] sum_elements;
511 delete [] sum_ele_dist;
512 delete [] sum_side_dist;
523 START_TIMER(
"DarcyFlowMHOutput::output_internal_flow_data");
530 raw_output_file <<
"// fields:\n//ele_id ele_presure flux_in_barycenter[3] n_sides side_pressures[n] side_fluxes[n]\n";
537 for (
unsigned int i = 0; i < 3; i++)
542 for (
unsigned int i = 0; i < ele->n_sides(); i++) {
545 for (
unsigned int i = 0; i < ele->n_sides(); i++) {
588 for (
unsigned int li = 0; li < ele->
n_sides(); li++) {
598 double velocity_diff=0, divergence_diff=0, pressure_diff=0, diff;
602 double mean_x_squared=0;
603 for(
unsigned int i_node=0; i_node < ele->
n_nodes(); i_node++ )
604 for(
unsigned int j_node=0; j_node < ele->
n_nodes(); j_node++ )
606 mean_x_squared += (i_node == j_node ? 2.0 : 1.0) / ( 6 * dim )
610 for(
unsigned int i_point=0; i_point < fe_values.
n_points(); i_point++) {
614 analytical = anal_sol.
value(q_point, ele );
615 for(
unsigned int i=0; i< 3; i++) anal_flux[i] = analytical[i+1];
619 for(
unsigned int i_shape=0; i_shape < ele->
n_sides(); i_shape++) {
622 diff += fluxes[ i_shape ] *
630 diff = - (1.0 / conductivity) * diff / dim / ele.
measure() / cross + pressure_mean ;
631 diff = ( diff - analytical[0]);
632 pressure_diff += diff * diff * fe_values.
JxW(i_point);
636 flux_in_q_point.zeros();
637 for(
unsigned int i_shape=0; i_shape < ele->
n_sides(); i_shape++) {
638 flux_in_q_point += fluxes[ i_shape ]
643 flux_in_q_point -= anal_flux;
644 velocity_diff +=
dot(flux_in_q_point, flux_in_q_point) * fe_values.
JxW(i_point);
648 for(
unsigned int i_shape=0; i_shape < ele->
n_sides(); i_shape++) diff += fluxes[ i_shape ];
649 diff = ( diff / ele.
measure() / cross - analytical[4]);
650 divergence_diff += diff * diff * fe_values.
JxW(i_point);
664 result.
div_diff[ ele.
idx() ] = sqrt(divergence_diff);
665 result.
div_error[dim-1] += divergence_diff;
670 : fe_p0(0), fe_p1(1), order(4), quad(dim, order),
692 for(
unsigned int j=0; j<3; j++){
700 unsigned int solution_size;
706 switch (ele->dim()) {
721 for(
unsigned int j=0; j<3; j++){
728 os <<
"l2 norm output\n\n"
void set_python_field_from_file(const FilePath &file_name, const string &func_name)
void get_solution_vector(double *&vec, unsigned int &vec_size) override
Field< 3, FieldValue< 3 >::VectorFixed > field_ele_flux
Class MappingP1 implements the affine transformation of the unit cell onto the actual cell...
std::shared_ptr< FieldFE< 3, FieldValue< 3 >::Scalar > > vel_diff_ptr
static auto subdomain(Mesh &mesh) -> IndexField
struct DarcyFlowMHOutput::DiffData diff_data
Declaration of class which handles the ordering of degrees of freedom (dof) and mappings between loca...
Output class for darcy_flow_mh model.
unsigned int n_nodes() const
virtual void prepare_specific_output(Input::Record in_rec)
RegionSet get_region_set(const std::string &set_name) const
Classes with algorithms for computation of intersections of meshes.
virtual void prepare_output(Input::Record in_rec)
unsigned int side_idx() const
OutputSpecificFields output_specific_fields
Specific quantities for output in DarcyFlowMH - error estimates etc.
Field< 3, FieldValue< 3 >::Scalar > field_node_pressure
MixedMeshIntersections & mixed_intersections()
FEValues< dim, 3 > fe_values
#define MessageOut()
Macro defining 'message' record of log.
void output(TimeStep step)
const Input::Type::Instance & make_output_type_from_record(Input::Type::Record &in_rec, const string &equation_name, const string &aditional_description="")
void make_element_vector(ElementSetRef element_indices)
std::string format(CStringRef format_str, ArgList args)
std::vector< int > velocity_mask
static std::shared_ptr< OutputTime > create_output_stream(const std::string &equation_name, const Input::Record &in_rec, std::string unit_str)
This method delete all object instances of class OutputTime stored in output_streams vector...
bool is_output_specific_fields
Output specific field stuff.
void l2_diff_local(ElementAccessor< 3 > &ele, FEValues< dim, 3 > &fe_values, FEValues< dim, 3 > &fv_rt, FieldPython< 3, FieldValue< 3 >::Vector > &anal_sol, DiffData &result)
Computes L2 error on an element.
Standard quantities for output in DarcyFlowMH.
void compute_l2_difference()
Fields computed from the mesh data.
void make_corner_scalar(vector< double > &node_scalar)
Class FEValues calculates finite element data on the actual cells such as shape function values...
FieldPython< 3, FieldValue< 3 >::Vector > ExactSolution
SideIter side(const unsigned int loc_index)
void fill_output_data(VectorMPI &vec_seq, std::shared_ptr< FieldFE< spacedim, Value > > field_ptr)
const RegionDB & region_db() const
std::shared_ptr< FieldFE< 3, FieldValue< 3 >::Scalar > > ele_pressure_ptr
Field of pressure head in barycenters of elements.
virtual unsigned int n_nodes() const
const TimeStep & step(int index=-1) const
std::shared_ptr< DOFHandlerMultiDim > dh_
VectorMPI corner_pressure
Field< 3, FieldValue< 3 >::Scalar > subdomain
FieldCommon & units(const UnitSI &units)
Set basic units of the field.
std::vector< unsigned int > all_element_idx_
std::shared_ptr< OutputTime > output_stream
std::shared_ptr< EqData > data_
Field< 3, FieldValue< 3 >::Scalar > pressure_diff
unsigned int n_points()
Returns the number of quadrature points.
std::shared_ptr< DiscreteSpace > ds
virtual ElementAccessor< 3 > element_accessor(unsigned int idx) const
Create and return ElementAccessor to element of given idx.
void make_node_scalar_param(ElementSetRef element_indices)
Calculate nodes scalar, store it in double* node_scalars instead of node->scalar. ...
static unsigned int oposite_node(unsigned int sid)
arma::vec::fixed< spacedim > centre() const
Computes the barycenter.
Field< 3, FieldValue< 3 >::Scalar > velocity_diff
double element_scalar(ElementAccessor< 3 > &ele) const
temporary replacement for DofHandler accessor, scalar (pressure) on element
void open_stream(Stream &stream) const
Field< 3, FieldValue< 3 >::Scalar > field_ele_pressure
Transformed quadrature points.
Global macros to enhance readability and debugging, general constants.
static constexpr Mask equation_result
Match result fields. These are never given by input or copy of input.
OutputFields output_fields
static const Input::Type::Instance & get_input_type_specific()
double JxW(const unsigned int point_no) override
Return the product of Jacobian determinant and the quadrature weight at given quadrature point...
Definitions of basic Lagrangean finite elements with polynomial shape functions.
static constexpr Mask equation_external_output
Match an output field, that can be also copy of other field.
unsigned int n_sides() const
static auto region_id(Mesh &mesh) -> IndexField
void resize(unsigned int local_size)
Type dot(const Mat< Type, nRows, nCols > &a, const Mat< Type, nRows, nCols > &b)
#define START_TIMER(tag)
Starts a timer with specified tag.
Provides the numbering of the finite element degrees of freedom on the computational mesh...
virtual Value::return_type const & value(const Point &p, const ElementAccessor< spacedim > &elm) const
static const Input::Type::Instance & get_input_type()
Field< 3, FieldValue< 3 >::Scalar > div_diff
std::shared_ptr< FieldFE< 3, FieldValue< 3 >::Scalar > > pressure_diff_ptr
virtual Range< ElementAccessor< 3 > > elements_range() const
Returns range of bulk elements.
ofstream raw_output_file
Raw data output file.
double measure() const
Computes the measure of the element.
unsigned int n_sides() const
void output_internal_flow_data()
const FEValuesViews::Vector< dim, spacedim > & vector_view(unsigned int i) const
Accessor to vector values of multicomponent FE.
Dedicated class for storing path to input and output files.
Field< 3, FieldValue< 3 >::Scalar > field_ele_piezo_head
double side_flux(const Side &side) const
temporary replacement for DofHandler accessor, flux through given side
FieldCommon & description(const string &description)
std::shared_ptr< FieldFE< 3, FieldValue< 3 >::Scalar > > ele_piezo_head_ptr
Field of piezo-metric head in barycenters of elements.
std::string get_unit_string() const
virtual unsigned int n_elements(bool boundary=false) const
Returns count of boundary or bulk elements.
void initialize(std::shared_ptr< OutputTime > stream, Mesh *mesh, Input::Record in_rec, const TimeGovernor &tg)
Field< 3, FieldValue< 3 >::Scalar > region_id
bool compute_errors_
Specific experimental error computing.
static Input::Type::Record & get_input_type()
void set_field(const RegionSet &domain, FieldBasePtr field, double time=0.0)
bool set_time(const TimeStep &time, LimitSide limit_side)
Definitions of particular quadrature rules on simplices.
FieldCommon & name(const string &name)
std::shared_ptr< FieldFE< 3, FieldValue< 3 >::Scalar > > div_diff_ptr
mixed-hybrid model of linear Darcy flow, possibly unsteady.
void set_mesh(const Mesh &mesh)
std::shared_ptr< FieldFE< 3, FieldValue< 3 >::VectorFixed > > ele_flux_ptr
Field of flux in barycenter of every element.
bool is_field_output_time(const FieldCommon &field, TimeStep step) const
const Input::Type::Instance & make_output_type(const string &equation_name, const string &aditional_description="")
Field< 3, FieldValue< 3 >::Scalar > cross_section
Field< 3, FieldValue< 3 >::Scalar > conductivity
FieldCommon & flags(FieldFlag::Flags::Mask mask)
double side_scalar(const Side &side) const
temporary replacement for DofHandler accessor, scalar (pressure) on edge of the side ...
Class for representation SI units of Fields.
DarcyFlowMHOutput(DarcyMH *flow, Input::Record in_rec)
static UnitSI & dimensionless()
Returns dimensionless unit.
#define DebugOut()
Macro defining 'debug' record of log.
unsigned int idx() const
Return local idx of element in boundary / bulk part of element vector.
void make_element_scalar(ElementSetRef element_indices)
virtual ~DarcyFlowMHOutput()
std::vector< IntersectionLocal< 1, 2 > > intersection_storage12_
Stores 1D-2D intersections.
Implementation of range helper class.
Definitions of Raviart-Thomas finite elements.
MortarMethod mortar_method_
virtual Value::return_type const & value(const Point &p, const ElementAccessor< spacedim > &elm)
FieldCommon & output_type(OutputTime::DiscreteSpace rt)
void output()
Calculate values for output.
void reinit(ElementAccessor< 3 > &cell)
Update cell-dependent data (gradients, Jacobians etc.)
Transformed quadrature weights.
const MH_DofHandler & get_mh_dofhandler() override
Mixed-hybrid model of linear Darcy flow, possibly unsteady.
const Node * node(unsigned int ni) const
arma::vec::fixed< spacedim > point(const unsigned int point_no)
Return coordinates of the quadrature point in the actual cell system.