Skip to content
Snippets Groups Projects

Compare revisions

Changes are shown as if the source revision was being merged into the target revision. Learn more about comparing revisions.

Source

Select target project
No results found

Target

Select target project
  • podlesny/dune-tectonic
  • agnumpde/dune-tectonic
2 results
Show changes
Showing
with 620 additions and 233 deletions
...@@ -13,15 +13,16 @@ ...@@ -13,15 +13,16 @@
template <size_t dim, class BlockProblem, class Grid> template <size_t dim, class BlockProblem, class Grid>
SolverFactory<dim, BlockProblem, Grid>::SolverFactory( SolverFactory<dim, BlockProblem, Grid>::SolverFactory(
Dune::ParameterTree const &parset, size_t refinements, Grid const &grid, Dune::ParameterTree const &parset, Grid const &grid,
Dune::BitSetVector<dim> const &ignoreNodes) Dune::BitSetVector<dim> const &ignoreNodes)
: baseEnergyNorm(linearBaseSolverStep), : baseEnergyNorm(linearBaseSolverStep),
linearBaseSolver(&linearBaseSolverStep, linearBaseSolver(&linearBaseSolverStep,
parset.get<size_t>("linear.maxiumumIterations"), parset.get<size_t>("linear.maxiumumIterations"),
parset.get<double>("linear.tolerance"), &baseEnergyNorm, parset.get<double>("linear.tolerance"), &baseEnergyNorm,
Solver::QUIET), Solver::QUIET),
transferOperators(refinements), transferOperators(grid.maxLevel()),
multigridStep(new Solver(linearIterationStep, nonlinearSmoother)) { multigridStep(
std::make_shared<Step>(linearIterationStep, nonlinearSmoother)) {
// linear iteration step // linear iteration step
linearIterationStep.setMGType(parset.get<int>("linear.cycle"), linearIterationStep.setMGType(parset.get<int>("linear.cycle"),
parset.get<int>("linear.pre"), parset.get<int>("linear.pre"),
...@@ -30,7 +31,7 @@ SolverFactory<dim, BlockProblem, Grid>::SolverFactory( ...@@ -30,7 +31,7 @@ SolverFactory<dim, BlockProblem, Grid>::SolverFactory(
linearIterationStep.setSmoother(&linearPresmoother, &linearPostsmoother); linearIterationStep.setSmoother(&linearPresmoother, &linearPostsmoother);
// transfer operators // transfer operators
for (auto &x : transferOperators) for (auto &&x : transferOperators)
x = new CompressedMultigridTransfer<Vector>; x = new CompressedMultigridTransfer<Vector>;
TransferOperatorAssembler<Grid>(grid) TransferOperatorAssembler<Grid>(grid)
.assembleOperatorPointerHierarchy(transferOperators); .assembleOperatorPointerHierarchy(transferOperators);
...@@ -45,14 +46,13 @@ SolverFactory<dim, BlockProblem, Grid>::SolverFactory( ...@@ -45,14 +46,13 @@ SolverFactory<dim, BlockProblem, Grid>::SolverFactory(
template <size_t dim, class BlockProblem, class Grid> template <size_t dim, class BlockProblem, class Grid>
SolverFactory<dim, BlockProblem, Grid>::~SolverFactory() { SolverFactory<dim, BlockProblem, Grid>::~SolverFactory() {
for (auto &x : transferOperators) for (auto &&x : transferOperators)
delete x; delete x;
delete multigridStep;
} }
template <size_t dim, class BlockProblem, class Grid> template <size_t dim, class BlockProblem, class Grid>
auto SolverFactory<dim, BlockProblem, Grid>::getSolver() -> Solver *{ auto SolverFactory<dim, BlockProblem, Grid>::getStep()
-> std::shared_ptr<Step> {
return multigridStep; return multigridStep;
} }
......
#ifndef SOLVER_FACTORY_HH #ifndef SRC_SPATIAL_SOLVING_SOLVERFACTORY_HH
#define SOLVER_FACTORY_HH #define SRC_SPATIAL_SOLVING_SOLVERFACTORY_HH
#include <dune/common/bitsetvector.hh> #include <dune/common/bitsetvector.hh>
#include <dune/common/parametertree.hh> #include <dune/common/parametertree.hh>
#pragma clang diagnostic push
#pragma clang diagnostic ignored "-Wsign-compare"
#include <dune/solvers/iterationsteps/multigridstep.hh> #include <dune/solvers/iterationsteps/multigridstep.hh>
#pragma clang diagnostic pop
#include <dune/solvers/iterationsteps/truncatedblockgsstep.hh> #include <dune/solvers/iterationsteps/truncatedblockgsstep.hh>
#include <dune/solvers/norms/energynorm.hh> #include <dune/solvers/norms/energynorm.hh>
#include <dune/solvers/solvers/loopsolver.hh> #include <dune/solvers/solvers/loopsolver.hh>
...@@ -26,16 +22,17 @@ class SolverFactory { ...@@ -26,16 +22,17 @@ class SolverFactory {
private: private:
using NonlinearSmoother = GenericNonlinearGS<BlockProblem>; using NonlinearSmoother = GenericNonlinearGS<BlockProblem>;
using Solver =
TruncatedNonsmoothNewtonMultigrid<BlockProblem, NonlinearSmoother>;
public: public:
SolverFactory(Dune::ParameterTree const &parset, size_t refinements, using Step =
Grid const &grid, Dune::BitSetVector<dim> const &ignoreNodes); TruncatedNonsmoothNewtonMultigrid<BlockProblem, NonlinearSmoother>;
SolverFactory(Dune::ParameterTree const &parset, Grid const &grid,
Dune::BitSetVector<dim> const &ignoreNodes);
~SolverFactory(); ~SolverFactory();
Solver *getSolver(); std::shared_ptr<Step> getStep();
private: private:
TruncatedBlockGSStep<Matrix, Vector> linearBaseSolverStep; TruncatedBlockGSStep<Matrix, Vector> linearBaseSolverStep;
...@@ -46,7 +43,6 @@ class SolverFactory { ...@@ -46,7 +43,6 @@ class SolverFactory {
MultigridStep<Matrix, Vector> linearIterationStep; MultigridStep<Matrix, Vector> linearIterationStep;
std::vector<CompressedMultigridTransfer<Vector> *> transferOperators; std::vector<CompressedMultigridTransfer<Vector> *> transferOperators;
NonlinearSmoother nonlinearSmoother; NonlinearSmoother nonlinearSmoother;
Solver *multigridStep; std::shared_ptr<Step> multigridStep;
}; };
#endif #endif
#ifndef DIM #ifndef MY_DIM
#error DIM unset #error MY_DIM unset
#endif #endif
#include "explicitgrid.hh" #include "../explicitgrid.hh"
#include "explicitvectors.hh" #include "../explicitvectors.hh"
#include <dune/tnnmg/nonlinearities/zerononlinearity.hh> #include <dune/tnnmg/nonlinearities/zerononlinearity.hh>
#include <dune/tnnmg/problem-classes/blocknonlineartnnmgproblem.hh> #include <dune/tnnmg/problem-classes/blocknonlineartnnmgproblem.hh>
#include <dune/tnnmg/problem-classes/convexproblem.hh> #include <dune/tnnmg/problem-classes/convexproblem.hh>
#include <dune/tectonic/globalnonlinearity.hh> #include <dune/tectonic/globalfriction.hh>
#include <dune/tectonic/myblockproblem.hh> #include <dune/tectonic/myblockproblem.hh>
template class SolverFactory< template class SolverFactory<
DIM, MY_DIM,
MyBlockProblem<ConvexProblem<GlobalNonlinearity<Matrix, Vector>, Matrix>>, MyBlockProblem<ConvexProblem<GlobalFriction<Matrix, Vector>, Matrix>>,
Grid>; Grid>;
template class SolverFactory< template class SolverFactory<
DIM, BlockNonlinearTNNMGProblem< MY_DIM, BlockNonlinearTNNMGProblem<ConvexProblem<
ConvexProblem<ZeroNonlinearity<LocalVector, LocalMatrix>, Matrix>>, ZeroNonlinearity<LocalVector, LocalMatrix>, Matrix>>,
Grid>; Grid>;
#include <cassert>
#include <dune/tnnmg/problem-classes/bisection.hh>
#include <dune/tnnmg/problem-classes/directionalconvexfunction.hh>
#include "compute_state_dieterich_euler.hh"
#include <dune/common/fvector.hh>
#include <dune/common/fmatrix.hh>
#include <dune/solvers/common/interval.hh>
/* Dieterich's law:
\f$ \dot \theta = 1 - V \theta/L \f$
Transformed using \alpha = \log \theta:
\f$ \dot \alpha = \exp(-\alpha) - V/L \f$
discretised in time (using backward euler):
\f$\delta \alpha_1 = \exp(-\alpha_1) - V/L\f$
or
\f$ 0 = ( \alpha_1 - \alpha_0 )/\tau - ( \exp(-\alpha_1) - V/L ) \f$
this is obviously monotone in \f$\alpha_1\f$; we can thus see if as
a convex minimisation problem.
find the antiderivative:
\f$ J(\alpha_1)
= 0.5/\tau * \alpha_1^2 - ( \alpha_0/\tau - V/L ) \alpha_1 +
\exp(-\alpha_1)\f$
Consequence: linear part is \f$ \alpha_0/\tau - V/L \f$; nonlinear
part is \f$\exp(-\alpha_1)\f$ which has derivative \f$
-\exp(-\alpha_1) \f$.
*/
//! The nonlinearity \f$f(x) = exp(-x)\f$
class DieterichNonlinearity {
public:
using VectorType = Dune::FieldVector<double, 1>;
using MatrixType = Dune::FieldMatrix<double, 1, 1>;
DieterichNonlinearity() {}
void directionalSubDiff(VectorType const &u, VectorType const &v,
Dune::Solvers::Interval<double> &D) const {
D[0] = D[1] = v[0] * (-std::exp(-u[0]));
}
void directionalDomain(VectorType const &, VectorType const &,
Dune::Solvers::Interval<double> &dom) const {
dom[0] = -std::numeric_limits<double>::max();
dom[1] = std::numeric_limits<double>::max();
}
};
double state_update_dieterich_euler(double tau, double VoL, double logState_o) {
DieterichNonlinearity::VectorType const start(0);
DieterichNonlinearity::VectorType const direction(1);
DieterichNonlinearity phi;
DirectionalConvexFunction<DieterichNonlinearity> const J(
1.0 / tau, logState_o / tau - VoL, phi, start, direction);
int bisectionsteps = 0;
Bisection const bisection;
return bisection.minimize(J, 0.0, 0.0, bisectionsteps);
}
#ifndef COMPUTE_STATE_DIETERICH_EULER_HH
#define COMPUTE_STATE_DIETERICH_EULER_HH
double state_update_dieterich_euler(double h, double VoL, double logState_o);
#endif
#include <cassert>
#include <cmath>
#include "compute_state_ruina.hh"
double state_update_ruina(double tau, double uol, double logState_o) {
if (uol == 0)
return logState_o;
double const ret = logState_o - uol * std::log(uol / tau);
return ret / (1 + uol);
}
#ifndef COMPUTE_STATE_RUINA_HH
#define COMPUTE_STATE_RUINA_HH
double state_update_ruina(double h, double uol, double logState_o);
#endif
#ifndef DIETERICH_STATE_UPDATER_HH
#define DIETERICH_STATE_UPDATER_HH
#include "compute_state_dieterich_euler.hh"
#include "stateupdater.hh"
template <class ScalarVector, class Vector>
class DieterichStateUpdater : public StateUpdater<ScalarVector, Vector> {
public:
DieterichStateUpdater(ScalarVector _logState_initial,
Dune::BitSetVector<1> const &_nodes, double _L);
void virtual nextTimeStep();
void virtual setup(double _tau);
void virtual solve(Vector const &velocity_field);
void virtual extractLogState(ScalarVector &);
private:
ScalarVector logState_o;
ScalarVector logState;
Dune::BitSetVector<1> const &nodes;
double const L;
double tau;
};
template <class ScalarVector, class Vector>
DieterichStateUpdater<ScalarVector, Vector>::DieterichStateUpdater(
ScalarVector _logState_initial, Dune::BitSetVector<1> const &_nodes,
double _L)
: logState(_logState_initial), nodes(_nodes), L(_L) {}
template <class ScalarVector, class Vector>
void DieterichStateUpdater<ScalarVector, Vector>::nextTimeStep() {
logState_o = logState;
}
template <class ScalarVector, class Vector>
void DieterichStateUpdater<ScalarVector, Vector>::setup(double _tau) {
tau = _tau;
}
template <class ScalarVector, class Vector>
void DieterichStateUpdater<ScalarVector, Vector>::solve(
Vector const &velocity_field) {
for (size_t i = 0; i < nodes.size(); ++i)
if (nodes[i][0]) {
double const V = velocity_field[i].two_norm();
logState[i] = state_update_dieterich_euler(tau, V / L, logState_o[i]);
}
}
template <class ScalarVector, class Vector>
void DieterichStateUpdater<ScalarVector, Vector>::extractLogState(
ScalarVector &_logState) {
_logState = logState;
}
#endif
#ifndef RUINA_STATE_UPDATER_HH
#define RUINA_STATE_UPDATER_HH
#include "compute_state_ruina.hh"
#include "stateupdater.hh"
template <class ScalarVector, class Vector>
class RuinaStateUpdater : public StateUpdater<ScalarVector, Vector> {
public:
RuinaStateUpdater(ScalarVector _logState_initial,
Dune::BitSetVector<1> const &_nodes, double _L);
void virtual nextTimeStep();
void virtual setup(double _tau);
void virtual solve(Vector const &velocity_field);
void virtual extractLogState(ScalarVector &);
private:
ScalarVector logState_o;
ScalarVector logState;
Dune::BitSetVector<1> const &nodes;
double const L;
double tau;
};
template <class ScalarVector, class Vector>
RuinaStateUpdater<ScalarVector, Vector>::RuinaStateUpdater(
ScalarVector _logState_initial, Dune::BitSetVector<1> const &_nodes,
double _L)
: logState(_logState_initial), nodes(_nodes), L(_L) {}
template <class ScalarVector, class Vector>
void RuinaStateUpdater<ScalarVector, Vector>::nextTimeStep() {
logState_o = logState;
}
template <class ScalarVector, class Vector>
void RuinaStateUpdater<ScalarVector, Vector>::setup(double _tau) {
tau = _tau;
}
template <class ScalarVector, class Vector>
void RuinaStateUpdater<ScalarVector, Vector>::solve(
Vector const &velocity_field) {
for (size_t i = 0; i < nodes.size(); ++i)
if (nodes[i][0]) {
double const V = velocity_field[i].two_norm();
logState[i] = state_update_ruina(tau, V * tau / L, logState_o[i]);
}
}
template <class ScalarVector, class Vector>
void RuinaStateUpdater<ScalarVector, Vector>::extractLogState(
ScalarVector &_logState) {
_logState = logState;
}
#endif
#ifdef HAVE_CONFIG_H
#include "config.h"
#endif
#include "adaptivetimestepper.hh"
void IterationRegister::registerCount(FixedPointIterationCounter count) {
totalCount += count;
}
void IterationRegister::registerFinalCount(FixedPointIterationCounter count) {
finalCount = count;
}
void IterationRegister::reset() {
totalCount = FixedPointIterationCounter();
finalCount = FixedPointIterationCounter();
}
template <class Factory, class Updaters, class ErrorNorm>
AdaptiveTimeStepper<Factory, Updaters, ErrorNorm>::AdaptiveTimeStepper(
Factory &factory, Dune::ParameterTree const &parset,
std::shared_ptr<Nonlinearity> globalFriction, Updaters &current,
double relativeTime, double relativeTau,
std::function<void(double, Vector &)> externalForces,
ErrorNorm const &errorNorm,
std::function<bool(Updaters &, Updaters &)> mustRefine)
: relativeTime_(relativeTime),
relativeTau_(relativeTau),
finalTime_(parset.get<double>("problem.finalTime")),
factory_(factory),
parset_(parset),
globalFriction_(globalFriction),
current_(current),
R1_(),
externalForces_(externalForces),
mustRefine_(mustRefine),
errorNorm_(errorNorm) {}
template <class Factory, class Updaters, class ErrorNorm>
bool AdaptiveTimeStepper<Factory, Updaters, ErrorNorm>::reachedEnd() {
return relativeTime_ >= 1.0;
}
template <class Factory, class Updaters, class ErrorNorm>
IterationRegister AdaptiveTimeStepper<Factory, Updaters, ErrorNorm>::advance() {
/*
| C | We check here if making the step R1 of size tau is a
| R1 | R2 | good idea. To check if we can coarsen, we compare
|F1|F2| | the result of (R1+R2) with C, i.e. two steps of size
tau with one of size 2*tau. To check if we need to
refine, we compare the result of (F1+F2) with R1, i.e. two steps
of size tau/2 with one of size tau. The method makes multiple
coarsening/refining attempts, with coarsening coming first. */
if (R1_.updaters == Updaters())
R1_ = step(current_, relativeTime_, relativeTau_);
bool didCoarsen = false;
iterationRegister_.reset();
UpdatersWithCount R2;
UpdatersWithCount C;
while (relativeTime_ + relativeTau_ <= 1.0) {
R2 = step(R1_.updaters, relativeTime_ + relativeTau_, relativeTau_);
C = step(current_, relativeTime_, 2 * relativeTau_);
if (mustRefine_(R2.updaters, C.updaters))
break;
didCoarsen = true;
relativeTau_ *= 2;
R1_ = C;
}
UpdatersWithCount F1;
UpdatersWithCount F2;
if (!didCoarsen) {
while (true) {
F1 = step(current_, relativeTime_, relativeTau_ / 2.0);
F2 = step(F1.updaters, relativeTime_ + relativeTau_ / 2.0,
relativeTau_ / 2.0);
if (!mustRefine_(F2.updaters, R1_.updaters))
break;
relativeTau_ /= 2.0;
R1_ = F1;
R2 = F2;
}
}
iterationRegister_.registerFinalCount(R1_.count);
relativeTime_ += relativeTau_;
current_ = R1_.updaters;
R1_ = R2;
return iterationRegister_;
}
template <class Factory, class Updaters, class ErrorNorm>
typename AdaptiveTimeStepper<Factory, Updaters, ErrorNorm>::UpdatersWithCount
AdaptiveTimeStepper<Factory, Updaters, ErrorNorm>::step(
Updaters const &oldUpdaters, double rTime, double rTau) {
UpdatersWithCount newUpdatersAndCount = {oldUpdaters.clone(), {}};
newUpdatersAndCount.count =
MyCoupledTimeStepper(finalTime_, factory_, parset_, globalFriction_,
newUpdatersAndCount.updaters, errorNorm_,
externalForces_)
.step(rTime, rTau);
iterationRegister_.registerCount(newUpdatersAndCount.count);
return newUpdatersAndCount;
}
#include "adaptivetimestepper_tmpl.cc"
#ifndef SRC_TIME_STEPPING_ADAPTIVETIMESTEPPER_HH
#define SRC_TIME_STEPPING_ADAPTIVETIMESTEPPER_HH
#include <fstream>
#include "coupledtimestepper.hh"
struct IterationRegister {
void registerCount(FixedPointIterationCounter count);
void registerFinalCount(FixedPointIterationCounter count);
void reset();
FixedPointIterationCounter totalCount;
FixedPointIterationCounter finalCount;
};
template <class Factory, class Updaters, class ErrorNorm>
class AdaptiveTimeStepper {
struct UpdatersWithCount {
Updaters updaters;
FixedPointIterationCounter count;
};
using Vector = typename Factory::Vector;
using ConvexProblem = typename Factory::ConvexProblem;
using Nonlinearity = typename ConvexProblem::NonlinearityType;
using MyCoupledTimeStepper = CoupledTimeStepper<Factory, Updaters, ErrorNorm>;
public:
AdaptiveTimeStepper(Factory &factory, Dune::ParameterTree const &parset,
std::shared_ptr<Nonlinearity> globalFriction,
Updaters &current, double relativeTime,
double relativeTau,
std::function<void(double, Vector &)> externalForces,
ErrorNorm const &errorNorm,
std::function<bool(Updaters &, Updaters &)> mustRefine);
bool reachedEnd();
IterationRegister advance();
double relativeTime_;
double relativeTau_;
private:
UpdatersWithCount step(Updaters const &oldUpdaters, double rTime,
double rTau);
double finalTime_;
Factory &factory_;
Dune::ParameterTree const &parset_;
std::shared_ptr<Nonlinearity> globalFriction_;
Updaters &current_;
UpdatersWithCount R1_;
std::function<void(double, Vector &)> externalForces_;
std::function<bool(Updaters &, Updaters &)> mustRefine_;
ErrorNorm const &errorNorm_;
IterationRegister iterationRegister_;
};
#endif
#ifndef MY_DIM
#error MY_DIM unset
#endif
#include "../explicitgrid.hh"
#include "../explicitvectors.hh"
#include <dune/common/function.hh>
#include <dune/solvers/norms/energynorm.hh>
#include <dune/tnnmg/problem-classes/convexproblem.hh>
#include <dune/tectonic/globalfriction.hh>
#include <dune/tectonic/myblockproblem.hh>
#include "../spatial-solving/solverfactory.hh"
#include "rate/rateupdater.hh"
#include "state/stateupdater.hh"
#include "updaters.hh"
using Function = Dune::VirtualFunction<double, double>;
using Factory = SolverFactory<
MY_DIM,
MyBlockProblem<ConvexProblem<GlobalFriction<Matrix, Vector>, Matrix>>,
Grid>;
using MyStateUpdater = StateUpdater<ScalarVector, Vector>;
using MyRateUpdater = RateUpdater<Vector, Matrix, Function, MY_DIM>;
using MyUpdaters = Updaters<MyRateUpdater, MyStateUpdater>;
using ErrorNorm = EnergyNorm<ScalarMatrix, ScalarVector>;
template class AdaptiveTimeStepper<Factory, MyUpdaters, ErrorNorm>;
#ifdef HAVE_CONFIG_H
#include "config.h"
#endif
#include "coupledtimestepper.hh"
template <class Factory, class Updaters, class ErrorNorm>
CoupledTimeStepper<Factory, Updaters, ErrorNorm>::CoupledTimeStepper(
double finalTime, Factory &factory, Dune::ParameterTree const &parset,
std::shared_ptr<Nonlinearity> globalFriction, Updaters updaters,
ErrorNorm const &errorNorm,
std::function<void(double, Vector &)> externalForces)
: finalTime_(finalTime),
factory_(factory),
parset_(parset),
globalFriction_(globalFriction),
updaters_(updaters),
externalForces_(externalForces),
errorNorm_(errorNorm) {}
template <class Factory, class Updaters, class ErrorNorm>
FixedPointIterationCounter
CoupledTimeStepper<Factory, Updaters, ErrorNorm>::step(double relativeTime,
double relativeTau) {
updaters_.state_->nextTimeStep();
updaters_.rate_->nextTimeStep();
auto const newRelativeTime = relativeTime + relativeTau;
Vector ell;
externalForces_(newRelativeTime, ell);
Matrix velocityMatrix;
Vector velocityRHS;
Vector velocityIterate;
auto const tau = relativeTau * finalTime_;
updaters_.state_->setup(tau);
updaters_.rate_->setup(ell, tau, newRelativeTime, velocityRHS,
velocityIterate, velocityMatrix);
FixedPointIterator<Factory, Updaters, ErrorNorm> fixedPointIterator(
factory_, parset_, globalFriction_, errorNorm_);
auto const iterations = fixedPointIterator.run(updaters_, velocityMatrix,
velocityRHS, velocityIterate);
return iterations;
}
#include "coupledtimestepper_tmpl.cc"
#ifndef SRC_TIME_STEPPING_COUPLEDTIMESTEPPER_HH
#define SRC_TIME_STEPPING_COUPLEDTIMESTEPPER_HH
#include <functional>
#include <memory>
#include <dune/common/parametertree.hh>
#include "../spatial-solving/fixedpointiterator.hh"
template <class Factory, class Updaters, class ErrorNorm>
class CoupledTimeStepper {
using Vector = typename Factory::Vector;
using Matrix = typename Factory::Matrix;
using ConvexProblem = typename Factory::ConvexProblem;
using Nonlinearity = typename ConvexProblem::NonlinearityType;
public:
CoupledTimeStepper(double finalTime, Factory &factory,
Dune::ParameterTree const &parset,
std::shared_ptr<Nonlinearity> globalFriction,
Updaters updaters, ErrorNorm const &errorNorm,
std::function<void(double, Vector &)> externalForces);
FixedPointIterationCounter step(double relativeTime, double relativeTau);
private:
double finalTime_;
Factory &factory_;
Dune::ParameterTree const &parset_;
std::shared_ptr<Nonlinearity> globalFriction_;
Updaters updaters_;
std::function<void(double, Vector &)> externalForces_;
ErrorNorm const &errorNorm_;
};
#endif
#ifndef MY_DIM
#error MY_DIM unset
#endif
#include "../explicitgrid.hh"
#include "../explicitvectors.hh"
#include <dune/common/function.hh>
#include <dune/solvers/norms/energynorm.hh>
#include <dune/tnnmg/problem-classes/convexproblem.hh>
#include <dune/tectonic/globalfriction.hh>
#include <dune/tectonic/myblockproblem.hh>
#include "../spatial-solving/solverfactory.hh"
#include "rate/rateupdater.hh"
#include "state/stateupdater.hh"
#include "updaters.hh"
using Function = Dune::VirtualFunction<double, double>;
using Factory = SolverFactory<
MY_DIM,
MyBlockProblem<ConvexProblem<GlobalFriction<Matrix, Vector>, Matrix>>,
Grid>;
using MyStateUpdater = StateUpdater<ScalarVector, Vector>;
using MyRateUpdater = RateUpdater<Vector, Matrix, Function, MY_DIM>;
using MyUpdaters = Updaters<MyRateUpdater, MyStateUpdater>;
using ErrorNorm = EnergyNorm<ScalarMatrix, ScalarVector>;
template class CoupledTimeStepper<Factory, MyUpdaters, ErrorNorm>;
#ifndef DUNE_TECTONIC_TIMESTEPPING_HH #ifdef HAVE_CONFIG_H
#define DUNE_TECTONIC_TIMESTEPPING_HH #include "config.h"
#endif
#include "enums.hh"
#include <dune/common/bitsetvector.hh>
template <class Vector, class Matrix, class Function, size_t dim>
class TimeSteppingScheme {
public:
void virtual nextTimeStep() = 0;
void virtual setup(Vector const &ell, double _tau, double relativeTime,
Vector &rhs, Vector &iterate, Matrix &AB) = 0;
void virtual postProcess(Vector const &iterate) = 0;
void virtual extractDisplacement(Vector &displacement) const = 0;
void virtual extractVelocity(Vector &velocity) const = 0;
void virtual extractOldVelocity(Vector &velocity) const = 0;
};
#include "timestepping/newmark.hh" #include "rate.hh"
#include "timestepping/backward_euler.hh" #include "rate/backward_euler.hh"
#include "rate/newmark.hh"
template <class Vector, class Matrix, class Function, int dimension> template <class Vector, class Matrix, class Function, int dimension>
std::shared_ptr<TimeSteppingScheme<Vector, Matrix, Function, dimension>> std::shared_ptr<RateUpdater<Vector, Matrix, Function, dimension>>
initTimeStepper(Config::scheme scheme, initRateUpdater(Config::scheme scheme,
Function const &velocityDirichletFunction, Function const &velocityDirichletFunction,
Dune::BitSetVector<dimension> const &velocityDirichletNodes, Dune::BitSetVector<dimension> const &velocityDirichletNodes,
Matrix const &massMatrix, Matrix const &stiffnessMatrix, Matrices<Matrix> const &matrices, Vector const &u_initial,
Matrix const &dampingMatrix, Vector const &u_initial,
Vector const &v_initial, Vector const &a_initial) { Vector const &v_initial, Vector const &a_initial) {
switch (scheme) { switch (scheme) {
case Config::Newmark: case Config::Newmark:
return std::make_shared<Newmark<Vector, Matrix, Function, dimension>>( return std::make_shared<Newmark<Vector, Matrix, Function, dimension>>(
stiffnessMatrix, massMatrix, dampingMatrix, u_initial, v_initial, matrices, u_initial, v_initial, a_initial, velocityDirichletNodes,
a_initial, velocityDirichletNodes, velocityDirichletFunction); velocityDirichletFunction);
case Config::BackwardEuler: case Config::BackwardEuler:
return std::make_shared< return std::make_shared<
BackwardEuler<Vector, Matrix, Function, dimension>>( BackwardEuler<Vector, Matrix, Function, dimension>>(
stiffnessMatrix, massMatrix, dampingMatrix, u_initial, v_initial, matrices, u_initial, v_initial, a_initial, velocityDirichletNodes,
velocityDirichletNodes, velocityDirichletFunction); velocityDirichletFunction);
default: default:
assert(false); assert(false);
} }
} }
#endif #include "rate_tmpl.cc"
#ifndef SRC_TIME_STEPPING_RATE_HH
#define SRC_TIME_STEPPING_RATE_HH
#include <memory>
#include "../enums.hh"
#include "rate/rateupdater.hh"
template <class Vector, class Matrix, class Function, int dimension>
std::shared_ptr<RateUpdater<Vector, Matrix, Function, dimension>>
initRateUpdater(Config::scheme scheme,
Function const &velocityDirichletFunction,
Dune::BitSetVector<dimension> const &velocityDirichletNodes,
Matrices<Matrix> const &matrices, Vector const &u_initial,
Vector const &v_initial, Vector const &a_initial);
#endif
#include <dune/solvers/common/arithmetic.hh>
#include "backward_euler.hh"
template <class Vector, class Matrix, class Function, size_t dim> template <class Vector, class Matrix, class Function, size_t dim>
BackwardEuler<Vector, Matrix, Function, dim>::BackwardEuler( BackwardEuler<Vector, Matrix, Function, dim>::BackwardEuler(
Matrix const &_A, Matrix const &_M, Matrix const &_C, Matrices<Matrix> const &_matrices, Vector const &_u_initial,
Vector const &_u_initial, Vector const &_v_initial, Vector const &_v_initial, Vector const &_a_initial,
Dune::BitSetVector<dim> const &_dirichletNodes, Dune::BitSetVector<dim> const &_dirichletNodes,
Function const &_dirichletFunction) Function const &_dirichletFunction)
: A(_A), : RateUpdater<Vector, Matrix, Function, dim>(
M(_M), _matrices, _u_initial, _v_initial, _a_initial, _dirichletNodes,
C(_C), _dirichletFunction) {}
u(_u_initial),
v(_v_initial),
dirichletNodes(_dirichletNodes),
dirichletFunction(_dirichletFunction) {}
template <class Vector, class Matrix, class Function, size_t dim>
void BackwardEuler<Vector, Matrix, Function, dim>::nextTimeStep() {
v_o = v;
u_o = u;
}
template <class Vector, class Matrix, class Function, size_t dim> template <class Vector, class Matrix, class Function, size_t dim>
void BackwardEuler<Vector, Matrix, Function, dim>::setup( void BackwardEuler<Vector, Matrix, Function, dim>::setup(
Vector const &ell, double _tau, double relativeTime, Vector &rhs, Vector const &ell, double _tau, double relativeTime, Vector &rhs,
Vector &iterate, Matrix &AM) { Vector &iterate, Matrix &AM) {
postProcessCalled = false; this->dirichletFunction.evaluate(relativeTime, this->dirichletValue);
this->tau = _tau;
tau = _tau;
/* We start out with the formulation /* We start out with the formulation
...@@ -49,68 +42,51 @@ void BackwardEuler<Vector, Matrix, Function, dim>::setup( ...@@ -49,68 +42,51 @@ void BackwardEuler<Vector, Matrix, Function, dim>::setup(
// set up LHS (for fixed tau, we'd only really have to do this once) // set up LHS (for fixed tau, we'd only really have to do this once)
{ {
Dune::MatrixIndexSet indices(A.N(), A.M()); Dune::MatrixIndexSet indices(this->matrices.elasticity.N(),
indices.import(A); this->matrices.elasticity.M());
indices.import(M); indices.import(this->matrices.elasticity);
indices.import(C); indices.import(this->matrices.mass);
indices.import(this->matrices.damping);
indices.exportIdx(AM); indices.exportIdx(AM);
} }
AM = 0.0; AM = 0.0;
Arithmetic::addProduct(AM, 1.0 / tau, M); Arithmetic::addProduct(AM, 1.0 / this->tau, this->matrices.mass);
Arithmetic::addProduct(AM, 1.0, C); Arithmetic::addProduct(AM, 1.0, this->matrices.damping);
Arithmetic::addProduct(AM, tau, A); Arithmetic::addProduct(AM, this->tau, this->matrices.elasticity);
// set up RHS // set up RHS
{ {
rhs = ell; rhs = ell;
Arithmetic::addProduct(rhs, 1.0 / tau, M, v_o); Arithmetic::addProduct(rhs, 1.0 / this->tau, this->matrices.mass,
Arithmetic::subtractProduct(rhs, A, u_o); this->v_o);
Arithmetic::subtractProduct(rhs, this->matrices.elasticity, this->u_o);
} }
// v_o makes a good initial iterate; we could use anything, though iterate = this->v_o;
iterate = 0.0;
for (size_t i = 0; i < dirichletNodes.size(); ++i) for (size_t i = 0; i < this->dirichletNodes.size(); ++i)
for (size_t j = 0; j < dim; ++j) for (size_t j = 0; j < dim; ++j)
if (dirichletNodes[i][j]) { if (this->dirichletNodes[i][j])
if (j == 0) iterate[i][j] = (j == 0) ? this->dirichletValue : 0;
dirichletFunction.evaluate(relativeTime, iterate[i][j]);
else
iterate[i][j] = 0;
}
} }
template <class Vector, class Matrix, class Function, size_t dim> template <class Vector, class Matrix, class Function, size_t dim>
void BackwardEuler<Vector, Matrix, Function, dim>::postProcess( void BackwardEuler<Vector, Matrix, Function, dim>::postProcess(
Vector const &iterate) { Vector const &iterate) {
postProcessCalled = true; this->postProcessCalled = true;
v = iterate; this->v = iterate;
u = u_o; this->u = this->u_o;
Arithmetic::addProduct(u, tau, v); Arithmetic::addProduct(this->u, this->tau, this->v);
}
template <class Vector, class Matrix, class Function, size_t dim>
void BackwardEuler<Vector, Matrix, Function, dim>::extractDisplacement(
Vector &displacement) const {
if (!postProcessCalled)
DUNE_THROW(Dune::Exception, "It seems you forgot to call postProcess!");
displacement = u; this->a = this->v;
this->a -= this->v_o;
this->a /= this->tau;
} }
template <class Vector, class Matrix, class Function, size_t dim> template <class Vector, class Matrix, class Function, size_t dim>
void BackwardEuler<Vector, Matrix, Function, dim>::extractVelocity( std::shared_ptr<RateUpdater<Vector, Matrix, Function, dim>>
Vector &velocity) const { BackwardEuler<Vector, Matrix, Function, dim>::clone() const {
if (!postProcessCalled) return std::make_shared<BackwardEuler<Vector, Matrix, Function, dim>>(*this);
DUNE_THROW(Dune::Exception, "It seems you forgot to call postProcess!");
velocity = v;
}
template <class Vector, class MatrixType, class FunctionType, size_t dim>
void BackwardEuler<Vector, MatrixType, FunctionType, dim>::extractOldVelocity(
Vector &velocity) const {
velocity = v_o;
} }
#ifndef DUNE_TECTONIC_TIMESTEPPING_BACKWARD_EULER_HH #ifndef SRC_TIME_STEPPING_RATE_BACKWARD_EULER_HH
#define DUNE_TECTONIC_TIMESTEPPING_BACKWARD_EULER_HH #define SRC_TIME_STEPPING_RATE_BACKWARD_EULER_HH
template <class Vector, class Matrix, class Function, size_t dim> template <class Vector, class Matrix, class Function, size_t dim>
class BackwardEuler : public TimeSteppingScheme<Vector, Matrix, Function, dim> { class BackwardEuler : public RateUpdater<Vector, Matrix, Function, dim> {
public: public:
BackwardEuler(Matrix const &_A, Matrix const &_M, Matrix const &_C, BackwardEuler(Matrices<Matrix> const &_matrices, Vector const &_u_initial,
Vector const &_u_initial, Vector const &_v_initial, Vector const &_v_initial, Vector const &_a_initial,
Dune::BitSetVector<dim> const &_dirichletNodes, Dune::BitSetVector<dim> const &_dirichletNodes,
Function const &_dirichletFunction); Function const &_dirichletFunction);
void nextTimeStep() override;
void setup(Vector const &, double, double, Vector &, Vector &, void setup(Vector const &, double, double, Vector &, Vector &,
Matrix &) override; Matrix &) override;
void postProcess(Vector const &) override; void postProcess(Vector const &) override;
void extractDisplacement(Vector &) const override;
void extractVelocity(Vector &) const override;
void extractOldVelocity(Vector &) const override;
private: std::shared_ptr<RateUpdater<Vector, Matrix, Function, dim>> clone()
Matrix const &A; const override;
Matrix const &M;
Matrix const &C;
Vector u;
Vector v;
Dune::BitSetVector<dim> const &dirichletNodes;
Function const &dirichletFunction;
Vector u_o;
Vector v_o;
double tau; private:
bool postProcessCalled = false;
}; };
#endif #endif
#include <dune/solvers/common/arithmetic.hh>
#include "newmark.hh"
template <class Vector, class Matrix, class Function, size_t dim> template <class Vector, class Matrix, class Function, size_t dim>
Newmark<Vector, Matrix, Function, dim>::Newmark( Newmark<Vector, Matrix, Function, dim>::Newmark(
Matrix const &_A, Matrix const &_M, Matrix const &_C, Matrices<Matrix> const &_matrices, Vector const &_u_initial,
Vector const &_u_initial, Vector const &_v_initial, Vector const &_v_initial, Vector const &_a_initial,
Vector const &_a_initial, Dune::BitSetVector<dim> const &_dirichletNodes, Dune::BitSetVector<dim> const &_dirichletNodes,
Function const &_dirichletFunction) Function const &_dirichletFunction)
: A(_A), : RateUpdater<Vector, Matrix, Function, dim>(
M(_M), _matrices, _u_initial, _v_initial, _a_initial, _dirichletNodes,
C(_C), _dirichletFunction) {}
u(_u_initial),
v(_v_initial),
a(_a_initial),
dirichletNodes(_dirichletNodes),
dirichletFunction(_dirichletFunction) {}
template <class Vector, class Matrix, class Function, size_t dim>
void Newmark<Vector, Matrix, Function, dim>::nextTimeStep() {
a_o = a;
v_o = v;
u_o = u;
}
template <class Vector, class Matrix, class Function, size_t dim> template <class Vector, class Matrix, class Function, size_t dim>
void Newmark<Vector, Matrix, Function, dim>::setup(Vector const &ell, void Newmark<Vector, Matrix, Function, dim>::setup(Vector const &ell,
...@@ -26,9 +18,8 @@ void Newmark<Vector, Matrix, Function, dim>::setup(Vector const &ell, ...@@ -26,9 +18,8 @@ void Newmark<Vector, Matrix, Function, dim>::setup(Vector const &ell,
double relativeTime, double relativeTime,
Vector &rhs, Vector &iterate, Vector &rhs, Vector &iterate,
Matrix &AM) { Matrix &AM) {
postProcessCalled = false; this->dirichletFunction.evaluate(relativeTime, this->dirichletValue);
this->tau = _tau;
tau = _tau;
/* We start out with the formulation /* We start out with the formulation
...@@ -54,78 +45,58 @@ void Newmark<Vector, Matrix, Function, dim>::setup(Vector const &ell, ...@@ -54,78 +45,58 @@ void Newmark<Vector, Matrix, Function, dim>::setup(Vector const &ell,
// set up LHS (for fixed tau, we'd only really have to do this once) // set up LHS (for fixed tau, we'd only really have to do this once)
{ {
Dune::MatrixIndexSet indices(A.N(), A.M()); Dune::MatrixIndexSet indices(this->matrices.elasticity.N(),
indices.import(A); this->matrices.elasticity.M());
indices.import(M); indices.import(this->matrices.elasticity);
indices.import(C); indices.import(this->matrices.mass);
indices.import(this->matrices.damping);
indices.exportIdx(AM); indices.exportIdx(AM);
} }
AM = 0.0; AM = 0.0;
Arithmetic::addProduct(AM, 2.0 / tau, M); Arithmetic::addProduct(AM, 2.0 / this->tau, this->matrices.mass);
Arithmetic::addProduct(AM, 1.0, C); Arithmetic::addProduct(AM, 1.0, this->matrices.damping);
Arithmetic::addProduct(AM, tau / 2.0, A); Arithmetic::addProduct(AM, this->tau / 2.0, this->matrices.elasticity);
// set up RHS // set up RHS
{ {
rhs = ell; rhs = ell;
Arithmetic::addProduct(rhs, 2.0 / tau, M, v_o); Arithmetic::addProduct(rhs, 2.0 / this->tau, this->matrices.mass,
Arithmetic::addProduct(rhs, M, a_o); this->v_o);
Arithmetic::subtractProduct(rhs, tau / 2.0, A, v_o); Arithmetic::addProduct(rhs, this->matrices.mass, this->a_o);
Arithmetic::subtractProduct(rhs, A, u_o); Arithmetic::subtractProduct(rhs, this->tau / 2.0, this->matrices.elasticity,
this->v_o);
Arithmetic::subtractProduct(rhs, this->matrices.elasticity, this->u_o);
} }
// v_o makes a good initial iterate; we could use anything, though iterate = this->v_o;
iterate = 0.0;
for (size_t i = 0; i < dirichletNodes.size(); ++i) for (size_t i = 0; i < this->dirichletNodes.size(); ++i)
for (size_t j = 0; j < dim; ++j) for (size_t j = 0; j < dim; ++j)
if (dirichletNodes[i][j]) { if (this->dirichletNodes[i][j])
if (j == 0) iterate[i][j] = (j == 0) ? this->dirichletValue : 0;
dirichletFunction.evaluate(relativeTime, iterate[i][j]);
else
iterate[i][j] = 0;
}
} }
template <class Vector, class Matrix, class Function, size_t dim> template <class Vector, class Matrix, class Function, size_t dim>
void Newmark<Vector, Matrix, Function, dim>::postProcess( void Newmark<Vector, Matrix, Function, dim>::postProcess(
Vector const &iterate) { Vector const &iterate) {
postProcessCalled = true; this->postProcessCalled = true;
v = iterate; this->v = iterate;
// u1 = tau/2 ( v1 + v0 ) + u0 // u1 = tau/2 ( v1 + v0 ) + u0
u = u_o; this->u = this->u_o;
Arithmetic::addProduct(u, tau / 2.0, v); Arithmetic::addProduct(this->u, this->tau / 2.0, this->v);
Arithmetic::addProduct(u, tau / 2.0, v_o); Arithmetic::addProduct(this->u, this->tau / 2.0, this->v_o);
// a1 = 2/tau ( v1 - v0 ) - a0 // a1 = 2/tau ( v1 - v0 ) - a0
a = 0; this->a = 0.0;
Arithmetic::addProduct(a, 2.0 / tau, v); Arithmetic::addProduct(this->a, 2.0 / this->tau, this->v);
Arithmetic::subtractProduct(a, 2.0 / tau, v_o); Arithmetic::subtractProduct(this->a, 2.0 / this->tau, this->v_o);
Arithmetic::subtractProduct(a, 1.0, a_o); Arithmetic::subtractProduct(this->a, 1.0, this->a_o);
} }
template <class Vector, class Matrix, class Function, size_t dim> template <class Vector, class Matrix, class Function, size_t dim>
void Newmark<Vector, Matrix, Function, dim>::extractDisplacement( std::shared_ptr<RateUpdater<Vector, Matrix, Function, dim>>
Vector &displacement) const { Newmark<Vector, Matrix, Function, dim>::clone() const {
if (!postProcessCalled) return std::make_shared<Newmark<Vector, Matrix, Function, dim>>(*this);
DUNE_THROW(Dune::Exception, "It seems you forgot to call postProcess!");
displacement = u;
}
template <class Vector, class Matrix, class Function, size_t dim>
void Newmark<Vector, Matrix, Function, dim>::extractVelocity(Vector &velocity)
const {
if (!postProcessCalled)
DUNE_THROW(Dune::Exception, "It seems you forgot to call postProcess!");
velocity = v;
}
template <class Vector, class MatrixType, class FunctionType, size_t dim>
void Newmark<Vector, MatrixType, FunctionType, dim>::extractOldVelocity(
Vector &velocity) const {
velocity = v_o;
} }