62 class DG_Solver :
public Solver
74 BlockILU::Reordering::MINIMUM_DISCARDED_FILL),
77 linear_solver.iterative_mode =
false;
78 linear_solver.SetRelTol(1e-9);
79 linear_solver.SetAbsTol(0.0);
80 linear_solver.SetMaxIter(100);
81 linear_solver.SetPrintLevel(0);
82 linear_solver.SetPreconditioner(prec);
85 void SetTimeStep(
double dt_)
96 linear_solver.SetOperator(A);
100 void SetOperator(
const Operator &op)
102 linear_solver.SetOperator(op);
107 linear_solver.Mult(x, y);
123 DG_Solver *dg_solver;
131 virtual void ImplicitSolve(
const double dt,
const Vector &x,
Vector &k);
137 int main(
int argc,
char *argv[])
141 const char *mesh_file =
"../data/periodic-hexagon.mesh";
145 const char *device_config =
"cpu";
146 int ode_solver_type = 4;
147 double t_final = 10.0;
149 bool visualization =
true;
151 bool paraview =
false;
156 cout.precision(precision);
159 args.
AddOption(&mesh_file,
"-m",
"--mesh",
160 "Mesh file to use.");
162 "Problem setup to use. See options in velocity_function().");
163 args.
AddOption(&ref_levels,
"-r",
"--refine",
164 "Number of times to refine the mesh uniformly.");
166 "Order (degree) of the finite elements.");
167 args.
AddOption(&pa,
"-pa",
"--partial-assembly",
"-no-pa",
168 "--no-partial-assembly",
"Enable Partial Assembly.");
169 args.
AddOption(&device_config,
"-d",
"--device",
170 "Device configuration string, see Device::Configure().");
171 args.
AddOption(&ode_solver_type,
"-s",
"--ode-solver",
172 "ODE solver: 1 - Forward Euler,\n\t"
173 " 2 - RK2 SSP, 3 - RK3 SSP, 4 - RK4, 6 - RK6,\n\t"
174 " 11 - Backward Euler,\n\t"
175 " 12 - SDIRK23 (L-stable), 13 - SDIRK33,\n\t"
176 " 22 - Implicit Midpoint Method,\n\t"
177 " 23 - SDIRK23 (A-stable), 24 - SDIRK34");
178 args.
AddOption(&t_final,
"-tf",
"--t-final",
179 "Final time; start time is 0.");
180 args.
AddOption(&dt,
"-dt",
"--time-step",
182 args.
AddOption(&visualization,
"-vis",
"--visualization",
"-no-vis",
183 "--no-visualization",
184 "Enable or disable GLVis visualization.");
185 args.
AddOption(&visit,
"-visit",
"--visit-datafiles",
"-no-visit",
186 "--no-visit-datafiles",
187 "Save data files for VisIt (visit.llnl.gov) visualization.");
188 args.
AddOption(¶view,
"-paraview",
"--paraview-datafiles",
"-no-paraview",
189 "--no-paraview-datafiles",
190 "Save data files for ParaView (paraview.org) visualization.");
191 args.
AddOption(&binary,
"-binary",
"--binary-datafiles",
"-ascii",
193 "Use binary (Sidre) or ascii format for VisIt data files.");
194 args.
AddOption(&vis_steps,
"-vs",
"--visualization-steps",
195 "Visualize every n-th timestep.");
204 Device device(device_config);
209 Mesh mesh(mesh_file, 1, 1);
215 switch (ode_solver_type)
219 case 2: ode_solver =
new RK2Solver(1.0);
break;
221 case 4: ode_solver =
new RK4Solver;
break;
222 case 6: ode_solver =
new RK6Solver;
break;
233 cout <<
"Unknown ODE solver type: " << ode_solver_type <<
'\n';
241 for (
int lev = 0; lev < ref_levels; lev++)
256 cout <<
"Number of unknowns: " << fes.
GetVSize() << endl;
297 ofstream omesh(
"ex9.mesh");
298 omesh.precision(precision);
300 ofstream osol(
"ex9-init.gf");
301 osol.precision(precision);
312 #ifdef MFEM_USE_SIDRE
315 MFEM_ABORT(
"Must build with MFEM_USE_SIDRE=YES for binary output.");
346 char vishost[] =
"localhost";
348 sout.
open(vishost, visport);
351 cout <<
"Unable to connect to GLVis server at "
352 << vishost <<
':' << visport << endl;
353 visualization =
false;
354 cout <<
"GLVis visualization disabled.\n";
358 sout.precision(precision);
359 sout <<
"solution\n" << mesh << u;
362 cout <<
"GLVis visualization paused."
363 <<
" Press space (in the GLVis window) to resume it.\n";
374 ode_solver->
Init(adv);
377 for (
int ti = 0; !done; )
379 double dt_real = min(dt, t_final - t);
380 ode_solver->
Step(u, t, dt_real);
383 done = (t >= t_final - 1e-8*dt);
385 if (done || ti % vis_steps == 0)
387 cout <<
"time step: " << ti <<
", time: " << t << endl;
391 sout <<
"solution\n" << mesh << u << flush;
413 ofstream osol(
"ex9-final.gf");
414 osol.precision(precision);
463 MFEM_VERIFY(dg_solver != NULL,
464 "Implicit time integration is not supported with partial assembly");
467 dg_solver->SetTimeStep(dt);
468 dg_solver->Mult(z, k);
484 for (
int i = 0; i <
dim; i++)
497 case 1: v(0) = 1.0;
break;
498 case 2: v(0) = sqrt(2./3.); v(1) = sqrt(1./3.);
break;
499 case 3: v(0) = sqrt(3./6.); v(1) = sqrt(2./6.); v(2) = sqrt(1./6.);
508 const double w = M_PI/2;
511 case 1: v(0) = 1.0;
break;
512 case 2: v(0) = w*X(1); v(1) = -w*X(0);
break;
513 case 3: v(0) = w*X(1); v(1) = -w*X(0); v(2) = 0.0;
break;
520 const double w = M_PI/2;
521 double d = max((X(0)+1.)*(1.-X(0)),0.) * max((X(1)+1.)*(1.-X(1)),0.);
525 case 1: v(0) = 1.0;
break;
526 case 2: v(0) = d*w*X(1); v(1) = -d*w*X(0);
break;
527 case 3: v(0) = d*w*X(1); v(1) = -d*w*X(0); v(2) = 0.0;
break;
541 for (
int i = 0; i <
dim; i++)
555 return exp(-40.*pow(X(0)-0.5,2));
559 double rx = 0.45, ry = 0.25, cx = 0., cy = -0.2, w = 10.;
562 const double s = (1. + 0.25*cos(2*M_PI*X(2)));
566 return ( erfc(w*(X(0)-cx-rx))*erfc(-w*(X(0)-cx+rx)) *
567 erfc(w*(X(1)-cy-ry))*erfc(-w*(X(1)-cy+ry)) )/16;
573 double x_ = X(0), y_ = X(1), rho, phi;
576 return pow(sin(M_PI*rho),2)*sin(3*phi);
580 const double f = M_PI;
581 return sin(f*X(0))*sin(f*X(1));
void SetPrecision(int prec)
Set the precision (number of digits) used for the text output of doubles.
int GetVSize() const
Return the number of vector dofs, i.e. GetNDofs() x GetVDim().
virtual void Print(std::ostream &out=mfem::out) const
Conjugate gradient method.
Class for grid function - Vector with associated FE space.
void SetCycle(int c)
Set time cycle (for time-dependent simulations)
Data type for scaled Jacobi-type smoother of sparse matrix.
void SetDataFormat(VTKFormat fmt)
virtual void Mult(const Vector &b, Vector &x) const
Operator application: y=A(x).
Helper class for ParaView visualization data.
Base abstract class for first order time dependent operators.
void Mult(const Table &A, const Table &B, Table &C)
C = A * B (as boolean matrices)
void GetBoundingBox(Vector &min, Vector &max, int ref=2)
Returns the minimum and maximum corners of the mesh bounding box.
virtual void Step(Vector &x, double &t, double &dt)=0
Perform a time step from time t [in] to time t [out] based on the requested step size dt [in]...
virtual void RegisterField(const std::string &field_name, mfem::GridFunction *gf) override
Add a grid function to the collection.
virtual void Init(TimeDependentOperator &f)
Associate a TimeDependentOperator with the ODE solver.
virtual void SetTime(const double _t)
Set the current time.
int Size() const
Returns the size of the vector.
Abstract class for solving systems of ODEs: dx/dt = f(x,t)
void Print(std::ostream &out=mfem::out)
Print the configuration of the MFEM virtual device object.
bool iterative_mode
If true, use the second argument of Mult() as an initial guess.
int main(int argc, char *argv[])
Backward Euler ODE solver. L-stable.
FE_Evolution(FiniteElementSpace &_vfes, Operator &_A, SparseMatrix &_Aflux)
Data collection with Sidre routines following the Conduit mesh blueprint specification.
virtual void Save(std::ostream &out) const
Save the GridFunction to an output stream.
virtual void RegisterField(const std::string &field_name, GridFunction *gf)
Add a grid function to the collection.
void SetPrintLevel(int print_lvl)
virtual void Save()
Save the collection to disk.
Jacobi smoothing for a given bilinear form (no matrix necessary).
void UniformRefinement(int i, const DSTable &, int *, int *, int *)
Data collection with VisIt I/O routines.
void SetMaxIter(int max_it)
virtual void SetCurvature(int order, bool discont=false, int space_dim=-1, int ordering=1)
void SetHighOrderOutput(bool high_order_output_)
void PrintUsage(std::ostream &out) const
void SetTime(double t)
Set physical time (for time-dependent simulations)
The classical explicit forth-order Runge-Kutta method, RK4.
void SetAbsTol(double atol)
virtual void ImplicitSolve(const double dt, const Vector &x, Vector &k)
Solve the equation: k = f(x + dt k, t), for the unknown k at the current time t.
void SetRelTol(double rtol)
void velocity_function(const Vector &x, Vector &v)
Class FiniteElementSpace - responsible for providing FEM view of the mesh, mainly managing the set of...
int GetDof() const
Returns the number of degrees of freedom in the finite element.
void AddOption(bool *var, const char *enable_short_name, const char *enable_long_name, const char *disable_short_name, const char *disable_long_name, const char *description, bool required=false)
Third-order, strong stability preserving (SSP) Runge-Kutta method.
virtual void Mult(const Vector &x, Vector &y) const
Perform the action of the operator: y = k = f(x, t), where k solves the algebraic equation F(x...
Implicit midpoint method. A-stable, not L-stable.
NURBSExtension * NURBSext
Optional NURBS mesh extension.
const FiniteElement * GetFE(int i) const
Returns pointer to the FiniteElement associated with i'th element.
void PrintOptions(std::ostream &out) const
virtual void ProjectCoefficient(Coefficient &coeff)
int open(const char hostname[], int port)
double u0_function(const Vector &x)
void SetLevelsOfDetail(int levels_of_detail_)
virtual void SetOperator(const Operator &op)
Also calls SetOperator for the preconditioner if there is one.
class for C-function coefficient
virtual void SetPreconditioner(Solver &pr)
This should be called before SetOperator.
virtual void Save() override
The MFEM Device class abstracts hardware devices such as GPUs, as well as programming models such as ...
The classical forward Euler method.
void SetPrefixPath(const std::string &prefix)
Set the path where the DataCollection will be saved.
double inflow_function(const Vector &x)
Arbitrary order "L2-conforming" discontinuous finite elements.