JSON Specification
Defaults¶
The following json contains the default values by PolyFEM.
Values of "REQUIRED!"
indicate the field has no default and must be specified by the user.
{
"boundary_conditions": {
"dirichlet_boundary": [],
"neumann_boundary": [],
"normal_aligned_neumann_boundary": [],
"obstacle_displacements": [],
"periodic_boundary": {
"correspondence": [],
"enabled": false,
"fixed_macro_strain": [],
"force_zero_mean": false,
"linear_displacement_offset": [],
"tolerance": 1e-05
},
"pressure_boundary": [],
"pressure_cavity": [],
"rhs": {
"unit": "REQUIRED!",
"value": "REQUIRED!"
}
},
"common": "",
"contact": {
"collision_mesh": {
"enabled": true,
"linear_map": "REQUIRED!",
"max_edge_length": "REQUIRED!",
"mesh": "REQUIRED!",
"tessellation_type": "regular"
},
"dhat": 0.001,
"dhat_percentage": 0.8,
"enabled": false,
"epsv": 0.001,
"friction_coefficient": 0,
"periodic": false,
"use_convergent_formulation": false
},
"geometry": "REQUIRED!",
"initial_conditions": {
"acceleration": [],
"solution": [],
"velocity": []
},
"input": {
"data": {
"reorder": false,
"state": ""
}
},
"materials": "REQUIRED!",
"output": {
"advanced": {
"compute_error": true,
"curved_mesh_size": false,
"save_ccd_debug_meshes": false,
"save_nl_solve_sequence": false,
"save_solve_sequence_debug": false,
"save_time_sequence": true,
"sol_at_node": -1,
"sol_on_grid": -1,
"spectrum": false,
"timestep_prefix": "step_",
"vis_boundary_only": false
},
"data": {
"advanced": {
"reorder_nodes": false
},
"full_mat": "",
"mises": "",
"nodes": "",
"rest_mesh": "",
"solution": "",
"state": "",
"stiffness_mat": "",
"stress_mat": ""
},
"directory": "",
"json": "",
"log": {
"file_level": "trace",
"level": "debug",
"path": "",
"quiet": false
},
"paraview": {
"file_name": "",
"high_order_mesh": true,
"options": {
"acceleration": false,
"body_ids": false,
"contact_forces": false,
"discretization_order": true,
"forces": false,
"friction_forces": false,
"material": false,
"nodes": true,
"scalar_values": true,
"tensor_values": true,
"use_hdf5": false,
"velocity": false
},
"points": false,
"skip_frame": 1,
"surface": false,
"vismesh_rel_area": 1e-05,
"volume": true,
"wireframe": false
},
"reference": {
"gradient": [],
"solution": []
},
"restart_json": ""
},
"preset_problem": {
"U": {},
"angular_v0": 0.5,
"angular_v1": -0.5,
"axis_coordiante": 2,
"axis_coordiante0": 2,
"axis_coordiante1": 2,
"bbox_center": [],
"fixed_boundary": 5,
"force": {},
"formulation": "",
"func": 0,
"kernel_distance": 0,
"kernel_weights": "",
"n_kernels": 0,
"n_turns": 0.5,
"time_dependent": {},
"turning_boundary": 6,
"turning_boundary0": 5,
"turning_boundary1": 6,
"type": "REQUIRED!",
"viscosity": 1
},
"root_path": "",
"solver": {
"adjoint_linear": {
"AMGCL": {
"precond": {
"class": "amg",
"coarsening": {
"aggr": {
"eps_strong": 0
},
"estimate_spectral_radius": true,
"relax": 1,
"type": "smoothed_aggregation"
},
"direct_coarse": false,
"max_levels": 6,
"ncycle": 2,
"relax": {
"degree": 16,
"higher": 2,
"lower": 0.008333333333,
"power_iters": 100,
"scale": true,
"type": "chebyshev"
}
},
"solver": {
"maxiter": 1000,
"tol": 1e-10,
"type": "cg"
}
},
"Eigen::BiCGSTAB": {
"max_iter": 1000,
"tolerance": 1e-12
},
"Eigen::ConjugateGradient": {
"max_iter": 1000,
"tolerance": 1e-12
},
"Eigen::DGMRES": {
"max_iter": 1000,
"tolerance": 1e-12
},
"Eigen::GMRES": {
"max_iter": 1000,
"tolerance": 1e-12
},
"Eigen::LeastSquaresConjugateGradient": {
"max_iter": 1000,
"tolerance": 1e-12
},
"Eigen::MINRES": {
"max_iter": 1000,
"tolerance": 1e-12
},
"Hypre": {
"max_iter": 1000,
"pre_max_iter": 1,
"tolerance": 1e-10
},
"Pardiso": {
"mtype": 11
},
"enable_overwrite_solver": false,
"precond": "",
"solver": ""
},
"advanced": {
"cache_size": 900000,
"lagged_regularization_iterations": 1,
"lagged_regularization_weight": 0,
"lump_mass_matrix": false
},
"augmented_lagrangian": {
"eta": 0.99,
"initial_weight": 1000000.0,
"max_weight": 100000000.0,
"nonlinear": {
"ADAM": {
"alpha": 0.001,
"beta_1": 0.9,
"beta_2": 0.999,
"epsilon": 1e-08
},
"L-BFGS": {
"history_size": 6
},
"L-BFGS-B": {
"history_size": 6
},
"Newton": {
"force_psd_projection": false,
"reg_weight_inc": 10,
"reg_weight_max": 100000000.0,
"reg_weight_min": 1e-08,
"residual_tolerance": 1e-05,
"use_psd_projection": true,
"use_psd_projection_in_regularized": true
},
"StochasticADAM": {
"alpha": 0.001,
"beta_1": 0.9,
"beta_2": 0.999,
"epsilon": 1e-08,
"erase_component_probability": 0.3
},
"StochasticGradientDescent": {
"erase_component_probability": 0.3
},
"advanced": {
"apply_gradient_fd": "None",
"derivative_along_delta_x_tol": 0,
"f_delta": 0,
"f_delta_step_tol": 100,
"gradient_fd_eps": 1e-07
},
"allow_out_of_iterations": false,
"box_constraints": {
"bounds": [],
"max_change": -1
},
"first_grad_norm_tol": 1e-10,
"grad_norm": 1e-08,
"iterations_per_strategy": 5,
"line_search": {
"Armijo": {
"c": 0.0001
},
"RobustArmijo": {
"delta_relative_tolerance": 0.1
},
"default_init_step_size": 1,
"max_step_size_iter": 30,
"max_step_size_iter_final": 100,
"method": "RobustArmijo",
"min_step_size": 1e-10,
"min_step_size_final": 1e-20,
"step_ratio": 0.5,
"use_grad_norm_tol": 1e-06
},
"max_iterations": 500,
"solver": "Newton",
"x_delta": 0
},
"scaling": 2.0
},
"contact": {
"CCD": {
"broad_phase": "hash_grid",
"max_iterations": 1000000,
"tolerance": 1e-06
},
"barrier_stiffness": "adaptive",
"friction_convergence_tol": 0.01,
"friction_iterations": 1
},
"linear": {
"AMGCL": {
"precond": {
"class": "amg",
"coarsening": {
"aggr": {
"eps_strong": 0
},
"estimate_spectral_radius": true,
"relax": 1,
"type": "smoothed_aggregation"
},
"direct_coarse": false,
"max_levels": 6,
"ncycle": 2,
"relax": {
"degree": 16,
"higher": 2,
"lower": 0.008333333333,
"power_iters": 100,
"scale": true,
"type": "chebyshev"
}
},
"solver": {
"maxiter": 1000,
"tol": 1e-10,
"type": "cg"
}
},
"Eigen::BiCGSTAB": {
"max_iter": 1000,
"tolerance": 1e-12
},
"Eigen::ConjugateGradient": {
"max_iter": 1000,
"tolerance": 1e-12
},
"Eigen::DGMRES": {
"max_iter": 1000,
"tolerance": 1e-12
},
"Eigen::GMRES": {
"max_iter": 1000,
"tolerance": 1e-12
},
"Eigen::LeastSquaresConjugateGradient": {
"max_iter": 1000,
"tolerance": 1e-12
},
"Eigen::MINRES": {
"max_iter": 1000,
"tolerance": 1e-12
},
"Hypre": {
"max_iter": 1000,
"pre_max_iter": 1,
"tolerance": 1e-10
},
"Pardiso": {
"mtype": 11
},
"enable_overwrite_solver": false,
"precond": "",
"solver": ""
},
"max_threads": 0,
"nonlinear": {
"ADAM": {
"alpha": 0.001,
"beta_1": 0.9,
"beta_2": 0.999,
"epsilon": 1e-08
},
"L-BFGS": {
"history_size": 6
},
"L-BFGS-B": {
"history_size": 6
},
"Newton": {
"force_psd_projection": false,
"reg_weight_inc": 10,
"reg_weight_max": 100000000.0,
"reg_weight_min": 1e-08,
"residual_tolerance": 1e-05,
"use_psd_projection": true,
"use_psd_projection_in_regularized": true
},
"StochasticADAM": {
"alpha": 0.001,
"beta_1": 0.9,
"beta_2": 0.999,
"epsilon": 1e-08,
"erase_component_probability": 0.3
},
"StochasticGradientDescent": {
"erase_component_probability": 0.3
},
"advanced": {
"apply_gradient_fd": "None",
"derivative_along_delta_x_tol": 0,
"f_delta": 0,
"f_delta_step_tol": 100,
"gradient_fd_eps": 1e-07
},
"allow_out_of_iterations": false,
"box_constraints": {
"bounds": [],
"max_change": -1
},
"first_grad_norm_tol": 1e-10,
"grad_norm": 1e-08,
"iterations_per_strategy": 5,
"line_search": {
"Armijo": {
"c": 0.0001
},
"RobustArmijo": {
"delta_relative_tolerance": 0.1
},
"default_init_step_size": 1,
"max_step_size_iter": 30,
"max_step_size_iter_final": 100,
"method": "RobustArmijo",
"min_step_size": 1e-10,
"min_step_size_final": 1e-20,
"step_ratio": 0.5,
"use_grad_norm_tol": 1e-06
},
"max_iterations": 500,
"solver": "Newton",
"x_delta": 0
},
"rayleigh_damping": []
},
"space": {
"advanced": {
"B": 3,
"bc_method": "sample",
"count_flipped_els": true,
"discr_order_max": 4,
"force_no_ref_for_harmonic": false,
"h1_formula": false,
"integral_constraints": 2,
"isoparametric": false,
"mass_quadrature_order": -1,
"n_boundary_samples": -1,
"n_harmonic_samples": 10,
"quadrature_order": -1,
"use_particle_advection": false
},
"basis_type": "Lagrange",
"discr_order": 1,
"poly_basis_type": "MFSHarmonic",
"pressure_discr_order": 1,
"remesh": {
"collapse": {
"abs_max_edge_length": 1e+100,
"acceptance_tolerance": -1e-08,
"culling_threshold": 0.01,
"enabled": true,
"max_depth": 3,
"rel_max_edge_length": 1
},
"enabled": false,
"local_relaxation": {
"local_mesh_n_ring": 2,
"local_mesh_rel_area": 0.01,
"max_nl_iterations": 1
},
"smooth": {
"acceptance_tolerance": -1e-08,
"enabled": false,
"max_iters": 1
},
"split": {
"acceptance_tolerance": 0.001,
"culling_threshold": 0.95,
"enabled": true,
"max_depth": 3,
"min_edge_length": 1e-06
},
"swap": {
"acceptance_tolerance": -1e-08,
"enabled": false,
"max_depth": 3
},
"type": "physics"
},
"use_p_ref": false
},
"tests": {
"err_h1": 0,
"err_h1_semi": 0,
"err_l2": 0,
"err_linf": 0,
"err_linf_grad": 0,
"err_lp": 0,
"margin": 1e-05,
"time_steps": 1
},
"time": {
"dt": "REQUIRED!",
"integrator": {
"beta": 0.25,
"gamma": 0.5,
"steps": 1,
"type": "REQUIRED!"
},
"quasistatic": false,
"t0": 0,
"tend": "REQUIRED!",
"time_steps": "REQUIRED!"
},
"units": {
"characteristic_length": 1,
"length": "m",
"mass": "kg",
"time": "s"
}
}
Full Specification¶
The following json contains the full specification of the PolyFEM JSON API.
/
(object
)
/
Description
Root of the configuration file.Required
/geometry
(list
)
/geometry
Description
List of geometry objects./geometry/*
/geometry/*
Description
Each geometry object stores a mesh, a set of transformations applied to it after loading, and a set of selections, which can be used to specify boundary conditions, materials, optimization parameters and other quantities that can be associated with a part of an object.Required
/geometry/*/mesh
(file
)
/geometry/*/mesh
Description
Path of the mesh file to load.Extensions: ['.obj', '.msh', '.stl', '.ply', '.mesh']
Optional
/geometry/*/type
(string
)
/geometry/*/type
Description
Type of geometry, currently only one supported. In future we will add stuff like planes, spheres, etc.Default: 'mesh'
Options: ['mesh', 'plane', 'ground', 'mesh_sequence', 'mesh_array']
/geometry/*/extract
(string
)
/geometry/*/extract
Description
Used to extract stuff from the mesh. Eg extract surface extracts the surface from a tet mesh.Default: 'volume'
Options: ['volume', 'edges', 'points', 'surface']
/geometry/*/unit
(string
)
/geometry/*/unit
Description
Units of the geometric model.Default: ''
/geometry/*/transformation
(object
)
/geometry/*/transformation
Description
Geometric transformations applied to the geometry after loading it.Default: None
Optional
/geometry/*/transformation/translation
(list
)
/geometry/*/transformation/translation
Description
Translate (two entries for 2D problems or three entries for 3D problems)./geometry/*/transformation/translation/*
(float
)
/geometry/*/transformation/translation/*
Description
FIXME: Missing documentation in the specification.Default: 0
/geometry/*/transformation/rotation
(list
)
/geometry/*/transformation/rotation
Description
Rotate, in 2D, one number, the rotation angle, in 3D, three or four Euler angles, axis+angle, or a unit quaternion. Depends on rotation mode./geometry/*/transformation/rotation/*
(float
)
/geometry/*/transformation/rotation/*
Description
FIXME: Missing documentation in the specification.Default: 0
/geometry/*/transformation/rotation_mode
(string
)
/geometry/*/transformation/rotation_mode
Description
Type of rotation, supported are any permutation of [xyz]+, axis_angle, quaternion, or rotation_vector.Default: 'xyz'
/geometry/*/transformation/scale
(list
)
/geometry/*/transformation/scale
Description
Scale by specified factors along axes (two entries for 2D problems or three entries for 3D problems)./geometry/*/transformation/scale/*
(float
)
/geometry/*/transformation/scale/*
Description
FIXME: Missing documentation in the specification.Default: 0
/geometry/*/transformation/dimensions
/geometry/*/transformation/dimensions
Description
Scale the object so that bounding box dimensions match specified dimensions, 2 entries for 2D problems, 3 entries for 3D problems.Default: 1
Description
Scale the object so that bounding box dimensions match specified dimensions, 2 entries for 2D problems, 3 entries for 3D problems./geometry/*/transformation/dimensions/*
(float
)
/geometry/*/transformation/dimensions/*
Description
FIXME: Missing documentation in the specification.Default: 0
/geometry/*/volume_selection
/geometry/*/volume_selection
Description
Assign specified ID to all elements of the geometry.Description
Load ids from a file; the file is required to have one ID per element of the geometryExtensions: ['.txt']
Description
Offsets the volume IDs loaded from the mesh.Default: None
Optional
/geometry/*/volume_selection/id_offset
(int
)
/geometry/*/volume_selection/id_offset
Description
Offsets the volume IDs loaded from the mesh.Default: 0
Description
List of selection (ID assignment) operations to apply to the geometry; operations can be box, sphere, etc./geometry/*/volume_selection/*
/geometry/*/volume_selection/*
Description
Assign the ID to all elements with barycenters inside an axis-aligned box given by the list of its 2 corners, one with min, the other with max coordinates along all axes. If relative option is set to true, the coordinates of the box corners are specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry.Default: None
Required
/geometry/*/volume_selection/*/id
(int
)
/geometry/*/volume_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/box
(list
)
/geometry/*/volume_selection/*/box
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/box/*
(list
)
/geometry/*/volume_selection/*/box/*
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/box/*/*
(float
)
/geometry/*/volume_selection/*/box/*/*
Description
FIXME: Missing documentation in the specification.Default: 0
Optional
/geometry/*/volume_selection/*/relative
(bool
)
/geometry/*/volume_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assign the ID to all elements with barycenters inside a sphere with specified center and radius. If relative option is set to true, the coordinates of the center are specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry, and the radius is specified relative to the bounding box diagonal length.Default: None
Required
/geometry/*/volume_selection/*/id
(int
)
/geometry/*/volume_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/radius
(float
)
/geometry/*/volume_selection/*/radius
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/center
(list
)
/geometry/*/volume_selection/*/center
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/center/*
(float
)
/geometry/*/volume_selection/*/center/*
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/volume_selection/*/relative
(bool
)
/geometry/*/volume_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assign the ID to all elements with barycenters inside a cylinder with specified axis (p1, p2) and radius. If relative option is set to true, the coordinates of the center are specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry, and the radius is specified relative to the bounding box diagonal length.Default: None
Required
/geometry/*/volume_selection/*/id
(int
)
/geometry/*/volume_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/radius
(float
)
/geometry/*/volume_selection/*/radius
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/p1
(list
)
/geometry/*/volume_selection/*/p1
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/p1/*
(float
)
/geometry/*/volume_selection/*/p1/*
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/p2
(list
)
/geometry/*/volume_selection/*/p2
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/p2/*
(float
)
/geometry/*/volume_selection/*/p2/*
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/volume_selection/*/relative
(bool
)
/geometry/*/volume_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assign the ID to all elements with barycenters in a halfspace. The halfspace boundary plane is defined by a point in the plane and the normal, which points to the halfspace. The option relative set to true indicates that the point position is specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry.Default: None
Required
/geometry/*/volume_selection/*/id
(int
)
/geometry/*/volume_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/point
(list
)
/geometry/*/volume_selection/*/point
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/point/*
(float
)
/geometry/*/volume_selection/*/point/*
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/normal
(list
)
/geometry/*/volume_selection/*/normal
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/normal/*
(float
)
/geometry/*/volume_selection/*/normal/*
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/volume_selection/*/relative
(bool
)
/geometry/*/volume_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Same as halfspace, but the boundary plane is axis-aligned. The choice of axis is specified either by a string matching the regexp r”[+-][xyzXYZ]” or an int matching the regular expression [+-]?[123] where the sign is the side of the plane to select and letter or number indicates the axis to which the plane is perpendicular. The offset is the plane offset from the origin. If the relative option is set to true, the offset is with respect to the center of the bounding box.Default: None
Required
/geometry/*/volume_selection/*/id
(int
)
/geometry/*/volume_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/axis
/geometry/*/volume_selection/*/axis
Description
FIXME: Missing documentation in the specification.Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/position
(float
)
/geometry/*/volume_selection/*/position
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/volume_selection/*/relative
(bool
)
/geometry/*/volume_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
/geometry/*/surface_selection
/geometry/*/surface_selection
Description
Assign specified ID to all elements of the geometry.Description
Load ids from a file; the file is required to have one ID per element of the geometryExtensions: ['.txt']
Description
List of selection (ID assignment) operations to apply to the geometry; operations can be box, sphere, etc./geometry/*/surface_selection/*
/geometry/*/surface_selection/*
Description
Assign the ID to all elements with barycenters inside an axis-aligned box given by the list of its 2 corners, one with min, the other with max coordinates along all axes. If relative option is set to true, the coordinates of the box corners are specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry.Default: None
Required
/geometry/*/surface_selection/*/id
(int
)
/geometry/*/surface_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/box
(list
)
/geometry/*/surface_selection/*/box
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/box/*
(list
)
/geometry/*/surface_selection/*/box/*
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/box/*/*
(float
)
/geometry/*/surface_selection/*/box/*/*
Description
FIXME: Missing documentation in the specification.Default: 0
Optional
/geometry/*/surface_selection/*/relative
(bool
)
/geometry/*/surface_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assign the ID to all elements with barycenters inside a sphere with specified center and radius. If relative option is set to true, the coordinates of the center are specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry, and the radius is specified relative to the bounding box diagonal length.Default: None
Required
/geometry/*/surface_selection/*/id
(int
)
/geometry/*/surface_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/radius
(float
)
/geometry/*/surface_selection/*/radius
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/center
(list
)
/geometry/*/surface_selection/*/center
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/center/*
(float
)
/geometry/*/surface_selection/*/center/*
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/surface_selection/*/relative
(bool
)
/geometry/*/surface_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assign the ID to all elements with barycenters inside a cylinder with specified axis (p1, p2) and radius. If relative option is set to true, the coordinates of the center are specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry, and the radius is specified relative to the bounding box diagonal length.Default: None
Required
/geometry/*/surface_selection/*/id
(int
)
/geometry/*/surface_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/radius
(float
)
/geometry/*/surface_selection/*/radius
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/p1
(list
)
/geometry/*/surface_selection/*/p1
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/p1/*
(float
)
/geometry/*/surface_selection/*/p1/*
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/p2
(list
)
/geometry/*/surface_selection/*/p2
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/p2/*
(float
)
/geometry/*/surface_selection/*/p2/*
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/surface_selection/*/relative
(bool
)
/geometry/*/surface_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assign the ID to all elements with barycenters in a halfspace. The halfspace boundary plane is defined by a point in the plane and the normal, which points to the halfspace. The option relative set to true indicates that the point position is specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry.Default: None
Required
/geometry/*/surface_selection/*/id
(int
)
/geometry/*/surface_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/point
(list
)
/geometry/*/surface_selection/*/point
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/point/*
(float
)
/geometry/*/surface_selection/*/point/*
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/normal
(list
)
/geometry/*/surface_selection/*/normal
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/normal/*
(float
)
/geometry/*/surface_selection/*/normal/*
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/surface_selection/*/relative
(bool
)
/geometry/*/surface_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Same as halfspace, but the boundary plane is axis-aligned. The choice of axis is specified either by a string matching the regexp r”[+-][xyzXYZ]” or an int matching the regular expression [+-]?[123] where the sign is the side of the plane to select and letter or number indicates the axis to which the plane is perpendicular. The offset is the plane offset from the origin. If the relative option is set to true, the offset is with respect to the center of the bounding box.Default: None
Required
/geometry/*/surface_selection/*/id
(int
)
/geometry/*/surface_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/axis
/geometry/*/surface_selection/*/axis
Description
FIXME: Missing documentation in the specification.Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/position
(float
)
/geometry/*/surface_selection/*/position
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/surface_selection/*/relative
(bool
)
/geometry/*/surface_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assigns ids to sides touching the bbox of the model using a threshold. Assigns 1+offset to left, 2+offset to bottom, 3+offset to right, 4+offset to top, 5+offset to front, 6+offset to back, 7+offset to everything else.Default: None
Required
/geometry/*/surface_selection/*/threshold
(float
)
/geometry/*/surface_selection/*/threshold
Description
Threshold for box side selection.Optional
/geometry/*/surface_selection/*/id_offset
(int
)
/geometry/*/surface_selection/*/id_offset
Description
ID offset of box side selection.Default: 0
/geometry/*/curve_selection
(object
)
/geometry/*/curve_selection
Description
Selection of curvesDefault: None
/geometry/*/point_selection
/geometry/*/point_selection
Description
Assign specified ID to all elements of the geometry.Description
Load ids from a file; the file is required to have one ID per element of the geometryExtensions: ['.txt']
Description
List of selection (ID assignment) operations to apply to the geometry; operations can be box, sphere, etc./geometry/*/point_selection/*
/geometry/*/point_selection/*
Description
Assign the ID to all elements with barycenters inside an axis-aligned box given by the list of its 2 corners, one with min, the other with max coordinates along all axes. If relative option is set to true, the coordinates of the box corners are specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry.Default: None
Required
/geometry/*/point_selection/*/id
(int
)
/geometry/*/point_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/box
(list
)
/geometry/*/point_selection/*/box
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/box/*
(list
)
/geometry/*/point_selection/*/box/*
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/box/*/*
(float
)
/geometry/*/point_selection/*/box/*/*
Description
FIXME: Missing documentation in the specification.Default: 0
Optional
/geometry/*/point_selection/*/relative
(bool
)
/geometry/*/point_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assign the ID to all elements with barycenters inside a sphere with specified center and radius. If relative option is set to true, the coordinates of the center are specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry, and the radius is specified relative to the bounding box diagonal length.Default: None
Required
/geometry/*/point_selection/*/id
(int
)
/geometry/*/point_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/radius
(float
)
/geometry/*/point_selection/*/radius
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/center
(list
)
/geometry/*/point_selection/*/center
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/center/*
(float
)
/geometry/*/point_selection/*/center/*
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/point_selection/*/relative
(bool
)
/geometry/*/point_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assign the ID to all elements with barycenters inside a cylinder with specified axis (p1, p2) and radius. If relative option is set to true, the coordinates of the center are specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry, and the radius is specified relative to the bounding box diagonal length.Default: None
Required
/geometry/*/point_selection/*/id
(int
)
/geometry/*/point_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/radius
(float
)
/geometry/*/point_selection/*/radius
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/p1
(list
)
/geometry/*/point_selection/*/p1
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/p1/*
(float
)
/geometry/*/point_selection/*/p1/*
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/p2
(list
)
/geometry/*/point_selection/*/p2
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/p2/*
(float
)
/geometry/*/point_selection/*/p2/*
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/point_selection/*/relative
(bool
)
/geometry/*/point_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assign the ID to all elements with barycenters in a halfspace. The halfspace boundary plane is defined by a point in the plane and the normal, which points to the halfspace. The option relative set to true indicates that the point position is specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry.Default: None
Required
/geometry/*/point_selection/*/id
(int
)
/geometry/*/point_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/point
(list
)
/geometry/*/point_selection/*/point
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/point/*
(float
)
/geometry/*/point_selection/*/point/*
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/normal
(list
)
/geometry/*/point_selection/*/normal
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/normal/*
(float
)
/geometry/*/point_selection/*/normal/*
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/point_selection/*/relative
(bool
)
/geometry/*/point_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Same as halfspace, but the boundary plane is axis-aligned. The choice of axis is specified either by a string matching the regexp r”[+-][xyzXYZ]” or an int matching the regular expression [+-]?[123] where the sign is the side of the plane to select and letter or number indicates the axis to which the plane is perpendicular. The offset is the plane offset from the origin. If the relative option is set to true, the offset is with respect to the center of the bounding box.Default: None
Required
/geometry/*/point_selection/*/id
(int
)
/geometry/*/point_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/axis
/geometry/*/point_selection/*/axis
Description
FIXME: Missing documentation in the specification.Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/position
(float
)
/geometry/*/point_selection/*/position
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/point_selection/*/relative
(bool
)
/geometry/*/point_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assigns ids to sides touching the bbox of the model using a threshold. Assigns 1+offset to left, 2+offset to bottom, 3+offset to right, 4+offset to top, 5+offset to front, 6+offset to back, 7+offset to everything else.Default: None
Required
/geometry/*/point_selection/*/threshold
(float
)
/geometry/*/point_selection/*/threshold
Description
Threshold for box side selection.Optional
/geometry/*/point_selection/*/id_offset
(int
)
/geometry/*/point_selection/*/id_offset
Description
ID offset of box side selection.Default: 0
/geometry/*/n_refs
(int
)
/geometry/*/n_refs
Description
number of uniform refinementsDefault: 0
/geometry/*/advanced
(object
)
/geometry/*/advanced
Description
Advanced options for geometryDefault: None
Optional
/geometry/*/advanced/normalize_mesh
(bool
)
/geometry/*/advanced/normalize_mesh
Description
Rescale the mesh to it fits in the biunit cubeDefault: False
/geometry/*/advanced/force_linear_geometry
(bool
)
/geometry/*/advanced/force_linear_geometry
Description
Discard high-order nodes for curved geometriesDefault: False
/geometry/*/advanced/refinement_location
(float
)
/geometry/*/advanced/refinement_location
Description
parametric location of the refinementDefault: 0.5
/geometry/*/advanced/min_component
(int
)
/geometry/*/advanced/min_component
Description
Size of the minimum component for collisionDefault: -1
/geometry/*/enabled
(bool
)
/geometry/*/enabled
Description
Skips the geometry if falseDefault: True
/geometry/*/is_obstacle
(bool
)
/geometry/*/is_obstacle
Description
The geometry elements are not included in deforming geometry, only in collision computationsDefault: False
Type: mesh_array
Description
Each geometry object stores a mesh, a set of transformations applied to it after loading, and a set of selections, which can be used to specify boundary conditions, materials, optimization parameters and other quantities that can be associated with a part of an object.Required
/geometry/*/mesh
(file
)
/geometry/*/mesh
Description
Path of the mesh file to load.Extensions: ['.obj', '.msh', '.stl', '.ply', '.mesh']
/geometry/*/array
(object
)
/geometry/*/array
Description
Array of meshesRequired
/geometry/*/array/offset
(float
)
/geometry/*/array/offset
Description
Offset of the mesh in the array./geometry/*/array/size
(list
)
/geometry/*/array/size
Description
Size of the array (two entries for 2D problems or three entries for 3D problems)./geometry/*/array/size/*
(int
)
/geometry/*/array/size/*
Description
Size of the array (two entries for 2D problems or three entries for 3D problems).Range: [1, inf]
Optional
/geometry/*/array/relative
(bool
)
/geometry/*/array/relative
Description
Is the offset value relative to the mesh’s dimensions.Default: False
Optional
/geometry/*/type
(string
)
/geometry/*/type
Description
Type of geometry, currently only one supported. In future we will add stuff like planes, spheres, etc.Default: 'mesh'
Options: ['mesh', 'plane', 'ground', 'mesh_sequence', 'mesh_array']
/geometry/*/extract
(string
)
/geometry/*/extract
Description
Used to extract stuff from the mesh. Eg extract surface extracts the surface from a tet mesh.Default: 'volume'
Options: ['volume', 'edges', 'points', 'surface']
/geometry/*/unit
(string
)
/geometry/*/unit
Description
Units of the geometric model.Default: ''
/geometry/*/transformation
(object
)
/geometry/*/transformation
Description
Geometric transformations applied to the geometry after loading it.Default: None
Optional
/geometry/*/transformation/translation
(list
)
/geometry/*/transformation/translation
Description
Translate (two entries for 2D problems or three entries for 3D problems)./geometry/*/transformation/translation/*
(float
)
/geometry/*/transformation/translation/*
Description
FIXME: Missing documentation in the specification.Default: 0
/geometry/*/transformation/rotation
(list
)
/geometry/*/transformation/rotation
Description
Rotate, in 2D, one number, the rotation angle, in 3D, three or four Euler angles, axis+angle, or a unit quaternion. Depends on rotation mode./geometry/*/transformation/rotation/*
(float
)
/geometry/*/transformation/rotation/*
Description
FIXME: Missing documentation in the specification.Default: 0
/geometry/*/transformation/rotation_mode
(string
)
/geometry/*/transformation/rotation_mode
Description
Type of rotation, supported are any permutation of [xyz]+, axis_angle, quaternion, or rotation_vector.Default: 'xyz'
/geometry/*/transformation/scale
(list
)
/geometry/*/transformation/scale
Description
Scale by specified factors along axes (two entries for 2D problems or three entries for 3D problems)./geometry/*/transformation/scale/*
(float
)
/geometry/*/transformation/scale/*
Description
FIXME: Missing documentation in the specification.Default: 0
/geometry/*/transformation/dimensions
/geometry/*/transformation/dimensions
Description
Scale the object so that bounding box dimensions match specified dimensions, 2 entries for 2D problems, 3 entries for 3D problems.Default: 1
Description
Scale the object so that bounding box dimensions match specified dimensions, 2 entries for 2D problems, 3 entries for 3D problems./geometry/*/transformation/dimensions/*
(float
)
/geometry/*/transformation/dimensions/*
Description
FIXME: Missing documentation in the specification.Default: 0
/geometry/*/volume_selection
/geometry/*/volume_selection
Description
Assign specified ID to all elements of the geometry.Description
Load ids from a file; the file is required to have one ID per element of the geometryExtensions: ['.txt']
Description
Offsets the volume IDs loaded from the mesh.Default: None
Optional
/geometry/*/volume_selection/id_offset
(int
)
/geometry/*/volume_selection/id_offset
Description
Offsets the volume IDs loaded from the mesh.Default: 0
Description
List of selection (ID assignment) operations to apply to the geometry; operations can be box, sphere, etc./geometry/*/volume_selection/*
/geometry/*/volume_selection/*
Description
Assign the ID to all elements with barycenters inside an axis-aligned box given by the list of its 2 corners, one with min, the other with max coordinates along all axes. If relative option is set to true, the coordinates of the box corners are specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry.Default: None
Required
/geometry/*/volume_selection/*/id
(int
)
/geometry/*/volume_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/box
(list
)
/geometry/*/volume_selection/*/box
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/box/*
(list
)
/geometry/*/volume_selection/*/box/*
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/box/*/*
(float
)
/geometry/*/volume_selection/*/box/*/*
Description
FIXME: Missing documentation in the specification.Default: 0
Optional
/geometry/*/volume_selection/*/relative
(bool
)
/geometry/*/volume_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assign the ID to all elements with barycenters inside a sphere with specified center and radius. If relative option is set to true, the coordinates of the center are specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry, and the radius is specified relative to the bounding box diagonal length.Default: None
Required
/geometry/*/volume_selection/*/id
(int
)
/geometry/*/volume_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/radius
(float
)
/geometry/*/volume_selection/*/radius
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/center
(list
)
/geometry/*/volume_selection/*/center
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/center/*
(float
)
/geometry/*/volume_selection/*/center/*
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/volume_selection/*/relative
(bool
)
/geometry/*/volume_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assign the ID to all elements with barycenters inside a cylinder with specified axis (p1, p2) and radius. If relative option is set to true, the coordinates of the center are specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry, and the radius is specified relative to the bounding box diagonal length.Default: None
Required
/geometry/*/volume_selection/*/id
(int
)
/geometry/*/volume_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/radius
(float
)
/geometry/*/volume_selection/*/radius
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/p1
(list
)
/geometry/*/volume_selection/*/p1
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/p1/*
(float
)
/geometry/*/volume_selection/*/p1/*
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/p2
(list
)
/geometry/*/volume_selection/*/p2
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/p2/*
(float
)
/geometry/*/volume_selection/*/p2/*
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/volume_selection/*/relative
(bool
)
/geometry/*/volume_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assign the ID to all elements with barycenters in a halfspace. The halfspace boundary plane is defined by a point in the plane and the normal, which points to the halfspace. The option relative set to true indicates that the point position is specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry.Default: None
Required
/geometry/*/volume_selection/*/id
(int
)
/geometry/*/volume_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/point
(list
)
/geometry/*/volume_selection/*/point
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/point/*
(float
)
/geometry/*/volume_selection/*/point/*
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/normal
(list
)
/geometry/*/volume_selection/*/normal
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/normal/*
(float
)
/geometry/*/volume_selection/*/normal/*
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/volume_selection/*/relative
(bool
)
/geometry/*/volume_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Same as halfspace, but the boundary plane is axis-aligned. The choice of axis is specified either by a string matching the regexp r”[+-][xyzXYZ]” or an int matching the regular expression [+-]?[123] where the sign is the side of the plane to select and letter or number indicates the axis to which the plane is perpendicular. The offset is the plane offset from the origin. If the relative option is set to true, the offset is with respect to the center of the bounding box.Default: None
Required
/geometry/*/volume_selection/*/id
(int
)
/geometry/*/volume_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/axis
/geometry/*/volume_selection/*/axis
Description
FIXME: Missing documentation in the specification.Description
FIXME: Missing documentation in the specification./geometry/*/volume_selection/*/position
(float
)
/geometry/*/volume_selection/*/position
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/volume_selection/*/relative
(bool
)
/geometry/*/volume_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
/geometry/*/surface_selection
/geometry/*/surface_selection
Description
Assign specified ID to all elements of the geometry.Description
Load ids from a file; the file is required to have one ID per element of the geometryExtensions: ['.txt']
Description
List of selection (ID assignment) operations to apply to the geometry; operations can be box, sphere, etc./geometry/*/surface_selection/*
/geometry/*/surface_selection/*
Description
Assign the ID to all elements with barycenters inside an axis-aligned box given by the list of its 2 corners, one with min, the other with max coordinates along all axes. If relative option is set to true, the coordinates of the box corners are specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry.Default: None
Required
/geometry/*/surface_selection/*/id
(int
)
/geometry/*/surface_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/box
(list
)
/geometry/*/surface_selection/*/box
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/box/*
(list
)
/geometry/*/surface_selection/*/box/*
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/box/*/*
(float
)
/geometry/*/surface_selection/*/box/*/*
Description
FIXME: Missing documentation in the specification.Default: 0
Optional
/geometry/*/surface_selection/*/relative
(bool
)
/geometry/*/surface_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assign the ID to all elements with barycenters inside a sphere with specified center and radius. If relative option is set to true, the coordinates of the center are specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry, and the radius is specified relative to the bounding box diagonal length.Default: None
Required
/geometry/*/surface_selection/*/id
(int
)
/geometry/*/surface_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/radius
(float
)
/geometry/*/surface_selection/*/radius
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/center
(list
)
/geometry/*/surface_selection/*/center
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/center/*
(float
)
/geometry/*/surface_selection/*/center/*
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/surface_selection/*/relative
(bool
)
/geometry/*/surface_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assign the ID to all elements with barycenters inside a cylinder with specified axis (p1, p2) and radius. If relative option is set to true, the coordinates of the center are specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry, and the radius is specified relative to the bounding box diagonal length.Default: None
Required
/geometry/*/surface_selection/*/id
(int
)
/geometry/*/surface_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/radius
(float
)
/geometry/*/surface_selection/*/radius
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/p1
(list
)
/geometry/*/surface_selection/*/p1
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/p1/*
(float
)
/geometry/*/surface_selection/*/p1/*
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/p2
(list
)
/geometry/*/surface_selection/*/p2
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/p2/*
(float
)
/geometry/*/surface_selection/*/p2/*
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/surface_selection/*/relative
(bool
)
/geometry/*/surface_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assign the ID to all elements with barycenters in a halfspace. The halfspace boundary plane is defined by a point in the plane and the normal, which points to the halfspace. The option relative set to true indicates that the point position is specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry.Default: None
Required
/geometry/*/surface_selection/*/id
(int
)
/geometry/*/surface_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/point
(list
)
/geometry/*/surface_selection/*/point
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/point/*
(float
)
/geometry/*/surface_selection/*/point/*
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/normal
(list
)
/geometry/*/surface_selection/*/normal
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/normal/*
(float
)
/geometry/*/surface_selection/*/normal/*
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/surface_selection/*/relative
(bool
)
/geometry/*/surface_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Same as halfspace, but the boundary plane is axis-aligned. The choice of axis is specified either by a string matching the regexp r”[+-][xyzXYZ]” or an int matching the regular expression [+-]?[123] where the sign is the side of the plane to select and letter or number indicates the axis to which the plane is perpendicular. The offset is the plane offset from the origin. If the relative option is set to true, the offset is with respect to the center of the bounding box.Default: None
Required
/geometry/*/surface_selection/*/id
(int
)
/geometry/*/surface_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/axis
/geometry/*/surface_selection/*/axis
Description
FIXME: Missing documentation in the specification.Description
FIXME: Missing documentation in the specification./geometry/*/surface_selection/*/position
(float
)
/geometry/*/surface_selection/*/position
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/surface_selection/*/relative
(bool
)
/geometry/*/surface_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assigns ids to sides touching the bbox of the model using a threshold. Assigns 1+offset to left, 2+offset to bottom, 3+offset to right, 4+offset to top, 5+offset to front, 6+offset to back, 7+offset to everything else.Default: None
Required
/geometry/*/surface_selection/*/threshold
(float
)
/geometry/*/surface_selection/*/threshold
Description
Threshold for box side selection.Optional
/geometry/*/surface_selection/*/id_offset
(int
)
/geometry/*/surface_selection/*/id_offset
Description
ID offset of box side selection.Default: 0
/geometry/*/curve_selection
(object
)
/geometry/*/curve_selection
Description
Selection of curvesDefault: None
/geometry/*/point_selection
/geometry/*/point_selection
Description
Assign specified ID to all elements of the geometry.Description
Load ids from a file; the file is required to have one ID per element of the geometryExtensions: ['.txt']
Description
List of selection (ID assignment) operations to apply to the geometry; operations can be box, sphere, etc./geometry/*/point_selection/*
/geometry/*/point_selection/*
Description
Assign the ID to all elements with barycenters inside an axis-aligned box given by the list of its 2 corners, one with min, the other with max coordinates along all axes. If relative option is set to true, the coordinates of the box corners are specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry.Default: None
Required
/geometry/*/point_selection/*/id
(int
)
/geometry/*/point_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/box
(list
)
/geometry/*/point_selection/*/box
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/box/*
(list
)
/geometry/*/point_selection/*/box/*
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/box/*/*
(float
)
/geometry/*/point_selection/*/box/*/*
Description
FIXME: Missing documentation in the specification.Default: 0
Optional
/geometry/*/point_selection/*/relative
(bool
)
/geometry/*/point_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assign the ID to all elements with barycenters inside a sphere with specified center and radius. If relative option is set to true, the coordinates of the center are specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry, and the radius is specified relative to the bounding box diagonal length.Default: None
Required
/geometry/*/point_selection/*/id
(int
)
/geometry/*/point_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/radius
(float
)
/geometry/*/point_selection/*/radius
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/center
(list
)
/geometry/*/point_selection/*/center
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/center/*
(float
)
/geometry/*/point_selection/*/center/*
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/point_selection/*/relative
(bool
)
/geometry/*/point_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assign the ID to all elements with barycenters inside a cylinder with specified axis (p1, p2) and radius. If relative option is set to true, the coordinates of the center are specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry, and the radius is specified relative to the bounding box diagonal length.Default: None
Required
/geometry/*/point_selection/*/id
(int
)
/geometry/*/point_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/radius
(float
)
/geometry/*/point_selection/*/radius
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/p1
(list
)
/geometry/*/point_selection/*/p1
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/p1/*
(float
)
/geometry/*/point_selection/*/p1/*
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/p2
(list
)
/geometry/*/point_selection/*/p2
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/p2/*
(float
)
/geometry/*/point_selection/*/p2/*
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/point_selection/*/relative
(bool
)
/geometry/*/point_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assign the ID to all elements with barycenters in a halfspace. The halfspace boundary plane is defined by a point in the plane and the normal, which points to the halfspace. The option relative set to true indicates that the point position is specified in bilinear/trilinear coordinates with respect to the bounding box of the geometry.Default: None
Required
/geometry/*/point_selection/*/id
(int
)
/geometry/*/point_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/point
(list
)
/geometry/*/point_selection/*/point
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/point/*
(float
)
/geometry/*/point_selection/*/point/*
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/normal
(list
)
/geometry/*/point_selection/*/normal
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/normal/*
(float
)
/geometry/*/point_selection/*/normal/*
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/point_selection/*/relative
(bool
)
/geometry/*/point_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Same as halfspace, but the boundary plane is axis-aligned. The choice of axis is specified either by a string matching the regexp r”[+-][xyzXYZ]” or an int matching the regular expression [+-]?[123] where the sign is the side of the plane to select and letter or number indicates the axis to which the plane is perpendicular. The offset is the plane offset from the origin. If the relative option is set to true, the offset is with respect to the center of the bounding box.Default: None
Required
/geometry/*/point_selection/*/id
(int
)
/geometry/*/point_selection/*/id
Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/axis
/geometry/*/point_selection/*/axis
Description
FIXME: Missing documentation in the specification.Description
FIXME: Missing documentation in the specification./geometry/*/point_selection/*/position
(float
)
/geometry/*/point_selection/*/position
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/point_selection/*/relative
(bool
)
/geometry/*/point_selection/*/relative
Description
FIXME: Missing documentation in the specification.Default: False
Description
Assigns ids to sides touching the bbox of the model using a threshold. Assigns 1+offset to left, 2+offset to bottom, 3+offset to right, 4+offset to top, 5+offset to front, 6+offset to back, 7+offset to everything else.Default: None
Required
/geometry/*/point_selection/*/threshold
(float
)
/geometry/*/point_selection/*/threshold
Description
Threshold for box side selection.Optional
/geometry/*/point_selection/*/id_offset
(int
)
/geometry/*/point_selection/*/id_offset
Description
ID offset of box side selection.Default: 0
/geometry/*/n_refs
(int
)
/geometry/*/n_refs
Description
number of uniform refinementsDefault: 0
/geometry/*/advanced
(object
)
/geometry/*/advanced
Description
Advanced options for geometryDefault: None
Optional
/geometry/*/advanced/normalize_mesh
(bool
)
/geometry/*/advanced/normalize_mesh
Description
Rescale the mesh to it fits in the biunit cubeDefault: False
/geometry/*/advanced/force_linear_geometry
(bool
)
/geometry/*/advanced/force_linear_geometry
Description
Discard high-order nodes for curved geometriesDefault: False
/geometry/*/advanced/refinement_location
(float
)
/geometry/*/advanced/refinement_location
Description
parametric location of the refinementDefault: 0.5
/geometry/*/advanced/min_component
(int
)
/geometry/*/advanced/min_component
Description
Size of the minimum component for collisionDefault: -1
/geometry/*/enabled
(bool
)
/geometry/*/enabled
Description
Skips the geometry if falseDefault: True
/geometry/*/is_obstacle
(bool
)
/geometry/*/is_obstacle
Description
The geometry elements are not included in deforming geometry, only in collision computationsDefault: False
Type: plane
Description
Plane geometry object defined by its origin and normal.Required
/geometry/*/point
(list
)
/geometry/*/point
Description
Point on plane (two entries for 2D problems or three entries for 3D problems)./geometry/*/point/*
(float
)
/geometry/*/point/*
Description
FIXME: Missing documentation in the specification./geometry/*/normal
(list
)
/geometry/*/normal
Description
Normal of plane (two entries for 2D problems or three entries for 3D problems)./geometry/*/normal/*
(float
)
/geometry/*/normal/*
Description
FIXME: Missing documentation in the specification.Optional
/geometry/*/type
(string
)
/geometry/*/type
Description
Type of geometry, currently only one supported. In future we will add stuff like planes, spheres, etc.Default: 'mesh'
Options: ['mesh', 'plane', 'ground', 'mesh_sequence', 'mesh_array']
/geometry/*/enabled
(bool
)
/geometry/*/enabled
Description
Skips the geometry if falseDefault: True
/geometry/*/is_obstacle
(bool
)
/geometry/*/is_obstacle
Description
The geometry elements are not included in deforming geometry, only in collision computationsDefault: False
Type: ground
Description
Plane orthogonal to gravity defined by its height.Required
/geometry/*/height
(float
)
/geometry/*/height
Description
Height of ground plane.Optional
/geometry/*/type
(string
)
/geometry/*/type
Description
Type of geometry, currently only one supported. In future we will add stuff like planes, spheres, etc.Default: 'mesh'
Options: ['mesh', 'plane', 'ground', 'mesh_sequence', 'mesh_array']
/geometry/*/enabled
(bool
)
/geometry/*/enabled
Description
Skips the geometry if falseDefault: True
/geometry/*/is_obstacle
(bool
)
/geometry/*/is_obstacle
Description
The geometry elements are not included in deforming geometry, only in collision computationsDefault: False
Type: mesh_sequence
Description
Mesh sequence.Required
/geometry/*/mesh_sequence
/geometry/*/mesh_sequence
Description
Directory (or GLOB) of meshes for the mesh sequence.Description
List of mesh files for the mesh sequence./geometry/*/mesh_sequence/*
(file
)
/geometry/*/mesh_sequence/*
Description
Path of the mesh file to load.Extensions: ['.obj', '.msh', '.stl', '.ply', '.mesh']
/geometry/*/fps
(int
)
/geometry/*/fps
Description
Frames of the mesh sequence per second.Optional
/geometry/*/type
(string
)
/geometry/*/type
Description
Type of geometry, currently only one supported. In future we will add stuff like planes, spheres, etc.Default: 'mesh'
Options: ['mesh', 'plane', 'ground', 'mesh_sequence', 'mesh_array']
/geometry/*/extract
(string
)
/geometry/*/extract
Description
Used to extract stuff from the mesh. Eg extract surface extracts the surface from a tet mesh.Default: 'volume'
Options: ['volume', 'edges', 'points', 'surface']
/geometry/*/unit
(string
)
/geometry/*/unit
Description
Units of the geometric model.Default: ''
/geometry/*/transformation
(object
)
/geometry/*/transformation
Description
Geometric transformations applied to the geometry after loading it.Default: None
Optional
/geometry/*/transformation/translation
(list
)
/geometry/*/transformation/translation
Description
Translate (two entries for 2D problems or three entries for 3D problems)./geometry/*/transformation/translation/*
(float
)
/geometry/*/transformation/translation/*
Description
FIXME: Missing documentation in the specification.Default: 0
/geometry/*/transformation/rotation
(list
)
/geometry/*/transformation/rotation
Description
Rotate, in 2D, one number, the rotation angle, in 3D, three or four Euler angles, axis+angle, or a unit quaternion. Depends on rotation mode./geometry/*/transformation/rotation/*
(float
)
/geometry/*/transformation/rotation/*
Description
FIXME: Missing documentation in the specification.Default: 0
/geometry/*/transformation/rotation_mode
(string
)
/geometry/*/transformation/rotation_mode
Description
Type of rotation, supported are any permutation of [xyz]+, axis_angle, quaternion, or rotation_vector.Default: 'xyz'
/geometry/*/transformation/scale
(list
)
/geometry/*/transformation/scale
Description
Scale by specified factors along axes (two entries for 2D problems or three entries for 3D problems)./geometry/*/transformation/scale/*
(float
)
/geometry/*/transformation/scale/*
Description
FIXME: Missing documentation in the specification.Default: 0
/geometry/*/transformation/dimensions
/geometry/*/transformation/dimensions
Description
Scale the object so that bounding box dimensions match specified dimensions, 2 entries for 2D problems, 3 entries for 3D problems.Default: 1
Description
Scale the object so that bounding box dimensions match specified dimensions, 2 entries for 2D problems, 3 entries for 3D problems./geometry/*/transformation/dimensions/*
(float
)
/geometry/*/transformation/dimensions/*
Description
FIXME: Missing documentation in the specification.Default: 0
/geometry/*/n_refs
(int
)
/geometry/*/n_refs
Description
number of uniform refinementsDefault: 0
/geometry/*/advanced
(object
)
/geometry/*/advanced
Description
Advanced options for geometryDefault: None
Optional
/geometry/*/advanced/normalize_mesh
(bool
)
/geometry/*/advanced/normalize_mesh
Description
Rescale the mesh to it fits in the biunit cubeDefault: False
/geometry/*/advanced/force_linear_geometry
(bool
)
/geometry/*/advanced/force_linear_geometry
Description
Discard high-order nodes for curved geometriesDefault: False
/geometry/*/advanced/refinement_location
(float
)
/geometry/*/advanced/refinement_location
Description
parametric location of the refinementDefault: 0.5
/geometry/*/advanced/min_component
(int
)
/geometry/*/advanced/min_component
Description
Size of the minimum component for collisionDefault: -1
/geometry/*/enabled
(bool
)
/geometry/*/enabled
Description
Skips the geometry if falseDefault: True
/geometry/*/is_obstacle
(bool
)
/geometry/*/is_obstacle
Description
The geometry elements are not included in deforming geometry, only in collision computationsDefault: False
/materials
(list
)
/materials
Description
Material Parameters lists including ID pointing to volume selection, Young’s modulus (\(E\)), Poisson’s ratio (\(\nu\)), Density (\(\rho\)), or Lamé constants (\(\lambda\) and \(\mu\))./materials/*
/materials/*
Type: NeoHookean
Description
Material Parameters including ID, Young’s modulus (\(E\)), Poisson’s ratio (\(\nu\)), density (\(\rho\))Required
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/E
/materials/*/E
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/E/value
/materials/*/E/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/E/unit
(string
)
/materials/*/E/unit
Description
The unit of the Value/materials/*/nu
/materials/*/nu
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/nu/value
/materials/*/nu/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/nu/unit
(string
)
/materials/*/nu/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the Value/materials/*/phi
/materials/*/phi
Description
Value as a constant floatDefault: 0
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/phi/value
/materials/*/phi/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/phi/unit
(string
)
/materials/*/phi/unit
Description
The unit of the Value/materials/*/psi
/materials/*/psi
Description
Value as a constant floatDefault: 0
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/psi/value
/materials/*/psi/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/psi/unit
(string
)
/materials/*/psi/unit
Description
The unit of the ValueType: NeoHookean
Description
Material Parameters including ID, Lamé first (\(\lambda\)), Lamé second (\(\mu\)), density (\(\rho\))Required
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/lambda
/materials/*/lambda
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/lambda/value
/materials/*/lambda/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/lambda/unit
(string
)
/materials/*/lambda/unit
Description
The unit of the Value/materials/*/mu
/materials/*/mu
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/mu/value
/materials/*/mu/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/mu/unit
(string
)
/materials/*/mu/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the Value/materials/*/phi
/materials/*/phi
Description
Value as a constant floatDefault: 0
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/phi/value
/materials/*/phi/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/phi/unit
(string
)
/materials/*/phi/unit
Description
The unit of the Value/materials/*/psi
/materials/*/psi
Description
Value as a constant floatDefault: 0
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/psi/value
/materials/*/psi/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/psi/unit
(string
)
/materials/*/psi/unit
Description
The unit of the ValueType: MooneyRivlin
Description
Material Parameters including ID, for Mooney-RivlinRequired
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/c1
/materials/*/c1
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/c1/value
/materials/*/c1/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/c1/unit
(string
)
/materials/*/c1/unit
Description
The unit of the Value/materials/*/c2
/materials/*/c2
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/c2/value
/materials/*/c2/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/c2/unit
(string
)
/materials/*/c2/unit
Description
The unit of the Value/materials/*/k
/materials/*/k
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/k/value
/materials/*/k/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/k/unit
(string
)
/materials/*/k/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the ValueType: MooneyRivlin3Param
Description
Material Parameters including ID, for Mooney-RivlinRequired
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/c1
/materials/*/c1
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/c1/value
/materials/*/c1/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/c1/unit
(string
)
/materials/*/c1/unit
Description
The unit of the Value/materials/*/c2
/materials/*/c2
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/c2/value
/materials/*/c2/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/c2/unit
(string
)
/materials/*/c2/unit
Description
The unit of the Value/materials/*/c3
/materials/*/c3
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/c3/value
/materials/*/c3/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/c3/unit
(string
)
/materials/*/c3/unit
Description
The unit of the Value/materials/*/d1
/materials/*/d1
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/d1/value
/materials/*/d1/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/d1/unit
(string
)
/materials/*/d1/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the ValueType: MooneyRivlin3ParamSymbolic
Description
Material Parameters including ID, for Mooney-RivlinRequired
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/c1
/materials/*/c1
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/c1/value
/materials/*/c1/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/c1/unit
(string
)
/materials/*/c1/unit
Description
The unit of the Value/materials/*/c2
/materials/*/c2
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/c2/value
/materials/*/c2/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/c2/unit
(string
)
/materials/*/c2/unit
Description
The unit of the Value/materials/*/c3
/materials/*/c3
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/c3/value
/materials/*/c3/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/c3/unit
(string
)
/materials/*/c3/unit
Description
The unit of the Value/materials/*/d1
/materials/*/d1
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/d1/value
/materials/*/d1/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/d1/unit
(string
)
/materials/*/d1/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the ValueType: UnconstrainedOgden
Description
Material Parameters including ID, for Ogden.Required
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/alphas
/materials/*/alphas
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/alphas/value
/materials/*/alphas/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/alphas/unit
(string
)
/materials/*/alphas/unit
Description
The unit of the Value/materials/*/mus
(list
)
/materials/*/mus
Description
Ogden mu/materials/*/mus/*
/materials/*/mus/*
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/mus/*/value
/materials/*/mus/*/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/mus/*/unit
(string
)
/materials/*/mus/*/unit
Description
The unit of the Value/materials/*/Ds
(list
)
/materials/*/Ds
Description
Ogden D/materials/*/Ds/*
/materials/*/Ds/*
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/Ds/*/value
/materials/*/Ds/*/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/Ds/*/unit
(string
)
/materials/*/Ds/*/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the ValueType: IncompressibleOgden
Description
Material Parameters including ID, for Ogden.Required
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/c
/materials/*/c
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/c/value
/materials/*/c/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/c/unit
(string
)
/materials/*/c/unit
Description
The unit of the ValueDescription
Coefficient(s) of Incompressible Ogden/materials/*/c/*
/materials/*/c/*
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/c/*/value
/materials/*/c/*/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/c/*/unit
(string
)
/materials/*/c/*/unit
Description
The unit of the Value/materials/*/m
/materials/*/m
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/m/value
/materials/*/m/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/m/unit
(string
)
/materials/*/m/unit
Description
The unit of the ValueDescription
Exponent(s) of Incompressible Ogden/materials/*/m/*
/materials/*/m/*
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/m/*/value
/materials/*/m/*/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/m/*/unit
(string
)
/materials/*/m/*/unit
Description
The unit of the Value/materials/*/k
/materials/*/k
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/k/value
/materials/*/k/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/k/unit
(string
)
/materials/*/k/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the ValueType: LinearElasticity
Description
Material Parameters including ID, Young’s modulus (\(E\)), Poisson’s ratio (\(\nu\)), density (\(\rho\))Required
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/E
/materials/*/E
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/E/value
/materials/*/E/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/E/unit
(string
)
/materials/*/E/unit
Description
The unit of the Value/materials/*/nu
/materials/*/nu
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/nu/value
/materials/*/nu/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/nu/unit
(string
)
/materials/*/nu/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the Value/materials/*/phi
/materials/*/phi
Description
Value as a constant floatDefault: 0
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/phi/value
/materials/*/phi/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/phi/unit
(string
)
/materials/*/phi/unit
Description
The unit of the Value/materials/*/psi
/materials/*/psi
Description
Value as a constant floatDefault: 0
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/psi/value
/materials/*/psi/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/psi/unit
(string
)
/materials/*/psi/unit
Description
The unit of the ValueType: LinearElasticity
Description
Material Parameters including ID, Lamé first (\(\lambda\)), Lamé second (\(\mu\)), density (\(\rho\))Required
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/lambda
/materials/*/lambda
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/lambda/value
/materials/*/lambda/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/lambda/unit
(string
)
/materials/*/lambda/unit
Description
The unit of the Value/materials/*/mu
/materials/*/mu
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/mu/value
/materials/*/mu/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/mu/unit
(string
)
/materials/*/mu/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the ValueType: HookeLinearElasticity
Description
Material Parameters including ID, E, nu, density (\(\rho\))Required
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/E
/materials/*/E
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/E/value
/materials/*/E/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/E/unit
(string
)
/materials/*/E/unit
Description
The unit of the Value/materials/*/nu
/materials/*/nu
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/nu/value
/materials/*/nu/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/nu/unit
(string
)
/materials/*/nu/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the ValueType: HookeLinearElasticity
Description
Material Parameters including ID, E, nu, density (\(\rho\))Required
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/elasticity_tensor
(list
)
/materials/*/elasticity_tensor
Description
Symmetric elasticity tensor/materials/*/elasticity_tensor/*
/materials/*/elasticity_tensor/*
Description
Value as a constant floatDefault: 0
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/elasticity_tensor/*/value
/materials/*/elasticity_tensor/*/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/elasticity_tensor/*/unit
(string
)
/materials/*/elasticity_tensor/*/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the ValueType: SaintVenant
Description
Material Parameters including ID, E, nu, density (\(\rho\))Required
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/E
/materials/*/E
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/E/value
/materials/*/E/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/E/unit
(string
)
/materials/*/E/unit
Description
The unit of the Value/materials/*/nu
/materials/*/nu
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/nu/value
/materials/*/nu/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/nu/unit
(string
)
/materials/*/nu/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the Value/materials/*/phi
/materials/*/phi
Description
Value as a constant floatDefault: 0
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/phi/value
/materials/*/phi/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/phi/unit
(string
)
/materials/*/phi/unit
Description
The unit of the Value/materials/*/psi
/materials/*/psi
Description
Value as a constant floatDefault: 0
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/psi/value
/materials/*/psi/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/psi/unit
(string
)
/materials/*/psi/unit
Description
The unit of the ValueType: SaintVenant
Description
Material Parameters including ID, E, nu, density (\(\rho\))Required
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/elasticity_tensor
(list
)
/materials/*/elasticity_tensor
Description
Symmetric elasticity tensor/materials/*/elasticity_tensor/*
/materials/*/elasticity_tensor/*
Description
Value as a constant floatDefault: 0
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/elasticity_tensor/*/value
/materials/*/elasticity_tensor/*/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/elasticity_tensor/*/unit
(string
)
/materials/*/elasticity_tensor/*/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the Value/materials/*/phi
/materials/*/phi
Description
Value as a constant floatDefault: 0
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/phi/value
/materials/*/phi/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/phi/unit
(string
)
/materials/*/phi/unit
Description
The unit of the Value/materials/*/psi
/materials/*/psi
Description
Value as a constant floatDefault: 0
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/psi/value
/materials/*/psi/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/psi/unit
(string
)
/materials/*/psi/unit
Description
The unit of the ValueType: Stokes
Description
Material Parameters including ID, viscosity, density (\(\rho\))Required
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/viscosity
/materials/*/viscosity
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/viscosity/value
/materials/*/viscosity/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/viscosity/unit
(string
)
/materials/*/viscosity/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the ValueType: NavierStokes
Description
Material Parameters including ID, viscosity, density (\(\rho\))Required
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/viscosity
/materials/*/viscosity
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/viscosity/value
/materials/*/viscosity/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/viscosity/unit
(string
)
/materials/*/viscosity/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the ValueType: OperatorSplitting
Description
Material Parameters including ID, viscosity, density (\(\rho\))Required
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/viscosity
/materials/*/viscosity
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/viscosity/value
/materials/*/viscosity/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/viscosity/unit
(string
)
/materials/*/viscosity/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the ValueType: IncompressibleLinearElasticity
Description
Material Parameters including ID, Young’s modulus (\(E\)), Poisson’s ratio (\(\nu\)), density (\(\rho\))Required
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/E
/materials/*/E
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/E/value
/materials/*/E/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/E/unit
(string
)
/materials/*/E/unit
Description
The unit of the Value/materials/*/nu
/materials/*/nu
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/nu/value
/materials/*/nu/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/nu/unit
(string
)
/materials/*/nu/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the ValueType: IncompressibleLinearElasticity
Description
Material Parameters including ID, Lamé first (\(\lambda\)), Lamé second (\(\mu\)), density (\(\rho\))Required
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/lambda
/materials/*/lambda
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/lambda/value
/materials/*/lambda/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/lambda/unit
(string
)
/materials/*/lambda/unit
Description
The unit of the Value/materials/*/mu
/materials/*/mu
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/mu/value
/materials/*/mu/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/mu/unit
(string
)
/materials/*/mu/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the ValueType: Laplacian
Description
Material Parameters including ID, density (\(\rho\))Required
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
Optional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the ValueType: Helmholtz
Description
Material Parameters including ID, k, density (\(\rho\))Required
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/k
/materials/*/k
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/k/value
/materials/*/k/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/k/unit
(string
)
/materials/*/k/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the ValueType: Bilaplacian
Description
Material Parameters including ID, density (\(\rho\))Required
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
Optional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the ValueType: AMIPS
Description
Material Parameters including IDRequired
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
Optional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the ValueType: AMIPSAutodiff
Description
Material Parameters including IDRequired
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
Optional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the ValueType: FixedCorotational
Description
Material Parameters including IDRequired
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/E
/materials/*/E
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/E/value
/materials/*/E/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/E/unit
(string
)
/materials/*/E/unit
Description
The unit of the Value/materials/*/nu
/materials/*/nu
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/nu/value
/materials/*/nu/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/nu/unit
(string
)
/materials/*/nu/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the Value/materials/*/phi
/materials/*/phi
Description
Value as a constant floatDefault: 0
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/phi/value
/materials/*/phi/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/phi/unit
(string
)
/materials/*/phi/unit
Description
The unit of the Value/materials/*/psi
/materials/*/psi
Description
Value as a constant floatDefault: 0
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/psi/value
/materials/*/psi/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/psi/unit
(string
)
/materials/*/psi/unit
Description
The unit of the ValueType: FixedCorotational
Description
Material Parameters including IDRequired
/materials/*/type
(string
)
/materials/*/type
Description
Type of materialOptions: ['LinearElasticity', 'HookeLinearElasticity', 'SaintVenant', 'NeoHookean', 'MooneyRivlin', 'MooneyRivlin3Param', 'MooneyRivlin3ParamSymbolic', 'UnconstrainedOgden', 'IncompressibleOgden', 'Stokes', 'NavierStokes', 'OperatorSplitting', 'IncompressibleLinearElasticity', 'Laplacian', 'Helmholtz', 'Bilaplacian', 'AMIPS', 'AMIPSAutodiff', 'FixedCorotational']
/materials/*/lambda
/materials/*/lambda
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/lambda/value
/materials/*/lambda/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/lambda/unit
(string
)
/materials/*/lambda/unit
Description
The unit of the Value/materials/*/mu
/materials/*/mu
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/mu/value
/materials/*/mu/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/mu/unit
(string
)
/materials/*/mu/unit
Description
The unit of the ValueOptional
/materials/*/id
/materials/*/id
Description
Volume selection IDDefault: 0
Description
Volume selection IDs/materials/*/id/*
(int
)
/materials/*/id/*
Description
Volume selection ID/materials/*/rho
/materials/*/rho
Description
Value as a constant floatDefault: 1
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/rho/value
/materials/*/rho/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/rho/unit
(string
)
/materials/*/rho/unit
Description
The unit of the Value/materials/*/phi
/materials/*/phi
Description
Value as a constant floatDefault: 0
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/phi/value
/materials/*/phi/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/phi/unit
(string
)
/materials/*/phi/unit
Description
The unit of the Value/materials/*/psi
/materials/*/psi
Description
Value as a constant floatDefault: 0
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/materials/*/psi/value
/materials/*/psi/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/materials/*/psi/unit
(string
)
/materials/*/psi/unit
Description
The unit of the ValueOptional
/units
(object
)
/units
Description
Basic units used in the code.Default: None
Optional
/units/length
(string
)
/units/length
Description
Length unit.Default: 'm'
/units/mass
(string
)
/units/mass
Description
Mass unit.Default: 'kg'
/units/time
(string
)
/units/time
Description
Time unit.Default: 's'
/units/characteristic_length
(float
)
/units/characteristic_length
Description
Characteristic length, used for tolerances.Default: 1
/preset_problem
/preset_problem
Type: Linear
Description
TODODefault: 'skip'
Required
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: Quadratic
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: Cubic
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: Sine
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: Franke
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: FrankeOld
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: GenericScalarExact
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Optional
/preset_problem/func
(int
)
/preset_problem/func
Description
TODODefault: 0
Type: Zero_BC
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: Elastic
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: Walk
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: TorsionElastic
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Optional
/preset_problem/axis_coordiante
(int
)
/preset_problem/axis_coordiante
Description
TODODefault: 2
/preset_problem/n_turns
(float
)
/preset_problem/n_turns
Description
TODODefault: 0.5
/preset_problem/fixed_boundary
(int
)
/preset_problem/fixed_boundary
Description
TODODefault: 5
/preset_problem/turning_boundary
(int
)
/preset_problem/turning_boundary
Description
TODODefault: 6
/preset_problem/bbox_center
(list
)
/preset_problem/bbox_center
Description
TODO/preset_problem/bbox_center/*
(float
)
/preset_problem/bbox_center/*
Description
TODODefault: 0
Type: DoubleTorsionElastic
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Optional
/preset_problem/axis_coordiante0
(int
)
/preset_problem/axis_coordiante0
Description
TODODefault: 2
/preset_problem/axis_coordiante1
(int
)
/preset_problem/axis_coordiante1
Description
TODODefault: 2
/preset_problem/angular_v0
(float
)
/preset_problem/angular_v0
Description
TODODefault: 0.5
/preset_problem/angular_v1
(float
)
/preset_problem/angular_v1
Description
TODODefault: -0.5
/preset_problem/turning_boundary0
(int
)
/preset_problem/turning_boundary0
Description
TODODefault: 5
/preset_problem/turning_boundary1
(int
)
/preset_problem/turning_boundary1
Description
TODODefault: 6
/preset_problem/bbox_center
(list
)
/preset_problem/bbox_center
Description
TODO/preset_problem/bbox_center/*
(float
)
/preset_problem/bbox_center/*
Description
TODODefault: 0
Type: ElasticZeroBC
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: ElasticExact
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: ElasticCantileverExact
Description
TODO, add displacement, E, nu, formulation, mesh_sizeRequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: CompressionElasticExact
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: QuadraticElasticExact
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: LinearElasticExact
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: PointBasedTensor
Description
TODO, add optionalsRequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: Kernel
Description
TODO, add optionalsRequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Optional
/preset_problem/formulation
(string
)
/preset_problem/formulation
Description
TODODefault: ''
/preset_problem/n_kernels
(int
)
/preset_problem/n_kernels
Description
TODODefault: 0
/preset_problem/kernel_distance
(float
)
/preset_problem/kernel_distance
Description
TODODefault: 0
/preset_problem/kernel_weights
(string
)
/preset_problem/kernel_weights
Description
TODODefault: ''
Type: Node
Description
TODO, add optionalsRequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: TimeDependentScalar
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: MinSurf
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: Gravity
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Optional
Type: ConstantVelocity
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: TwoSpheres
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: DrivenCavity
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: DrivenCavityC0
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: DrivenCavitySmooth
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: Flow
Description
TODO, add inflow, outflow, inflow_amout, outflow_amout, direction, obstacleRequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: FlowWithObstacle
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Optional
Type: CornerFlow
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Optional
Type: UnitFlowWithObstacle
Description
TODO, add inflow_id, direction, no_slipRequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Optional
Type: StokesLaw
Description
TODO, add radiusRequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Optional
/preset_problem/viscosity
(float
)
/preset_problem/viscosity
Description
TODODefault: 1
Type: TaylorGreenVortex
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Optional
/preset_problem/viscosity
(float
)
/preset_problem/viscosity
Description
TODODefault: 1
Type: SimpleStokeProblemExact
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Optional
/preset_problem/func
(int
)
/preset_problem/func
Description
TODODefault: 0
Type: SineStokeProblemExact
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: TransientStokeProblemExact
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Optional
/preset_problem/func
(int
)
/preset_problem/func
Description
TODODefault: 0
/preset_problem/viscosity
(float
)
/preset_problem/viscosity
Description
TODODefault: 1
Type: Kovnaszy
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Optional
/preset_problem/viscosity
(float
)
/preset_problem/viscosity
Description
TODODefault: 1
Type: Airfoil
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Optional
Type: Lshape
Description
TODORequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Optional
Type: TestProblem
Description
TODO, type, omega, is_scalarRequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
Type: BilaplacianProblemWithSolution
Description
TODO, type, omega, is_scalarRequired
/preset_problem/type
(string
)
/preset_problem/type
Description
Type of preset problem to use.Options: ['Linear', 'Quadratic', 'Cubic', 'Sine', 'Franke', 'FrankeOld', 'GenericScalarExact', 'Zero_BC', 'Elastic', 'Walk', 'TorsionElastic', 'DoubleTorsionElastic', 'ElasticZeroBC', 'ElasticExact', 'ElasticCantileverExact', 'CompressionElasticExact', 'QuadraticElasticExact', 'LinearElasticExact', 'PointBasedTensor', 'Kernel', 'Node', 'TimeDependentScalar', 'MinSurf', 'Gravity', 'ConstantVelocity', 'TwoSpheres', 'DrivenCavity', 'DrivenCavityC0', 'DrivenCavitySmooth', 'Flow', 'FlowWithObstacle', 'CornerFlow', 'UnitFlowWithObstacle', 'StokesLaw', 'TaylorGreenVortex', 'SimpleStokeProblemExact', 'SineStokeProblemExact', 'TransientStokeProblemExact', 'Kovnaszy', 'Airfoil', 'Lshape', 'TestProblem', 'BilaplacianProblemWithSolution']
/common
(file
)
/common
Description
Path to common settings will patch the current file.Default: ''
Extensions: ['.json']
/root_path
(string
)
/root_path
Description
Path for all relative paths, set automatically to the folder containing this JSON.Default: ''
/space
(object
)
/space
Description
Options related to the FE space.Default: None
Optional
/space/discr_order
/space/discr_order
Description
Lagrange element order for the space for the main unknown, for all elements.Default: 1
Description
Path to file containing Lagrange element order for the space for the main unknown per element.Extensions: ['.txt', '.bin']
Description
List of Lagrange element order for the space for the main unknown with volume IDs./space/discr_order/*
(object
)
/space/discr_order/*
Description
Lagrange element order for the a space tagged with volume ID for the main unknown.Required
/space/discr_order/*/id
/space/discr_order/*/id
Description
Volume selection ID to apply the discr_order to.Description
List of volume selection IDs to apply the discr_order to./space/discr_order/*/id/*
(int
)
/space/discr_order/*/id/*
Description
Volume selection ID to apply the discr_order to./space/discr_order/*/order
(int
)
/space/discr_order/*/order
Description
Lagrange element order for the space for the main unknown, for all elements./space/pressure_discr_order
(int
)
/space/pressure_discr_order
Description
Lagrange element order for the space for the pressure unknown, for all elements.Default: 1
/space/basis_type
(string
)
/space/basis_type
Description
Type of basis to use for non polygonal element, one of Lagrange, Spline, or Serendipity. Spline or Serendipity work only for quad/hex meshesDefault: 'Lagrange'
Options: ['Lagrange', 'Spline', 'Serendipity']
/space/poly_basis_type
(string
)
/space/poly_basis_type
Description
Type of basis to use for a polygonal element, one of MFSHarmonic, MeanValue, or Wachspress see ‘PolySpline..’ paper for details.Default: 'MFSHarmonic'
Options: ['MFSHarmonic', 'MeanValue', 'Wachspress']
/space/use_p_ref
(bool
)
/space/use_p_ref
Description
Perform a priori p-refinement based on element shape, as described in ‘Decoupling..’ paper.Default: False
/space/remesh
(object
)
/space/remesh
Description
Settings for adaptive remeshingDefault: None
Optional
/space/remesh/enabled
(bool
)
/space/remesh/enabled
Description
Whether to do adaptive remeshingDefault: False
/space/remesh/split
(object
)
/space/remesh/split
Description
Settings for adaptive remeshing edge splitting operationsDefault: None
Optional
/space/remesh/split/enabled
(bool
)
/space/remesh/split/enabled
Description
Whether to do edge splitting in adaptive remeshingDefault: True
/space/remesh/split/acceptance_tolerance
(float
)
/space/remesh/split/acceptance_tolerance
Description
Accept split operation if energy decreased by at least xDefault: 0.001
Range: [0, inf]
/space/remesh/split/culling_threshold
(float
)
/space/remesh/split/culling_threshold
Description
Split operation culling threshold on energyDefault: 0.95
Range: [0, 1]
/space/remesh/split/max_depth
(int
)
/space/remesh/split/max_depth
Description
Maximum depth split per time-stepDefault: 3
Range: [1, inf]
/space/remesh/split/min_edge_length
(float
)
/space/remesh/split/min_edge_length
Description
Minimum edge length to splitDefault: 1e-06
Range: [0, inf]
/space/remesh/collapse
(object
)
/space/remesh/collapse
Description
Settings for adaptive remeshing edge collapse operationsDefault: None
Optional
/space/remesh/collapse/enabled
(bool
)
/space/remesh/collapse/enabled
Description
Whether to do edge collapse in adaptive remeshingDefault: True
/space/remesh/collapse/acceptance_tolerance
(float
)
/space/remesh/collapse/acceptance_tolerance
Description
Accept collapse operation if energy decreased by at least xDefault: -1e-08
Range: [-inf, 0]
/space/remesh/collapse/culling_threshold
(float
)
/space/remesh/collapse/culling_threshold
Description
Collapse operation culling threshold on energyDefault: 0.01
Range: [0, 1]
/space/remesh/collapse/max_depth
(int
)
/space/remesh/collapse/max_depth
Description
Maximum depth collapse per time-stepDefault: 3
Range: [1, inf]
/space/remesh/collapse/rel_max_edge_length
(float
)
/space/remesh/collapse/rel_max_edge_length
Description
Length of maximum edge length to collapse relative to initial minimum edge lengthDefault: 1
Range: [0, inf]
/space/remesh/collapse/abs_max_edge_length
(float
)
/space/remesh/collapse/abs_max_edge_length
Description
Length of maximum edge length to collapse in absolute units of distanceDefault: 1e+100
Range: [0, inf]
/space/remesh/swap
(object
)
/space/remesh/swap
Description
Settings for adaptive remeshing edge/face swap operationsDefault: None
Optional
/space/remesh/swap/enabled
(bool
)
/space/remesh/swap/enabled
Description
Whether to do edge/face swap in adaptive remeshingDefault: False
/space/remesh/swap/acceptance_tolerance
(float
)
/space/remesh/swap/acceptance_tolerance
Description
Accept swap operation if energy decreased by at least xDefault: -1e-08
Range: [-inf, 0]
/space/remesh/swap/max_depth
(int
)
/space/remesh/swap/max_depth
Description
Maximum depth swap per time-stepDefault: 3
Range: [1, inf]
/space/remesh/smooth
(object
)
/space/remesh/smooth
Description
Settings for adaptive remeshing vertex smoothing operationsDefault: None
Optional
/space/remesh/smooth/enabled
(bool
)
/space/remesh/smooth/enabled
Description
Whether to do vertex smoothing in adaptive remeshingDefault: False
/space/remesh/smooth/acceptance_tolerance
(float
)
/space/remesh/smooth/acceptance_tolerance
Description
Accept smooth operation if energy decreased by at least xDefault: -1e-08
Range: [-inf, 0]
/space/remesh/smooth/max_iters
(int
)
/space/remesh/smooth/max_iters
Description
Maximum number of smoothing iterations per time-stepDefault: 1
Range: [1, inf]
/space/remesh/local_relaxation
(object
)
/space/remesh/local_relaxation
Description
Settings for adaptive remeshing local relaxationDefault: None
Optional
/space/remesh/local_relaxation/local_mesh_n_ring
(int
)
/space/remesh/local_relaxation/local_mesh_n_ring
Description
Size of n-ring for local relaxationDefault: 2
/space/remesh/local_relaxation/local_mesh_rel_area
(float
)
/space/remesh/local_relaxation/local_mesh_rel_area
Description
Minimum area for local relaxationDefault: 0.01
/space/remesh/local_relaxation/max_nl_iterations
(int
)
/space/remesh/local_relaxation/max_nl_iterations
Description
Maximum number of nonlinear solver iterations before acceptance checkDefault: 1
/space/remesh/type
(string
)
/space/remesh/type
Description
Type of adaptive remeshing to use.Default: 'physics'
Options: ['physics', 'sizing_field']
/space/advanced
(object
)
/space/advanced
Description
Advanced settings for the FE space.Default: None
Optional
/space/advanced/discr_order_max
(int
)
/space/advanced/discr_order_max
Description
Maximal discretization order in adaptive p-refinement and hp-refinementDefault: 4
/space/advanced/isoparametric
(bool
)
/space/advanced/isoparametric
Description
Forces geometric map basis to be the same degree as the main variable basis, irrespective of the degree associated with the geom. map degrees associated with the elements of the geometry.Default: False
/space/advanced/bc_method
(string
)
/space/advanced/bc_method
Description
Method for imposing analytic Dirichet boundary conditions. If ‘lsq’ (least-squares fit), then the bc function is sampled at quadrature points, and the FEspace nodal values on the boundary are determined by minimizing L2 norm of the difference. If ‘sample’, then the analytic bc function is sampled at the boundary nodes.Default: 'sample'
Options: ['lsq', 'sample']
/space/advanced/n_boundary_samples
(int
)
/space/advanced/n_boundary_samples
Description
Per-element number of boundary samples for analytic Dirichlet and Neumann boundary conditions.Default: -1
/space/advanced/quadrature_order
(int
)
/space/advanced/quadrature_order
Description
Minimal quadrature order to use in matrix and rhs assembly; the actual order is determined as min(2*(p-1)+1,quadrature_order).Default: -1
/space/advanced/mass_quadrature_order
(int
)
/space/advanced/mass_quadrature_order
Description
Minimal quadrature order to use in mass matrix assembler; the actual order is determined as min(2*p+1,quadrature_order)Default: -1
/space/advanced/integral_constraints
(int
)
/space/advanced/integral_constraints
Description
Number of constraints for non-conforming polygonal basis; 0, 1, or 2; see ‘PolySpline..’ paper for details.Default: 2
/space/advanced/n_harmonic_samples
(int
)
/space/advanced/n_harmonic_samples
Description
If MFSHarmonics is used for a polygonal element, number of collocation samples used in the basis construction;see ‘PolySpline..’ paper for details.Default: 10
/space/advanced/force_no_ref_for_harmonic
(bool
)
/space/advanced/force_no_ref_for_harmonic
Description
If true, do not do uniform global refinement if the mesh contains polygonal elements.Default: False
/space/advanced/B
(int
)
/space/advanced/B
Description
The target deviation of the error on elements from perfect element error, for a priori geometry-dependent p-refinement, see ‘Decoupling .. ‘ paper.Default: 3
/space/advanced/h1_formula
(bool
)
/space/advanced/h1_formula
Description
Default: False
/space/advanced/count_flipped_els
(bool
)
/space/advanced/count_flipped_els
Description
Count the number of elements with Jacobian of the geometric map not positive at quadrature points.Default: True
/space/advanced/use_particle_advection
(bool
)
/space/advanced/use_particle_advection
Description
Use particle advection in splitting method for solving NS equation.Default: False
/time
/time
Description
The time parameters: start timet0
, end time tend
, time step dt
.
Default: 'skip'
Required
/time/tend
(float
)
/time/tend
Description
Ending timeRange: [0, inf]
/time/dt
(float
)
/time/dt
Description
Time step size \(\Delta t\)Range: [0, inf]
Optional
/time/t0
(float
)
/time/t0
Description
Startning timeDefault: 0
Range: [0, inf]
/time/integrator
/time/integrator
Description
Time integratorDefault: 'ImplicitEuler'
Options: ['ImplicitEuler', 'BDF1', 'BDF2', 'BDF3', 'BDF4', 'BDF5', 'BDF6', 'ImplicitNewmark']
Type: ImplicitEuler
Description
Implicit Euler time integrationRequired
/time/integrator/type
(string
)
/time/integrator/type
Description
Type of time integrator to useOptions: ['ImplicitEuler', 'BDF', 'ImplicitNewmark']
Type: BDF
Description
Backwards differentiation formula time integrationRequired
/time/integrator/type
(string
)
/time/integrator/type
Description
Type of time integrator to useOptions: ['ImplicitEuler', 'BDF', 'ImplicitNewmark']
Optional
/time/integrator/steps
(int
)
/time/integrator/steps
Description
BDF orderDefault: 1
Range: [1, 6]
Type: ImplicitNewmark
Description
Implicit Newmark time integrationRequired
/time/integrator/type
(string
)
/time/integrator/type
Description
Type of time integrator to useOptions: ['ImplicitEuler', 'BDF', 'ImplicitNewmark']
Optional
/time/integrator/gamma
(float
)
/time/integrator/gamma
Description
Newmark gammaDefault: 0.5
Range: [0, 1]
/time/integrator/beta
(float
)
/time/integrator/beta
Description
Newmark betaDefault: 0.25
Range: [0, 0.5]
/time/quasistatic
(bool
)
/time/quasistatic
Description
Ignore inertia in time dependent. Used for doing incremental load.Default: False
Description
The time parameters: start timet0
, time step dt
, number of time steps.
Required
/time/time_steps
(int
)
/time/time_steps
Description
Number of time stepsRange: [0, inf]
/time/dt
(float
)
/time/dt
Description
Time step size \(\Delta t\)Range: [0, inf]
Optional
/time/t0
(float
)
/time/t0
Description
Startning timeDefault: 0
Range: [0, inf]
/time/integrator
/time/integrator
Description
Time integratorDefault: 'ImplicitEuler'
Options: ['ImplicitEuler', 'BDF1', 'BDF2', 'BDF3', 'BDF4', 'BDF5', 'BDF6', 'ImplicitNewmark']
Type: ImplicitEuler
Description
Implicit Euler time integrationRequired
/time/integrator/type
(string
)
/time/integrator/type
Description
Type of time integrator to useOptions: ['ImplicitEuler', 'BDF', 'ImplicitNewmark']
Type: BDF
Description
Backwards differentiation formula time integrationRequired
/time/integrator/type
(string
)
/time/integrator/type
Description
Type of time integrator to useOptions: ['ImplicitEuler', 'BDF', 'ImplicitNewmark']
Optional
/time/integrator/steps
(int
)
/time/integrator/steps
Description
BDF orderDefault: 1
Range: [1, 6]
Type: ImplicitNewmark
Description
Implicit Newmark time integrationRequired
/time/integrator/type
(string
)
/time/integrator/type
Description
Type of time integrator to useOptions: ['ImplicitEuler', 'BDF', 'ImplicitNewmark']
Optional
/time/integrator/gamma
(float
)
/time/integrator/gamma
Description
Newmark gammaDefault: 0.5
Range: [0, 1]
/time/integrator/beta
(float
)
/time/integrator/beta
Description
Newmark betaDefault: 0.25
Range: [0, 0.5]
/time/quasistatic
(bool
)
/time/quasistatic
Description
Ignore inertia in time dependent. Used for doing incremental load.Default: False
Description
The time parameters: start timet0
, end time tend
, number of time steps.
Required
/time/time_steps
(int
)
/time/time_steps
Description
Number of time stepsRange: [0, inf]
/time/tend
(float
)
/time/tend
Description
Ending timeRange: [0, inf]
Optional
/time/t0
(float
)
/time/t0
Description
Startning timeDefault: 0
Range: [0, inf]
/time/integrator
/time/integrator
Description
Time integratorDefault: 'ImplicitEuler'
Options: ['ImplicitEuler', 'BDF1', 'BDF2', 'BDF3', 'BDF4', 'BDF5', 'BDF6', 'ImplicitNewmark']
Type: ImplicitEuler
Description
Implicit Euler time integrationRequired
/time/integrator/type
(string
)
/time/integrator/type
Description
Type of time integrator to useOptions: ['ImplicitEuler', 'BDF', 'ImplicitNewmark']
Type: BDF
Description
Backwards differentiation formula time integrationRequired
/time/integrator/type
(string
)
/time/integrator/type
Description
Type of time integrator to useOptions: ['ImplicitEuler', 'BDF', 'ImplicitNewmark']
Optional
/time/integrator/steps
(int
)
/time/integrator/steps
Description
BDF orderDefault: 1
Range: [1, 6]
Type: ImplicitNewmark
Description
Implicit Newmark time integrationRequired
/time/integrator/type
(string
)
/time/integrator/type
Description
Type of time integrator to useOptions: ['ImplicitEuler', 'BDF', 'ImplicitNewmark']
Optional
/time/integrator/gamma
(float
)
/time/integrator/gamma
Description
Newmark gammaDefault: 0.5
Range: [0, 1]
/time/integrator/beta
(float
)
/time/integrator/beta
Description
Newmark betaDefault: 0.25
Range: [0, 0.5]
/time/quasistatic
(bool
)
/time/quasistatic
Description
Ignore inertia in time dependent. Used for doing incremental load.Default: False
/contact
(object
)
/contact
Description
Contact handling parameters.Default: None
Optional
/contact/enabled
(bool
)
/contact/enabled
Description
True if contact handling is enabled.Default: False
/contact/dhat
(float
)
/contact/dhat
Description
Contact barrier activation distance.Default: 0.001
Range: [0, inf]
/contact/dhat_percentage
(float
)
/contact/dhat_percentage
Description
\(\hat{d}\) as percentage of the diagonal of the bounding boxDefault: 0.8
/contact/epsv
(float
)
/contact/epsv
Description
Friction smoothing parameter.Default: 0.001
Range: [0, inf]
/contact/friction_coefficient
(float
)
/contact/friction_coefficient
Description
Coefficient of friction (global)Default: 0
/contact/use_convergent_formulation
(bool
)
/contact/use_convergent_formulation
Description
Whether to use the convergent (area weighted) formulation of IPC.Default: False
/contact/collision_mesh
/contact/collision_mesh
Description
Load a preconstructed collision mesh.Default: 'skip'
Required
/contact/collision_mesh/mesh
(string
)
/contact/collision_mesh/mesh
Description
Path to preconstructed collision mesh./contact/collision_mesh/linear_map
(string
)
/contact/collision_mesh/linear_map
Description
HDF file storing the linear mapping of displacements.Optional
/contact/collision_mesh/enabled
(bool
)
/contact/collision_mesh/enabled
Description
Default: True
Description
Construct a collision mesh with a maximum edge length.Required
/contact/collision_mesh/max_edge_length
(float
)
/contact/collision_mesh/max_edge_length
Description
Maximum edge length to use for building the collision mesh.Optional
/contact/collision_mesh/tessellation_type
(string
)
/contact/collision_mesh/tessellation_type
Description
Type of tessellation to use for building the collision mesh.Default: 'regular'
Options: ['regular', 'irregular']
/contact/collision_mesh/enabled
(bool
)
/contact/collision_mesh/enabled
Description
Default: True
/contact/periodic
(bool
)
/contact/periodic
Description
Set to true to check collision between adjacent periodic cells.Default: False
/solver
(object
)
/solver
Description
The settings for the solver including linear solver, nonlinear solver, and some advanced options.Default: None
Optional
/solver/max_threads
(int
)
/solver/max_threads
Description
Maximum number of threads used; 0 is unlimited.Default: 0
Range: [0, inf]
/solver/linear
(object
)
/solver/linear
Description
Settings for the linear solver.Default: None
Optional
/solver/linear/enable_overwrite_solver
(bool
)
/solver/linear/enable_overwrite_solver
Description
If solver name is not present, falls back to defaultDefault: False
/solver/linear/solver
(string
)
/solver/linear/solver
Description
Linear solver type.Default: ''
Options: ['Eigen::SimplicialLDLT', 'Eigen::SparseLU', 'Eigen::CholmodSupernodalLLT', 'Eigen::UmfPackLU', 'Eigen::SuperLU', 'Eigen::PardisoLDLT', 'Eigen::PardisoLLT', 'Eigen::PardisoLU', 'Pardiso', 'Hypre', 'AMGCL', 'Eigen::LeastSquaresConjugateGradient', 'Eigen::DGMRES', 'Eigen::ConjugateGradient', 'Eigen::BiCGSTAB', 'Eigen::GMRES', 'Eigen::MINRES']
/solver/linear/precond
(string
)
/solver/linear/precond
Description
Preconditioner used if using an iterative linear solver.Default: ''
Options: ['Eigen::IdentityPreconditioner', 'Eigen::DiagonalPreconditioner', 'Eigen::IncompleteCholesky', 'Eigen::LeastSquareDiagonalPreconditioner', 'Eigen::IncompleteLUT']
/solver/linear/Eigen::LeastSquaresConjugateGradient
(object
)
/solver/linear/Eigen::LeastSquaresConjugateGradient
Description
Settings for the Eigen’s Least Squares Conjugate Gradient solver.Default: None
Optional
/solver/linear/Eigen::LeastSquaresConjugateGradient/max_iter
(int
)
/solver/linear/Eigen::LeastSquaresConjugateGradient/max_iter
Description
Maximum number of iterations.Default: 1000
/solver/linear/Eigen::LeastSquaresConjugateGradient/tolerance
(float
)
/solver/linear/Eigen::LeastSquaresConjugateGradient/tolerance
Description
Convergence tolerance.Default: 1e-12
/solver/linear/Eigen::DGMRES
(object
)
/solver/linear/Eigen::DGMRES
Description
Settings for the Eigen’s DGMRES solver.Default: None
Optional
/solver/linear/Eigen::DGMRES/max_iter
(int
)
/solver/linear/Eigen::DGMRES/max_iter
Description
Maximum number of iterations.Default: 1000
/solver/linear/Eigen::DGMRES/tolerance
(float
)
/solver/linear/Eigen::DGMRES/tolerance
Description
Convergence tolerance.Default: 1e-12
/solver/linear/Eigen::ConjugateGradient
(object
)
/solver/linear/Eigen::ConjugateGradient
Description
Settings for the Eigen’s Conjugate Gradient solver.Default: None
Optional
/solver/linear/Eigen::ConjugateGradient/max_iter
(int
)
/solver/linear/Eigen::ConjugateGradient/max_iter
Description
Maximum number of iterations.Default: 1000
/solver/linear/Eigen::ConjugateGradient/tolerance
(float
)
/solver/linear/Eigen::ConjugateGradient/tolerance
Description
Convergence tolerance.Default: 1e-12
/solver/linear/Eigen::BiCGSTAB
(object
)
/solver/linear/Eigen::BiCGSTAB
Description
Settings for the Eigen’s BiCGSTAB solver.Default: None
Optional
/solver/linear/Eigen::BiCGSTAB/max_iter
(int
)
/solver/linear/Eigen::BiCGSTAB/max_iter
Description
Maximum number of iterations.Default: 1000
/solver/linear/Eigen::BiCGSTAB/tolerance
(float
)
/solver/linear/Eigen::BiCGSTAB/tolerance
Description
Convergence tolerance.Default: 1e-12
/solver/linear/Eigen::GMRES
(object
)
/solver/linear/Eigen::GMRES
Description
Settings for the Eigen’s GMRES solver.Default: None
Optional
/solver/linear/Eigen::GMRES/max_iter
(int
)
/solver/linear/Eigen::GMRES/max_iter
Description
Maximum number of iterations.Default: 1000
/solver/linear/Eigen::GMRES/tolerance
(float
)
/solver/linear/Eigen::GMRES/tolerance
Description
Convergence tolerance.Default: 1e-12
/solver/linear/Eigen::MINRES
(object
)
/solver/linear/Eigen::MINRES
Description
Settings for the Eigen’s MINRES solver.Default: None
Optional
/solver/linear/Eigen::MINRES/max_iter
(int
)
/solver/linear/Eigen::MINRES/max_iter
Description
Maximum number of iterations.Default: 1000
/solver/linear/Eigen::MINRES/tolerance
(float
)
/solver/linear/Eigen::MINRES/tolerance
Description
Convergence tolerance.Default: 1e-12
/solver/linear/Pardiso
(object
)
/solver/linear/Pardiso
Description
Settings for the Pardiso solver.Default: None
Optional
/solver/linear/Pardiso/mtype
(int
)
/solver/linear/Pardiso/mtype
Description
Matrix type.Default: 11
Options: [1, 2, -2, 3, 4, -4, 6, 11, 13]
/solver/linear/Hypre
(object
)
/solver/linear/Hypre
Description
Settings for the Hypre solver.Default: None
Optional
/solver/linear/Hypre/max_iter
(int
)
/solver/linear/Hypre/max_iter
Description
Maximum number of iterations.Default: 1000
/solver/linear/Hypre/pre_max_iter
(int
)
/solver/linear/Hypre/pre_max_iter
Description
Maximum number of pre iterations.Default: 1
/solver/linear/Hypre/tolerance
(float
)
/solver/linear/Hypre/tolerance
Description
Convergence tolerance.Default: 1e-10
/solver/linear/AMGCL
(object
)
/solver/linear/AMGCL
Description
Settings for the AMGCL solver.Default: None
Optional
/solver/linear/AMGCL/solver
(object
)
/solver/linear/AMGCL/solver
Description
Solver settings for the AMGCL.Default: None
Optional
/solver/linear/AMGCL/solver/tol
(float
)
/solver/linear/AMGCL/solver/tol
Description
Convergence tolerance.Default: 1e-10
/solver/linear/AMGCL/solver/maxiter
(int
)
/solver/linear/AMGCL/solver/maxiter
Description
Maximum number of iterations.Default: 1000
/solver/linear/AMGCL/solver/type
(string
)
/solver/linear/AMGCL/solver/type
Description
Type of solver to use.Default: 'cg'
/solver/linear/AMGCL/precond
(object
)
/solver/linear/AMGCL/precond
Description
Preconditioner settings for the AMGCL.Default: None
Optional
/solver/linear/AMGCL/precond/relax
(object
)
/solver/linear/AMGCL/precond/relax
Description
Preconditioner settings for the AMGCL.Default: None
Optional
/solver/linear/AMGCL/precond/relax/degree
(int
)
/solver/linear/AMGCL/precond/relax/degree
Description
Degree of the polynomial.Default: 16
/solver/linear/AMGCL/precond/relax/type
(string
)
/solver/linear/AMGCL/precond/relax/type
Description
Type of relaxation to use.Default: 'chebyshev'
/solver/linear/AMGCL/precond/relax/power_iters
(int
)
/solver/linear/AMGCL/precond/relax/power_iters
Description
Number of power iterations.Default: 100
/solver/linear/AMGCL/precond/relax/higher
(float
)
/solver/linear/AMGCL/precond/relax/higher
Description
Higher level relaxation.Default: 2
/solver/linear/AMGCL/precond/relax/lower
(float
)
/solver/linear/AMGCL/precond/relax/lower
Description
Lower level relaxation.Default: 0.008333333333
/solver/linear/AMGCL/precond/relax/scale
(bool
)
/solver/linear/AMGCL/precond/relax/scale
Description
Scale.Default: True
/solver/linear/AMGCL/precond/class
(string
)
/solver/linear/AMGCL/precond/class
Description
Type of preconditioner to use.Default: 'amg'
/solver/linear/AMGCL/precond/max_levels
(int
)
/solver/linear/AMGCL/precond/max_levels
Description
Maximum number of levels.Default: 6
/solver/linear/AMGCL/precond/direct_coarse
(bool
)
/solver/linear/AMGCL/precond/direct_coarse
Description
Use direct solver for the coarsest level.Default: False
/solver/linear/AMGCL/precond/ncycle
(int
)
/solver/linear/AMGCL/precond/ncycle
Description
Number of cycles.Default: 2
/solver/linear/AMGCL/precond/coarsening
(object
)
/solver/linear/AMGCL/precond/coarsening
Description
Coarsening parameters.Default: None
Optional
/solver/linear/AMGCL/precond/coarsening/type
(string
)
/solver/linear/AMGCL/precond/coarsening/type
Description
Coarsening type.Default: 'smoothed_aggregation'
/solver/linear/AMGCL/precond/coarsening/estimate_spectral_radius
(bool
)
/solver/linear/AMGCL/precond/coarsening/estimate_spectral_radius
Description
Should the spectral radius be estimated.Default: True
/solver/linear/AMGCL/precond/coarsening/relax
(float
)
/solver/linear/AMGCL/precond/coarsening/relax
Description
Coarsening relaxation.Default: 1
/solver/linear/AMGCL/precond/coarsening/aggr
(object
)
/solver/linear/AMGCL/precond/coarsening/aggr
Description
Aggregation settings.Default: None
Optional
/solver/linear/AMGCL/precond/coarsening/aggr/eps_strong
(float
)
/solver/linear/AMGCL/precond/coarsening/aggr/eps_strong
Description
Aggregation epsilon strong.Default: 0
/solver/adjoint_linear
(object
)
/solver/adjoint_linear
Description
Settings for the linear solver.Default: None
Optional
/solver/adjoint_linear/enable_overwrite_solver
(bool
)
/solver/adjoint_linear/enable_overwrite_solver
Description
If solver name is not present, falls back to defaultDefault: False
/solver/adjoint_linear/solver
(string
)
/solver/adjoint_linear/solver
Description
Linear solver type.Default: ''
Options: ['Eigen::SimplicialLDLT', 'Eigen::SparseLU', 'Eigen::CholmodSupernodalLLT', 'Eigen::UmfPackLU', 'Eigen::SuperLU', 'Eigen::PardisoLDLT', 'Eigen::PardisoLLT', 'Eigen::PardisoLU', 'Pardiso', 'Hypre', 'AMGCL', 'Eigen::LeastSquaresConjugateGradient', 'Eigen::DGMRES', 'Eigen::ConjugateGradient', 'Eigen::BiCGSTAB', 'Eigen::GMRES', 'Eigen::MINRES']
/solver/adjoint_linear/precond
(string
)
/solver/adjoint_linear/precond
Description
Preconditioner used if using an iterative linear solver.Default: ''
Options: ['Eigen::IdentityPreconditioner', 'Eigen::DiagonalPreconditioner', 'Eigen::IncompleteCholesky', 'Eigen::LeastSquareDiagonalPreconditioner', 'Eigen::IncompleteLUT']
/solver/adjoint_linear/Eigen::LeastSquaresConjugateGradient
(object
)
/solver/adjoint_linear/Eigen::LeastSquaresConjugateGradient
Description
Settings for the Eigen’s Least Squares Conjugate Gradient solver.Default: None
Optional
/solver/adjoint_linear/Eigen::LeastSquaresConjugateGradient/max_iter
(int
)
/solver/adjoint_linear/Eigen::LeastSquaresConjugateGradient/max_iter
Description
Maximum number of iterations.Default: 1000
/solver/adjoint_linear/Eigen::LeastSquaresConjugateGradient/tolerance
(float
)
/solver/adjoint_linear/Eigen::LeastSquaresConjugateGradient/tolerance
Description
Convergence tolerance.Default: 1e-12
/solver/adjoint_linear/Eigen::DGMRES
(object
)
/solver/adjoint_linear/Eigen::DGMRES
Description
Settings for the Eigen’s DGMRES solver.Default: None
Optional
/solver/adjoint_linear/Eigen::DGMRES/max_iter
(int
)
/solver/adjoint_linear/Eigen::DGMRES/max_iter
Description
Maximum number of iterations.Default: 1000
/solver/adjoint_linear/Eigen::DGMRES/tolerance
(float
)
/solver/adjoint_linear/Eigen::DGMRES/tolerance
Description
Convergence tolerance.Default: 1e-12
/solver/adjoint_linear/Eigen::ConjugateGradient
(object
)
/solver/adjoint_linear/Eigen::ConjugateGradient
Description
Settings for the Eigen’s Conjugate Gradient solver.Default: None
Optional
/solver/adjoint_linear/Eigen::ConjugateGradient/max_iter
(int
)
/solver/adjoint_linear/Eigen::ConjugateGradient/max_iter
Description
Maximum number of iterations.Default: 1000
/solver/adjoint_linear/Eigen::ConjugateGradient/tolerance
(float
)
/solver/adjoint_linear/Eigen::ConjugateGradient/tolerance
Description
Convergence tolerance.Default: 1e-12
/solver/adjoint_linear/Eigen::BiCGSTAB
(object
)
/solver/adjoint_linear/Eigen::BiCGSTAB
Description
Settings for the Eigen’s BiCGSTAB solver.Default: None
Optional
/solver/adjoint_linear/Eigen::BiCGSTAB/max_iter
(int
)
/solver/adjoint_linear/Eigen::BiCGSTAB/max_iter
Description
Maximum number of iterations.Default: 1000
/solver/adjoint_linear/Eigen::BiCGSTAB/tolerance
(float
)
/solver/adjoint_linear/Eigen::BiCGSTAB/tolerance
Description
Convergence tolerance.Default: 1e-12
/solver/adjoint_linear/Eigen::GMRES
(object
)
/solver/adjoint_linear/Eigen::GMRES
Description
Settings for the Eigen’s GMRES solver.Default: None
Optional
/solver/adjoint_linear/Eigen::GMRES/max_iter
(int
)
/solver/adjoint_linear/Eigen::GMRES/max_iter
Description
Maximum number of iterations.Default: 1000
/solver/adjoint_linear/Eigen::GMRES/tolerance
(float
)
/solver/adjoint_linear/Eigen::GMRES/tolerance
Description
Convergence tolerance.Default: 1e-12
/solver/adjoint_linear/Eigen::MINRES
(object
)
/solver/adjoint_linear/Eigen::MINRES
Description
Settings for the Eigen’s MINRES solver.Default: None
Optional
/solver/adjoint_linear/Eigen::MINRES/max_iter
(int
)
/solver/adjoint_linear/Eigen::MINRES/max_iter
Description
Maximum number of iterations.Default: 1000
/solver/adjoint_linear/Eigen::MINRES/tolerance
(float
)
/solver/adjoint_linear/Eigen::MINRES/tolerance
Description
Convergence tolerance.Default: 1e-12
/solver/adjoint_linear/Pardiso
(object
)
/solver/adjoint_linear/Pardiso
Description
Settings for the Pardiso solver.Default: None
Optional
/solver/adjoint_linear/Pardiso/mtype
(int
)
/solver/adjoint_linear/Pardiso/mtype
Description
Matrix type.Default: 11
Options: [1, 2, -2, 3, 4, -4, 6, 11, 13]
/solver/adjoint_linear/Hypre
(object
)
/solver/adjoint_linear/Hypre
Description
Settings for the Hypre solver.Default: None
Optional
/solver/adjoint_linear/Hypre/max_iter
(int
)
/solver/adjoint_linear/Hypre/max_iter
Description
Maximum number of iterations.Default: 1000
/solver/adjoint_linear/Hypre/pre_max_iter
(int
)
/solver/adjoint_linear/Hypre/pre_max_iter
Description
Maximum number of pre iterations.Default: 1
/solver/adjoint_linear/Hypre/tolerance
(float
)
/solver/adjoint_linear/Hypre/tolerance
Description
Convergence tolerance.Default: 1e-10
/solver/adjoint_linear/AMGCL
(object
)
/solver/adjoint_linear/AMGCL
Description
Settings for the AMGCL solver.Default: None
Optional
/solver/adjoint_linear/AMGCL/solver
(object
)
/solver/adjoint_linear/AMGCL/solver
Description
Solver settings for the AMGCL.Default: None
Optional
/solver/adjoint_linear/AMGCL/solver/tol
(float
)
/solver/adjoint_linear/AMGCL/solver/tol
Description
Convergence tolerance.Default: 1e-10
/solver/adjoint_linear/AMGCL/solver/maxiter
(int
)
/solver/adjoint_linear/AMGCL/solver/maxiter
Description
Maximum number of iterations.Default: 1000
/solver/adjoint_linear/AMGCL/solver/type
(string
)
/solver/adjoint_linear/AMGCL/solver/type
Description
Type of solver to use.Default: 'cg'
/solver/adjoint_linear/AMGCL/precond
(object
)
/solver/adjoint_linear/AMGCL/precond
Description
Preconditioner settings for the AMGCL.Default: None
Optional
/solver/adjoint_linear/AMGCL/precond/relax
(object
)
/solver/adjoint_linear/AMGCL/precond/relax
Description
Preconditioner settings for the AMGCL.Default: None
Optional
/solver/adjoint_linear/AMGCL/precond/relax/degree
(int
)
/solver/adjoint_linear/AMGCL/precond/relax/degree
Description
Degree of the polynomial.Default: 16
/solver/adjoint_linear/AMGCL/precond/relax/type
(string
)
/solver/adjoint_linear/AMGCL/precond/relax/type
Description
Type of relaxation to use.Default: 'chebyshev'
/solver/adjoint_linear/AMGCL/precond/relax/power_iters
(int
)
/solver/adjoint_linear/AMGCL/precond/relax/power_iters
Description
Number of power iterations.Default: 100
/solver/adjoint_linear/AMGCL/precond/relax/higher
(float
)
/solver/adjoint_linear/AMGCL/precond/relax/higher
Description
Higher level relaxation.Default: 2
/solver/adjoint_linear/AMGCL/precond/relax/lower
(float
)
/solver/adjoint_linear/AMGCL/precond/relax/lower
Description
Lower level relaxation.Default: 0.008333333333
/solver/adjoint_linear/AMGCL/precond/relax/scale
(bool
)
/solver/adjoint_linear/AMGCL/precond/relax/scale
Description
Scale.Default: True
/solver/adjoint_linear/AMGCL/precond/class
(string
)
/solver/adjoint_linear/AMGCL/precond/class
Description
Type of preconditioner to use.Default: 'amg'
/solver/adjoint_linear/AMGCL/precond/max_levels
(int
)
/solver/adjoint_linear/AMGCL/precond/max_levels
Description
Maximum number of levels.Default: 6
/solver/adjoint_linear/AMGCL/precond/direct_coarse
(bool
)
/solver/adjoint_linear/AMGCL/precond/direct_coarse
Description
Use direct solver for the coarsest level.Default: False
/solver/adjoint_linear/AMGCL/precond/ncycle
(int
)
/solver/adjoint_linear/AMGCL/precond/ncycle
Description
Number of cycles.Default: 2
/solver/adjoint_linear/AMGCL/precond/coarsening
(object
)
/solver/adjoint_linear/AMGCL/precond/coarsening
Description
Coarsening parameters.Default: None
Optional
/solver/adjoint_linear/AMGCL/precond/coarsening/type
(string
)
/solver/adjoint_linear/AMGCL/precond/coarsening/type
Description
Coarsening type.Default: 'smoothed_aggregation'
/solver/adjoint_linear/AMGCL/precond/coarsening/estimate_spectral_radius
(bool
)
/solver/adjoint_linear/AMGCL/precond/coarsening/estimate_spectral_radius
Description
Should the spectral radius be estimated.Default: True
/solver/adjoint_linear/AMGCL/precond/coarsening/relax
(float
)
/solver/adjoint_linear/AMGCL/precond/coarsening/relax
Description
Coarsening relaxation.Default: 1
/solver/adjoint_linear/AMGCL/precond/coarsening/aggr
(object
)
/solver/adjoint_linear/AMGCL/precond/coarsening/aggr
Description
Aggregation settings.Default: None
Optional
/solver/adjoint_linear/AMGCL/precond/coarsening/aggr/eps_strong
(float
)
/solver/adjoint_linear/AMGCL/precond/coarsening/aggr/eps_strong
Description
Aggregation epsilon strong.Default: 0
/solver/nonlinear
(object
)
/solver/nonlinear
Description
Settings for nonlinear solver. Interior-loop linear solver settings are defined in the solver/linear section.Default: None
Optional
/solver/nonlinear/solver
/solver/nonlinear/solver
Description
Nonlinear solver typeDefault: 'Newton'
Options: ['Newton', 'DenseNewton', 'GradientDescent', 'ADAM', 'StochasticADAM', 'StochasticGradientDescent', 'L-BFGS', 'BFGS', 'L-BFGS-B', 'MMA']
Description
List of solvers for ballback. Eg, [{‘type’:’Newton’}, {‘type’:’L-BFGS’}, {‘type’:’GradientDescent’}] will solve using Newton, in case of failure will fallback to L-BFGS and eventually to GradientDescent/solver/nonlinear/solver/*
/solver/nonlinear/solver/*
Type: Newton
Description
Options for Newton.Required
/solver/nonlinear/solver/*/type
(string
)
/solver/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/nonlinear/solver/*/residual_tolerance
(float
)
/solver/nonlinear/solver/*/residual_tolerance
Description
Tolerance of the linear system residual. If residual is above, the direction is rejected.Default: 1e-05
Type: ProjectedNewton
Description
Options for projected Newton.Required
/solver/nonlinear/solver/*/type
(string
)
/solver/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/nonlinear/solver/*/residual_tolerance
(float
)
/solver/nonlinear/solver/*/residual_tolerance
Description
Tolerance of the linear system residual. If residual is above, the direction is rejected.Default: 1e-05
Type: RegularizedNewton
Description
Options for regularized Newton.Required
/solver/nonlinear/solver/*/type
(string
)
/solver/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/nonlinear/solver/*/residual_tolerance
(float
)
/solver/nonlinear/solver/*/residual_tolerance
Description
Tolerance of the linear system residual. If residual is above, the direction is rejected.Default: 1e-05
/solver/nonlinear/solver/*/reg_weight_min
(float
)
/solver/nonlinear/solver/*/reg_weight_min
Description
Minimum regulariztion weight.Default: 1e-08
/solver/nonlinear/solver/*/reg_weight_max
(float
)
/solver/nonlinear/solver/*/reg_weight_max
Description
Maximum regulariztion weight.Default: 100000000.0
/solver/nonlinear/solver/*/reg_weight_inc
(float
)
/solver/nonlinear/solver/*/reg_weight_inc
Description
Regulariztion weight increment.Default: 10
Type: RegularizedProjectedNewton
Description
Options for regularized projected Newton.Required
/solver/nonlinear/solver/*/type
(string
)
/solver/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/nonlinear/solver/*/residual_tolerance
(float
)
/solver/nonlinear/solver/*/residual_tolerance
Description
Tolerance of the linear system residual. If residual is above, the direction is rejected.Default: 1e-05
/solver/nonlinear/solver/*/reg_weight_min
(float
)
/solver/nonlinear/solver/*/reg_weight_min
Description
Minimum regulariztion weight.Default: 1e-08
/solver/nonlinear/solver/*/reg_weight_max
(float
)
/solver/nonlinear/solver/*/reg_weight_max
Description
Maximum regulariztion weight.Default: 100000000.0
/solver/nonlinear/solver/*/reg_weight_inc
(float
)
/solver/nonlinear/solver/*/reg_weight_inc
Description
Regulariztion weight increment.Default: 10
Type: DenseNewton
Description
Options for Newton.Required
/solver/nonlinear/solver/*/type
(string
)
/solver/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/nonlinear/solver/*/residual_tolerance
(float
)
/solver/nonlinear/solver/*/residual_tolerance
Description
Tolerance of the linear system residual. If residual is above, the direction is rejected.Default: 1e-05
Type: DenseProjectedNewton
Description
Options for projected Newton.Required
/solver/nonlinear/solver/*/type
(string
)
/solver/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/nonlinear/solver/*/residual_tolerance
(float
)
/solver/nonlinear/solver/*/residual_tolerance
Description
Tolerance of the linear system residual. If residual is above, the direction is rejected.Default: 1e-05
Type: DenseRegularizedNewton
Description
Options for regularized Newton.Required
/solver/nonlinear/solver/*/type
(string
)
/solver/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/nonlinear/solver/*/residual_tolerance
(float
)
/solver/nonlinear/solver/*/residual_tolerance
Description
Tolerance of the linear system residual. If residual is above, the direction is rejected.Default: 1e-05
/solver/nonlinear/solver/*/reg_weight_min
(float
)
/solver/nonlinear/solver/*/reg_weight_min
Description
Minimum regulariztion weight.Default: 1e-08
/solver/nonlinear/solver/*/reg_weight_max
(float
)
/solver/nonlinear/solver/*/reg_weight_max
Description
Maximum regulariztion weight.Default: 100000000.0
/solver/nonlinear/solver/*/reg_weight_inc
(float
)
/solver/nonlinear/solver/*/reg_weight_inc
Description
Regulariztion weight increment.Default: 10
Type: DenseRegularizedProjectedNewton
Description
Options for projected regularized Newton.Required
/solver/nonlinear/solver/*/type
(string
)
/solver/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/nonlinear/solver/*/residual_tolerance
(float
)
/solver/nonlinear/solver/*/residual_tolerance
Description
Tolerance of the linear system residual. If residual is above, the direction is rejected.Default: 1e-05
/solver/nonlinear/solver/*/reg_weight_min
(float
)
/solver/nonlinear/solver/*/reg_weight_min
Description
Minimum regulariztion weight.Default: 1e-08
/solver/nonlinear/solver/*/reg_weight_max
(float
)
/solver/nonlinear/solver/*/reg_weight_max
Description
Maximum regulariztion weight.Default: 100000000.0
/solver/nonlinear/solver/*/reg_weight_inc
(float
)
/solver/nonlinear/solver/*/reg_weight_inc
Description
Regulariztion weight increment.Default: 10
Type: GradientDescent
Description
Options for Gradient Descent.Required
/solver/nonlinear/solver/*/type
(string
)
/solver/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Type: StochasticGradientDescent
Description
Options for Stochastic Gradient Descent.Required
/solver/nonlinear/solver/*/type
(string
)
/solver/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/nonlinear/solver/*/erase_component_probability
(float
)
/solver/nonlinear/solver/*/erase_component_probability
Description
Probability of erasing a component on the gradient for stochastic solvers.Default: 0.3
Type: L-BFGS
Description
Options for L-BFGS.Required
/solver/nonlinear/solver/*/type
(string
)
/solver/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/nonlinear/solver/*/history_size
(int
)
/solver/nonlinear/solver/*/history_size
Description
The number of corrections to approximate the inverse Hessian matrix.Default: 6
Type: BFGS
Description
Options for BFGS.Required
/solver/nonlinear/solver/*/type
(string
)
/solver/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Type: ADAM
Description
Options for ADAM.Required
/solver/nonlinear/solver/*/type
(string
)
/solver/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/nonlinear/solver/*/alpha
(float
)
/solver/nonlinear/solver/*/alpha
Description
Parameter alpha for ADAM.Default: 0.001
/solver/nonlinear/solver/*/beta_1
(float
)
/solver/nonlinear/solver/*/beta_1
Description
Parameter beta_1 for ADAM.Default: 0.9
/solver/nonlinear/solver/*/beta_2
(float
)
/solver/nonlinear/solver/*/beta_2
Description
Parameter beta_2 for ADAM.Default: 0.999
/solver/nonlinear/solver/*/epsilon
(float
)
/solver/nonlinear/solver/*/epsilon
Description
Parameter epsilon for ADAM.Default: 1e-08
Type: StochasticADAM
Description
Options for ADAM.Required
/solver/nonlinear/solver/*/type
(string
)
/solver/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/nonlinear/solver/*/alpha
(float
)
/solver/nonlinear/solver/*/alpha
Description
Parameter alpha for ADAM.Default: 0.001
/solver/nonlinear/solver/*/beta_1
(float
)
/solver/nonlinear/solver/*/beta_1
Description
Parameter beta_1 for ADAM.Default: 0.9
/solver/nonlinear/solver/*/beta_2
(float
)
/solver/nonlinear/solver/*/beta_2
Description
Parameter beta_2 for ADAM.Default: 0.999
/solver/nonlinear/solver/*/epsilon
(float
)
/solver/nonlinear/solver/*/epsilon
Description
Parameter epsilon for ADAM.Default: 1e-08
/solver/nonlinear/solver/*/erase_component_probability
(float
)
/solver/nonlinear/solver/*/erase_component_probability
Description
Probability of erasing a component on the gradient for stochastic solvers.Default: 0.3
/solver/nonlinear/x_delta
(float
)
/solver/nonlinear/x_delta
Description
Stopping criterion: minimal change of the variables x for the iterations to continue. Computed as the L2 norm of x divide by the time step.Default: 0
Range: [0, inf]
/solver/nonlinear/grad_norm
(float
)
/solver/nonlinear/grad_norm
Description
Stopping criterion: Minimal gradient norm for the iterations to continue.Default: 1e-08
Range: [0, inf]
/solver/nonlinear/first_grad_norm_tol
(float
)
/solver/nonlinear/first_grad_norm_tol
Description
Minimal gradient norm for the iterations to not start, assume we already are at a minimum.Default: 1e-10
/solver/nonlinear/max_iterations
(int
)
/solver/nonlinear/max_iterations
Description
Maximum number of iterations for a nonlinear solve.Default: 500
/solver/nonlinear/iterations_per_strategy
/solver/nonlinear/iterations_per_strategy
Description
Number of iterations for every substrategy before reset.Default: 5
Description
Number of iterations for every substrategy before reset./solver/nonlinear/iterations_per_strategy/*
(int
)
/solver/nonlinear/iterations_per_strategy/*
Description
Number of iterations for every substrategy before reset.Default: 5
/solver/nonlinear/line_search
(object
)
/solver/nonlinear/line_search
Description
Settings for line-search in the nonlinear solverDefault: None
Optional
/solver/nonlinear/line_search/method
(string
)
/solver/nonlinear/line_search/method
Description
Line-search typeDefault: 'RobustArmijo'
Options: ['Armijo', 'RobustArmijo', 'Backtracking', 'None']
/solver/nonlinear/line_search/use_grad_norm_tol
(float
)
/solver/nonlinear/line_search/use_grad_norm_tol
Description
When the energy is smaller than use_grad_norm_tol, line-search uses norm of gradient instead of energyDefault: 1e-06
/solver/nonlinear/line_search/min_step_size
(float
)
/solver/nonlinear/line_search/min_step_size
Description
Mimimum step sizeDefault: 1e-10
/solver/nonlinear/line_search/max_step_size_iter
(int
)
/solver/nonlinear/line_search/max_step_size_iter
Description
Number of iterationsDefault: 30
/solver/nonlinear/line_search/min_step_size_final
(float
)
/solver/nonlinear/line_search/min_step_size_final
Description
Mimimum step size for last descent strategyDefault: 1e-20
/solver/nonlinear/line_search/max_step_size_iter_final
(int
)
/solver/nonlinear/line_search/max_step_size_iter_final
Description
Number of iterations for last descent strategyDefault: 100
/solver/nonlinear/line_search/default_init_step_size
(float
)
/solver/nonlinear/line_search/default_init_step_size
Description
Initial step sizeDefault: 1
/solver/nonlinear/line_search/step_ratio
(float
)
/solver/nonlinear/line_search/step_ratio
Description
Ratio used to decrease the stepDefault: 0.5
/solver/nonlinear/line_search/Armijo
(object
)
/solver/nonlinear/line_search/Armijo
Description
Options for Armijo.Default: None
Optional
/solver/nonlinear/line_search/Armijo/c
(float
)
/solver/nonlinear/line_search/Armijo/c
Description
Armijo c parameter.Default: 0.0001
/solver/nonlinear/line_search/RobustArmijo
(object
)
/solver/nonlinear/line_search/RobustArmijo
Description
Options for RobustArmijo.Default: None
Optional
/solver/nonlinear/line_search/RobustArmijo/delta_relative_tolerance
(float
)
/solver/nonlinear/line_search/RobustArmijo/delta_relative_tolerance
Description
Relative tolerance on E to switch to approximate.Default: 0.1
/solver/nonlinear/allow_out_of_iterations
(bool
)
/solver/nonlinear/allow_out_of_iterations
Description
If false (default), an exception will be thrown when the nonlinear solver reaches the maximum number of iterations.Default: False
/solver/nonlinear/L-BFGS
(object
)
/solver/nonlinear/L-BFGS
Description
Options for LBFGS.Default: None
Optional
/solver/nonlinear/L-BFGS/history_size
(int
)
/solver/nonlinear/L-BFGS/history_size
Description
The number of corrections to approximate the inverse Hessian matrix.Default: 6
/solver/nonlinear/L-BFGS-B
(object
)
/solver/nonlinear/L-BFGS-B
Description
Options for the boxed L-BFGS.Default: None
Optional
/solver/nonlinear/L-BFGS-B/history_size
(int
)
/solver/nonlinear/L-BFGS-B/history_size
Description
The number of corrections to approximate the inverse Hessian matrix.Default: 6
/solver/nonlinear/Newton
(object
)
/solver/nonlinear/Newton
Description
Options for Newton.Default: None
Optional
/solver/nonlinear/Newton/residual_tolerance
(float
)
/solver/nonlinear/Newton/residual_tolerance
Description
Tolerance of the linear system residual. If residual is above, the direction is rejected.Default: 1e-05
/solver/nonlinear/Newton/reg_weight_min
(float
)
/solver/nonlinear/Newton/reg_weight_min
Description
Minimum regulariztion weight.Default: 1e-08
/solver/nonlinear/Newton/reg_weight_max
(float
)
/solver/nonlinear/Newton/reg_weight_max
Description
Maximum regulariztion weight.Default: 100000000.0
/solver/nonlinear/Newton/reg_weight_inc
(float
)
/solver/nonlinear/Newton/reg_weight_inc
Description
Regulariztion weight increment.Default: 10
/solver/nonlinear/Newton/force_psd_projection
(bool
)
/solver/nonlinear/Newton/force_psd_projection
Description
Force the Hessian to be PSD when using second order solvers (i.e., Newton’s method).Default: False
/solver/nonlinear/Newton/use_psd_projection
(bool
)
/solver/nonlinear/Newton/use_psd_projection
Description
Use PSD as fallback using second order solvers (i.e., Newton’s method).Default: True
/solver/nonlinear/Newton/use_psd_projection_in_regularized
(bool
)
/solver/nonlinear/Newton/use_psd_projection_in_regularized
Description
Use PSD in regularized Newton.Default: True
/solver/nonlinear/ADAM
(object
)
/solver/nonlinear/ADAM
Description
Options for ADAM.Default: None
Optional
/solver/nonlinear/ADAM/alpha
(float
)
/solver/nonlinear/ADAM/alpha
Description
Parameter alpha for ADAM.Default: 0.001
/solver/nonlinear/ADAM/beta_1
(float
)
/solver/nonlinear/ADAM/beta_1
Description
Parameter beta_1 for ADAM.Default: 0.9
/solver/nonlinear/ADAM/beta_2
(float
)
/solver/nonlinear/ADAM/beta_2
Description
Parameter beta_2 for ADAM.Default: 0.999
/solver/nonlinear/ADAM/epsilon
(float
)
/solver/nonlinear/ADAM/epsilon
Description
Parameter epsilon for ADAM.Default: 1e-08
/solver/nonlinear/StochasticADAM
(object
)
/solver/nonlinear/StochasticADAM
Description
Options for ADAM.Default: None
Optional
/solver/nonlinear/StochasticADAM/alpha
(float
)
/solver/nonlinear/StochasticADAM/alpha
Description
Parameter alpha for ADAM.Default: 0.001
/solver/nonlinear/StochasticADAM/beta_1
(float
)
/solver/nonlinear/StochasticADAM/beta_1
Description
Parameter beta_1 for ADAM.Default: 0.9
/solver/nonlinear/StochasticADAM/beta_2
(float
)
/solver/nonlinear/StochasticADAM/beta_2
Description
Parameter beta_2 for ADAM.Default: 0.999
/solver/nonlinear/StochasticADAM/epsilon
(float
)
/solver/nonlinear/StochasticADAM/epsilon
Description
Parameter epsilon for ADAM.Default: 1e-08
/solver/nonlinear/StochasticADAM/erase_component_probability
(float
)
/solver/nonlinear/StochasticADAM/erase_component_probability
Description
Probability of erasing a component on the gradient for ADAM.Default: 0.3
/solver/nonlinear/StochasticGradientDescent
(object
)
/solver/nonlinear/StochasticGradientDescent
Description
Options for Stochastic Gradient Descent.Default: None
Optional
/solver/nonlinear/StochasticGradientDescent/erase_component_probability
(float
)
/solver/nonlinear/StochasticGradientDescent/erase_component_probability
Description
Probability of erasing a component on the gradient for StochasticGradientDescent.Default: 0.3
/solver/nonlinear/box_constraints
(object
)
/solver/nonlinear/box_constraints
Description
FIXME: Missing documentation in the specification.Default: None
Optional
/solver/nonlinear/box_constraints/bounds
(list
)
/solver/nonlinear/box_constraints/bounds
Description
Box constraints on optimization variables./solver/nonlinear/box_constraints/bounds/*
/solver/nonlinear/box_constraints/bounds/*
Description
Box constraint values on optimization variables./solver/nonlinear/box_constraints/bounds/*/*
(float
)
/solver/nonlinear/box_constraints/bounds/*/*
Description
Box constraint values on optimization variables.Description
Box constraint values on optimization variables./solver/nonlinear/box_constraints/max_change
/solver/nonlinear/box_constraints/max_change
Description
Maximum change of optimization variables in one iteration, only for solvers with box constraints. Negative value to disable this constraint.Default: -1
Description
Maximum change of optimization variables in one iteration, only for solvers with box constraints./solver/nonlinear/box_constraints/max_change/*
(float
)
/solver/nonlinear/box_constraints/max_change/*
Description
Maximum change of every optimization variable in one iteration, only for solvers with box constraints./solver/nonlinear/advanced
(object
)
/solver/nonlinear/advanced
Description
Nonlinear solver advanced optionsDefault: None
Optional
/solver/nonlinear/advanced/f_delta
(float
)
/solver/nonlinear/advanced/f_delta
Description
Dangerous Option: Quit the optimization if the solver reduces the energy by less than f_delta for consecutive f_delta_step_tol steps.Default: 0
Range: [0, inf]
/solver/nonlinear/advanced/f_delta_step_tol
(int
)
/solver/nonlinear/advanced/f_delta_step_tol
Description
Dangerous Option: Quit the optimization if the solver reduces the energy by less than f_delta for consecutive f_delta_step_tol steps.Default: 100
/solver/nonlinear/advanced/derivative_along_delta_x_tol
(float
)
/solver/nonlinear/advanced/derivative_along_delta_x_tol
Description
Quit the optimization if the directional derivative along the descent direction is smaller than this tolerance.Default: 0
Range: [0, inf]
/solver/nonlinear/advanced/apply_gradient_fd
(string
)
/solver/nonlinear/advanced/apply_gradient_fd
Description
Expensive Option: For every iteration of the nonlinear solver, run finite difference to verify gradient of energy.Default: 'None'
Options: ['None', 'DirectionalDerivative', 'FullFiniteDiff']
/solver/nonlinear/advanced/gradient_fd_eps
(float
)
/solver/nonlinear/advanced/gradient_fd_eps
Description
Expensive Option: Eps for finite difference to verify gradient of energy.Default: 1e-07
/solver/augmented_lagrangian
(object
)
/solver/augmented_lagrangian
Description
Parameters for the AL for imposing Dirichlet BCs. If the bc are not imposable, we add \(w\|u - bc\|^2\) to the energy (\(u\) is the solution at the Dirichlet nodes and \(bc\) are the Dirichlet values). After convergence, we try to impose bc again. The algorithm computes E + a/2*AL^2 - lambda AL, where E is the current energy (elastic, inertia, contact, etc.) and AL is the augmented Lagrangian energy. a starts atinitial_weight
and, in case DBC cannot be imposed, we update a as a *= scaling
until max_weight
. See IPC additional material
Default: None
Optional
/solver/augmented_lagrangian/initial_weight
(float
)
/solver/augmented_lagrangian/initial_weight
Description
Initial weight for ALDefault: 1000000.0
Range: [0, inf]
/solver/augmented_lagrangian/scaling
(float
)
/solver/augmented_lagrangian/scaling
Description
Multiplication factorDefault: 2.0
/solver/augmented_lagrangian/max_weight
(float
)
/solver/augmented_lagrangian/max_weight
Description
Maximum weightDefault: 100000000.0
/solver/augmented_lagrangian/eta
(float
)
/solver/augmented_lagrangian/eta
Description
Tolerance for increasing the weight or updating the lagrangianDefault: 0.99
Range: [0, 1]
/solver/augmented_lagrangian/nonlinear
(object
)
/solver/augmented_lagrangian/nonlinear
Description
Settings for nonlinear solver. Interior-loop linear solver settings are defined in the solver/linear section.Default: None
Optional
/solver/augmented_lagrangian/nonlinear/solver
/solver/augmented_lagrangian/nonlinear/solver
Description
Nonlinear solver typeDefault: 'Newton'
Options: ['Newton', 'DenseNewton', 'GradientDescent', 'ADAM', 'StochasticADAM', 'StochasticGradientDescent', 'L-BFGS', 'BFGS', 'L-BFGS-B', 'MMA']
Description
List of solvers for ballback. Eg, [{‘type’:’Newton’}, {‘type’:’L-BFGS’}, {‘type’:’GradientDescent’}] will solve using Newton, in case of failure will fallback to L-BFGS and eventually to GradientDescent/solver/augmented_lagrangian/nonlinear/solver/*
/solver/augmented_lagrangian/nonlinear/solver/*
Type: Newton
Description
Options for Newton.Required
/solver/augmented_lagrangian/nonlinear/solver/*/type
(string
)
/solver/augmented_lagrangian/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/augmented_lagrangian/nonlinear/solver/*/residual_tolerance
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/residual_tolerance
Description
Tolerance of the linear system residual. If residual is above, the direction is rejected.Default: 1e-05
Type: ProjectedNewton
Description
Options for projected Newton.Required
/solver/augmented_lagrangian/nonlinear/solver/*/type
(string
)
/solver/augmented_lagrangian/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/augmented_lagrangian/nonlinear/solver/*/residual_tolerance
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/residual_tolerance
Description
Tolerance of the linear system residual. If residual is above, the direction is rejected.Default: 1e-05
Type: RegularizedNewton
Description
Options for regularized Newton.Required
/solver/augmented_lagrangian/nonlinear/solver/*/type
(string
)
/solver/augmented_lagrangian/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/augmented_lagrangian/nonlinear/solver/*/residual_tolerance
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/residual_tolerance
Description
Tolerance of the linear system residual. If residual is above, the direction is rejected.Default: 1e-05
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_min
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_min
Description
Minimum regulariztion weight.Default: 1e-08
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_max
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_max
Description
Maximum regulariztion weight.Default: 100000000.0
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_inc
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_inc
Description
Regulariztion weight increment.Default: 10
Type: RegularizedProjectedNewton
Description
Options for regularized projected Newton.Required
/solver/augmented_lagrangian/nonlinear/solver/*/type
(string
)
/solver/augmented_lagrangian/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/augmented_lagrangian/nonlinear/solver/*/residual_tolerance
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/residual_tolerance
Description
Tolerance of the linear system residual. If residual is above, the direction is rejected.Default: 1e-05
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_min
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_min
Description
Minimum regulariztion weight.Default: 1e-08
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_max
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_max
Description
Maximum regulariztion weight.Default: 100000000.0
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_inc
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_inc
Description
Regulariztion weight increment.Default: 10
Type: DenseNewton
Description
Options for Newton.Required
/solver/augmented_lagrangian/nonlinear/solver/*/type
(string
)
/solver/augmented_lagrangian/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/augmented_lagrangian/nonlinear/solver/*/residual_tolerance
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/residual_tolerance
Description
Tolerance of the linear system residual. If residual is above, the direction is rejected.Default: 1e-05
Type: DenseProjectedNewton
Description
Options for projected Newton.Required
/solver/augmented_lagrangian/nonlinear/solver/*/type
(string
)
/solver/augmented_lagrangian/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/augmented_lagrangian/nonlinear/solver/*/residual_tolerance
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/residual_tolerance
Description
Tolerance of the linear system residual. If residual is above, the direction is rejected.Default: 1e-05
Type: DenseRegularizedNewton
Description
Options for regularized Newton.Required
/solver/augmented_lagrangian/nonlinear/solver/*/type
(string
)
/solver/augmented_lagrangian/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/augmented_lagrangian/nonlinear/solver/*/residual_tolerance
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/residual_tolerance
Description
Tolerance of the linear system residual. If residual is above, the direction is rejected.Default: 1e-05
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_min
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_min
Description
Minimum regulariztion weight.Default: 1e-08
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_max
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_max
Description
Maximum regulariztion weight.Default: 100000000.0
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_inc
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_inc
Description
Regulariztion weight increment.Default: 10
Type: DenseRegularizedProjectedNewton
Description
Options for projected regularized Newton.Required
/solver/augmented_lagrangian/nonlinear/solver/*/type
(string
)
/solver/augmented_lagrangian/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/augmented_lagrangian/nonlinear/solver/*/residual_tolerance
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/residual_tolerance
Description
Tolerance of the linear system residual. If residual is above, the direction is rejected.Default: 1e-05
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_min
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_min
Description
Minimum regulariztion weight.Default: 1e-08
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_max
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_max
Description
Maximum regulariztion weight.Default: 100000000.0
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_inc
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/reg_weight_inc
Description
Regulariztion weight increment.Default: 10
Type: GradientDescent
Description
Options for Gradient Descent.Required
/solver/augmented_lagrangian/nonlinear/solver/*/type
(string
)
/solver/augmented_lagrangian/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Type: StochasticGradientDescent
Description
Options for Stochastic Gradient Descent.Required
/solver/augmented_lagrangian/nonlinear/solver/*/type
(string
)
/solver/augmented_lagrangian/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/augmented_lagrangian/nonlinear/solver/*/erase_component_probability
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/erase_component_probability
Description
Probability of erasing a component on the gradient for stochastic solvers.Default: 0.3
Type: L-BFGS
Description
Options for L-BFGS.Required
/solver/augmented_lagrangian/nonlinear/solver/*/type
(string
)
/solver/augmented_lagrangian/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/augmented_lagrangian/nonlinear/solver/*/history_size
(int
)
/solver/augmented_lagrangian/nonlinear/solver/*/history_size
Description
The number of corrections to approximate the inverse Hessian matrix.Default: 6
Type: BFGS
Description
Options for BFGS.Required
/solver/augmented_lagrangian/nonlinear/solver/*/type
(string
)
/solver/augmented_lagrangian/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Type: ADAM
Description
Options for ADAM.Required
/solver/augmented_lagrangian/nonlinear/solver/*/type
(string
)
/solver/augmented_lagrangian/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/augmented_lagrangian/nonlinear/solver/*/alpha
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/alpha
Description
Parameter alpha for ADAM.Default: 0.001
/solver/augmented_lagrangian/nonlinear/solver/*/beta_1
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/beta_1
Description
Parameter beta_1 for ADAM.Default: 0.9
/solver/augmented_lagrangian/nonlinear/solver/*/beta_2
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/beta_2
Description
Parameter beta_2 for ADAM.Default: 0.999
/solver/augmented_lagrangian/nonlinear/solver/*/epsilon
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/epsilon
Description
Parameter epsilon for ADAM.Default: 1e-08
Type: StochasticADAM
Description
Options for ADAM.Required
/solver/augmented_lagrangian/nonlinear/solver/*/type
(string
)
/solver/augmented_lagrangian/nonlinear/solver/*/type
Description
Nonlinear solver typeOptions: ['Newton', 'DenseNewton', 'ProjectedNewton', 'DenseProjectedNewton', 'RegularizedNewton', 'DenseRegularizedNewton', 'RegularizedProjectedNewton', 'DenseRegularizedProjectedNewton', 'GradientDescent', 'StochasticGradientDescent', 'ADAM', 'StochasticADAM', 'L-BFGS', 'BFGS']
Optional
/solver/augmented_lagrangian/nonlinear/solver/*/alpha
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/alpha
Description
Parameter alpha for ADAM.Default: 0.001
/solver/augmented_lagrangian/nonlinear/solver/*/beta_1
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/beta_1
Description
Parameter beta_1 for ADAM.Default: 0.9
/solver/augmented_lagrangian/nonlinear/solver/*/beta_2
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/beta_2
Description
Parameter beta_2 for ADAM.Default: 0.999
/solver/augmented_lagrangian/nonlinear/solver/*/epsilon
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/epsilon
Description
Parameter epsilon for ADAM.Default: 1e-08
/solver/augmented_lagrangian/nonlinear/solver/*/erase_component_probability
(float
)
/solver/augmented_lagrangian/nonlinear/solver/*/erase_component_probability
Description
Probability of erasing a component on the gradient for stochastic solvers.Default: 0.3
/solver/augmented_lagrangian/nonlinear/x_delta
(float
)
/solver/augmented_lagrangian/nonlinear/x_delta
Description
Stopping criterion: minimal change of the variables x for the iterations to continue. Computed as the L2 norm of x divide by the time step.Default: 0
Range: [0, inf]
/solver/augmented_lagrangian/nonlinear/grad_norm
(float
)
/solver/augmented_lagrangian/nonlinear/grad_norm
Description
Stopping criterion: Minimal gradient norm for the iterations to continue.Default: 1e-08
Range: [0, inf]
/solver/augmented_lagrangian/nonlinear/first_grad_norm_tol
(float
)
/solver/augmented_lagrangian/nonlinear/first_grad_norm_tol
Description
Minimal gradient norm for the iterations to not start, assume we already are at a minimum.Default: 1e-10
/solver/augmented_lagrangian/nonlinear/max_iterations
(int
)
/solver/augmented_lagrangian/nonlinear/max_iterations
Description
Maximum number of iterations for a nonlinear solve.Default: 500
/solver/augmented_lagrangian/nonlinear/iterations_per_strategy
/solver/augmented_lagrangian/nonlinear/iterations_per_strategy
Description
Number of iterations for every substrategy before reset.Default: 5
Description
Number of iterations for every substrategy before reset./solver/augmented_lagrangian/nonlinear/iterations_per_strategy/*
(int
)
/solver/augmented_lagrangian/nonlinear/iterations_per_strategy/*
Description
Number of iterations for every substrategy before reset.Default: 5
/solver/augmented_lagrangian/nonlinear/line_search
(object
)
/solver/augmented_lagrangian/nonlinear/line_search
Description
Settings for line-search in the nonlinear solverDefault: None
Optional
/solver/augmented_lagrangian/nonlinear/line_search/method
(string
)
/solver/augmented_lagrangian/nonlinear/line_search/method
Description
Line-search typeDefault: 'RobustArmijo'
Options: ['Armijo', 'RobustArmijo', 'Backtracking', 'None']
/solver/augmented_lagrangian/nonlinear/line_search/use_grad_norm_tol
(float
)
/solver/augmented_lagrangian/nonlinear/line_search/use_grad_norm_tol
Description
When the energy is smaller than use_grad_norm_tol, line-search uses norm of gradient instead of energyDefault: 1e-06
/solver/augmented_lagrangian/nonlinear/line_search/min_step_size
(float
)
/solver/augmented_lagrangian/nonlinear/line_search/min_step_size
Description
Mimimum step sizeDefault: 1e-10
/solver/augmented_lagrangian/nonlinear/line_search/max_step_size_iter
(int
)
/solver/augmented_lagrangian/nonlinear/line_search/max_step_size_iter
Description
Number of iterationsDefault: 30
/solver/augmented_lagrangian/nonlinear/line_search/min_step_size_final
(float
)
/solver/augmented_lagrangian/nonlinear/line_search/min_step_size_final
Description
Mimimum step size for last descent strategyDefault: 1e-20
/solver/augmented_lagrangian/nonlinear/line_search/max_step_size_iter_final
(int
)
/solver/augmented_lagrangian/nonlinear/line_search/max_step_size_iter_final
Description
Number of iterations for last descent strategyDefault: 100
/solver/augmented_lagrangian/nonlinear/line_search/default_init_step_size
(float
)
/solver/augmented_lagrangian/nonlinear/line_search/default_init_step_size
Description
Initial step sizeDefault: 1
/solver/augmented_lagrangian/nonlinear/line_search/step_ratio
(float
)
/solver/augmented_lagrangian/nonlinear/line_search/step_ratio
Description
Ratio used to decrease the stepDefault: 0.5
/solver/augmented_lagrangian/nonlinear/line_search/Armijo
(object
)
/solver/augmented_lagrangian/nonlinear/line_search/Armijo
Description
Options for Armijo.Default: None
Optional
/solver/augmented_lagrangian/nonlinear/line_search/Armijo/c
(float
)
/solver/augmented_lagrangian/nonlinear/line_search/Armijo/c
Description
Armijo c parameter.Default: 0.0001
/solver/augmented_lagrangian/nonlinear/line_search/RobustArmijo
(object
)
/solver/augmented_lagrangian/nonlinear/line_search/RobustArmijo
Description
Options for RobustArmijo.Default: None
Optional
/solver/augmented_lagrangian/nonlinear/line_search/RobustArmijo/delta_relative_tolerance
(float
)
/solver/augmented_lagrangian/nonlinear/line_search/RobustArmijo/delta_relative_tolerance
Description
Relative tolerance on E to switch to approximate.Default: 0.1
/solver/augmented_lagrangian/nonlinear/allow_out_of_iterations
(bool
)
/solver/augmented_lagrangian/nonlinear/allow_out_of_iterations
Description
If false (default), an exception will be thrown when the nonlinear solver reaches the maximum number of iterations.Default: False
/solver/augmented_lagrangian/nonlinear/L-BFGS
(object
)
/solver/augmented_lagrangian/nonlinear/L-BFGS
Description
Options for LBFGS.Default: None
Optional
/solver/augmented_lagrangian/nonlinear/L-BFGS/history_size
(int
)
/solver/augmented_lagrangian/nonlinear/L-BFGS/history_size
Description
The number of corrections to approximate the inverse Hessian matrix.Default: 6
/solver/augmented_lagrangian/nonlinear/L-BFGS-B
(object
)
/solver/augmented_lagrangian/nonlinear/L-BFGS-B
Description
Options for the boxed L-BFGS.Default: None
Optional
/solver/augmented_lagrangian/nonlinear/L-BFGS-B/history_size
(int
)
/solver/augmented_lagrangian/nonlinear/L-BFGS-B/history_size
Description
The number of corrections to approximate the inverse Hessian matrix.Default: 6
/solver/augmented_lagrangian/nonlinear/Newton
(object
)
/solver/augmented_lagrangian/nonlinear/Newton
Description
Options for Newton.Default: None
Optional
/solver/augmented_lagrangian/nonlinear/Newton/residual_tolerance
(float
)
/solver/augmented_lagrangian/nonlinear/Newton/residual_tolerance
Description
Tolerance of the linear system residual. If residual is above, the direction is rejected.Default: 1e-05
/solver/augmented_lagrangian/nonlinear/Newton/reg_weight_min
(float
)
/solver/augmented_lagrangian/nonlinear/Newton/reg_weight_min
Description
Minimum regulariztion weight.Default: 1e-08
/solver/augmented_lagrangian/nonlinear/Newton/reg_weight_max
(float
)
/solver/augmented_lagrangian/nonlinear/Newton/reg_weight_max
Description
Maximum regulariztion weight.Default: 100000000.0
/solver/augmented_lagrangian/nonlinear/Newton/reg_weight_inc
(float
)
/solver/augmented_lagrangian/nonlinear/Newton/reg_weight_inc
Description
Regulariztion weight increment.Default: 10
/solver/augmented_lagrangian/nonlinear/Newton/force_psd_projection
(bool
)
/solver/augmented_lagrangian/nonlinear/Newton/force_psd_projection
Description
Force the Hessian to be PSD when using second order solvers (i.e., Newton’s method).Default: False
/solver/augmented_lagrangian/nonlinear/Newton/use_psd_projection
(bool
)
/solver/augmented_lagrangian/nonlinear/Newton/use_psd_projection
Description
Use PSD as fallback using second order solvers (i.e., Newton’s method).Default: True
/solver/augmented_lagrangian/nonlinear/Newton/use_psd_projection_in_regularized
(bool
)
/solver/augmented_lagrangian/nonlinear/Newton/use_psd_projection_in_regularized
Description
Use PSD in regularized Newton.Default: True
/solver/augmented_lagrangian/nonlinear/ADAM
(object
)
/solver/augmented_lagrangian/nonlinear/ADAM
Description
Options for ADAM.Default: None
Optional
/solver/augmented_lagrangian/nonlinear/ADAM/alpha
(float
)
/solver/augmented_lagrangian/nonlinear/ADAM/alpha
Description
Parameter alpha for ADAM.Default: 0.001
/solver/augmented_lagrangian/nonlinear/ADAM/beta_1
(float
)
/solver/augmented_lagrangian/nonlinear/ADAM/beta_1
Description
Parameter beta_1 for ADAM.Default: 0.9
/solver/augmented_lagrangian/nonlinear/ADAM/beta_2
(float
)
/solver/augmented_lagrangian/nonlinear/ADAM/beta_2
Description
Parameter beta_2 for ADAM.Default: 0.999
/solver/augmented_lagrangian/nonlinear/ADAM/epsilon
(float
)
/solver/augmented_lagrangian/nonlinear/ADAM/epsilon
Description
Parameter epsilon for ADAM.Default: 1e-08
/solver/augmented_lagrangian/nonlinear/StochasticADAM
(object
)
/solver/augmented_lagrangian/nonlinear/StochasticADAM
Description
Options for ADAM.Default: None
Optional
/solver/augmented_lagrangian/nonlinear/StochasticADAM/alpha
(float
)
/solver/augmented_lagrangian/nonlinear/StochasticADAM/alpha
Description
Parameter alpha for ADAM.Default: 0.001
/solver/augmented_lagrangian/nonlinear/StochasticADAM/beta_1
(float
)
/solver/augmented_lagrangian/nonlinear/StochasticADAM/beta_1
Description
Parameter beta_1 for ADAM.Default: 0.9
/solver/augmented_lagrangian/nonlinear/StochasticADAM/beta_2
(float
)
/solver/augmented_lagrangian/nonlinear/StochasticADAM/beta_2
Description
Parameter beta_2 for ADAM.Default: 0.999
/solver/augmented_lagrangian/nonlinear/StochasticADAM/epsilon
(float
)
/solver/augmented_lagrangian/nonlinear/StochasticADAM/epsilon
Description
Parameter epsilon for ADAM.Default: 1e-08
/solver/augmented_lagrangian/nonlinear/StochasticADAM/erase_component_probability
(float
)
/solver/augmented_lagrangian/nonlinear/StochasticADAM/erase_component_probability
Description
Probability of erasing a component on the gradient for ADAM.Default: 0.3
/solver/augmented_lagrangian/nonlinear/StochasticGradientDescent
(object
)
/solver/augmented_lagrangian/nonlinear/StochasticGradientDescent
Description
Options for Stochastic Gradient Descent.Default: None
Optional
/solver/augmented_lagrangian/nonlinear/StochasticGradientDescent/erase_component_probability
(float
)
/solver/augmented_lagrangian/nonlinear/StochasticGradientDescent/erase_component_probability
Description
Probability of erasing a component on the gradient for StochasticGradientDescent.Default: 0.3
/solver/augmented_lagrangian/nonlinear/box_constraints
(object
)
/solver/augmented_lagrangian/nonlinear/box_constraints
Description
FIXME: Missing documentation in the specification.Default: None
Optional
/solver/augmented_lagrangian/nonlinear/box_constraints/bounds
(list
)
/solver/augmented_lagrangian/nonlinear/box_constraints/bounds
Description
Box constraints on optimization variables./solver/augmented_lagrangian/nonlinear/box_constraints/bounds/*
/solver/augmented_lagrangian/nonlinear/box_constraints/bounds/*
Description
Box constraint values on optimization variables./solver/augmented_lagrangian/nonlinear/box_constraints/bounds/*/*
(float
)
/solver/augmented_lagrangian/nonlinear/box_constraints/bounds/*/*
Description
Box constraint values on optimization variables.Description
Box constraint values on optimization variables./solver/augmented_lagrangian/nonlinear/box_constraints/max_change
/solver/augmented_lagrangian/nonlinear/box_constraints/max_change
Description
Maximum change of optimization variables in one iteration, only for solvers with box constraints. Negative value to disable this constraint.Default: -1
Description
Maximum change of optimization variables in one iteration, only for solvers with box constraints./solver/augmented_lagrangian/nonlinear/box_constraints/max_change/*
(float
)
/solver/augmented_lagrangian/nonlinear/box_constraints/max_change/*
Description
Maximum change of every optimization variable in one iteration, only for solvers with box constraints./solver/augmented_lagrangian/nonlinear/advanced
(object
)
/solver/augmented_lagrangian/nonlinear/advanced
Description
Nonlinear solver advanced optionsDefault: None
Optional
/solver/augmented_lagrangian/nonlinear/advanced/f_delta
(float
)
/solver/augmented_lagrangian/nonlinear/advanced/f_delta
Description
Dangerous Option: Quit the optimization if the solver reduces the energy by less than f_delta for consecutive f_delta_step_tol steps.Default: 0
Range: [0, inf]
/solver/augmented_lagrangian/nonlinear/advanced/f_delta_step_tol
(int
)
/solver/augmented_lagrangian/nonlinear/advanced/f_delta_step_tol
Description
Dangerous Option: Quit the optimization if the solver reduces the energy by less than f_delta for consecutive f_delta_step_tol steps.Default: 100
/solver/augmented_lagrangian/nonlinear/advanced/derivative_along_delta_x_tol
(float
)
/solver/augmented_lagrangian/nonlinear/advanced/derivative_along_delta_x_tol
Description
Quit the optimization if the directional derivative along the descent direction is smaller than this tolerance.Default: 0
Range: [0, inf]
/solver/augmented_lagrangian/nonlinear/advanced/apply_gradient_fd
(string
)
/solver/augmented_lagrangian/nonlinear/advanced/apply_gradient_fd
Description
Expensive Option: For every iteration of the nonlinear solver, run finite difference to verify gradient of energy.Default: 'None'
Options: ['None', 'DirectionalDerivative', 'FullFiniteDiff']
/solver/augmented_lagrangian/nonlinear/advanced/gradient_fd_eps
(float
)
/solver/augmented_lagrangian/nonlinear/advanced/gradient_fd_eps
Description
Expensive Option: Eps for finite difference to verify gradient of energy.Default: 1e-07
/solver/contact
(object
)
/solver/contact
Description
Settings for contact handling in the solver.Default: None
Optional
/solver/contact/CCD
(object
)
/solver/contact/CCD
Description
CCD optionsDefault: None
Optional
/solver/contact/CCD/broad_phase
(string
)
/solver/contact/CCD/broad_phase
Description
Broad phase collision-detection algorithm to useDefault: 'hash_grid'
Options: ['hash_grid', 'HG', 'brute_force', 'BF', 'spatial_hash', 'SH', 'bvh', 'BVH', 'sweep_and_prune', 'SAP', 'sweep_and_tiniest_queue', 'STQ']
/solver/contact/CCD/tolerance
(float
)
/solver/contact/CCD/tolerance
Description
CCD toleranceDefault: 1e-06
/solver/contact/CCD/max_iterations
(int
)
/solver/contact/CCD/max_iterations
Description
Maximum number of iterations for continuous collision detectionDefault: 1000000
/solver/contact/friction_iterations
(int
)
/solver/contact/friction_iterations
Description
Maximum number of update iterations for lagged friction formulation (see IPC paper).Default: 1
/solver/contact/friction_convergence_tol
(float
)
/solver/contact/friction_convergence_tol
Description
Tolerence for friction convergenceDefault: 0.01
/solver/contact/barrier_stiffness
/solver/contact/barrier_stiffness
Description
How coefficient of clamped log-barrier function for contact is updatedDefault: 'adaptive'
Options: ['adaptive']
Description
The coefficient of clamped log-barrier function value when not adaptive/solver/rayleigh_damping
(list
)
/solver/rayleigh_damping
Description
Apply Rayleigh damping./solver/rayleigh_damping/*
/solver/rayleigh_damping/*
Description
Apply Rayleigh damping to the given Form with a stiffness ratio.Required
/solver/rayleigh_damping/*/form
(string
)
/solver/rayleigh_damping/*/form
Description
Form to damp.Options: ['elasticity', 'contact', 'friction']
/solver/rayleigh_damping/*/stiffness_ratio
(float
)
/solver/rayleigh_damping/*/stiffness_ratio
Description
Ratio of to damp (stiffness = 0.75 * stiffness_ratio * Δt³).Range: [0, inf]
Optional
/solver/rayleigh_damping/*/lagging_iterations
(int
)
/solver/rayleigh_damping/*/lagging_iterations
Description
Maximum number of update iterations for lagging.Default: 1
Description
Apply Rayleigh damping to the given Form with a stiffness.Required
/solver/rayleigh_damping/*/form
(string
)
/solver/rayleigh_damping/*/form
Description
Form to damp.Options: ['elasticity', 'contact', 'friction']
/solver/rayleigh_damping/*/stiffness
(float
)
/solver/rayleigh_damping/*/stiffness
Description
Ratio of to damp.Range: [0, inf]
Optional
/solver/rayleigh_damping/*/lagging_iterations
(int
)
/solver/rayleigh_damping/*/lagging_iterations
Description
Maximum number of update iterations for lagging.Default: 1
/solver/advanced
(object
)
/solver/advanced
Description
Advanced settings for the solverDefault: None
Optional
/solver/advanced/cache_size
(int
)
/solver/advanced/cache_size
Description
Maximum number of elements when the assembly values are cached.Default: 900000
/solver/advanced/lump_mass_matrix
(bool
)
/solver/advanced/lump_mass_matrix
Description
If true, use diagonal mass matrix with entries on the diagonal equal to the sum of entries in each row of the full mass matrix.}Default: False
/solver/advanced/lagged_regularization_weight
(float
)
/solver/advanced/lagged_regularization_weight
Description
Weight used to regularize singular static problems.Default: 0
/solver/advanced/lagged_regularization_iterations
(int
)
/solver/advanced/lagged_regularization_iterations
Description
Number of regularize singular static problems.Default: 1
/boundary_conditions
(object
)
/boundary_conditions
Description
The settings for boundary conditions.Default: None
Optional
/boundary_conditions/rhs
/boundary_conditions/rhs
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/boundary_conditions/rhs/value
/boundary_conditions/rhs/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/boundary_conditions/rhs/unit
(string
)
/boundary_conditions/rhs/unit
Description
The unit of the ValueDescription
Right-hand side of the system being solved for vector-valued PDEs./boundary_conditions/rhs/*
/boundary_conditions/rhs/*
Description
Value as a constant floatDefault: 0
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/boundary_conditions/rhs/*/value
/boundary_conditions/rhs/*/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/boundary_conditions/rhs/*/unit
(string
)
/boundary_conditions/rhs/*/unit
Description
The unit of the Value/boundary_conditions/dirichlet_boundary
(list
)
/boundary_conditions/dirichlet_boundary
Description
The list of boundary conditions for the main variable. Elements of the list are assignment pairs (ID, value) where ID is assigned by surface selection./boundary_conditions/dirichlet_boundary/*
/boundary_conditions/dirichlet_boundary/*
Description
Dirichlet boundary condition.Default: None
Required
/boundary_conditions/dirichlet_boundary/*/id
/boundary_conditions/dirichlet_boundary/*/id
Description
ID of boundary condition from surface selection.Range: [0, 2147483646]
Description
select all ids.Options: ['all']
/boundary_conditions/dirichlet_boundary/*/value
(list
)
/boundary_conditions/dirichlet_boundary/*/value
Description
Values of boundary condition, length 1 for scalar-valued pde, ⅔ for vector-valued PDEs depending on the dimension./boundary_conditions/dirichlet_boundary/*/value/*
/boundary_conditions/dirichlet_boundary/*/value/*
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/boundary_conditions/dirichlet_boundary/*/value/*/value
/boundary_conditions/dirichlet_boundary/*/value/*/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/boundary_conditions/dirichlet_boundary/*/value/*/unit
(string
)
/boundary_conditions/dirichlet_boundary/*/value/*/unit
Description
The unit of the ValueDescription
Dirichlet boundary condition specified per timestep./boundary_conditions/dirichlet_boundary/*/value/*/*
/boundary_conditions/dirichlet_boundary/*/value/*/*
Description
Value as a constant floatDefault: 0
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/boundary_conditions/dirichlet_boundary/*/value/*/*/value
/boundary_conditions/dirichlet_boundary/*/value/*/*/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/boundary_conditions/dirichlet_boundary/*/value/*/*/unit
(string
)
/boundary_conditions/dirichlet_boundary/*/value/*/*/unit
Description
The unit of the ValueOptional
/boundary_conditions/dirichlet_boundary/*/time_reference
(list
)
/boundary_conditions/dirichlet_boundary/*/time_reference
Description
List of times when the Dirichlet boundary condition is specified/boundary_conditions/dirichlet_boundary/*/time_reference/*
(float
)
/boundary_conditions/dirichlet_boundary/*/time_reference/*
Description
Values of Dirichlet boundary condition for timestep/boundary_conditions/dirichlet_boundary/*/interpolation
(list
)
/boundary_conditions/dirichlet_boundary/*/interpolation
Description
interpolation of boundary condition/boundary_conditions/dirichlet_boundary/*/interpolation/*
/boundary_conditions/dirichlet_boundary/*/interpolation/*
Type: none
Description
interpolation of boundary conditionDefault: {'type': 'none'}
Required
/boundary_conditions/dirichlet_boundary/*/interpolation/*/type
(string
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
Type: linear
Description
interpolation of boundary conditionRequired
/boundary_conditions/dirichlet_boundary/*/interpolation/*/type
(string
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
Type: linear_ramp
Description
interpolation of boundary conditionRequired
/boundary_conditions/dirichlet_boundary/*/interpolation/*/type
(string
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
/boundary_conditions/dirichlet_boundary/*/interpolation/*/to
(float
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/to
Description
interpolation ending timeOptional
/boundary_conditions/dirichlet_boundary/*/interpolation/*/from
(float
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/from
Description
interpolation starting timeDefault: 0
Type: piecewise_constant
Description
interpolation of boundary conditionRequired
/boundary_conditions/dirichlet_boundary/*/interpolation/*/type
(string
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
/boundary_conditions/dirichlet_boundary/*/interpolation/*/points
(list
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/points
Description
interpolation time points/boundary_conditions/dirichlet_boundary/*/interpolation/*/points/*
(float
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/points/*
Description
interpolation time point/boundary_conditions/dirichlet_boundary/*/interpolation/*/values
(list
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/values
Description
interpolation values/boundary_conditions/dirichlet_boundary/*/interpolation/*/values/*
(float
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/values/*
Description
interpolation valueOptional
/boundary_conditions/dirichlet_boundary/*/interpolation/*/extend
(string
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/extend
Description
how to extend the piecewise interpolationDefault: 'constant'
Options: ['constant', 'extrapolate', 'repeat', 'repeat_offset']
Type: piecewise_linear
Description
interpolation of boundary conditionRequired
/boundary_conditions/dirichlet_boundary/*/interpolation/*/type
(string
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
/boundary_conditions/dirichlet_boundary/*/interpolation/*/points
(list
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/points
Description
interpolation time points/boundary_conditions/dirichlet_boundary/*/interpolation/*/points/*
(float
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/points/*
Description
interpolation time point/boundary_conditions/dirichlet_boundary/*/interpolation/*/values
(list
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/values
Description
interpolation values/boundary_conditions/dirichlet_boundary/*/interpolation/*/values/*
(float
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/values/*
Description
interpolation valueOptional
/boundary_conditions/dirichlet_boundary/*/interpolation/*/extend
(string
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/extend
Description
how to extend the piecewise interpolationDefault: 'constant'
Options: ['constant', 'extrapolate', 'repeat', 'repeat_offset']
Type: piecewise_cubic
Description
interpolation of boundary conditionRequired
/boundary_conditions/dirichlet_boundary/*/interpolation/*/type
(string
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
/boundary_conditions/dirichlet_boundary/*/interpolation/*/points
(list
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/points
Description
interpolation time points/boundary_conditions/dirichlet_boundary/*/interpolation/*/points/*
(float
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/points/*
Description
interpolation time point/boundary_conditions/dirichlet_boundary/*/interpolation/*/values
(list
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/values
Description
interpolation values/boundary_conditions/dirichlet_boundary/*/interpolation/*/values/*
(float
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/values/*
Description
interpolation valueOptional
/boundary_conditions/dirichlet_boundary/*/interpolation/*/extend
(string
)
/boundary_conditions/dirichlet_boundary/*/interpolation/*/extend
Description
how to extend the piecewise interpolationDefault: 'constant'
Options: ['constant', 'extrapolate', 'repeat', 'repeat_offset']
/boundary_conditions/dirichlet_boundary/*/dimension
(list
)
/boundary_conditions/dirichlet_boundary/*/dimension
Description
List of 2 (2D) or 3 (3D) boolean values indicating if the Dirichlet boundary condition is applied for a particular dimension./boundary_conditions/dirichlet_boundary/*/dimension/*
(bool
)
/boundary_conditions/dirichlet_boundary/*/dimension/*
Description
valueDefault: True
Description
Dirichlet boundary condition loaded from a file,/boundary_conditions/neumann_boundary
(list
)
/boundary_conditions/neumann_boundary
Description
The list of boundary conditions for the main variable. Elements of the list are assignment pairs (ID, value) where ID is assigned by surface selection./boundary_conditions/neumann_boundary/*
(object
)
/boundary_conditions/neumann_boundary/*
Description
Neumann boundary conditionDefault: None
Required
/boundary_conditions/neumann_boundary/*/id
/boundary_conditions/neumann_boundary/*/id
Description
ID of boundary condition from surface selection.Range: [0, 2147483646]
Description
select all ids.Options: ['all']
/boundary_conditions/neumann_boundary/*/value
(list
)
/boundary_conditions/neumann_boundary/*/value
Description
Values of boundary condition, length 1 for scalar-valued pde, ⅔ for vector-valued PDEs depending on the dimension./boundary_conditions/neumann_boundary/*/value/*
/boundary_conditions/neumann_boundary/*/value/*
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/boundary_conditions/neumann_boundary/*/value/*/value
/boundary_conditions/neumann_boundary/*/value/*/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/boundary_conditions/neumann_boundary/*/value/*/unit
(string
)
/boundary_conditions/neumann_boundary/*/value/*/unit
Description
The unit of the ValueOptional
/boundary_conditions/neumann_boundary/*/interpolation
(list
)
/boundary_conditions/neumann_boundary/*/interpolation
Description
interpolation of boundary condition/boundary_conditions/neumann_boundary/*/interpolation/*
/boundary_conditions/neumann_boundary/*/interpolation/*
Type: none
Description
interpolation of boundary conditionDefault: {'type': 'none'}
Required
/boundary_conditions/neumann_boundary/*/interpolation/*/type
(string
)
/boundary_conditions/neumann_boundary/*/interpolation/*/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
Type: linear
Description
interpolation of boundary conditionRequired
/boundary_conditions/neumann_boundary/*/interpolation/*/type
(string
)
/boundary_conditions/neumann_boundary/*/interpolation/*/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
Type: linear_ramp
Description
interpolation of boundary conditionRequired
/boundary_conditions/neumann_boundary/*/interpolation/*/type
(string
)
/boundary_conditions/neumann_boundary/*/interpolation/*/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
/boundary_conditions/neumann_boundary/*/interpolation/*/to
(float
)
/boundary_conditions/neumann_boundary/*/interpolation/*/to
Description
interpolation ending timeOptional
/boundary_conditions/neumann_boundary/*/interpolation/*/from
(float
)
/boundary_conditions/neumann_boundary/*/interpolation/*/from
Description
interpolation starting timeDefault: 0
Type: piecewise_constant
Description
interpolation of boundary conditionRequired
/boundary_conditions/neumann_boundary/*/interpolation/*/type
(string
)
/boundary_conditions/neumann_boundary/*/interpolation/*/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
/boundary_conditions/neumann_boundary/*/interpolation/*/points
(list
)
/boundary_conditions/neumann_boundary/*/interpolation/*/points
Description
interpolation time points/boundary_conditions/neumann_boundary/*/interpolation/*/points/*
(float
)
/boundary_conditions/neumann_boundary/*/interpolation/*/points/*
Description
interpolation time point/boundary_conditions/neumann_boundary/*/interpolation/*/values
(list
)
/boundary_conditions/neumann_boundary/*/interpolation/*/values
Description
interpolation values/boundary_conditions/neumann_boundary/*/interpolation/*/values/*
(float
)
/boundary_conditions/neumann_boundary/*/interpolation/*/values/*
Description
interpolation valueOptional
/boundary_conditions/neumann_boundary/*/interpolation/*/extend
(string
)
/boundary_conditions/neumann_boundary/*/interpolation/*/extend
Description
how to extend the piecewise interpolationDefault: 'constant'
Options: ['constant', 'extrapolate', 'repeat', 'repeat_offset']
Type: piecewise_linear
Description
interpolation of boundary conditionRequired
/boundary_conditions/neumann_boundary/*/interpolation/*/type
(string
)
/boundary_conditions/neumann_boundary/*/interpolation/*/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
/boundary_conditions/neumann_boundary/*/interpolation/*/points
(list
)
/boundary_conditions/neumann_boundary/*/interpolation/*/points
Description
interpolation time points/boundary_conditions/neumann_boundary/*/interpolation/*/points/*
(float
)
/boundary_conditions/neumann_boundary/*/interpolation/*/points/*
Description
interpolation time point/boundary_conditions/neumann_boundary/*/interpolation/*/values
(list
)
/boundary_conditions/neumann_boundary/*/interpolation/*/values
Description
interpolation values/boundary_conditions/neumann_boundary/*/interpolation/*/values/*
(float
)
/boundary_conditions/neumann_boundary/*/interpolation/*/values/*
Description
interpolation valueOptional
/boundary_conditions/neumann_boundary/*/interpolation/*/extend
(string
)
/boundary_conditions/neumann_boundary/*/interpolation/*/extend
Description
how to extend the piecewise interpolationDefault: 'constant'
Options: ['constant', 'extrapolate', 'repeat', 'repeat_offset']
Type: piecewise_cubic
Description
interpolation of boundary conditionRequired
/boundary_conditions/neumann_boundary/*/interpolation/*/type
(string
)
/boundary_conditions/neumann_boundary/*/interpolation/*/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
/boundary_conditions/neumann_boundary/*/interpolation/*/points
(list
)
/boundary_conditions/neumann_boundary/*/interpolation/*/points
Description
interpolation time points/boundary_conditions/neumann_boundary/*/interpolation/*/points/*
(float
)
/boundary_conditions/neumann_boundary/*/interpolation/*/points/*
Description
interpolation time point/boundary_conditions/neumann_boundary/*/interpolation/*/values
(list
)
/boundary_conditions/neumann_boundary/*/interpolation/*/values
Description
interpolation values/boundary_conditions/neumann_boundary/*/interpolation/*/values/*
(float
)
/boundary_conditions/neumann_boundary/*/interpolation/*/values/*
Description
interpolation valueOptional
/boundary_conditions/neumann_boundary/*/interpolation/*/extend
(string
)
/boundary_conditions/neumann_boundary/*/interpolation/*/extend
Description
how to extend the piecewise interpolationDefault: 'constant'
Options: ['constant', 'extrapolate', 'repeat', 'repeat_offset']
/boundary_conditions/normal_aligned_neumann_boundary
(list
)
/boundary_conditions/normal_aligned_neumann_boundary
Description
Neumann boundary condition for normal times value for vector-valued PDEs./boundary_conditions/normal_aligned_neumann_boundary/*
(object
)
/boundary_conditions/normal_aligned_neumann_boundary/*
Description
pressure BC entryDefault: None
Required
/boundary_conditions/normal_aligned_neumann_boundary/*/id
(int
)
/boundary_conditions/normal_aligned_neumann_boundary/*/id
Description
ID for the pressure Neumann boundary conditionRange: [0, 2147483646]
/boundary_conditions/normal_aligned_neumann_boundary/*/value
/boundary_conditions/normal_aligned_neumann_boundary/*/value
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/boundary_conditions/normal_aligned_neumann_boundary/*/value/value
/boundary_conditions/normal_aligned_neumann_boundary/*/value/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/boundary_conditions/normal_aligned_neumann_boundary/*/value/unit
(string
)
/boundary_conditions/normal_aligned_neumann_boundary/*/value/unit
Description
The unit of the ValueOptional
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation
Type: none
Description
interpolation of boundary conditionDefault: {'type': 'none'}
Required
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/type
(string
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
Type: linear
Description
interpolation of boundary conditionRequired
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/type
(string
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
Type: linear_ramp
Description
interpolation of boundary conditionRequired
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/type
(string
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/to
(float
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/to
Description
interpolation ending timeOptional
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/from
(float
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/from
Description
interpolation starting timeDefault: 0
Type: piecewise_constant
Description
interpolation of boundary conditionRequired
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/type
(string
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/points
(list
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/points
Description
interpolation time points/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/points/*
(float
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/points/*
Description
interpolation time point/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/values
(list
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/values
Description
interpolation values/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/values/*
(float
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/values/*
Description
interpolation valueOptional
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/extend
(string
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/extend
Description
how to extend the piecewise interpolationDefault: 'constant'
Options: ['constant', 'extrapolate', 'repeat', 'repeat_offset']
Type: piecewise_linear
Description
interpolation of boundary conditionRequired
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/type
(string
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/points
(list
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/points
Description
interpolation time points/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/points/*
(float
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/points/*
Description
interpolation time point/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/values
(list
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/values
Description
interpolation values/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/values/*
(float
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/values/*
Description
interpolation valueOptional
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/extend
(string
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/extend
Description
how to extend the piecewise interpolationDefault: 'constant'
Options: ['constant', 'extrapolate', 'repeat', 'repeat_offset']
Type: piecewise_cubic
Description
interpolation of boundary conditionRequired
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/type
(string
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/points
(list
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/points
Description
interpolation time points/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/points/*
(float
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/points/*
Description
interpolation time point/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/values
(list
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/values
Description
interpolation values/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/values/*
(float
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/values/*
Description
interpolation valueOptional
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/extend
(string
)
/boundary_conditions/normal_aligned_neumann_boundary/*/interpolation/extend
Description
how to extend the piecewise interpolationDefault: 'constant'
Options: ['constant', 'extrapolate', 'repeat', 'repeat_offset']
/boundary_conditions/pressure_boundary
(list
)
/boundary_conditions/pressure_boundary
Description
Neumann boundary condition for normal times value for vector-valued PDEs./boundary_conditions/pressure_boundary/*
(object
)
/boundary_conditions/pressure_boundary/*
Description
pressure BC entryDefault: None
Required
/boundary_conditions/pressure_boundary/*/id
(int
)
/boundary_conditions/pressure_boundary/*/id
Description
ID for the pressure Neumann boundary conditionRange: [0, 2147483646]
/boundary_conditions/pressure_boundary/*/value
/boundary_conditions/pressure_boundary/*/value
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/boundary_conditions/pressure_boundary/*/value/value
/boundary_conditions/pressure_boundary/*/value/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/boundary_conditions/pressure_boundary/*/value/unit
(string
)
/boundary_conditions/pressure_boundary/*/value/unit
Description
The unit of the ValueDescription
Values of pressure boundary condition specified per timestep/boundary_conditions/pressure_boundary/*/value/*
/boundary_conditions/pressure_boundary/*/value/*
Description
Value as a constant floatDefault: 0
Description
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/boundary_conditions/pressure_boundary/*/value/*/value
/boundary_conditions/pressure_boundary/*/value/*/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/boundary_conditions/pressure_boundary/*/value/*/unit
(string
)
/boundary_conditions/pressure_boundary/*/value/*/unit
Description
The unit of the ValueOptional
/boundary_conditions/pressure_boundary/*/time_reference
(list
)
/boundary_conditions/pressure_boundary/*/time_reference
Description
List of times when the pressure boundary condition is specified/boundary_conditions/pressure_boundary/*/time_reference/*
(float
)
/boundary_conditions/pressure_boundary/*/time_reference/*
Description
Values of pressure boundary condition for timestep/boundary_conditions/pressure_cavity
(list
)
/boundary_conditions/pressure_cavity
Description
Neumann boundary condition for normal times value for vector-valued PDEs./boundary_conditions/pressure_cavity/*
(object
)
/boundary_conditions/pressure_cavity/*
Description
pressure BC entryDefault: None
Required
/boundary_conditions/pressure_cavity/*/id
(int
)
/boundary_conditions/pressure_cavity/*/id
Description
ID for the pressure Neumann boundary conditionRange: [0, 2147483646]
/boundary_conditions/pressure_cavity/*/value
/boundary_conditions/pressure_cavity/*/value
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/boundary_conditions/pressure_cavity/*/value/value
/boundary_conditions/pressure_cavity/*/value/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/boundary_conditions/pressure_cavity/*/value/unit
(string
)
/boundary_conditions/pressure_cavity/*/value/unit
Description
The unit of the Value/boundary_conditions/obstacle_displacements
(list
)
/boundary_conditions/obstacle_displacements
Description
The list of boundary conditions for the main variable. Elements of the list are assignment pairs (ID, value) where ID is assigned by surface selection./boundary_conditions/obstacle_displacements/*
(object
)
/boundary_conditions/obstacle_displacements/*
Description
Obstacle displacementsDefault: None
Required
/boundary_conditions/obstacle_displacements/*/id
/boundary_conditions/obstacle_displacements/*/id
Description
ID of boundary condition from surface selection.Range: [0, 2147483646]
Description
select all ids.Options: ['all']
/boundary_conditions/obstacle_displacements/*/value
(list
)
/boundary_conditions/obstacle_displacements/*/value
Description
Values of boundary condition, length 1 for scalar-valued pde, ⅔ for vector-valued PDEs depending on the dimension./boundary_conditions/obstacle_displacements/*/value/*
/boundary_conditions/obstacle_displacements/*/value/*
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/boundary_conditions/obstacle_displacements/*/value/*/value
/boundary_conditions/obstacle_displacements/*/value/*/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/boundary_conditions/obstacle_displacements/*/value/*/unit
(string
)
/boundary_conditions/obstacle_displacements/*/value/*/unit
Description
The unit of the ValueOptional
/boundary_conditions/obstacle_displacements/*/interpolation
(list
)
/boundary_conditions/obstacle_displacements/*/interpolation
Description
interpolation of boundary condition/boundary_conditions/obstacle_displacements/*/interpolation/*
/boundary_conditions/obstacle_displacements/*/interpolation/*
Type: none
Description
interpolation of boundary conditionDefault: {'type': 'none'}
Required
/boundary_conditions/obstacle_displacements/*/interpolation/*/type
(string
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
Type: linear
Description
interpolation of boundary conditionRequired
/boundary_conditions/obstacle_displacements/*/interpolation/*/type
(string
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
Type: linear_ramp
Description
interpolation of boundary conditionRequired
/boundary_conditions/obstacle_displacements/*/interpolation/*/type
(string
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
/boundary_conditions/obstacle_displacements/*/interpolation/*/to
(float
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/to
Description
interpolation ending timeOptional
/boundary_conditions/obstacle_displacements/*/interpolation/*/from
(float
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/from
Description
interpolation starting timeDefault: 0
Type: piecewise_constant
Description
interpolation of boundary conditionRequired
/boundary_conditions/obstacle_displacements/*/interpolation/*/type
(string
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
/boundary_conditions/obstacle_displacements/*/interpolation/*/points
(list
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/points
Description
interpolation time points/boundary_conditions/obstacle_displacements/*/interpolation/*/points/*
(float
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/points/*
Description
interpolation time point/boundary_conditions/obstacle_displacements/*/interpolation/*/values
(list
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/values
Description
interpolation values/boundary_conditions/obstacle_displacements/*/interpolation/*/values/*
(float
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/values/*
Description
interpolation valueOptional
/boundary_conditions/obstacle_displacements/*/interpolation/*/extend
(string
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/extend
Description
how to extend the piecewise interpolationDefault: 'constant'
Options: ['constant', 'extrapolate', 'repeat', 'repeat_offset']
Type: piecewise_linear
Description
interpolation of boundary conditionRequired
/boundary_conditions/obstacle_displacements/*/interpolation/*/type
(string
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
/boundary_conditions/obstacle_displacements/*/interpolation/*/points
(list
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/points
Description
interpolation time points/boundary_conditions/obstacle_displacements/*/interpolation/*/points/*
(float
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/points/*
Description
interpolation time point/boundary_conditions/obstacle_displacements/*/interpolation/*/values
(list
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/values
Description
interpolation values/boundary_conditions/obstacle_displacements/*/interpolation/*/values/*
(float
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/values/*
Description
interpolation valueOptional
/boundary_conditions/obstacle_displacements/*/interpolation/*/extend
(string
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/extend
Description
how to extend the piecewise interpolationDefault: 'constant'
Options: ['constant', 'extrapolate', 'repeat', 'repeat_offset']
Type: piecewise_cubic
Description
interpolation of boundary conditionRequired
/boundary_conditions/obstacle_displacements/*/interpolation/*/type
(string
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/type
Description
type of interpolation of boundary conditionOptions: ['none', 'linear', 'linear_ramp', 'piecewise_constant', 'piecewise_linear', 'piecewise_cubic']
/boundary_conditions/obstacle_displacements/*/interpolation/*/points
(list
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/points
Description
interpolation time points/boundary_conditions/obstacle_displacements/*/interpolation/*/points/*
(float
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/points/*
Description
interpolation time point/boundary_conditions/obstacle_displacements/*/interpolation/*/values
(list
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/values
Description
interpolation values/boundary_conditions/obstacle_displacements/*/interpolation/*/values/*
(float
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/values/*
Description
interpolation valueOptional
/boundary_conditions/obstacle_displacements/*/interpolation/*/extend
(string
)
/boundary_conditions/obstacle_displacements/*/interpolation/*/extend
Description
how to extend the piecewise interpolationDefault: 'constant'
Options: ['constant', 'extrapolate', 'repeat', 'repeat_offset']
/boundary_conditions/periodic_boundary
(object
)
/boundary_conditions/periodic_boundary
Description
Options for periodic boundary conditions.Default: None
Optional
/boundary_conditions/periodic_boundary/enabled
(bool
)
/boundary_conditions/periodic_boundary/enabled
Description
Default: False
/boundary_conditions/periodic_boundary/tolerance
(float
)
/boundary_conditions/periodic_boundary/tolerance
Description
Relative tolerance of deciding periodic correspondenceDefault: 1e-05
/boundary_conditions/periodic_boundary/correspondence
(list
)
/boundary_conditions/periodic_boundary/correspondence
Description
Periodic directions for periodic boundary conditions. If not specified, default to axis-aligned directions./boundary_conditions/periodic_boundary/correspondence/*
(list
)
/boundary_conditions/periodic_boundary/correspondence/*
Description
One periodic direction./boundary_conditions/periodic_boundary/correspondence/*/*
(float
)
/boundary_conditions/periodic_boundary/correspondence/*/*
Description
One entry of a periodic direction./boundary_conditions/periodic_boundary/linear_displacement_offset
(list
)
/boundary_conditions/periodic_boundary/linear_displacement_offset
Description
/boundary_conditions/periodic_boundary/linear_displacement_offset/*
(list
)
/boundary_conditions/periodic_boundary/linear_displacement_offset/*
Description
/boundary_conditions/periodic_boundary/linear_displacement_offset/*/*
/boundary_conditions/periodic_boundary/linear_displacement_offset/*/*
Description
Description
/boundary_conditions/periodic_boundary/fixed_macro_strain
(list
)
/boundary_conditions/periodic_boundary/fixed_macro_strain
Description
/boundary_conditions/periodic_boundary/fixed_macro_strain/*
(int
)
/boundary_conditions/periodic_boundary/fixed_macro_strain/*
Description
/boundary_conditions/periodic_boundary/force_zero_mean
(bool
)
/boundary_conditions/periodic_boundary/force_zero_mean
Description
The periodic solution is not unique, set to true to find the solution with zero mean.Default: False
/initial_conditions
(object
)
/initial_conditions
Description
Initial conditions for the time-dependent problem, imposed on the main variable, its derivative or second derivativeDefault: None
Optional
/initial_conditions/solution
(list
)
/initial_conditions/solution
Description
initial solution/initial_conditions/solution/*
(object
)
/initial_conditions/solution/*
Description
A list of (ID, value) pairs defining the initial conditions for the main variable values. Ids are set by selection, and values can be floats or formulas.Default: None
Required
/initial_conditions/solution/*/id
(int
)
/initial_conditions/solution/*/id
Description
ID from volume selections/initial_conditions/solution/*/value
(list
)
/initial_conditions/solution/*/value
Description
value of the solution/initial_conditions/solution/*/value/*
/initial_conditions/solution/*/value/*
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/initial_conditions/solution/*/value/*/value
/initial_conditions/solution/*/value/*/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/initial_conditions/solution/*/value/*/unit
(string
)
/initial_conditions/solution/*/value/*/unit
Description
The unit of the Value/initial_conditions/velocity
(list
)
/initial_conditions/velocity
Description
initial velocity/initial_conditions/velocity/*
(object
)
/initial_conditions/velocity/*
Description
A list of (ID, value) pairs defining the initial conditions for the first derivative of the main variable values. Ids are set by selection, and values can be floats or formulas.Default: None
Required
/initial_conditions/velocity/*/id
(int
)
/initial_conditions/velocity/*/id
Description
ID from volume selections/initial_conditions/velocity/*/value
(list
)
/initial_conditions/velocity/*/value
Description
value od the initial velocity/initial_conditions/velocity/*/value/*
/initial_conditions/velocity/*/value/*
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/initial_conditions/velocity/*/value/*/value
/initial_conditions/velocity/*/value/*/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/initial_conditions/velocity/*/value/*/unit
(string
)
/initial_conditions/velocity/*/value/*/unit
Description
The unit of the Value/initial_conditions/acceleration
(list
)
/initial_conditions/acceleration
Description
initial acceleration/initial_conditions/acceleration/*
(object
)
/initial_conditions/acceleration/*
Description
entriesDefault: None
Required
/initial_conditions/acceleration/*/id
(int
)
/initial_conditions/acceleration/*/id
Description
ID from volume selections/initial_conditions/acceleration/*/value
(list
)
/initial_conditions/acceleration/*/value
Description
value/initial_conditions/acceleration/*/value/*
/initial_conditions/acceleration/*/value/*
Description
Value as a constant floatDescription
Value as an expression of \(x,y,z,t\) or a fileDescription
Value with unitRequired
/initial_conditions/acceleration/*/value/*/value
/initial_conditions/acceleration/*/value/*/value
Description
The value of the constantDescription
The value as an expressionDescription
The value as a file/initial_conditions/acceleration/*/value/*/unit
(string
)
/initial_conditions/acceleration/*/value/*/unit
Description
The unit of the Value/output
(object
)
/output
Description
output settingsDefault: None
Optional
/output/directory
(string
)
/output/directory
Description
Directory for output files.Default: ''
/output/log
(object
)
/output/log
Description
Setting for the output log.Default: None
Optional
/output/log/level
/output/log/level
Description
Level of logging, 0 trace, 1 debug, 2 info, 3 warning, 4 error, 5 critical, and 6 off.Range: [0, 6]
Description
Level of logging.Default: 'debug'
Options: ['trace', 'debug', 'info', 'warning', 'error', 'critical', 'off']
/output/log/file_level
/output/log/file_level
Description
Level of logging to a file, 0 trace, 1 debug, 2 info, 3 warning, 4 error, 5 critical, and 6 off.Range: [0, 6]
Description
Level of logging.Default: 'trace'
Options: ['trace', 'debug', 'info', 'warning', 'error', 'critical', 'off']
/output/log/path
(string
)
/output/log/path
Description
File where to save the log; empty string is output to terminal.Default: ''
/output/log/quiet
(bool
)
/output/log/quiet
Description
Disable cout for logging.Default: False
/output/json
(string
)
/output/json
Description
File name for JSON output statistics on time/error/etc.Default: ''
/output/restart_json
(string
)
/output/restart_json
Description
File name for JSON output to restart the simulation.Default: ''
/output/paraview
(object
)
/output/paraview
Description
Output in paraview formatDefault: None
Optional
/output/paraview/file_name
(string
)
/output/paraview/file_name
Description
Paraview output file nameDefault: ''
/output/paraview/vismesh_rel_area
(float
)
/output/paraview/vismesh_rel_area
Description
relative area for the upsampled visualisation meshDefault: 1e-05
/output/paraview/skip_frame
(int
)
/output/paraview/skip_frame
Description
export every skip_frame-th frames for time dependent simulationsDefault: 1
/output/paraview/high_order_mesh
(bool
)
/output/paraview/high_order_mesh
Description
Enables/disables high-order output for paraview. Supported only for isoparametric or linear meshes with high-order solutions.Default: True
/output/paraview/volume
(bool
)
/output/paraview/volume
Description
Export volumetric meshDefault: True
/output/paraview/surface
(bool
)
/output/paraview/surface
Description
Export surface mesh (in 2d polygon)Default: False
/output/paraview/wireframe
(bool
)
/output/paraview/wireframe
Description
Export the wireframe of the meshDefault: False
/output/paraview/points
(bool
)
/output/paraview/points
Description
Export the Dirichlet pointsDefault: False
/output/paraview/options
(object
)
/output/paraview/options
Description
Optional fields in the outputDefault: None
Optional
/output/paraview/options/use_hdf5
(bool
)
/output/paraview/options/use_hdf5
Description
If true, export the data as hdf5, compatible with paraview >5.11Default: False
/output/paraview/options/material
(bool
)
/output/paraview/options/material
Description
If true, write out material values sampled on the vertices of the meshDefault: False
/output/paraview/options/body_ids
(bool
)
/output/paraview/options/body_ids
Description
Export volumes idsDefault: False
/output/paraview/options/contact_forces
(bool
)
/output/paraview/options/contact_forces
Description
If true, write out contact forces for surfaceDefault: False
/output/paraview/options/friction_forces
(bool
)
/output/paraview/options/friction_forces
Description
If true, write out friction forces for surfaceDefault: False
/output/paraview/options/velocity
(bool
)
/output/paraview/options/velocity
Description
If true, write out velocitiesDefault: False
/output/paraview/options/acceleration
(bool
)
/output/paraview/options/acceleration
Description
If true, write out accelerationsDefault: False
/output/paraview/options/scalar_values
(bool
)
/output/paraview/options/scalar_values
Description
If true, write out scalar valuesDefault: True
/output/paraview/options/tensor_values
(bool
)
/output/paraview/options/tensor_values
Description
If true, write out tensor valuesDefault: True
/output/paraview/options/discretization_order
(bool
)
/output/paraview/options/discretization_order
Description
If true, write out discretization orderDefault: True
/output/paraview/options/nodes
(bool
)
/output/paraview/options/nodes
Description
If true, write out node orderDefault: True
/output/paraview/options/forces
(bool
)
/output/paraview/options/forces
Description
If true, write out all variational forces on the FE meshDefault: False
/output/data
(object
)
/output/data
Description
File names to write output data to.Default: None
Optional
/output/data/solution
(string
)
/output/data/solution
Description
Main variable solution. Unrolled [xyz, xyz, …] using PolyFEM ordering. If reorder_nodes exports the solution with the same order the vertices of the input mesh as a #n x d fileDefault: ''
/output/data/full_mat
(string
)
/output/data/full_mat
Description
System matrix without boundary conditions. Doesn’t work for nonlinear problemsDefault: ''
/output/data/stiffness_mat
(string
)
/output/data/stiffness_mat
Description
System matrix with boundary conditions. Doesn’t work for nonlinear problemsDefault: ''
/output/data/stress_mat
(string
)
/output/data/stress_mat
Description
Exports stressDefault: ''
/output/data/state
(string
)
/output/data/state
Description
Writes the complete state in PolyFEM hdf5 format, used to restart the simDefault: ''
/output/data/rest_mesh
(string
)
/output/data/rest_mesh
Description
Writes the rest mesh in MSH format, used to restart the simDefault: ''
/output/data/mises
(string
)
/output/data/mises
Description
File name to write per-node Von Mises stress values to.Default: ''
/output/data/nodes
(string
)
/output/data/nodes
Description
Writes the FEM nodesDefault: ''
/output/data/advanced
(object
)
/output/data/advanced
Description
advanced optionsDefault: None
Optional
/output/data/advanced/reorder_nodes
(bool
)
/output/data/advanced/reorder_nodes
Description
Reorder nodes accodring to inputDefault: False
/output/advanced
(object
)
/output/advanced
Description
Additional output optionsDefault: None
Optional
/output/advanced/timestep_prefix
(string
)
/output/advanced/timestep_prefix
Description
Prefix for output file names for each time step, the final file is step_i.[vtu|vtm] where i is the time index.Default: 'step_'
/output/advanced/sol_on_grid
(float
)
/output/advanced/sol_on_grid
Description
exports the solution sampled on a grid, specify the grid spacingDefault: -1
/output/advanced/compute_error
(bool
)
/output/advanced/compute_error
Description
Enables the computation of the error. If no reference solution is provided, return the norms of the solutionDefault: True
/output/advanced/sol_at_node
(int
)
/output/advanced/sol_at_node
Description
Write out solution values at a specific node. the values will be written in the output JSON fileDefault: -1
/output/advanced/vis_boundary_only
(bool
)
/output/advanced/vis_boundary_only
Description
saves only elements touching the boundariesDefault: False
/output/advanced/curved_mesh_size
(bool
)
/output/advanced/curved_mesh_size
Description
upsample curved edges to compute mesh sizeDefault: False
/output/advanced/save_solve_sequence_debug
(bool
)
/output/advanced/save_solve_sequence_debug
Description
saves AL internal steps, for debuggingDefault: False
/output/advanced/save_ccd_debug_meshes
(bool
)
/output/advanced/save_ccd_debug_meshes
Description
saves AL internal steps, for debuggingDefault: False
/output/advanced/save_time_sequence
(bool
)
/output/advanced/save_time_sequence
Description
saves timestepsDefault: True
/output/advanced/save_nl_solve_sequence
(bool
)
/output/advanced/save_nl_solve_sequence
Description
saves obj after every nonlinear iteration, for debuggingDefault: False
/output/advanced/spectrum
(bool
)
/output/advanced/spectrum
Description
exports the spectrum of the matrix in the output JSON. Works only if POLYSOLVE_WITH_SPECTRA is enabledDefault: False
/output/reference
(object
)
/output/reference
Description
Write out the analytic/numerical ground-truth solution and or its gradientDefault: None
Optional
/output/reference/solution
(list
)
/output/reference/solution
Description
reference solution used to compute errors/output/reference/solution/*
(string
)
/output/reference/solution/*
Description
value as a function of \(x,y,z,t\)Default: ''
/output/reference/gradient
(list
)
/output/reference/gradient
Description
gradient of the reference solution to compute errors/output/reference/gradient/*
(string
)
/output/reference/gradient/*
Description
value as a function of \(x,y,z,t\)Default: ''
/input
(object
)
/input
Description
input dataDefault: None
Optional
/input/data
(object
)
/input/data
Description
input to restart time dependent simDefault: None
Optional
/input/data/state
(file
)
/input/data/state
Description
input state as hdf5Default: ''
/input/data/reorder
(bool
)
/input/data/reorder
Description
reorder input dataDefault: False
/tests
(object
)
/tests
Description
Used to test to compare different norms of solutions.Default: None
Optional
/tests/err_h1
(float
)
/tests/err_h1
Description
Reference h1 solution’s norm.Default: 0
/tests/err_h1_semi
(float
)
/tests/err_h1_semi
Description
Reference h1 seminorm solution’s norm.Default: 0
/tests/err_l2
(float
)
/tests/err_l2
Description
Reference \(L^2\) solution’s norm.Default: 0
/tests/err_linf
(float
)
/tests/err_linf
Description
Reference \(L^\infty\) solution’s norm.Default: 0
/tests/err_linf_grad
(float
)
/tests/err_linf_grad
Description
Reference \(L^\infty\) solution’s gradient norm.Default: 0
/tests/err_lp
(float
)
/tests/err_lp
Description
Reference \(L^8\) solution’s gradient norm.Default: 0
/tests/margin
(float
)
/tests/margin
Description
Reference tolerance used in tests.Default: 1e-05
/tests/time_steps
/tests/time_steps
Description
Number of time steps to test.Default: 1
Range: [1, inf]
Description
Number of time steps to test.Options: ['all', 'static']