Skip to content
Snippets Groups Projects
Forked from ogs / ogs
20778 commits behind the upstream repository.
Code owners
Assign users and groups as approvers for specific file changes. Learn more.
Process.h 14.51 KiB
/**
 * \copyright
 * Copyright (c) 2012-2016, OpenGeoSys Community (http://www.opengeosys.org)
 *            Distributed under a Modified BSD License.
 *              See accompanying file LICENSE.txt or
 *              http://www.opengeosys.org/project/license
 *
 */

#ifndef PROCESS_LIB_PROCESS_H_
#define PROCESS_LIB_PROCESS_H_

#include <memory>
#include <string>

#include <logog/include/logog.hpp>

#include "AssemblerLib/ComputeSparsityPattern.h"
#include "AssemblerLib/LocalToGlobalIndexMap.h"
#include "AssemblerLib/VectorMatrixAssembler.h"
#include "BaseLib/ConfigTree.h"
#include "FileIO/VtkIO/VtuInterface.h"
#include "MeshGeoToolsLib/MeshNodeSearcher.h"
#include "MeshLib/MeshSubset.h"
#include "MeshLib/MeshSubsets.h"

#include "DirichletBc.h"
#include "NeumannBc.h"
#include "NeumannBcAssembler.h"
#include "Parameter.h"
#include "ProcessVariable.h"
#include "UniformDirichletBoundaryCondition.h"

#include "NumLib/ODESolver/NonlinearSolver.h"
#include "NumLib/ODESolver/ODESystem.h"
#include "NumLib/ODESolver/TimeDiscretization.h"

namespace MeshLib
{
class Mesh;
}

namespace ProcessLib
{
template <typename GlobalSetup>
class Process
		: public NumLib::ODESystem<typename GlobalSetup::MatrixType,
		                           typename GlobalSetup::VectorType,
		                           // TODO: later on use a simpler ODE system
		                           NumLib::ODESystemTag::FirstOrderImplicitQuasilinear,
		                           NumLib::NonlinearSolverTag::Newton>
{
public:
	using GlobalVector = typename GlobalSetup::VectorType;
	using GlobalMatrix = typename GlobalSetup::MatrixType;
	using Index = typename GlobalMatrix::IndexType;
	using NonlinearSolver = NumLib::NonlinearSolverBase<GlobalMatrix, GlobalVector>;
	using TimeDiscretization = NumLib::TimeDiscretization<GlobalVector>;

	Process(MeshLib::Mesh& mesh,
	        NonlinearSolver& nonlinear_solver,
	        std::unique_ptr<TimeDiscretization>&& time_discretization)
	    : _mesh(mesh), _nonlinear_solver(nonlinear_solver)
	    , _time_discretization(std::move(time_discretization))
	{}

	virtual ~Process()
	{
		delete _mesh_subset_all_nodes;
	}

	/// Process specific initialization called by initialize().
	virtual void createLocalAssemblers() = 0;

	/// Postprocessing after solve().
	/// The file_name is indicating the name of possible output file.
	void postTimestep(std::string const& file_name,
	                  const unsigned /*timestep*/,
	                  GlobalVector const& x)
	{
		post(x);
		output(file_name, x);
	}

	void initialize()
	{
		DBUG("Initialize process.");

		DBUG("Construct dof mappings.");
		constructDofTable();

#ifndef USE_PETSC
		DBUG("Compute sparsity pattern");
		computeSparsityPattern();
#endif

		DBUG("Create global assembler.");
		_global_assembler.reset(
		    new GlobalAssembler(*_local_to_global_index_map));

		createLocalAssemblers();

		DBUG("Initialize boundary conditions.");
		for (ProcessVariable& pv : _process_variables)
		{
			createDirichletBcs(pv, 0);  // 0 is the component id
			createNeumannBcs(pv, 0);    // 0 is the component id
		}

		for (auto& bc : _neumann_bcs)
			bc->initialize(_global_setup, _mesh.getDimension());
	}

	void setInitialConditions(GlobalVector& x)
	{
		DBUG("Set initial conditions.");
		for (ProcessVariable& pv : _process_variables)
		{
			setInitialConditions(pv, 0, x);  // 0 is the component id
		}
	}

	MathLib::MatrixSpecifications getMatrixSpecifications() const override final
	{
		return { 0u, 0u,
		         &_sparsity_pattern,
		         _local_to_global_index_map.get(),
		         &_mesh };
	}

	void assemble(const double t, GlobalVector const& x,
	              GlobalMatrix& M, GlobalMatrix& K, GlobalVector& b) override final
	{
		assembleConcreteProcess(t, x, M, K, b);

		// Call global assembler for each Neumann boundary local assembler.
		for (auto const& bc : _neumann_bcs)
			bc->integrate(_global_setup, t, b);
	}
	void assembleJacobian(
		const double t, GlobalVector const& x, GlobalVector const& xdot,
		const double dxdot_dx, GlobalMatrix const& M,
		const double dx_dx, GlobalMatrix const& K,
		GlobalMatrix& Jac) override final
	{
		assembleJacobianConcreteProcess(t, x, xdot, dxdot_dx, M, dx_dx, K, Jac);

		// TODO In this method one could check if the user wants to use an
		//      analytical or a numerical Jacobian. Then the right
		//      assembleJacobianConcreteProcess() method will be chosen.
		//      Additionally in the default implementation of said method one
		//      could provide a fallback to a numerical Jacobian. However, that
		//      would be in a sense implicit behaviour and it might be better to
		//      just abort, as is currently the case.
		//      In order to implement the Jacobian assembly entirely, in addition
		//      to the operator() in VectorMatrixAssembler there has to be a method
		//      that dispatches the Jacobian assembly.
		//      Similarly, then the NeumannBC specialization of VectorMatrixAssembler
		//      probably can be merged into the main class s.t. one has only one
		//      type of VectorMatrixAssembler (for each equation type) with the
		//      three methods assemble(), assembleJacobian() and assembleNeumannBC().
		//      That list can be extended, e.g. by methods for the assembly of
		//      source terms.
		//      UPDATE: Probably it is better to keep a separate NeumannBC version of the
		//      VectoMatrixAssembler since that will work for all kinds of processes.
	}

	std::vector<DirichletBc<Index> > const* getKnownSolutions()
	const override final
	{
		return &_dirichlet_bcs;
	}

	NonlinearSolver& getNonlinearSolver() const
	{
		return _nonlinear_solver;
	}

	TimeDiscretization& getTimeDiscretization() const
	{
		return *_time_discretization;
	}

protected:
	virtual void post(GlobalVector const& /*x*/) {}

private:
	virtual void assembleConcreteProcess(
	    const double t, GlobalVector const& x,
	    GlobalMatrix& M, GlobalMatrix& K, GlobalVector& b) = 0;

	virtual void assembleJacobianConcreteProcess(
		const double /*t*/, GlobalVector const& /*x*/, GlobalVector const& /*xdot*/,
		const double /*dxdot_dx*/, GlobalMatrix const& /*M*/,
		const double /*dx_dx*/, GlobalMatrix const& /*K*/,
		GlobalMatrix& /*Jac*/)
	{
		ERR("The concrete implementation of this Process did not override the"
			" assembleJacobianConcreteProcess() method."
			" Hence, no analytical Jacobian is provided for this process"
			" and the Newton-Raphson method cannot be used to solve it.");
		std::abort();
	}

	void constructDofTable()
	{
		// Create single component dof in every of the mesh's nodes.
		_mesh_subset_all_nodes =
		    new MeshLib::MeshSubset(_mesh, &_mesh.getNodes());

		// Collect the mesh subsets in a vector.
		std::vector<std::unique_ptr<MeshLib::MeshSubsets>> all_mesh_subsets;
		for (ProcessVariable const& pv : _process_variables)
		{
			std::generate_n(
			    std::back_inserter(all_mesh_subsets),
			    pv.getNumberOfComponents(),
			    [&]()
			    {
				    return std::unique_ptr<MeshLib::MeshSubsets>{
				        new MeshLib::MeshSubsets{_mesh_subset_all_nodes}};
				});
		}

		_local_to_global_index_map.reset(
		    new AssemblerLib::LocalToGlobalIndexMap(
		        std::move(all_mesh_subsets),
		        AssemblerLib::ComponentOrder::BY_COMPONENT));
	}

	/// Sets the initial condition values in the solution vector x for a given
	/// process variable and component.
	void setInitialConditions(ProcessVariable const& variable,
	                          int const component_id,
	                          GlobalVector& x)
	{
		std::size_t const n_nodes = _mesh.getNNodes();
		for (std::size_t node_id = 0; node_id < n_nodes; ++node_id)
		{
			MeshLib::Location const l(_mesh.getID(),
			                          MeshLib::MeshItemType::Node, node_id);
			auto global_index = std::abs(
			    _local_to_global_index_map->getGlobalIndex(l, component_id));
#ifdef USE_PETSC
			// The global indices of the ghost entries of the global
			// matrix or the global vectors need to be set as negative values
			// for equation assembly, however the global indices start from zero.
			// Therefore, any ghost entry with zero index is assigned an negative
			// value of the vector size or the matrix dimension.
			// To assign the initial value for the ghost entries,
			// the negative indices of the ghost entries are restored to zero.
			// checked hereby.
			if ( global_index == x.size() )
			    global_index = 0;
#endif
			x.set(global_index,
			      variable.getInitialConditionValue(*_mesh.getNode(node_id),
			                                        component_id));
		}
	}

	void createDirichletBcs(ProcessVariable& variable, int const component_id)
	{
		MeshGeoToolsLib::MeshNodeSearcher& mesh_node_searcher =
		    MeshGeoToolsLib::MeshNodeSearcher::getMeshNodeSearcher(
		        variable.getMesh());

		variable.initializeDirichletBCs(std::back_inserter(_dirichlet_bcs),
		                                mesh_node_searcher,
		                                *_local_to_global_index_map,
		                                component_id);
	}

	void createNeumannBcs(ProcessVariable& variable, int const component_id)
	{
		// Find mesh nodes.
		MeshGeoToolsLib::MeshNodeSearcher& mesh_node_searcher =
		    MeshGeoToolsLib::MeshNodeSearcher::getMeshNodeSearcher(
		        variable.getMesh());
		MeshGeoToolsLib::BoundaryElementsSearcher mesh_element_searcher(
		    variable.getMesh(), mesh_node_searcher);

		// Create a neumann BC for the process variable storing them in the
		// _neumann_bcs vector.
		variable.createNeumannBcs(std::back_inserter(_neumann_bcs),
		                          mesh_element_searcher,
		                          _global_setup,
		                          _integration_order,
		                          *_local_to_global_index_map,
		                          0,  // 0 is the variable id TODO
		                          component_id);
	}

	/// Computes and stores global matrix' sparsity pattern from given
	/// DOF-table.
	void computeSparsityPattern()
	{
		_sparsity_pattern = std::move(AssemblerLib::computeSparsityPattern(
		    *_local_to_global_index_map, _mesh));
	}

	void output(std::string const& file_name, GlobalVector const& x)
	{
		DBUG("Process output.");

		// Copy result
#ifdef USE_PETSC
		// TODO It is also possible directly to copy the data for single process
		// variable to a mesh property. It needs a vector of global indices and
		// some PETSc magic to do so.
		std::vector<double> x_copy(x.getLocalSize() + x.getGhostSize());
#else
		std::vector<double> x_copy(x.size());
#endif
		x.copyValues(x_copy);

		std::size_t const n_nodes = _mesh.getNNodes();
		for (ProcessVariable& pv : _process_variables)
		{
			auto& output_data = pv.getOrCreateMeshProperty();

			int const n_components = pv.getNumberOfComponents();
			for (std::size_t node_id = 0; node_id < n_nodes; ++node_id)
			{
				MeshLib::Location const l(_mesh.getID(),
				                          MeshLib::MeshItemType::Node, node_id);
				// TODO extend component ids to multiple process variables.
				for (int component_id = 0; component_id < n_components;
				     ++component_id)
				{
					auto const index =
					    _local_to_global_index_map->getLocalIndex(
					        l, component_id, x.getRangeBegin(),
					        x.getRangeEnd());

					output_data[node_id * n_components + component_id] =
					    x_copy[index];
				}
			}
		}

		// Write output file
		DBUG("Writing output to \'%s\'.", file_name.c_str());
		FileIO::VtuInterface vtu_interface(&_mesh, vtkXMLWriter::Binary, true);
		vtu_interface.writeToFile(file_name);
	}

protected:
	unsigned const _integration_order = 2;

	MeshLib::Mesh& _mesh;
	MeshLib::MeshSubset const* _mesh_subset_all_nodes = nullptr;

	GlobalSetup _global_setup;

	using GlobalAssembler = AssemblerLib::VectorMatrixAssembler<
	        GlobalMatrix,
	        GlobalVector,
	        NumLib::ODESystemTag::FirstOrderImplicitQuasilinear>;

	std::unique_ptr<GlobalAssembler> _global_assembler;

	std::unique_ptr<AssemblerLib::LocalToGlobalIndexMap>
	    _local_to_global_index_map;

	AssemblerLib::SparsityPattern _sparsity_pattern;

	std::vector<DirichletBc<GlobalIndexType>> _dirichlet_bcs;
	std::vector<std::unique_ptr<NeumannBc<GlobalSetup>>> _neumann_bcs;

	/// Variables used by this process.
	std::vector<std::reference_wrapper<ProcessVariable>> _process_variables;

	NonlinearSolver& _nonlinear_solver;
	std::unique_ptr<TimeDiscretization> _time_discretization;
};

/// Find a process variable for a name given in the process configuration under
/// the tag.
/// In the process config a process variable is referenced by a name. For
/// example it will be looking for a variable named "H" in the list of process
/// variables when the tag is "hydraulic_head":
/// \code
///     <process>
///         ...
///         <hydraulic_head>H</hydraulic_head>
///     </process>
/// \endcode
/// and return a reference to that variable.
ProcessVariable& findProcessVariable(
    BaseLib::ConfigTree const& process_config, std::string const& tag,
    std::vector<ProcessVariable> const& variables);

/// Find a parameter of specific type for a name given in the process
/// configuration under the tag.
/// In the process config a parameter is referenced by a name. For example it
/// will be looking for a parameter named "K" in the list of parameters
/// when the tag is "hydraulic_conductivity":
/// \code
///     <process>
///         ...
///         <hydraulic_conductivity>K</hydraulic_conductivity>
///     </process>
/// \endcode
/// and return a reference to that parameter. Additionally it checks for the
/// type of the found parameter.
template <typename... ParameterArgs>
Parameter<ParameterArgs...>& findParameter(
    BaseLib::ConfigTree const& process_config, std::string const& tag,
    std::vector<std::unique_ptr<ParameterBase>> const& parameters)
{
	// Find parameter name in process config.
	auto const name = process_config.getConfParam<std::string>(tag);

	// Find corresponding parameter by name.
	auto const parameter_it =
	    std::find_if(parameters.cbegin(), parameters.cend(),
	                 [&name](std::unique_ptr<ParameterBase> const& p)
	                 {
		                 return p->name == name;
	                 });

	if (parameter_it == parameters.end())
	{
		ERR(
		    "Could not find parameter '%s' in the provided parameters list for "
		    "config tag <%s>.",
		    name.c_str(), tag.c_str());
		std::abort();
	}
	DBUG("Found parameter \'%s\'.", (*parameter_it)->name.c_str());

	// Check the type correctness of the found parameter.
	auto* const parameter =
	    dynamic_cast<Parameter<ParameterArgs...>*>(parameter_it->get());
	if (!parameter)
	{
		ERR("The read parameter is of incompatible type.");
		std::abort();
	}
	return *parameter;
}

}  // namespace ProcessLib

#endif  // PROCESS_LIB_PROCESS_H_