77#if MFEM_HYPRE_VERSION >= 21800
82class AIR_prec :
public Solver
93 AIR_prec(
int blocksize_) : AIR_solver(NULL), blocksize(blocksize_) { }
95 void SetOperator(
const Operator &op)
override
101 MFEM_VERIFY(A != NULL,
"AIR_prec requires a HypreParMatrix.")
108 AIR_solver->SetAdvectiveOptions(1, "", "FA");
109 AIR_solver->SetPrintLevel(0);
110 AIR_solver->SetMaxLevels(50);
118 BlockInverseScaleJob::RHS_ONLY);
119 AIR_solver->Mult(z_s, y);
130class DG_Solver :
public Solver
145 linear_solver(M.GetComm()),
152 BlockILU::Reordering::MINIMUM_DISCARDED_FILL);
156#if MFEM_HYPRE_VERSION >= 21800
157 prec =
new AIR_prec(block_size);
159 MFEM_ABORT(
"Must have MFEM_HYPRE_VERSION >= 21800 to use AIR.\n");
172 void SetTimeStep(
real_t dt_)
179 A =
Add(-dt, K, 0.0, K);
182 A_diag.
Add(1.0, M_diag);
188 void SetOperator(
const Operator &op)
override
195 linear_solver.
Mult(x, y);
198 ~DG_Solver()
override
218 DG_Solver *dg_solver;
229 ~FE_Evolution()
override;
233int main(
int argc,
char *argv[])
243 const char *mesh_file =
"../data/periodic-hexagon.mesh";
244 int ser_ref_levels = 2;
245 int par_ref_levels = 0;
250 const char *device_config =
"cpu";
251 int ode_solver_type = 4;
254 bool visualization =
true;
256 bool paraview =
false;
260#if MFEM_HYPRE_VERSION >= 21800
266 cout.precision(precision);
269 args.
AddOption(&mesh_file,
"-m",
"--mesh",
270 "Mesh file to use.");
272 "Problem setup to use. See options in velocity_function().");
273 args.
AddOption(&ser_ref_levels,
"-rs",
"--refine-serial",
274 "Number of times to refine the mesh uniformly in serial.");
275 args.
AddOption(&par_ref_levels,
"-rp",
"--refine-parallel",
276 "Number of times to refine the mesh uniformly in parallel.");
278 "Order (degree) of the finite elements.");
279 args.
AddOption(&pa,
"-pa",
"--partial-assembly",
"-no-pa",
280 "--no-partial-assembly",
"Enable Partial Assembly.");
281 args.
AddOption(&ea,
"-ea",
"--element-assembly",
"-no-ea",
282 "--no-element-assembly",
"Enable Element Assembly.");
283 args.
AddOption(&fa,
"-fa",
"--full-assembly",
"-no-fa",
284 "--no-full-assembly",
"Enable Full Assembly.");
285 args.
AddOption(&device_config,
"-d",
"--device",
286 "Device configuration string, see Device::Configure().");
287 args.
AddOption(&ode_solver_type,
"-s",
"--ode-solver",
289 args.
AddOption(&t_final,
"-tf",
"--t-final",
290 "Final time; start time is 0.");
291 args.
AddOption(&dt,
"-dt",
"--time-step",
293 args.
AddOption((
int *)&prec_type,
"-pt",
"--prec-type",
"Preconditioner for "
294 "implicit solves. 0 for ILU, 1 for pAIR-AMG.");
295 args.
AddOption(&visualization,
"-vis",
"--visualization",
"-no-vis",
296 "--no-visualization",
297 "Enable or disable GLVis visualization.");
298 args.
AddOption(&visit,
"-visit",
"--visit-datafiles",
"-no-visit",
299 "--no-visit-datafiles",
300 "Save data files for VisIt (visit.llnl.gov) visualization.");
301 args.
AddOption(¶view,
"-paraview",
"--paraview-datafiles",
"-no-paraview",
302 "--no-paraview-datafiles",
303 "Save data files for ParaView (paraview.org) visualization.");
304 args.
AddOption(&adios2,
"-adios2",
"--adios2-streams",
"-no-adios2",
305 "--no-adios2-streams",
306 "Save data using adios2 streams.");
307 args.
AddOption(&binary,
"-binary",
"--binary-datafiles",
"-ascii",
309 "Use binary (Sidre) or ascii format for VisIt data files.");
310 args.
AddOption(&vis_steps,
"-vs",
"--visualization-steps",
311 "Visualize every n-th timestep.");
326 Device device(device_config);
331 Mesh *mesh =
new Mesh(mesh_file, 1, 1);
342 for (
int lev = 0; lev < ser_ref_levels; lev++)
357 for (
int lev = 0; lev < par_ref_levels; lev++)
370 cout <<
"Number of unknowns: " << global_vSize << endl;
407 b->AddBdrFaceIntegrator(
424 u->ProjectCoefficient(u0);
428 ostringstream mesh_name, sol_name;
429 mesh_name <<
"ex9-mesh." << setfill(
'0') << setw(6) << myid;
430 sol_name <<
"ex9-init." << setfill(
'0') << setw(6) << myid;
431 ofstream omesh(mesh_name.str().c_str());
432 omesh.precision(precision);
434 ofstream osol(sol_name.str().c_str());
435 osol.precision(precision);
449 MFEM_ABORT(
"Must build with MFEM_USE_SIDRE=YES for binary output.");
481#ifdef MFEM_USE_ADIOS2
485 std::string postfix(mesh_file);
486 postfix.erase(0, std::string(
"../data/").size() );
487 postfix +=
"_o" + std::to_string(order);
488 const std::string collection_name =
"ex9-p-" + postfix +
".bp";
492 adios2_dc->
SetParameter(
"SubStreams", std::to_string(num_procs/2) );
511 cout <<
"Unable to connect to GLVis server at "
512 <<
vishost <<
':' << visport << endl;
514 visualization =
false;
517 cout <<
"GLVis visualization disabled.\n";
522 sout <<
"parallel " << num_procs <<
" " << myid <<
"\n";
523 sout.precision(precision);
524 sout <<
"solution\n" << *pmesh << *
u;
529 cout <<
"GLVis visualization paused."
530 <<
" Press space (in the GLVis window) to resume it.\n";
538 FE_Evolution adv(*m, *k, *B, prec_type);
542 ode_solver->Init(adv);
545 for (
int ti = 0; !done; )
547 real_t dt_real = min(dt, t_final - t);
548 ode_solver->Step(*U, t, dt_real);
551 done = (t >= t_final - 1e-8*dt);
553 if (done || ti % vis_steps == 0)
557 cout <<
"time step: " << ti <<
", time: " << t << endl;
566 sout <<
"parallel " << num_procs <<
" " << myid <<
"\n";
567 sout <<
"solution\n" << *pmesh << *
u << flush;
584#ifdef MFEM_USE_ADIOS2
600 ostringstream sol_name;
601 sol_name <<
"ex9-final." << setfill(
'0') << setw(6) << myid;
602 ofstream osol(sol_name.str().c_str());
603 osol.precision(precision);
617#ifdef MFEM_USE_ADIOS2
633 M_solver(M_.ParFESpace()->GetComm()),
647 M_solver.SetOperator(*M);
657 dg_solver =
new DG_Solver(M_mat, K_mat, *M_.
FESpace(), prec_type);
665 M_solver.SetPreconditioner(*M_prec);
666 M_solver.iterative_mode =
false;
667 M_solver.SetRelTol(1e-9);
668 M_solver.SetAbsTol(0.0);
669 M_solver.SetMaxIter(100);
670 M_solver.SetPrintLevel(0);
681 dg_solver->SetTimeStep(dt);
682 dg_solver->Mult(z, k);
685void FE_Evolution::Mult(
const Vector &x,
Vector &y)
const
693FE_Evolution::~FE_Evolution()
707 for (
int i = 0; i <
dim; i++)
720 case 1: v(0) = 1.0;
break;
721 case 2: v(0) = sqrt(2./3.); v(1) = sqrt(1./3.);
break;
722 case 3: v(0) = sqrt(3./6.); v(1) = sqrt(2./6.); v(2) = sqrt(1./6.);
734 case 1: v(0) = 1.0;
break;
735 case 2: v(0) = w*X(1); v(1) = -w*X(0);
break;
736 case 3: v(0) = w*X(1); v(1) = -w*X(0); v(2) = 0.0;
break;
744 real_t d = max((X(0)+1.)*(1.-X(0)),0.) * max((X(1)+1.)*(1.-X(1)),0.);
748 case 1: v(0) = 1.0;
break;
749 case 2: v(0) = d*w*X(1); v(1) = -d*w*X(0);
break;
750 case 3: v(0) = d*w*X(1); v(1) = -d*w*X(0); v(2) = 0.0;
break;
764 for (
int i = 0; i <
dim; i++)
778 return exp(-40.*pow(X(0)-0.5,2));
782 real_t rx = 0.45, ry = 0.25, cx = 0., cy = -0.2, w = 10.;
785 const real_t s = (1. + 0.25*cos(2*M_PI*X(2)));
789 return ( std::erfc(w*(X(0)-cx-rx))*std::erfc(-w*(X(0)-cx+rx)) *
790 std::erfc(w*(X(1)-cy-ry))*std::erfc(-w*(X(1)-cy+ry)) )/16;
796 real_t x_ = X(0), y_ = X(1), rho, phi;
797 rho = std::hypot(x_, y_);
799 return pow(sin(M_PI*rho),2)*sin(3*phi);
804 return sin(
f*X(0))*sin(
f*X(1));
void SetParameter(const std::string key, const std::string value) noexcept
@ GaussLobatto
Closed type.
Conjugate gradient method.
void Mult(const Vector &b, Vector &x) const override
Iterative solution of the linear system using the Conjugate Gradient method.
void SetPrecision(int prec)
Set the precision (number of digits) used for the text output of doubles.
virtual void RegisterField(const std::string &field_name, GridFunction *gf)
Add a grid function to the collection.
void SetCycle(int c)
Set time cycle (for time-dependent simulations)
void SetTime(real_t t)
Set physical time (for time-dependent simulations)
void SetPrefixPath(const std::string &prefix)
Set the path where the DataCollection will be saved.
virtual void Save()
Save the collection to disk.
The MFEM Device class abstracts hardware devices such as GPUs, as well as programming models such as ...
void Print(std::ostream &out=mfem::out)
Print the configuration of the MFEM virtual device object.
Class FiniteElementSpace - responsible for providing FEM view of the mesh, mainly managing the set of...
const FiniteElement * GetTypicalFE() const
Return GetFE(0) if the local mesh is not empty; otherwise return a typical FE based on the Geometry t...
int GetDof() const
Returns the number of degrees of freedom in the finite element.
A general function coefficient.
void Mult(const Vector &b, Vector &x) const override
Iterative solution of the linear system using the GMRES method.
The BoomerAMG solver in hypre.
Wrapper for hypre's ParCSR matrix class.
void GetDiag(Vector &diag) const
Get the local diagonal of the matrix.
HYPRE_Int Mult(HypreParVector &x, HypreParVector &y, real_t alpha=1.0, real_t beta=0.0) const
Computes y = alpha * A * x + beta * y.
Wrapper for hypre's parallel vector class.
Parallel smoothers in hypre.
static void Init()
Initialize hypre by calling HYPRE_Init() and set default options. After calling Hypre::Init(),...
void SetOperator(const Operator &op) override
Also calls SetOperator for the preconditioner if there is one.
void SetRelTol(real_t rtol)
virtual void SetPreconditioner(Solver &pr)
This should be called before SetOperator.
virtual void SetPrintLevel(int print_lvl)
Legacy method to set the level of verbosity of the solver output.
void SetMaxIter(int max_it)
void SetAbsTol(real_t atol)
Arbitrary order "L2-conforming" discontinuous finite elements.
NURBSExtension * NURBSext
Optional NURBS mesh extension.
void GetBoundingBox(Vector &min, Vector &max, int ref=2)
Returns the minimum and maximum corners of the mesh bounding box.
int Dimension() const
Dimension of the reference space used within the elements.
virtual void SetCurvature(int order, bool discont=false, int space_dim=-1, int ordering=1)
Set the curvature of the mesh nodes using the given polynomial degree.
void UniformRefinement(int i, const DSTable &, int *, int *, int *)
static bool Root()
Return true if the rank in MPI_COMM_WORLD is zero.
static int WorldRank()
Return the MPI rank in MPI_COMM_WORLD.
static int WorldSize()
Return the size of MPI_COMM_WORLD.
static void Init(int &argc, char **&argv, int required=default_thread_required, int *provided=nullptr)
Singleton creation with Mpi::Init(argc, argv).
static MFEM_EXPORT std::string Types
static MFEM_EXPORT std::unique_ptr< ODESolver > Select(const int ode_solver_type)
Pointer to an Operator of a specified type.
Jacobi smoothing for a given bilinear form (no matrix necessary).
int width
Dimension of the input / number of columns in the matrix.
int Height() const
Get the height (size of output) of the Operator. Synonym with NumRows().
int height
Dimension of the output / number of rows in the matrix.
int Width() const
Get the width (size of input) of the Operator. Synonym with NumCols().
void Parse()
Parse the command-line options. Note that this function expects all the options provided through the ...
void PrintUsage(std::ostream &out) const
Print the usage message.
void PrintOptions(std::ostream &out) const
Print the options.
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)
Add a boolean option and set 'var' to receive the value. Enable/disable tags are used to set the bool...
bool Good() const
Return true if the command line options were parsed successfully.
Abstract parallel finite element space.
HYPRE_BigInt GlobalTrueVSize() const
Class for parallel grid function.
Class for parallel meshes.
void Print(std::ostream &out=mfem::out, const std::string &comments="") const override
Helper class for ParaView visualization data.
void SetHighOrderOutput(bool high_order_output_)
void SetLevelsOfDetail(int levels_of_detail_)
void SetDataFormat(VTKFormat fmt)
Data collection with Sidre routines following the Conduit mesh blueprint specification.
bool iterative_mode
If true, use the second argument of Mult() as an initial guess.
void Add(const int i, const int j, const real_t val)
Base abstract class for first order time dependent operators.
virtual void SetTime(const real_t t_)
Set the current time.
A general vector function coefficient.
int Size() const
Returns the size of the vector.
Data collection with VisIt I/O routines.
int open(const char hostname[], int port)
Open the socket stream on 'port' at 'hostname'.
void velocity_function(const Vector &x, Vector &v)
real_t inflow_function(const Vector &x)
real_t u0_function(const Vector &x)
real_t u(const Vector &xvec)
void Mult(const Table &A, const Table &B, Table &C)
C = A * B (as boolean matrices)
void BlockInverseScale(const HypreParMatrix *A, HypreParMatrix *C, const Vector *b, HypreParVector *d, int blocksize, BlockInverseScaleJob job)
std::function< real_t(const Vector &)> f(real_t mass_coeff)
void Add(const DenseMatrix &A, const DenseMatrix &B, real_t alpha, DenseMatrix &C)
C = A + alpha*B.
void velocity_function(const Vector &x, Vector &v)
double u0_function(const Vector &x)
double inflow_function(const Vector &x)