|
| | DomainDiscretization (SmartPtr< approx_space_type > pApproxSpace) |
| | default Constructor
|
| |
| virtual | ~DomainDiscretization () |
| | virtual destructor
|
| |
Public Member Functions inherited from ug::DomainDiscretizationBase< TDomain, TAlgebra, StdGlobAssembler< TDomain, TAlgebra > > |
| void | add (SmartPtr< IDiscretizationItem< TDomain, TAlgebra > > di) |
| | adds a disc item to the assembling process
|
| |
| void | add (SmartPtr< IDomainConstraint< TDomain, TAlgebra > > pp) |
| | adds a constraint to the assembling process
|
| |
| void | add (SmartPtr< IElemDisc< TDomain > > elem) |
| | adds an element discretization to the assembling process
|
| |
| void | add_elem_error_indicator (SmartPtr< IElemError< TDomain > > elem) |
| | adds an element error indicator to the assembling process
|
| |
| virtual void | adjust_solution (vector_type &u, const GridLevel &gl) |
| | sets dirichlet values in solution vector
|
| |
| virtual void | adjust_solution (vector_type &u, ConstSmartPtr< DoFDistribution > dd) |
| | sets dirichlet values in solution vector
|
| |
| virtual void | adjust_solution (vector_type &u, number time, const GridLevel &gl) |
| | sets dirichlet values in solution vector
|
| |
| virtual void | adjust_solution (vector_type &u, number time, ConstSmartPtr< DoFDistribution > dd) |
| | sets dirichlet values in solution vector
|
| |
| SmartPtr< approx_space_type > | approximation_space () |
| |
| ConstSmartPtr< approx_space_type > | approximation_space () const |
| |
| virtual void | assemble_defect (vector_type &d, const vector_type &u, const GridLevel &gl) |
| | assembles Defect
|
| |
| virtual void | assemble_defect (vector_type &d, const vector_type &u, ConstSmartPtr< DoFDistribution > dd) |
| | assembles Defect
|
| |
| virtual void | assemble_defect (vector_type &d, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, const std::vector< number > &vScaleMass, const std::vector< number > &vScaleStiff, const GridLevel &gl) |
| | assembles Defect
|
| |
| virtual void | assemble_defect (vector_type &d, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, const std::vector< number > &vScaleMass, const std::vector< number > &vScaleStiff, ConstSmartPtr< DoFDistribution > dd) |
| | assembles Defect
|
| |
| virtual void | assemble_jacobian (matrix_type &J, const vector_type &u, const GridLevel &gl) |
| | assembles Jacobian (or Approximation of Jacobian)
|
| |
| virtual void | assemble_jacobian (matrix_type &J, const vector_type &u, ConstSmartPtr< DoFDistribution > dd) |
| | assembles Jacobian (or Approximation of Jacobian)
|
| |
| virtual void | assemble_jacobian (matrix_type &J, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, const number s_a, const GridLevel &gl) |
| | assembles Jacobian (or Approximation of Jacobian)
|
| |
| virtual void | assemble_jacobian (matrix_type &J, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, const number s_a0, ConstSmartPtr< DoFDistribution > dd) |
| | assembles Jacobian (or Approximation of Jacobian)
|
| |
| virtual void | assemble_linear (matrix_type &A, vector_type &b, ConstSmartPtr< DoFDistribution > dd) |
| | Assembles Matrix and Right-Hand-Side for a linear problem.
|
| |
| virtual void | assemble_linear (matrix_type &A, vector_type &b, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, const std::vector< number > &vScaleMass, const std::vector< number > &vScaleStiff, const GridLevel &gl) |
| | Assembles matrix_type and Right-Hand-Side for a linear problem.
|
| |
| virtual void | assemble_linear (matrix_type &A, vector_type &b, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, const std::vector< number > &vScaleMass, const std::vector< number > &vScaleStiff, ConstSmartPtr< DoFDistribution > dd) |
| | Assembles Matrix and Right-Hand-Side for a linear problem.
|
| |
| virtual void | assemble_linear (matrix_type &mat, vector_type &rhs, const GridLevel &gl) |
| | Assembles Matrix and Right-Hand-Side for a linear problem.
|
| |
| virtual void | assemble_mass_matrix (matrix_type &M, const vector_type &u, const GridLevel &gl) |
| | assembles the mass matrix
|
| |
| virtual void | assemble_mass_matrix (matrix_type &M, const vector_type &u, ConstSmartPtr< DoFDistribution > dd) |
| | assembles the mass matrix
|
| |
| virtual void | assemble_rhs (vector_type &b, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, const std::vector< number > &vScaleMass, const std::vector< number > &vScaleStiff, const GridLevel &gl) |
| | Assembles Right-Hand-Side for a linear problem.
|
| |
| virtual void | assemble_rhs (vector_type &b, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, const std::vector< number > &vScaleMass, const std::vector< number > &vScaleStiff, ConstSmartPtr< DoFDistribution > dd) |
| | assembles the rhs
|
| |
| virtual void | assemble_rhs (vector_type &rhs, const GridLevel &gl) |
| | assembles the rhs
|
| |
| virtual void | assemble_rhs (vector_type &rhs, const vector_type &u, const GridLevel &gl) |
| | assembles the rhs
|
| |
| virtual void | assemble_rhs (vector_type &rhs, const vector_type &u, ConstSmartPtr< DoFDistribution > dd) |
| | assembles rhs
|
| |
| virtual void | assemble_rhs (vector_type &rhs, ConstSmartPtr< DoFDistribution > dd) |
| | assembles rhs
|
| |
| virtual void | assemble_stiffness_matrix (matrix_type &A, const vector_type &u, const GridLevel &gl) |
| | assembles the stiffness matrix
|
| |
| virtual void | assemble_stiffness_matrix (matrix_type &A, const vector_type &u, ConstSmartPtr< DoFDistribution > dd) |
| | assembles the stiffness matrix
|
| |
| virtual void | calc_error (const GridFunction< TDomain, TAlgebra > &u) |
| |
| virtual void | calc_error (const GridFunction< TDomain, TAlgebra > &u, error_vector_type *u_vtk) |
| |
| virtual void | calc_error (const vector_type &u, const GridLevel &gl, error_vector_type *u_vtk=NULL) |
| |
| virtual void | calc_error (const vector_type &u, ConstSmartPtr< DoFDistribution > dd, error_vector_type *u_vtk=NULL) |
| |
| virtual void | calc_error (ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, const std::vector< number > &vScaleMass, const std::vector< number > &vScaleStiff, const GridLevel &gl, error_vector_type *u_vtk) |
| |
| virtual void | calc_error (ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, ConstSmartPtr< DoFDistribution > dd, const std::vector< number > &vScaleMass, const std::vector< number > &vScaleStiff, error_vector_type *u_vtk) |
| |
| virtual SmartPtr< IConstraint< TAlgebra > > | constraint (size_t i) |
| | returns the i'th constraint
|
| |
| | DomainDiscretizationBase (SmartPtr< approx_space_type > pApproxSpace) |
| | default Constructor
|
| |
| virtual void | finish_timestep (ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, const GridLevel &gl) |
| |
| virtual void | finish_timestep (ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, ConstSmartPtr< DoFDistribution > dd) |
| | finishes time step
|
| |
| virtual void | finish_timestep_elem (ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, const GridLevel &gl) |
| | finishes timestep
|
| |
| virtual void | finish_timestep_elem (ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, ConstSmartPtr< DoFDistribution > dd) |
| | finishes timestep
|
| |
| void | init_all_exports (bool bAsTimeDependent) |
| |
| virtual void | init_all_exports (const GridLevel &gl, bool bAsTimeDependent) |
| |
| virtual void | init_all_exports (ConstSmartPtr< DoFDistribution > dd, bool bAsTimeDependent) |
| |
| virtual void | invalidate_error () |
| |
| virtual bool | is_error_valid () |
| | returns whether current error values are valid
|
| |
| virtual void | mark_with_strategy (IRefiner &refiner, SmartPtr< IElementMarkingStrategy< TDomain > > strategy) |
| |
| virtual size_t | num_constraints () const |
| | returns number of registered constraints
|
| |
| virtual void | prepare_timestep (ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, number future_time, const GridLevel &gl) |
| |
| virtual void | prepare_timestep (ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, number future_time, ConstSmartPtr< DoFDistribution > dd) |
| | prepares time step
|
| |
| virtual void | prepare_timestep_elem (ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, const GridLevel &gl) |
| |
| virtual void | prepare_timestep_elem (ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, ConstSmartPtr< DoFDistribution > dd) |
| | prepares time step element-wise
|
| |
| void | remove (SmartPtr< IDomainConstraint< TDomain, TAlgebra > > pp) |
| | removes a constraint from the assembling process
|
| |
| void | remove (SmartPtr< IElemDisc< TDomain > > elem) |
| | removes a element discretization from the assembling process
|
| |
| void | remove_elem_error_indicator (SmartPtr< IElemError< TDomain > > elem) |
| | removes a element discretization from the assembling process
|
| |
| virtual | ~DomainDiscretizationBase () |
| | virtual destructor
|
| |
| void | assemble_jacobian (matrix_type &J, GridFunction< TDomain, TAlgebra > &u) |
| |
| void | assemble_defect (vector_type &d, GridFunction< TDomain, TAlgebra > &u) |
| |
| void | assemble_linear (matrix_type &A, GridFunction< TDomain, TAlgebra > &rhs) |
| |
| void | assemble_rhs (vector_type &rhs, GridFunction< TDomain, TAlgebra > &u) |
| |
| void | assemble_rhs (GridFunction< TDomain, TAlgebra > &b) |
| |
| void | adjust_solution (GridFunction< TDomain, TAlgebra > &u) |
| |
| virtual SmartPtr< AssemblingTuner< TAlgebra > > | ass_tuner () |
| |
| virtual ConstSmartPtr< AssemblingTuner< TAlgebra > > | ass_tuner () const |
| |
Public Member Functions inherited from ug::IDomainDiscretization< TAlgebra > |
| void | adjust_solution (vector_type &u, number time) |
| | adjust solution on surface level
|
| |
| void | assemble_defect (vector_type &d, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, const std::vector< number > &vScaleMass, const std::vector< number > &vScaleStiff) |
| | assembles defect on surface level
|
| |
| void | assemble_jacobian (matrix_type &J, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, const number s_a) |
| | assembles jacobian on surface level
|
| |
| void | assemble_linear (matrix_type &A, vector_type &b, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, const std::vector< number > &vScaleMass, const std::vector< number > &vScaleStiff) |
| | assembles linear on surface level
|
| |
| void | assemble_rhs (vector_type &b, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, const std::vector< number > &vScaleMass, const std::vector< number > &vScaleStiff) |
| | assembles rhs on surface level
|
| |
| virtual void | finish_timestep (ConstSmartPtr< VectorTimeSeries< vector_type > > vSol) |
| |
| void | finish_timestep_elem (ConstSmartPtr< VectorTimeSeries< vector_type > > vSol) |
| | finishes timestep on surface level
|
| |
| virtual void | prepare_timestep (ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, number future_time) |
| |
| void | prepare_timestep_elem (ConstSmartPtr< VectorTimeSeries< vector_type > > vSol) |
| | prepares timestep on surface level
|
| |
| virtual | ~IDomainDiscretization () |
| |
| void | adjust_solution (vector_type &u) |
| |
| virtual void | adjust_solution (vector_type &u, const GridLevel &gl)=0 |
| | sets dirichlet values in solution vector
|
| |
| void | assemble_defect (vector_type &d, const vector_type &u) |
| |
| virtual void | assemble_defect (vector_type &d, const vector_type &u, const GridLevel &gl)=0 |
| | assembles Defect
|
| |
| void | assemble_jacobian (matrix_type &J, const vector_type &u) |
| |
| virtual void | assemble_jacobian (matrix_type &J, const vector_type &u, const GridLevel &gl)=0 |
| | assembles Jacobian (or Approximation of Jacobian)
|
| |
| void | assemble_linear (matrix_type &A, vector_type &b) |
| |
| virtual void | assemble_linear (matrix_type &A, vector_type &b, const GridLevel &gl)=0 |
| | Assembles Matrix and Right-Hand-Side for a linear problem.
|
| |
| void | assemble_mass_matrix (matrix_type &M, const vector_type &u) |
| |
| virtual void | assemble_mass_matrix (matrix_type &M, const vector_type &u, const GridLevel &gl) |
| | assembles mass matrix
|
| |
| void | assemble_rhs (vector_type &b) |
| |
| virtual void | assemble_rhs (vector_type &b, const GridLevel &gl)=0 |
| | Assembles Right-Hand-Side for a linear problem.
|
| |
| virtual void | assemble_rhs (vector_type &rhs, const vector_type &u) |
| |
| virtual void | assemble_rhs (vector_type &rhs, const vector_type &u, const GridLevel &gl)=0 |
| | assembles rhs
|
| |
| void | assemble_stiffness_matrix (matrix_type &A, const vector_type &u) |
| |
| virtual void | assemble_stiffness_matrix (matrix_type &A, const vector_type &u, const GridLevel &gl) |
| | assembles stiffness matrix
|
| |
| virtual | ~IAssemble () |
| | Virtual Destructor.
|
| |
Public Member Functions inherited from ug::IDomainErrorIndicator< TAlgebra > |
| virtual void | calc_error (const vector_type &u, const GridLevel &gl, error_vector_type *u_vtk=NULL)=0 |
| |
| virtual void | calc_error (const vector_type &u, ConstSmartPtr< DoFDistribution > dd, error_vector_type *u_vtk=NULL)=0 |
| |
| virtual void | calc_error (ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, const std::vector< number > &vScaleMass, const std::vector< number > &vScaleStiff, const GridLevel &gl, error_vector_type *u_vtk)=0 |
| | Transient version.
|
| |
| virtual void | calc_error (ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, ConstSmartPtr< DoFDistribution > dd, const std::vector< number > &vScaleMass, const std::vector< number > &vScaleStiff, error_vector_type *u_vtk)=0 |
| | Transient version.
|
| |
| virtual | ~IDomainErrorIndicator () |
| |
Public Member Functions inherited from ug::IDomainMarker< TDomain > |
| virtual | ~IDomainMarker () |
| |
|
Protected Member Functions inherited from ug::DomainDiscretizationBase< TDomain, TAlgebra, StdGlobAssembler< TDomain, TAlgebra > > |
| ConstSmartPtr< DoFDistribution > | dd (const GridLevel &gl) const |
| | returns the level dof distribution
|
| |
| void | update_constraints () |
| |
| void | update_disc_items () |
| |
| void | update_elem_discs () |
| | set the approximation space in the elem discs and extract IElemDiscs
|
| |
| void | update_elem_errors () |
| |
| void | update_error_items () |
| |
| template<typename TElem , typename TIterator > |
| static void | AssembleDefect (const std::vector< IElemDisc< domain_type > * > &vElemDisc, ConstSmartPtr< domain_type > spDomain, ConstSmartPtr< DoFDistribution > dd, TIterator iterBegin, TIterator iterEnd, int si, bool bNonRegularGrid, vector_type &d, const vector_type &u, ConstSmartPtr< AssemblingTuner< TAlgebra > > spAssTuner) |
| |
| template<typename TElem , typename TIterator > |
| static void | AssembleDefect (const std::vector< IElemDisc< domain_type > * > &vElemDisc, ConstSmartPtr< domain_type > spDomain, ConstSmartPtr< DoFDistribution > dd, TIterator iterBegin, TIterator iterEnd, int si, bool bNonRegularGrid, vector_type &d, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, const std::vector< number > &vScaleMass, const std::vector< number > &vScaleStiff, ConstSmartPtr< AssemblingTuner< TAlgebra > > spAssTuner) |
| |
| template<typename TElem , typename TIterator > |
| static void | AssembleErrorEstimator (const std::vector< IElemError< domain_type > * > &vElemDisc, ConstSmartPtr< domain_type > spDomain, ConstSmartPtr< DoFDistribution > dd, TIterator iterBegin, TIterator iterEnd, int si, bool bNonRegularGrid, const std::vector< number > &vScaleMass, const std::vector< number > &vScaleStiff, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol) |
| |
| template<typename TElem , typename TIterator > |
| static void | AssembleErrorEstimator (const std::vector< IElemError< domain_type > * > &vElemDisc, ConstSmartPtr< domain_type > spDomain, ConstSmartPtr< DoFDistribution > dd, TIterator iterBegin, TIterator iterEnd, int si, bool bNonRegularGrid, const vector_type &u) |
| |
| template<typename TElem , typename TIterator > |
| static void | AssembleJacobian (const std::vector< IElemDisc< domain_type > * > &vElemDisc, ConstSmartPtr< domain_type > spDomain, ConstSmartPtr< DoFDistribution > dd, TIterator iterBegin, TIterator iterEnd, int si, bool bNonRegularGrid, matrix_type &J, const vector_type &u, ConstSmartPtr< AssemblingTuner< TAlgebra > > spAssTuner) |
| |
| template<typename TElem , typename TIterator > |
| static void | AssembleJacobian (const std::vector< IElemDisc< domain_type > * > &vElemDisc, ConstSmartPtr< domain_type > spDomain, ConstSmartPtr< DoFDistribution > dd, TIterator iterBegin, TIterator iterEnd, int si, bool bNonRegularGrid, matrix_type &J, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, number s_a0, ConstSmartPtr< AssemblingTuner< TAlgebra > > spAssTuner) |
| |
| template<typename TElem , typename TIterator > |
| static void | AssembleLinear (const std::vector< IElemDisc< domain_type > * > &vElemDisc, ConstSmartPtr< domain_type > spDomain, ConstSmartPtr< DoFDistribution > dd, TIterator iterBegin, TIterator iterEnd, int si, bool bNonRegularGrid, matrix_type &A, vector_type &rhs, ConstSmartPtr< AssemblingTuner< TAlgebra > > spAssTuner) |
| |
| template<typename TElem , typename TIterator > |
| static void | AssembleLinear (const std::vector< IElemDisc< domain_type > * > &vElemDisc, ConstSmartPtr< domain_type > spDomain, ConstSmartPtr< DoFDistribution > dd, TIterator iterBegin, TIterator iterEnd, int si, bool bNonRegularGrid, matrix_type &A, vector_type &rhs, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, const std::vector< number > &vScaleMass, const std::vector< number > &vScaleStiff, ConstSmartPtr< AssemblingTuner< TAlgebra > > spAssTuner) |
| |
| template<typename TElem , typename TIterator > |
| static void | AssembleMassMatrix (const std::vector< IElemDisc< domain_type > * > &vElemDisc, ConstSmartPtr< domain_type > spDomain, ConstSmartPtr< DoFDistribution > dd, TIterator iterBegin, TIterator iterEnd, int si, bool bNonRegularGrid, matrix_type &M, const vector_type &u, ConstSmartPtr< AssemblingTuner< TAlgebra > > spAssTuner) |
| |
| template<typename TElem , typename TIterator > |
| static void | AssembleRhs (const std::vector< IElemDisc< domain_type > * > &vElemDisc, ConstSmartPtr< domain_type > spDomain, ConstSmartPtr< DoFDistribution > dd, TIterator iterBegin, TIterator iterEnd, int si, bool bNonRegularGrid, vector_type &rhs, const vector_type &u, ConstSmartPtr< AssemblingTuner< TAlgebra > > spAssTuner) |
| |
| template<typename TElem , typename TIterator > |
| static void | AssembleRhs (const std::vector< IElemDisc< domain_type > * > &vElemDisc, ConstSmartPtr< domain_type > spDomain, ConstSmartPtr< DoFDistribution > dd, TIterator iterBegin, TIterator iterEnd, int si, bool bNonRegularGrid, vector_type &rhs, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, const std::vector< number > &vScaleMass, const std::vector< number > &vScaleStiff, ConstSmartPtr< AssemblingTuner< TAlgebra > > spAssTuner) |
| |
| template<typename TElem , typename TIterator > |
| static void | AssembleStiffnessMatrix (const std::vector< IElemDisc< domain_type > * > &vElemDisc, ConstSmartPtr< domain_type > spDomain, ConstSmartPtr< DoFDistribution > dd, TIterator iterBegin, TIterator iterEnd, int si, bool bNonRegularGrid, matrix_type &A, const vector_type &u, ConstSmartPtr< AssemblingTuner< TAlgebra > > spAssTuner) |
| |
| static void | FinishTimestep (const std::vector< IElemDisc< domain_type > * > &vElemDisc, ConstSmartPtr< DoFDistribution > dd, bool bNonRegularGrid, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, ConstSmartPtr< AssemblingTuner< TAlgebra > > spAssTuner) |
| |
| template<typename TElem , typename TIterator > |
| static void | FinishTimestepElem (const std::vector< IElemDisc< domain_type > * > &vElemDisc, ConstSmartPtr< domain_type > spDomain, ConstSmartPtr< DoFDistribution > dd, TIterator iterBegin, TIterator iterEnd, int si, bool bNonRegularGrid, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, ConstSmartPtr< AssemblingTuner< TAlgebra > > spAssTuner) |
| |
| template<typename TElem , typename TIterator > |
| static void | InitAllExports (const std::vector< IElemDisc< domain_type > * > &vElemDisc, ConstSmartPtr< DoFDistribution > dd, TIterator iterBegin, TIterator iterEnd, int si, bool bNonRegularGrid, bool bAsTimeDependent) |
| |
| static void | PrepareTimestep (const std::vector< IElemDisc< domain_type > * > &vElemDisc, ConstSmartPtr< DoFDistribution > dd, bool bNonRegularGrid, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, number future_time, ConstSmartPtr< AssemblingTuner< TAlgebra > > spAssTuner) |
| |
| template<typename TElem , typename TIterator > |
| static void | PrepareTimestepElem (const std::vector< IElemDisc< domain_type > * > &vElemDisc, ConstSmartPtr< domain_type > spDomain, ConstSmartPtr< DoFDistribution > dd, TIterator iterBegin, TIterator iterEnd, int si, bool bNonRegularGrid, ConstSmartPtr< VectorTimeSeries< vector_type > > vSol, ConstSmartPtr< AssemblingTuner< TAlgebra > > spAssTuner) |
| |
Protected Attributes inherited from ug::DomainDiscretizationBase< TDomain, TAlgebra, StdGlobAssembler< TDomain, TAlgebra > > |
| bool | m_bErrorCalculated |
| |
| IMultigridElementIndicators< TDomain > | m_mgElemErrors |
| |
| SmartPtr< approx_space_type > | m_spApproxSpace |
| | current approximation space
|
| |
| SmartPtr< AssemblingTuner< TAlgebra > > | m_spAssTuner |
| | this object provides tools to adapt the assemble routine
|
| |
| std::vector< SmartPtr< IDomainConstraint< TDomain, TAlgebra > > > | m_vConstraint |
| | vector holding all registered constraints
|
| |
| std::vector< SmartPtr< IElemDisc< TDomain > > > | m_vDomainElemDisc |
| | vector holding all registered elem discs
|
| |
| std::vector< SmartPtr< IElemError< TDomain > > > | m_vDomainElemError |
| | vector holding all registered elem discs
|
| |
| std::vector< IElemDisc< TDomain > * > | m_vElemDisc |
| | vector holding all registered elem discs
|
| |
| std::vector< IElemError< TDomain > * > | m_vElemError |
| | vector holding all registered elem discs
|
| |
template<typename TDomain, typename TAlgebra>
class ug::DomainDiscretization< TDomain, TAlgebra >
domain discretization implementing the interface
This class template is an implementation of the IDomainDiscretization interface based on the simple groupping of several local (element) discretizations and constraints.
This is the "usual" and "trivial" global discretizations: all the local (element) discretizations are perfomed once for every element, and their contributions are algebraically added to the global data.
- Template Parameters
-
| TDomain | domain type |
| TAlgebra | algebra type |