OpenCMISS-Iron Internal API Documentation
|
This module contains all type definitions in order to avoid cyclic module references. More...
Go to the source code of this file.
Data Types | |
type | types::real_dp_ptr_type |
type | types::integer_intg_ptr_type |
type | types::integer_cint_alloc_type |
type | types::list_ptr_type |
Buffer type to allow arrays of pointers to a list. More... | |
type | types::list_type |
Contains information on a list. More... | |
type | types::quadrature_scheme_type |
Contains information for a particular quadrature scheme. More... | |
type | types::quadrature_scheme_ptr_type |
A buffer type to allow for an array of pointers to a QUADRATURE_SCHEME_TYPE. More... | |
type | types::quadrature_type |
Contains information on the quadrature to be used for integrating a basis. More... | |
type | types::basis_ptr_type |
A buffer type to allow for an array of pointers to a BASIS_TYPE. More... | |
type | types::basis_type |
Contains all information about a basis . More... | |
type | types::basis_functions_type |
Contains information on the defined basis functions. More... | |
type | types::coordinate_system_type |
Contains information on a coordinate system. More... | |
type | types::coordinate_system_ptr_type |
A buffer type to allow for an array of pointers to a COORDINATE_SYSTEM_TYPE. More... | |
type | types::data_projection_result_type |
Contains information about a data projection result. More... | |
type | types::data_projection_type |
type | types::data_projection_ptr_type |
A buffer type to allow for an array of pointers to a DATA_PROJECTION_TYPE. More... | |
type | types::data_point_type |
Contains information about a data point. More... | |
type | types::data_points_type |
Contains information on the data points defined on a region. More... | |
type | types::node_type |
Contains information about a node. More... | |
type | types::nodes_type |
Contains information on the nodes defined on a region. More... | |
type | types::meshdofstype |
Contains information on the dofs for a mesh. More... | |
type | types::mesh_adjacent_element_type |
Contains information on the mesh adjacent elements for a xi coordinate. More... | |
type | types::mesh_element_type |
Contains the information for an element in a mesh. More... | |
type | types::meshelementstype |
Contains the information for the elements of a mesh. More... | |
type | types::meshnodederivativetype |
Contains the information for a node derivative of a mesh. More... | |
type | types::meshnodetype |
Contains the topology information for a global node of a mesh. More... | |
type | types::meshnodestype |
Contains the information for the nodes of a mesh. More... | |
type | types::meshelementdatapointtype |
type | types::meshelementdatapointstype |
Contains information on the projected data points on an element. More... | |
type | types::meshdatapointtype |
Contains information of the projected data point. More... | |
type | types::meshdatapointstype |
type | types::meshcomponenttopologytype |
Contains information on the (global) topology of a mesh. More... | |
type | types::meshcomponenttopologyptrtype |
A buffer type to allow for an array of pointers to a MeshComponentTopologyType. More... | |
type | types::embedding_xi_type |
Embedded mesh types. More... | |
type | types::embedding_gausspoint_type |
type | types::mesh_embedding_type |
type | types::mesh_type |
Contains information on a mesh defined on a region. More... | |
type | types::mesh_ptr_type |
A buffer type to allow for an array of pointers to a MESH_TYPE. More... | |
type | types::meshes_type |
Contains information on the meshes defined on a region. More... | |
type | types::generated_mesh_regular_type |
Contains information on a generated regular mesh. More... | |
type | types::generated_mesh_cylinder_type |
Contains information of a generated cylinder mesh Allows only a 3D cylinder mesh with xi directions (r,theta,z) More... | |
type | types::generated_mesh_ellipsoid_type |
Contains information of a generated ellipsoid mesh Allows only a 3D ellipsoid mesh. More... | |
type | types::generated_mesh_type |
Contains information on a generated mesh. More... | |
type | types::generated_mesh_ptr_type |
A buffer type to allow for an array of pointers to a GENERATED_MESH_TYPE. More... | |
type | types::generated_meshes_type |
Contains information on the generated meshes defined on a region. More... | |
type | types::domain_dofs_type |
Contains information on the degrees-of-freedom (dofs) for a domain. More... | |
type | types::domain_line_type |
Contains the information for a line in a domain. More... | |
type | types::domain_line_ptr_type |
A buffer type to allow for an array of pointers to a DOMAIN_LINE_TYPE. More... | |
type | types::domain_lines_type |
Contains the topology information for the lines of a domain. More... | |
type | types::domain_face_type |
Contains the information for a face in a domain. More... | |
type | types::domain_face_ptr_type |
A buffer type to allow for an array of pointers to a DOMAIN_FACE_TYPE. More... | |
type | types::domain_faces_type |
Contains the topology information for the faces of a domain. More... | |
type | types::domain_element_type |
Contains the information for an element in a domain. More... | |
type | types::domain_elements_type |
Contains the topology information for the elements of a domain. More... | |
type | types::domain_node_derivative_type |
Contains the topology information for a local node derivative of a domain. More... | |
type | types::domain_node_type |
Contains the topology information for a local node of a domain. More... | |
type | types::domain_nodes_type |
Contains the topology information for the nodes of a domain. More... | |
type | types::domain_topology_type |
Contains the topology information for a domain. More... | |
type | types::distributed_vector_transfer_type |
Contains the information for an adjacent domain for transfering the ghost data of a distributed vector to/from the current domain. More... | |
type | types::distributed_vector_cmiss_type |
Contains information for a CMISS distributed vector. More... | |
type | types::distributed_vector_petsc_type |
Contains information for a PETSc distributed vector. More... | |
type | types::distributed_vector_type |
Contains the information for a vector that is distributed across a number of domains. More... | |
type | types::distributed_matrix_cmiss_type |
Contains information for a CMISS distributed matrix. More... | |
type | types::distributed_matrix_petsc_type |
Contains information for a PETSc distributed matrix. More... | |
type | types::distributed_matrix_type |
Contains the information for a matrix that is distributed across a number of domains. More... | |
type | types::vector_type |
Contains information for a vector. More... | |
type | types::matrix_type |
Contains information for a matrix. More... | |
type | types::domain_adjacent_domain_type |
Contains the information on an adjacent domain to a domain in a domain mapping. More... | |
type | types::domain_global_mapping_type |
Contains the local information for a global mapping number for a domain mapping. More... | |
type | types::domain_mapping_type |
Contains information on the domain mappings (i.e., local and global numberings). More... | |
type | types::domain_mappings_type |
Contains information on the domain decomposition mappings. More... | |
type | types::domain_type |
A pointer to the domain decomposition for this domain. More... | |
type | types::domain_ptr_type |
A buffer type to allow for an array of pointers to a DOMAIN_TYPE. More... | |
type | types::decomposition_line_type |
Contains the information for a line in a decomposition. More... | |
type | types::decomposition_lines_type |
Contains the topology information for the lines of a decomposition. More... | |
type | types::decomposition_face_type |
Contains the information for a face in a decomposition. More... | |
type | types::decomposition_faces_type |
Contains the topology information for the faces of a decomposition. More... | |
type | types::decomposition_adjacent_element_type |
Contains information on the decomposition adjacent elements for a xi coordinate. More... | |
type | types::decomposition_element_type |
Contains the information for an element in a decomposition. More... | |
type | types::decomposition_elements_type |
Contains the topology information for the elements of a decomposition. More... | |
type | types::decompositionelementdatapointtype |
Contains data point information. More... | |
type | types::decompositionelementdatapointstype |
Contains information on the projected data points on an element, for decomposition since data points on elements go with the elements. More... | |
type | types::decompositiondatapointstype |
Contains data point decompostion topology. More... | |
type | types::decomposition_topology_type |
Contains the topology information for a decomposition. More... | |
type | types::decomposition_type |
Contains information on the mesh decomposition. More... | |
type | types::decomposition_ptr_type |
A buffer type to allow for an array of pointers to a DECOMPOSITION_TYPE. More... | |
type | types::decompositions_type |
Contains information on the domain decompositions defined on a mesh. More... | |
type | types::field_physical_point_type |
Contains information on a physical point in a field. More... | |
type | types::field_physical_point_ptr_type |
Buffer type to allow for arrays of pointers to FIELD_PHYSICAL_POINT_TYPE. More... | |
type | types::field_interpolated_point_metrics_type |
Contains the interpolated point coordinate metrics. Old CMISS name GL,GU,RG. More... | |
type | types::field_interpolated_point_metrics_ptr_type |
type | types::field_interpolated_point_type |
Contains the interpolated value (and the derivatives wrt xi) of a field at a point. Old CMISS name XG. More... | |
type | types::field_interpolated_point_ptr_type |
type | types::field_interpolation_parameters_type |
Contains the parameters required to interpolate a field variable within an element. Old CMISS name XE. More... | |
type | types::field_interpolation_parameters_ptr_type |
type | types::field_geometric_parameters_type |
Contains the geometric parameters (lines, faces, volumes etc.) for a geometric field decomposition. More... | |
type | types::field_scaling_type |
A type to hold the scale factors for the appropriate mesh component of a field. More... | |
type | types::field_scalings_type |
A type to hold the field scalings for the field. More... | |
type | types::field_dof_to_param_map_type |
A type to hold the mapping from field dof numbers to field parameters (nodes, elements, etc) More... | |
type | types::field_node_param_to_dof_map_derivative_type |
A type to hold the mapping from a field node derivative's versions to field dof numbers for a particular field variable component. More... | |
type | types::field_node_param_to_dof_map_node_type |
A type to hold the mapping from a field node's derivative to field dof numbers for a particular field variable component. More... | |
type | types::field_node_param_to_dof_map_type |
A type to hold the mapping from field nodes to field dof numbers for a particular field variable component. More... | |
type | types::field_element_param_to_dof_map_type |
A type to hold the mapping from field elements to field dof numbers for a particular field variable component. More... | |
type | types::field_grid_point_param_to_dof_map_type |
A type to hold the mapping from field grid points to field dof numbers for a particular field variable component. More... | |
type | types::field_gauss_point_param_to_dof_map_type |
A type to hold the mapping from field Gauss points to field dof numbers for a particular field variable component. More... | |
type | types::field_data_point_param_to_dof_map_type |
A type to hold the mapping from field data points to field dof numbers for a particular field variable component. More... | |
type | types::field_param_to_dof_map_type |
A type to hold the mapping from field parameters (nodes, elements, etc) to field dof numbers for a particular field variable component. More... | |
type | types::field_variable_component_type |
Contains information for a component of a field variable. More... | |
type | types::field_parameter_set_type |
A type to hold the parameter sets for a field. More... | |
type | types::field_parameter_set_ptr_type |
A buffer type to allow for an array of pointers to a FIELD_PARAMETER_SET_TYPE. More... | |
type | types::field_parameter_sets_type |
A type to store the parameter sets for a field. More... | |
type | types::field_variable_type |
Contains information for a field variable defined on a field. More... | |
type | types::field_variable_ptr_type |
A buffer type to allow for an array of pointers to a FIELD_VARIABLE_TYPE. More... | |
type | types::field_create_values_cache_type |
A type to temporarily hold (cache) the user modifiable values which are used to create a field. More... | |
type | types::field_type |
Contains information for a field defined on a region. More... | |
type | types::field_ptr_type |
A buffer type to allow for an array of pointers to a FIELD_TYPE. More... | |
type | types::fields_type |
Contains information on the fields defined on a region. More... | |
type | types::element_matrix_type |
Contains information for an element matrix. More... | |
type | types::element_vector_type |
Contains information for an element vector. More... | |
type | types::nodalmatrixtype |
Contains information for an nodal matrix. More... | |
type | types::nodalvectortype |
Contains information for an nodal vector. More... | |
type | types::equations_matrix_type |
Contains information about an equations matrix. More... | |
type | types::equations_matrix_ptr_type |
A buffer type to allow for an array of pointers to a EQUATIONS_MATRIX_TYPE. More... | |
type | types::equations_jacobian_type |
Contains information on the Jacobian matrix for nonlinear problems. More... | |
type | types::equations_jacobian_ptr_type |
A buffer type to allow for an array of pointers to a EQUATIONS_JACOBIAN_TYPE. More... | |
type | types::equations_matrices_dynamic_type |
Contains information of the dynamic matrices for equations matrices. More... | |
type | types::equations_matrices_linear_type |
Contains information of the linear matrices for equations matrices. More... | |
type | types::equations_matrices_nonlinear_type |
Contains information of the nolinear matrices and vectors for equations matrices. More... | |
type | types::equations_matrices_rhs_type |
Contains information of the RHS vector for equations matrices. More... | |
type | types::equations_matrices_source_type |
Contains information of the source vector for equations matrices. More... | |
type | types::equations_matrices_type |
Contains information on the equations matrices and vectors. More... | |
type | types::var_to_equations_column_map_type |
Contains the information about the mapping of a variable DOF to an equations matrix column. More... | |
type | types::var_to_equations_matrices_map_type |
Contains the mapping for a dependent variable type to the equations matrices. More... | |
type | types::equations_matrix_to_var_map_type |
Contains information for mapping an equations matrix to a field variable. More... | |
type | types::equations_mapping_dynamic_type |
Contains information for mapping field variables to the dynamic matrices in the equations set of the mapping. More... | |
type | types::equations_mapping_linear_type |
Contains information for mapping field variables to the linear matrices in the equations set of the mapping. More... | |
type | types::equations_jacobian_to_var_map_type |
Contains the mapping from the Jacobian back to the nonlinear residual variables. More... | |
type | types::var_to_equations_jacobian_map_type |
Contains the mapping for a dependent variable type to the nonlinear Jacobian matrix. More... | |
type | types::equations_mapping_nonlinear_type |
Contains information on the equations mapping for nonlinear matrices i.e., how a field variable is mapped to residual vectors, and how the field variables are mapped to the rows and columns of the associated Jacobian matrices of the equations set of this equations mapping. There may be multiple residual variables with a Jacobian matrix for each variable. More... | |
type | types::equations_mapping_rhs_type |
Contains information on the equations mapping for a RHS i.e., how a field variable is mapped to the RHS vector for the equations set of this equations mapping. More... | |
type | types::equations_mapping_source_type |
Contains information on the equations mapping for a source i.e., how a field variable is mapped to the source vector for the equations set of this equations mapping. More... | |
type | types::equations_mapping_create_values_cache_type |
Contains information on the create values cache for the equations mapping. Because we do not want to allocate and deallocate large data structures as the equations mapping options are changed between create start and create finish we cache the important information and the allocate and process the data structures at create finish. More... | |
type | types::equations_mapping_type |
Contains information on the equations mapping i.e., how field variable DOFS are mapped to the rows and columns of a number of equations matrices. More... | |
type | types::equations_interpolation_type |
Contains information on the interpolation for the equations. More... | |
type | types::equations_type |
Contains information about the equations in an equations set. More... | |
type | types::equations_ptr_type |
type | types::boundary_conditions_variable_type |
Contains information on the boundary conditions for a dependent field variable. More... | |
type | types::boundary_conditions_variable_ptr_type |
A buffer type to allow for an array of pointers to a VARIABLE_BOUNDARY_CONDITIONS_TYPE. More... | |
type | types::boundary_conditions_type |
Contains information on the boundary conditions for the solver equations. More... | |
type | types::boundary_conditions_sparsity_indices_ptr_type |
A buffer type to allow for an array of pointers to a BOUNDARY_CONDITIONS_SPARSITY_INDICES_TYPE. More... | |
type | types::boundary_conditions_dirichlet_type |
Contains information on dofs with associated dirichlet conditions and corresponding non-zero elements in the equations matrices. More... | |
type | types::boundary_conditions_sparsity_indices_type |
Contains information on indices of non-zero elements with associated dirichlet conditions Indices stored in compressed column format without a values array. More... | |
type | types::boundaryconditionsneumanntype |
Contains information used to integrate Neumann boundary conditions. More... | |
type | types::boundary_conditions_pressure_incremented_type |
Contains information on dofs associated with pressure incremented conditions. More... | |
type | types::boundaryconditionsdofconstrainttype |
Describes the value of a DOF as a linear combination of other DOFs. More... | |
type | types::boundaryconditionsdofconstraintptrtype |
A pointer to a linear DOF constraint. More... | |
type | types::boundaryconditionscoupleddofstype |
The coupled equations DOF information for the DOF constraints. The BoundaryConditionsDofConstraintType describes how an equations DOF is a linear combination of other equations DOFs. This data structure describes a solver row or column that is mapped to multiple equations rows or columns and is used to help build the solver mapping. The first equation row/column is used as the owner of the solver row/column. More... | |
type | types::boundaryconditionscoupleddofsptrtype |
A pointer to the coupled equations DOF information for the DOF constraints. More... | |
type | types::boundaryconditionsdofconstraintstype |
Describes linear constraints between solver DOFs in the solver mapping. More... | |
type | types::equations_set_setup_type |
Contains information on the setup information for an equations set. More... | |
type | types::equations_set_geometry_type |
Contains information on the geometry for an equations set. More... | |
type | types::equations_set_materials_type |
type | types::equations_set_dependent_type |
Contains information on the dependent variables for the equations set. More... | |
type | types::equationssetderivedtype |
Contains information on the derived variables for the equations set, eg. stress or strain. More... | |
type | types::equations_set_independent_type |
Contains information on the independent variables for the equations set. More... | |
type | types::equations_set_source_type |
Contains information on the source for the equations set. More... | |
type | types::equations_set_analytic_type |
Contains information on the analytic setup for the equations set. More... | |
type | types::equations_set_equations_set_field_type |
type | types::equations_set_type |
Contains information on an equations set. More... | |
type | types::equations_set_ptr_type |
A buffer type to allow for an array of pointers to a EQUATIONS_SET_TYPE. More... | |
type | types::equations_sets_type |
type | types::interface_matrix_type |
Contains information about an interface matrix. More... | |
type | types::interface_matrix_ptr_type |
A buffer type to allow for an array of pointers to a INTERFACE_MATRIX_TYPE. More... | |
type | types::interface_rhs_type |
Contains information of the RHS vector for interface matrices. More... | |
type | types::interface_matrices_type |
Contains information on the interface matrices. More... | |
type | types::interface_matrix_to_var_map_type |
Contains information on interface variable mapping for an interface matrix. More... | |
type | types::interface_mapping_rhs_type |
type | types::interface_mapping_create_values_cache_type |
type | types::interface_mapping_type |
Contains information on an interface mapping. TODO: Generalise to non-Lagrange multipler mappings. More... | |
type | types::interface_equations_interpolation_set_type |
Contains information about the interpolation for a parameter set in interface equations. More... | |
type | types::interface_equations_domain_interpolation_type |
Contains information about the interpolation for a domain (interface or coupled mesh) in the interface equations. More... | |
type | types::interface_equations_interpolation_type |
Contains information on the interpolation for the interface equations. More... | |
type | types::interface_equations_type |
Contains information about the interface equations for an interface condition. More... | |
type | types::interface_geometry_type |
Contains information on the geometry for an interface condition. More... | |
type | types::interface_penalty_type |
Contains information about the penalty field information for an interface condition. More... | |
type | types::interface_lagrange_type |
Contains information about the Lagrange field information for an interface condition. More... | |
type | types::interface_dependent_type |
Contains information about the dependent field information for an interface condition. More... | |
type | types::interface_condition_type |
Contains information for the interface condition data. More... | |
type | types::interface_condition_ptr_type |
A buffer type to allow for an array of pointers to a INTERFACE_CONDITION_TYPE. More... | |
type | types::interface_conditions_type |
Contains information for interface region specific data that is not of 'region' importance. <<>> More... | |
type | types::interface_element_connectivity_type |
Contains information on the mesh connectivity for a given coupled mesh element. More... | |
type | types::interface_mesh_connectivity_type |
Contains information on the coupling between meshes in an interface. More... | |
type | types::interfacepointconnectivitytype |
Contains information on a data connectivity point. More... | |
type | types::interfacecoupledelementstype |
type | types::interfacepointsconnectivitytype |
Contains information on the data point coupling/points connectivity between meshes in the an interface. More... | |
type | types::interface_type |
Contains information for the interface data. More... | |
type | types::interface_ptr_type |
A buffer type to allow for an array of pointers to a INTERFACE_TYPE. More... | |
type | types::interfaces_type |
Contains information for interfaces on a parent region. More... | |
type | types::cellml_model_type |
This type is a wrapper for the C_PTR which references the actual CellML model definition object. More... | |
type | types::cellml_model_ptr_type |
A buffer type to allow for an array of pointers to a CELLML_MODEL_TYPE. More... | |
type | types::cellml_models_field_type |
Contains information on the models field for a CellML environment. More... | |
type | types::cellml_state_field_type |
Contains information on the state field for a CellML environment. More... | |
type | types::cellml_intermediate_field_type |
Contains information on the intermediate field for a CellML environment. More... | |
type | types::cellml_parameters_field_type |
Contains information on the parameters field for a CellML environment. More... | |
type | types::cellmlpetsccontexttype |
Contains information on the solver, cellml, dof etc. for which cellml equations are to be evaluated by petsc. More... | |
type | types::cellml_model_map_type |
Contains information on the mapping between CellML fields and OpenCMISS fields and vise versa. More... | |
type | types::cellml_model_map_ptr_type |
Buffer type to allow an array of pointers to CELLML_MODEL_MAP_FIELD_TYPE. More... | |
type | types::cellml_model_maps_type |
Contains information on the maps between a CellML model and external OpenCMISS fields. More... | |
type | types::cellml_model_maps_ptr_type |
Buffer type to allow arrays of pointer to CELLML_MODEL_MAPS_TYPE. More... | |
type | types::cellml_field_maps_type |
Contains information on the maps between CellML and external OpenCMISS fields. More... | |
type | types::cellml_type |
Contains information for a CellML environment. More... | |
type | types::cellml_ptr_type |
A buffer type to allow for an array of pointers to a CELLML_TYPE. More... | |
type | types::cellml_environments_type |
Contains information on the CellML environments defined. More... | |
type | types::solver_matrix_type |
Contains information on the solver matrix. More... | |
type | types::solver_matrix_ptr_type |
A buffer type to allow for an array of pointers to a SOLVER_MATRIX_TYPE. More... | |
type | types::solver_matrices_type |
Contains information on the solver matrices and rhs vector. More... | |
type | types::solver_equations_type |
Contains information about the solver equations for a solver. More... | |
type | types::cellml_equations_type |
Contains information about the CellML equations for a solver. More... | |
type | types::dynamic_solver_type |
Contains information for a dynamic solver. More... | |
type | types::forward_euler_dae_solver_type |
Contains information for an forward Euler differential-algebraic equation solver. More... | |
type | types::backward_euler_dae_solver_type |
Contains information for an backward Euler differential-algebraic equation solver. More... | |
type | types::improved_euler_dae_solver_type |
Contains information for an improved Euler differential-algebraic equation solver. More... | |
type | types::euler_dae_solver_type |
Contains information for an Euler differential-algebraic equation solver. More... | |
type | types::crank_nicolson_dae_solver_type |
Contains information for a Crank-Nicholson differential-algebraic equation solver. More... | |
type | types::runge_kutta_dae_solver_type |
Contains information for a Runge-Kutta differential-algebraic equation solver. More... | |
type | types::adams_moulton_dae_solver_type |
Contains information for an Adams-Moulton differential-algebraic equation solver. More... | |
type | types::bdf_dae_solver_type |
Contains information for a BDF differential-algebraic equation solver. More... | |
type | types::rush_larson_dae_solver_type |
Contains information for a Rush-Larson differential-algebraic equation solver. More... | |
type | types::external_dae_solver_type |
Contains information for an external differential-algebraic equation solver. More... | |
type | types::dae_solver_type |
Contains information for an differential-algebraic equation solver. More... | |
type | types::linear_direct_solver_type |
Contains information for a direct linear solver. More... | |
type | types::linear_iterative_solver_type |
Contains information for an iterative linear solver. More... | |
type | types::linear_solver_type |
Contains information for a linear solver. More... | |
type | types::newton_linesearch_solver_type |
Contains information for a Newton line search nonlinear solver. More... | |
type | types::newton_trustregion_solver_type |
Contains information for a Newton trust region nonlinear solver. More... | |
type | types::newtonsolverconvergencetest |
Contains information about the convergence test for a newton solver. More... | |
type | types::newton_solver_type |
Contains information for a Newton nonlinear solver. More... | |
type | types::quasi_newton_linesearch_solver_type |
Contains information for a Quasi-Newton line search nonlinear solver. More... | |
type | types::quasi_newton_trustregion_solver_type |
Contains information for a Quasi-Newton trust region nonlinear solver. More... | |
type | types::quasi_newton_solver_type |
Contains information for a Quasi-Newton nonlinear solver. More... | |
type | types::nonlinear_solver_type |
Contains information for a nonlinear solver. More... | |
type | types::eigenproblem_solver_type |
Contains information for an eigenproblem solver. More... | |
type | types::optimiser_solver_type |
Contains information for an optimiser solver. More... | |
type | types::cellml_evaluator_solver_type |
Contains information for a CellML evaluation solver. More... | |
type | types::geometrictransformationsolvertype |
Contains information for a geometric transformation solver. More... | |
type | types::solver_ptr_type |
A buffer type to allow for an array of pointers to a SOLVER_TYPE. More... | |
type | types::solver_type |
Contains information on the type of solver to be used. More... | |
type | types::solvers_type |
Contains information on the solvers to be used in a control loop. More... | |
type | types::equations_col_to_solver_cols_map_type |
type | types::equations_to_solver_maps_type |
type | types::equations_to_solver_maps_ptr_type |
A buffer type to allow for an array of pointers to a EQUATIONS_TO_SOLVER_MAPS_TYPE. More... | |
type | types::interface_to_solver_maps_type |
type | types::interface_to_solver_maps_ptr_type |
A buffer type to allow for an array of pointers to a INTERFACE_TO_SOLVER_MAPS_TYPE. More... | |
type | types::jacobian_col_to_solver_cols_map_type |
type | types::jacobian_to_solver_map_type |
type | types::jacobian_to_solver_map_ptr_type |
type | types::variable_to_solver_col_map_type |
Contains information on the mappings between field variable dofs inequations and the solver matrix columns (solver dofs) More... | |
type | types::equations_to_solver_matrix_maps_interface_type |
type | types::equations_to_solver_matrix_maps_sm_type |
Contains information on the equations to solver matrix mappings when indexing by solver matrix number. More... | |
type | types::equations_to_solver_matrix_maps_em_type |
Contains information on the equations to solver matrix mappings when indexing by equations matrix number. More... | |
type | types::equations_row_to_solver_rows_map_type |
Contains information on the mapping from the equations rows in an equations set to the solver rows. More... | |
type | types::equations_set_to_solver_map_type |
Contains information on the mappings from an equations set to the solver matrices. More... | |
type | types::interface_to_solver_matrix_maps_sm_type |
Contains information on the interface to solver matrix mappings when indexing by solver matrix number. More... | |
type | types::interface_row_to_solver_rows_map_type |
Contains information on the mapping from an interface condition column to a solver row. More... | |
type | types::interface_to_solver_matrix_maps_im_type |
Contains information on the interface to solver matrix mappings when indexing by interface matrix number. More... | |
type | types::interface_to_solver_matrix_maps_equations_type |
type | types::interface_column_to_solver_rows_map_type |
Contains information on the mapping from an interface condition column to a solver row. More... | |
type | types::interface_condition_to_solver_map_type |
Contains information on the mappings from an interface condition to the solver matrices. More... | |
type | types::solver_col_to_dynamic_equations_map_type |
Contains information about the mapping from a solver matrix column to dynamic equations matrices and variables. More... | |
type | types::solver_col_to_static_equations_map_type |
Contains information about the mapping from a solver matrix column to static equations matrices and variables. More... | |
type | types::solver_dof_to_variable_map_type |
Contains information about mapping the solver dof to the field variable dofs in the equations set. More... | |
type | types::solver_col_to_equations_set_map_type |
Contains information about the mappings from a solver matrix to the equations in an equations set. More... | |
type | types::solver_col_to_interface_equations_map_type |
Contains information about the mapping from a solver matrix column to interface equations matrices and variables. More... | |
type | types::solver_col_to_interface_map_type |
Contains information about the mappings from a solver matrix to the equations in an equations set. More... | |
type | types::solver_col_to_equations_maps_type |
Contains information on the mappings from a solver matrix to equations sets. More... | |
type | types::solver_row_to_equations_maps_type |
Contains information on the mappings from a solver row to the equations. More... | |
type | types::solver_mapping_create_values_cache_type |
Contains information about the cached create values for a solver mapping. More... | |
type | types::solver_mapping_variable_type |
type | types::solver_mapping_variables_type |
Contains information on the variables involved in a solver matrix. More... | |
type | types::solvermappingdofcouplingstype |
Describes the coupled rows or columns in the solver mapping. More... | |
type | types::solver_mapping_type |
Contains information on the solver mapping between the global equation sets and the solver matrices. More... | |
type | types::history_type |
Contains information about a history file for a control loop. More... | |
type | types::control_loop_simple_type |
Contains information on a simple (execute once) control loop. More... | |
type | types::control_loop_fixed_type |
Contains information on a fixed iteration control loop. More... | |
type | types::control_loop_time_type |
Contains information on a time iteration control loop. More... | |
type | types::control_loop_while_type |
Contains information on a do-while control loop. More... | |
type | types::control_loop_load_increment_type |
Contains information on a load-increment control loop. More... | |
type | types::control_loop_ptr_type |
A buffer type to allow for an array of pointers to a CONTROL_LOOP_TYPE. More... | |
type | types::control_loop_type |
Contains information on a control loop. More... | |
type | types::problem_setup_type |
type | types::problem_type |
Contains information for a problem. More... | |
type | types::problem_ptr_type |
A buffer type to allow for an array of pointers to a PROBLEM_TYPE. More... | |
type | types::problems_type |
Contains information on the problems defined. More... | |
type | types::region_ptr_type |
A buffer type to allow for an array of pointers to a REGION_TYPE. More... | |
type | types::region_type |
Contains information for a region. More... | |
type | types::regions_type |
Contains information about the regions. More... | |
Modules | |
module | types |
This module contains all type definitions in order to avoid cyclic module references. | |
This module contains all type definitions in order to avoid cyclic module references.
Version: MPL 1.1/GPL 2.0/LGPL 2.1
The contents of this file are subject to the Mozilla Public License Version 1.1 (the "License"); you may not use this file except in compliance with the License. You may obtain a copy of the License at http://www.mozilla.org/MPL/
Software distributed under the License is distributed on an "AS IS" basis, WITHOUT WARRANTY OF ANY KIND, either express or implied. See the License for the specific language governing rights and limitations under the License.
The Original Code is OpenCMISS
The Initial Developer of the Original Code is University of Auckland, Auckland, New Zealand, the University of Oxford, Oxford, United Kingdom and King's College, London, United Kingdom. Portions created by the University of Auckland, the University of Oxford and King's College, London are Copyright (C) 2007-2010 by the University of Auckland, the University of Oxford and King's College, London. All Rights Reserved.
Contributor(s):
Alternatively, the contents of this file may be used under the terms of either the GNU General Public License Version 2 or later (the "GPL"), or the GNU Lesser General Public License Version 2.1 or later (the "LGPL"), in which case the provisions of the GPL or the LGPL are applicable instead of those above. If you wish to allow use of your version of this file only under the terms of either the GPL or the LGPL, and not to allow others to use your version of this file under the terms of the MPL, indicate your decision by deleting the provisions above and replace them with the notice and other provisions required by the GPL or the LGPL. If you do not delete the provisions above, a recipient may use your version of this file under the terms of any one of the MPL, the GPL or the LGPL.
Definition in file types.f90.