127int main (
int argc,
char *argv[])
135 const char *mesh_file =
"icf.mesh";
136 int mesh_poly_deg = 1;
143 real_t adapt_lim_const = 0.0;
147 int solver_iter = 20;
148#ifdef MFEM_USE_SINGLE
149 real_t solver_rtol = 1e-4;
151 real_t solver_rtol = 1e-10;
153 int solver_art_type = 0;
155 int max_lin_iter = 100;
156 bool move_bnd =
true;
158 bool bal_expl_combo =
false;
159 bool hradaptivity =
false;
160 int h_metric_id = -1;
161 bool normalization =
false;
162 bool visualization =
true;
163 int verbosity_level = 0;
164 bool fdscheme =
false;
166 bool exactaction =
false;
167 bool integ_over_targ =
true;
168 const char *devopt =
"cpu";
172 int mesh_node_order = 0;
173 int barrier_type = 0;
174 int worst_case_type = 0;
178 args.
AddOption(&mesh_file,
"-m",
"--mesh",
179 "Mesh file to use.");
180 args.
AddOption(&mesh_poly_deg,
"-o",
"--order",
181 "Polynomial degree of mesh finite element space.");
182 args.
AddOption(&rs_levels,
"-rs",
"--refine-serial",
183 "Number of times to refine the mesh uniformly in serial.");
184 args.
AddOption(&rp_levels,
"-rp",
"--refine-parallel",
185 "Number of times to refine the mesh uniformly in parallel.");
186 args.
AddOption(&jitter,
"-ji",
"--jitter",
187 "Random perturbation scaling factor.");
188 args.
AddOption(&metric_id,
"-mid",
"--metric-id",
189 "Mesh optimization metric:\n\t"
191 "1 : |T|^2 -- 2D no type\n\t"
192 "2 : 0.5|T|^2/tau-1 -- 2D shape (condition number)\n\t"
193 "7 : |T-T^-t|^2 -- 2D shape+size\n\t"
194 "9 : tau*|T-T^-t|^2 -- 2D shape+size\n\t"
195 "14 : |T-I|^2 -- 2D shape+size+orientation\n\t"
196 "22 : 0.5(|T|^2-2*tau)/(tau-tau_0) -- 2D untangling\n\t"
197 "50 : 0.5|T^tT|^2/tau^2-1 -- 2D shape\n\t"
198 "55 : (tau-1)^2 -- 2D size\n\t"
199 "56 : 0.5(sqrt(tau)-1/sqrt(tau))^2 -- 2D size\n\t"
200 "58 : |T^tT|^2/(tau^2)-2*|T|^2/tau+2 -- 2D shape\n\t"
201 "77 : 0.5(tau-1/tau)^2 -- 2D size\n\t"
202 "80 : (1-gamma)mu_2 + gamma mu_77 -- 2D shape+size\n\t"
203 "85 : |T-|T|/sqrt(2)I|^2 -- 2D shape+orientation\n\t"
204 "90 : balanced combo mu_50 & mu_77 -- 2D shape+size\n\t"
205 "94 : balanced combo mu_2 & mu_56 -- 2D shape+size\n\t"
206 "98 : (1/tau)|T-I|^2 -- 2D shape+size+orientation\n\t"
209 "301: (|T||T^-1|)/3-1 -- 3D shape\n\t"
210 "302: (|T|^2|T^-1|^2)/9-1 -- 3D shape\n\t"
211 "303: (|T|^2)/3/tau^(2/3)-1 -- 3D shape\n\t"
212 "304: (|T|^3)/3^{3/2}/tau-1 -- 3D shape\n\t"
214 "313: (|T|^2)(tau-tau0)^(-2/3)/3 -- 3D untangling\n\t"
215 "315: (tau-1)^2 -- 3D no type\n\t"
216 "316: 0.5(sqrt(tau)-1/sqrt(tau))^2 -- 3D no type\n\t"
217 "321: |T-T^-t|^2 -- 3D shape+size\n\t"
218 "322: |T-adjT^-t|^2 -- 3D shape+size\n\t"
219 "323: |J|^3-3sqrt(3)ln(det(J))-3sqrt(3) -- 3D shape+size\n\t"
220 "328: balanced combo mu_301 & mu_316 -- 3D shape+size\n\t"
221 "332: (1-gamma) mu_302 + gamma mu_315 -- 3D shape+size\n\t"
222 "333: (1-gamma) mu_302 + gamma mu_316 -- 3D shape+size\n\t"
223 "334: (1-gamma) mu_303 + gamma mu_316 -- 3D shape+size\n\t"
224 "328: balanced combo mu_302 & mu_318 -- 3D shape+size\n\t"
225 "347: (1-gamma) mu_304 + gamma mu_316 -- 3D shape+size\n\t"
227 "360: (|T|^3)/3^{3/2}-tau -- 3D shape\n\t"
229 "11 : (1/4*alpha)|A-(adjA)^T(W^TW)/omega|^2 -- 2D shape\n\t"
230 "36 : (1/alpha)|A-W|^2 -- 2D shape+size+orientation\n\t"
231 "49 : (1-gamma) mu_2 + gamma nu_50 -- 2D shape+skew\n\t"
232 "51 : see fem/tmop.hpp -- 2D size+skew\n\t"
233 "107: (1/2*alpha)|A-|A|/|W|W|^2 -- 2D shape+orientation\n\t"
234 "126: (1-gamma)nu_11 + gamma*nu_14a -- 2D shape+size\n\t"
236 args.
AddOption(&target_id,
"-tid",
"--target-id",
237 "Target (ideal element) type:\n\t"
238 "1: Ideal shape, unit size\n\t"
239 "2: Ideal shape, equal size\n\t"
240 "3: Ideal shape, initial size\n\t"
241 "4: Given full analytic Jacobian (in physical space)\n\t"
242 "5: Ideal shape, given size (in physical space)");
243 args.
AddOption(&lim_const,
"-lc",
"--limit-const",
"Limiting constant.");
244 args.
AddOption(&adapt_lim_const,
"-alc",
"--adapt-limit-const",
245 "Adaptive limiting coefficient constant.");
246 args.
AddOption(&quad_type,
"-qt",
"--quad-type",
247 "Quadrature rule type:\n\t"
248 "1: Gauss-Lobatto\n\t"
249 "2: Gauss-Legendre\n\t"
250 "3: Closed uniform points");
251 args.
AddOption(&quad_order,
"-qo",
"--quad_order",
252 "Order of the quadrature rule.");
253 args.
AddOption(&solver_type,
"-st",
"--solver-type",
254 " Type of solver: (default) 0: Newton, 1: LBFGS");
255 args.
AddOption(&solver_iter,
"-ni",
"--newton-iters",
256 "Maximum number of Newton iterations.");
257 args.
AddOption(&solver_rtol,
"-rtol",
"--newton-rel-tolerance",
258 "Relative tolerance for the Newton solver.");
259 args.
AddOption(&solver_art_type,
"-art",
"--adaptive-rel-tol",
260 "Type of adaptive relative linear solver tolerance:\n\t"
261 "0: None (default)\n\t"
262 "1: Eisenstat-Walker type 1\n\t"
263 "2: Eisenstat-Walker type 2");
264 args.
AddOption(&lin_solver,
"-ls",
"--lin-solver",
269 "3: MINRES + Jacobi preconditioner\n\t"
270 "4: MINRES + l1-Jacobi preconditioner");
271 args.
AddOption(&max_lin_iter,
"-li",
"--lin-iter",
272 "Maximum number of iterations in the linear solve.");
273 args.
AddOption(&move_bnd,
"-bnd",
"--move-boundary",
"-fix-bnd",
275 "Enable motion along horizontal and vertical boundaries.");
276 args.
AddOption(&combomet,
"-cmb",
"--combo-type",
277 "Combination of metrics options:\n\t"
278 "0: Use single metric\n\t"
279 "1: Shape + space-dependent size given analytically\n\t"
280 "2: Shape + adapted size given discretely; shared target");
281 args.
AddOption(&bal_expl_combo,
"-bec",
"--balance-explicit-combo",
282 "-no-bec",
"--balance-explicit-combo",
283 "Automatic balancing of explicit combo metrics.");
284 args.
AddOption(&hradaptivity,
"-hr",
"--hr-adaptivity",
"-no-hr",
285 "--no-hr-adaptivity",
286 "Enable hr-adaptivity.");
287 args.
AddOption(&h_metric_id,
"-hmid",
"--h-metric",
288 "Same options as metric_id. Used to determine refinement"
289 " type for each element if h-adaptivity is enabled.");
290 args.
AddOption(&normalization,
"-nor",
"--normalization",
"-no-nor",
291 "--no-normalization",
292 "Make all terms in the optimization functional unitless.");
293 args.
AddOption(&fdscheme,
"-fd",
"--fd_approximation",
294 "-no-fd",
"--no-fd-approx",
295 "Enable finite difference based derivative computations.");
296 args.
AddOption(&exactaction,
"-ex",
"--exact_action",
297 "-no-ex",
"--no-exact-action",
298 "Enable exact action of TMOP_Integrator.");
299 args.
AddOption(&integ_over_targ,
"-it",
"--integrate-target",
300 "-ir",
"--integrate-reference",
301 "Integrate over target (-it) or reference (-ir) element.");
302 args.
AddOption(&visualization,
"-vis",
"--visualization",
"-no-vis",
303 "--no-visualization",
304 "Enable or disable GLVis visualization.");
305 args.
AddOption(&verbosity_level,
"-vl",
"--verbosity-level",
306 "Verbosity level for the involved iterative solvers:\n\t"
308 "1: Newton iterations\n\t"
309 "2: Newton iterations + linear solver summaries\n\t"
310 "3: newton iterations + linear solver iterations");
311 args.
AddOption(&adapt_eval,
"-ae",
"--adaptivity-evaluator",
312 "0 - Advection based (DEFAULT), 1 - GSLIB.");
313 args.
AddOption(&devopt,
"-d",
"--device",
314 "Device configuration string, see Device::Configure().");
315 args.
AddOption(&pa,
"-pa",
"--partial-assembly",
"-no-pa",
316 "--no-partial-assembly",
"Enable Partial Assembly.");
317 args.
AddOption(&n_hr_iter,
"-nhr",
"--n_hr_iter",
318 "Number of hr-adaptivity iterations.");
319 args.
AddOption(&n_h_iter,
"-nh",
"--n_h_iter",
320 "Number of h-adaptivity iterations per r-adaptivity"
322 args.
AddOption(&mesh_node_order,
"-mno",
"--mesh_node_ordering",
323 "Ordering of mesh nodes."
324 "0 (default): byNodes, 1: byVDIM");
325 args.
AddOption(&barrier_type,
"-btype",
"--barrier-type",
327 "1 - Shifted Barrier,"
328 "2 - Pseudo Barrier.");
329 args.
AddOption(&worst_case_type,
"-wctype",
"--worst-case-type",
341 if (h_metric_id < 0) { h_metric_id = metric_id; }
345 MFEM_VERIFY(strcmp(devopt,
"cpu")==0,
"HR-adaptivity is currently only"
346 " supported on cpus.");
349 if (myid == 0) { device.
Print();}
352 Mesh *mesh =
new Mesh(mesh_file, 1, 1,
false);
363 const bool periodic = (s && s->IsDGSpace()) ?
true :
false;
370 if (mesh_poly_deg <= 0) { mesh_poly_deg = 2; }
403 for (
int i = 0; i < pmesh->
GetNE(); i++)
409 for (
int j = 0; j < dofs.
Size(); j++)
411 h0(dofs[j]) = min(h0(dofs[j]), hi);
416 MPI_SUM, MPI_COMM_WORLD);
417 const real_t small_phys_size = pow(mesh_volume, 1.0 /
dim) / 100.0;
434 for (
int i = 0; i < pfes_h1.
GetNDofs(); i++)
436 for (
int d = 0; d <
dim; d++)
444 for (
int i = 0; i < pfes_h1.
GetNBE(); i++)
447 for (
int j = 0; j < vdofs.
Size(); j++) { rdm(vdofs[j]) = 0.0; }
476 ostringstream mesh_name;
477 mesh_name <<
"perturbed.mesh";
478 ofstream mesh_ofs(mesh_name.str().c_str());
479 mesh_ofs.precision(8);
539 if (myid == 0) { cout <<
"Unknown metric_id: " << metric_id << endl; }
558 default: cout <<
"Metric_id not supported for h-adaptivity: " << h_metric_id <<
565 switch (barrier_type)
567 case 0: btype = TMOP_WorstCaseUntangleOptimizer_Metric::BarrierType::None;
569 case 1: btype = TMOP_WorstCaseUntangleOptimizer_Metric::BarrierType::Shifted;
571 case 2: btype = TMOP_WorstCaseUntangleOptimizer_Metric::BarrierType::Pseudo;
573 default: cout <<
"barrier_type not supported: " << barrier_type << endl;
578 switch (worst_case_type)
580 case 0: wctype = TMOP_WorstCaseUntangleOptimizer_Metric::WorstCaseType::None;
582 case 1: wctype = TMOP_WorstCaseUntangleOptimizer_Metric::WorstCaseType::Beta;
584 case 2: wctype = TMOP_WorstCaseUntangleOptimizer_Metric::WorstCaseType::PMean;
586 default: cout <<
"worst_case_type not supported: " << worst_case_type << endl;
591 if (barrier_type > 0 || worst_case_type > 0)
593 if (barrier_type > 0)
595 MFEM_VERIFY(metric_id == 4 || metric_id == 14 || metric_id == 66,
596 "Metric not supported for shifted/pseudo barriers.");
607 if (metric_id < 300 || h_metric_id < 300)
609 MFEM_VERIFY(
dim == 2,
"Incompatible metric for 3D meshes");
611 if (metric_id >= 300 || h_metric_id >= 300)
613 MFEM_VERIFY(
dim == 3,
"Incompatible metric for 2D meshes");
620 int ind_fec_order = (target_id >= 5 && target_id <= 8 && !fdscheme) ?
629 pa ? AssemblyLevel::PARTIAL : AssemblyLevel::LEGACY;
658 MFEM_ABORT(
"MFEM is not built with GSLIB.");
674 disc.ProjectCoefficient(mat_coeff);
684 MFEM_ABORT(
"MFEM is not built with GSLIB.");
691 disc.GetDerivative(1,0,d_x);
692 disc.GetDerivative(1,1,d_y);
695 for (
int i = 0; i < size.Size(); i++)
697 size(i) = std::pow(d_x(i),2)+std::pow(d_y(i),2);
699 const real_t max = size.Max();
702 MPI_MAX, MPI_COMM_WORLD);
704 for (
int i = 0; i < d_x.Size(); i++)
706 d_x(i) = std::abs(d_x(i));
707 d_y(i) = std::abs(d_y(i));
710 const real_t aspr_ratio = 20.0;
711 const real_t size_ratio = 40.0;
713 for (
int i = 0; i < size.Size(); i++)
715 size(i) = (size(i)/max_all);
716 aspr(i) = (d_x(i)+eps)/(d_y(i)+eps);
717 aspr(i) = 0.1 + 0.9*(1-size(i))*(1-size(i));
718 if (aspr(i) > aspr_ratio) {aspr(i) = aspr_ratio;}
719 if (aspr(i) < 1.0/aspr_ratio) {aspr(i) = 1.0/aspr_ratio;}
722 const int NE = pmesh->
GetNE();
723 real_t volume = 0.0, volume_ind = 0.0;
725 for (
int i = 0; i < NE; i++)
730 size.GetValues(i, ir, vals);
739 real_t volume_all, volume_ind_all;
741 MPI_SUM, MPI_COMM_WORLD);
742 MPI_Allreduce(&volume_ind, &volume_ind_all, 1,
746 const real_t avg_zone_size = volume_all / NE_ALL;
748 const real_t small_avg_ratio =
749 (volume_ind_all + (volume_all - volume_ind_all) / size_ratio)
752 const real_t small_zone_size = small_avg_ratio * avg_zone_size;
753 const real_t big_zone_size = size_ratio * small_zone_size;
755 for (
int i = 0; i < size.Size(); i++)
757 const real_t val = size(i);
758 const real_t a = (big_zone_size - small_zone_size) / small_zone_size;
759 size(i) = big_zone_size / (1.0+
a*val);
784 MFEM_ABORT(
"MFEM is not built with GSLIB.");
806 MFEM_ABORT(
"MFEM is not built with GSLIB.");
811 size.ProjectCoefficient(size_coeff);
834 if (myid == 0) { cout <<
"Unknown target_id: " << target_id << endl; }
837 if (target_c == NULL)
845 if (metric_combo && bal_expl_combo)
848 metric_combo->ComputeBalancedWeights(x, *target_c, bal_weights);
849 metric_combo->SetWeights(bal_weights);
855 auto tmop_integ =
new TMOP_Integrator(metric_to_use, target_c, h_metric);
856 tmop_integ->IntegrateOverTarget(integ_over_targ);
857 if (barrier_type > 0 || worst_case_type > 0)
859 tmop_integ->ComputeUntangleMetricQuantiles(x, *pfespace);
865 MFEM_VERIFY(pa ==
false,
"PA for finite differences is not implemented.");
866 tmop_integ->EnableFiniteDifferences(x);
868 tmop_integ->SetExactActionFlag(exactaction);
878 if (myid == 0) { cout <<
"Unknown quad_type: " << quad_type << endl; }
881 tmop_integ->SetIntegrationRules(*irules, quad_order);
882 if (myid == 0 &&
dim == 2)
884 cout <<
"Triangle quadrature points: "
886 <<
"\nQuadrilateral quadrature points: "
889 if (myid == 0 &&
dim == 3)
891 cout <<
"Tetrahedron quadrature points: "
893 <<
"\nHexahedron quadrature points: "
895 <<
"\nPrism quadrature points: "
905 if (normalization) { dist = small_phys_size; }
907 if (lim_const != 0.0) { tmop_integ->EnableLimiting(x0, dist, lim_coeff); }
913 if (adapt_lim_const > 0.0)
915 MFEM_VERIFY(pa ==
false,
"PA is not implemented for adaptive limiting");
920 if (adapt_eval == 0) { adapt_lim_eval =
new AdvectorCG(al); }
921 else if (adapt_eval == 1)
926 MFEM_ABORT(
"MFEM is not built with GSLIB support!");
929 else { MFEM_ABORT(
"Bad interpolation option."); }
931 tmop_integ->EnableAdaptiveLimiting(adapt_lim_gf0, adapt_lim_coeff,
943 if (normalization) { tmop_integ->ParEnableNormalization(x0); }
952 if (pa) {
a.SetAssemblyLevel(AssemblyLevel::PARTIAL); }
965 tmop_integ->SetCoefficient(*metric_coeff1);
980 else { tmop_integ2 =
new TMOP_Integrator(metric2, target_c, h_metric); }
990 if (lim_const != 0.0) { combo->
EnableLimiting(x0, dist, lim_coeff); }
992 a.AddDomainIntegrator(combo);
994 else {
a.AddDomainIntegrator(tmop_integ); }
996 if (pa) {
a.Setup(); }
1000 const int NE = pmesh->
GetNE();
1001 for (
int i = 0; i < NE; i++)
1004 irules->
Get(pfespace->GetFE(i)->GetGeomType(), quad_order);
1009 min_detJ = min(min_detJ, transf->
Jacobian().
Det());
1014 MPI_MIN, MPI_COMM_WORLD);
1017 { cout <<
"Minimum det(J) of the original mesh is " << min_detJ << endl; }
1019 if (min_detJ < 0.0 && barrier_type == 0
1020 && metric_id != 22 && metric_id != 211 && metric_id != 252
1021 && metric_id != 311 && metric_id != 313 && metric_id != 352)
1023 MFEM_ABORT(
"The input mesh is inverted! Try an untangling metric.");
1028 "Untangling is supported only for ideal targets.");
1032 min_detJ /= Wideal.
Det();
1036 MPI_MIN, MPI_COMM_WORLD);
1038 min_detJ -= 0.01 * h0_min;
1042 if (periodic) { tmop_integ->SetInitialMeshPos(&x0); }
1043 const real_t init_energy =
a.GetParGridFunctionEnergy(periodic ? dx : x) /
1045 real_t init_metric_energy = init_energy;
1046 if (lim_const > 0.0 || adapt_lim_const > 0.0)
1050 init_metric_energy =
a.GetParGridFunctionEnergy(periodic ? dx : x) /
1053 adapt_lim_coeff.
constant = adapt_lim_const;
1060 char title[] =
"Initial metric values";
1069 if (move_bnd ==
false)
1073 a.SetEssentialBC(ess_bdr);
1078 for (
int i = 0; i < pmesh->
GetNBE(); i++)
1082 MFEM_VERIFY(!(
dim == 2 && attr == 3),
1083 "Boundary attribute 3 must be used only for 3D meshes. "
1084 "Adjust the attributes (1/2/3/4 for fixed x/y/z/all "
1085 "components, rest for free nodes), or use -fix-bnd.");
1086 if (attr == 1 || attr == 2 || attr == 3) { n += nd; }
1087 if (attr == 4) { n += nd *
dim; }
1091 for (
int i = 0; i < pmesh->
GetNBE(); i++)
1098 for (
int j = 0; j < nd; j++)
1099 { ess_vdofs[n++] = vdofs[j]; }
1103 for (
int j = 0; j < nd; j++)
1104 { ess_vdofs[n++] = vdofs[j+nd]; }
1108 for (
int j = 0; j < nd; j++)
1109 { ess_vdofs[n++] = vdofs[j+2*nd]; }
1113 for (
int j = 0; j < vdofs.
Size(); j++)
1114 { ess_vdofs[n++] = vdofs[j]; }
1117 a.SetEssentialVDofs(ess_vdofs);
1122 Solver *S = NULL, *S_prec = NULL;
1123#ifdef MFEM_USE_SINGLE
1124 const real_t linsol_rtol = 1e-5;
1126 const real_t linsol_rtol = 1e-12;
1130 if (verbosity_level == 2)
1132 if (verbosity_level > 2)
1134 if (lin_solver == 0)
1136 S =
new DSmoother(1, 1.0, max_lin_iter);
1138 else if (lin_solver == 1)
1154 if (lin_solver == 3 || lin_solver == 4)
1158 MFEM_VERIFY(lin_solver != 4,
"PA l1-Jacobi is not implemented");
1168 hs->SetPositiveDiagonal(
true);
1191 if (solver_art_type > 0)
1208 x, move_bnd, hradaptivity,
1209 mesh_poly_deg, h_metric_id,
1210 n_hr_iter, n_h_iter);
1213 if (adapt_lim_const > 0.)
1223 ostringstream mesh_name;
1224 mesh_name <<
"optimized.mesh";
1225 ofstream mesh_ofs(mesh_name.str().c_str());
1226 mesh_ofs.precision(8);
1237 if (periodic) { tmop_integ->SetInitialMeshPos(&x0); }
1238 const real_t fin_energy =
a.GetParGridFunctionEnergy(periodic ? dx : x) /
1240 real_t fin_metric_energy = fin_energy;
1241 if (lim_const > 0.0 || adapt_lim_const > 0.0)
1245 fin_metric_energy =
a.GetParGridFunctionEnergy(periodic ? dx : x) /
1248 adapt_lim_coeff.
constant = adapt_lim_const;
1252 std::cout << std::scientific << std::setprecision(4);
1253 cout <<
"Initial strain energy: " << init_energy
1254 <<
" = metrics: " << init_metric_energy
1255 <<
" + extra terms: " << init_energy - init_metric_energy << endl;
1256 cout <<
" Final strain energy: " << fin_energy
1257 <<
" = metrics: " << fin_metric_energy
1258 <<
" + extra terms: " << fin_energy - fin_metric_energy << endl;
1259 cout <<
"The strain energy decreased by: "
1260 << (init_energy - fin_energy) * 100.0 / init_energy <<
" %." << endl;
1266 char title[] =
"Final metric values";
1270 if (adapt_lim_const > 0.0 && visualization)
1274 600, 600, 300, 300);
1284 sock.
open(
"localhost", 19916);
1285 sock <<
"solution\n";
1291 sock <<
"window_title 'Displacements'\n"
1292 <<
"window_geometry "
1293 << 1200 <<
" " << 0 <<
" " << 600 <<
" " << 600 <<
"\n"
1294 <<
"keys jRmclA" << endl;
1302 delete metric_coeff1;
1303 delete adapt_lim_eval;
1305 delete hr_adapt_coeff;
1309 delete untangler_metric;
virtual void SetAnalyticTargetSpec(Coefficient *sspec, VectorCoefficient *vspec, TMOPMatrixCoefficient *mspec)
T Max() const
Find the maximal element in the array, using the comparison operator < for class T.
int Size() const
Return the logical size of the array.
@ GaussLobatto
Closed type.
Conjugate gradient method.
A coefficient that is constant across space and time.
Data type for scaled Jacobi-type smoother of sparse matrix.
Data type dense matrix using column-major storage.
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.
virtual void SetParDiscreteTargetAspectRatio(const ParGridFunction &tspec_)
void SetMinSizeForTargets(real_t min_size_)
virtual void SetParDiscreteTargetSize(const ParGridFunction &tspec_)
void SetAdaptivityEvaluator(AdaptivityEvaluator *ae)
virtual void SetParDiscreteTargetOrientation(const ParGridFunction &tspec_)
int GetAttribute() const
Return element's attribute.
Collection of finite elements from the same family in multiple dimensions. This class is used to matc...
const FiniteElement * GetBE(int i) const
Returns pointer to the FiniteElement in the FiniteElementCollection associated with i'th boundary fac...
int GetNDofs() const
Returns number of degrees of freedom. This is the number of Local Degrees of Freedom.
int GetNBE() const
Returns number of boundary elements in the mesh.
DofTransformation * GetBdrElementVDofs(int i, Array< int > &vdofs) const
Returns indices of degrees of freedom for i'th boundary element. The returned indices are offsets int...
int DofToVDof(int dof, int vd, int ndofs=-1) const
Compute a single vdof corresponding to the index dof and the vector index vd.
int GetDof() const
Returns the number of degrees of freedom in the finite element.
A general function coefficient.
const DenseMatrix & GetGeomToPerfGeomJac(int GeomType) const
void SetFromTrueVector()
Shortcut for calling SetFromTrueDofs() with GetTrueVector() as argument.
void ProjectGridFunction(const GridFunction &src)
Project the src GridFunction to this GridFunction, both of which must be on the same mesh.
Arbitrary order H1-conforming (continuous) finite elements.
Parallel smoothers in hypre.
void SetType(HypreSmoother::Type type, int relax_times=1)
Set the relaxation type and number of sweeps.
@ l1Jacobi
l1-scaled Jacobi
static void Init()
Initialize hypre by calling HYPRE_Init() and set default options. After calling Hypre::Init(),...
Class for integration point with weight.
Class for an integration rule - an Array of IntegrationPoint.
int GetNPoints() const
Returns the number of the points in the integration rule.
IntegrationPoint & IntPoint(int i)
Returns a reference to the i-th integration point.
Container class for integration rules.
const IntegrationRule & Get(int GeomType, int Order)
Returns an integration rule for given GeomType and Order.
void SetRelTol(real_t rtol)
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.
void SetPreconditioner(Solver &pr) override
This should be called before SetOperator.
Array< int > bdr_attributes
A list of all unique boundary attributes used by the Mesh.
const FiniteElementSpace * GetNodalFESpace() const
Geometry::Type GetTypicalElementGeometry() const
If the local mesh is not empty, return GetElementGeometry(0); otherwise, return a typical Geometry pr...
int GetNE() const
Returns number of elements.
int Dimension() const
Dimension of the reference space used within the elements.
const Element * GetBdrElement(int i) const
Return pointer to the i'th boundary element object.
real_t GetElementSize(int i, int type=0)
Get the size of the i-th element relative to the perfect reference element.
void GetElementTransformation(int i, IsoparametricTransformation *ElTr) const
Builds the transformation defining the i-th element in ElTr. ElTr must be allocated in advance and wi...
void SetNodalGridFunction(GridFunction *nodes, bool make_owner=false)
real_t GetElementVolume(int i)
int GetNBE() const
Returns number of boundary elements.
long long GetGlobalNE() const
Return the total (global) number of elements.
void EnsureNCMesh(bool simplices_nonconforming=false)
void UniformRefinement(int i, const DSTable &, int *, int *, int *)
Geometry::Type GetElementBaseGeometry(int i) const
static int WorldRank()
Return the MPI rank in 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).
void SetAdaptiveLinRtol(const int type=2, const real_t rtol0=0.5, const real_t rtol_max=0.9, const real_t alpha=0.5 *(1.0+sqrt(5.0)), const real_t gamma=1.0)
Enable adaptive linear solver relative tolerance algorithm.
Jacobi smoothing for a given bilinear form (no matrix necessary).
void SetPositiveDiagonal(bool pos_diag=true)
Replace diagonal entries with their absolute values.
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.
void GetElementDofs(int i, Array< int > &dofs, DofTransformation &doftrans) const override
The same as GetElementDofs(), but with a user-allocated DofTransformation object. doftrans must be al...
Class for parallel grid function.
void ProjectCoefficient(Coefficient &coeff) override
Project coeff Coefficient to this GridFunction. The projection computation depends on the choice of t...
void SaveAsOne(const char *fname, int precision=16) const
Class for parallel meshes.
void SetNodalFESpace(FiniteElementSpace *nfes) override
void PrintAsOne(std::ostream &out=mfem::out, const std::string &comments="") const
void ParEnableNormalization(const ParGridFunction &x)
void EnableLimiting(const GridFunction &n0, const GridFunction &dist, Coefficient &w0, TMOP_LimiterFunction *lfunc=NULL)
Adds the limiting term to the first integrator. Disables it for the rest.
void AddTMOPIntegrator(TMOP_Integrator *ti)
Adds a new TMOP_Integrator to the combination.
void AddGridFunctionForUpdate(GridFunction *gf)
void AddFESpaceForUpdate(FiniteElementSpace *fes)
void SetPreconditioner(Solver &pr) override
This should be called before SetOperator.
void SetIntegrationRules(IntegrationRules &irules, int order)
Prescribe a set of integration rules; relevant for mixed meshes.
void SetMinDetPtr(real_t *md_ptr)
2D barrier Shape+Size+Orientation (VOS) metric (polyconvex).
2D barrier Size+Skew (VQ) metric.
2D barrier Shape+Orientation (OS) metric (polyconvex).
2D barrier Shape+Size (VS) metric (polyconvex).
A TMOP integrator class based on any given TMOP_QualityMetric and TargetConstructor.
void SetExactActionFlag(bool flag_)
Flag to control if exact action of Integration is effected.
void SetCoefficient(Coefficient &w1)
Sets a scaling Coefficient for the quality metric term of the integrator.
void EnableFiniteDifferences(const GridFunction &x)
Enables FD-based approximation and computes dx.
void SetIntegrationRules(IntegrationRules &irules, int order)
Prescribe a set of integration rules; relevant for mixed meshes.
void IntegrateOverTarget(bool integ_over_target_)
2D non-barrier metric without a type.
2D barrier Shape+Size (VS) metric (not polyconvex).
2D barrier Shape+Size (VS) metric (not polyconvex).
2D non-barrier Shape+Size+Orientation (VOS) metric (polyconvex).
2D Shifted barrier form of shape metric (mu_2).
2D barrier shape (S) metric (not polyconvex).
2D barrier Shape+Orientation (OS) metric (polyconvex).
2D compound barrier Shape+Size (VS) metric (balanced).
2D compound barrier Shape+Size (VS) metric (balanced).
2D barrier Shape+Size+Orientation (VOS) metric (polyconvex).
3D barrier Shape (S) metric, well-posed (polyconvex & invex).
3D barrier Shape (S) metric, well-posed (polyconvex & invex).
3D barrier Shape (S) metric, well-posed (polyconvex & invex).
3D barrier Shape (S) metric, well-posed (polyconvex & invex).
3D Shape (S) metric, untangling version of 303.
3D barrier Shape+Size (VS) metric, well-posed (invex).
3D barrier Shape+Size (VS) metric, well-posed (invex).
3D barrier Shape+Size (VS) metric, well-posed (invex).
3D compound barrier Shape+Size (VS) metric (polyconvex, balanced).
3D compound barrier Shape+Size (VS) metric (polyconvex).
3D barrier Shape+Size (VS) metric, well-posed (polyconvex).
3D barrier Shape+Size (VS) metric, well-posed (polyconvex).
3D compound barrier Shape+Size (VS) metric (polyconvex, balanced).
3D barrier Shape+Size (VS) metric, well-posed (polyconvex).
3D non-barrier Shape (S) metric.
Abstract class for local mesh quality metrics in the target-matrix optimization paradigm (TMOP) by P....
Base class representing target-matrix construction algorithms for mesh optimization via the target-ma...
void SetVolumeScale(real_t vol_scale)
Used by target type IDEAL_SHAPE_EQUAL_SIZE. The default volume scale is 1.
void SetNodes(const GridFunction &n)
Set the nodes to be used in the target-matrix construction.
TargetType
Target-matrix construction algorithms supported by this class.
A general vector function coefficient.
void Randomize(int seed=0)
Set random values in the vector.
virtual real_t * HostReadWrite()
Shortcut for mfem::ReadWrite(vec.GetMemory(), vec.Size(), false).
real_t Min() const
Returns the minimal element of the vector.
int open(const char hostname[], int port)
Open the socket stream on 'port' at 'hostname'.
real_t adapt_lim_fun(const Vector &x)
IntegrationRules IntRulesCU(0, Quadrature1D::ClosedUniform)
real_t weight_fun(const Vector &x)
real_t material_indicator_2d(const Vector &x)
IntegrationRules IntRulesLo(0, Quadrature1D::GaussLobatto)
void ConstructSizeGF(GridFunction &size)
real_t discrete_ori_2d(const Vector &x)
void discrete_aspr_3d(const Vector &x, Vector &v)
void VisualizeMesh(socketstream &sock, const char *vishost, int visport, Mesh &mesh, const char *title, int x, int y, int w, int h, const char *keys)
void DiffuseField(ParGridFunction &field, int smooth_steps)
void VisualizeField(socketstream &sock, const char *vishost, int visport, GridFunction &gf, const char *title, int x, int y, int w, int h, const char *keys, bool vec)
real_t infinity()
Define a shortcut for std::numeric_limits<double>::infinity()
AssemblyLevel
Enumeration defining the assembly level for bilinear and nonlinear form classes derived from Operator...
void vis_tmop_metric_p(int order, TMOP_QualityMetric &qm, const TargetConstructor &tc, ParMesh &pmesh, char *title, int position)
IntegrationRules IntRules(0, Quadrature1D::GaussLegendre)
A global object with all integration rules (defined in intrules.cpp)
Settings for the output behavior of the IterativeSolver.
PrintLevel & Iterations()
PrintLevel & FirstAndLast()
Helper struct to convert a C++ type to an MPI type.