Feel++ 0.91.0
|
Namespaces | |
namespace | math |
Classes | |
class | AboutDataPrivate |
class | AboutPerson |
class | AboutData |
Holds information needed by the "About" box and other classes. More... | |
class | Application |
provides information about the Application More... | |
class | ApplicationXML |
XML application. More... | |
struct | has_value |
struct | set_value |
struct | clear_value |
class | Context |
Context class. More... | |
class | DebugStream |
class | NdebugStream |
class | Environment |
Initialize, finalize, and query the Feel++ environment. More... | |
struct | FactoryDefaultError |
class | Factory |
Implements a generic object Factory. More... | |
class | FactoryClone |
Implements a generic cloning object Factory. More... | |
class | Info |
information provider for versioning and installation directories More... | |
class | PolicyCreationUsingNew |
class | PolicyFeelTimeDefault |
class | Simget |
Simulation Object. More... | |
class | Singleton |
implement the Singleton pattern More... | |
class | AssertContext |
contains details about a failed assertion More... | |
struct | Assert |
struct | TimerPair |
class | TimerMap |
timers map More... | |
struct | strongest_numeric_type |
struct | strongest_numeric_type< T1, std::complex< T2 > > |
struct | strongest_numeric_type< std::complex< T1 >, T2 > |
struct | strongest_numeric_type< std::complex< T1 >, std::complex< T2 > > |
struct | is_shared_ptr |
struct | is_shared_ptr< boost::shared_ptr< T > > |
struct | remove_shared_ptr |
struct | remove_shared_ptr< boost::shared_ptr< T > > |
class | TypeInfo |
wrapper for std::type_info More... | |
struct | type_traits |
class | VisitorBase |
The base class of any Acyclic Visitor. More... | |
class | Visitor |
class | VisitorList |
class | VisitorBaseImpl< mpl::list< Head, Tail >, R > |
class | VisitorBaseImpl< mpl::list< Head >, R > |
class | VisitableCatchAllDefault |
class | VisitableBase |
class | VisitorCyclic |
class | Parameter_impl |
class | Parameter |
parameter class to describe code inputs More... | |
class | Output_impl |
class | Output |
class | xmlParser |
class | Aitken |
Aitken relaxation method for fixed point iterations. More... | |
struct | compute_aitken_return |
class | Backend |
! More... | |
struct | BackendAdaptiveReusePCdefaults |
class | BackendAdaptiveReusePC |
struct | BackendGmmDefaults |
class | BackendGmm |
class | BackendPetsc |
struct | BFGSInvHessian |
class | BoundingBox |
bounding box for a matrix of points More... | |
class | DataMap |
data layout in a multi-processor environnement More... | |
struct | norm_inf_adaptor |
struct | node |
struct | matrix_node |
class | GraphCSR |
Graph representation of the Compressed Sparse Row format. More... | |
class | Iteration |
brief description More... | |
class | LU |
struct | Blocks |
class | MatrixBlock |
block of matrices More... | |
class | MatrixGmm |
interface to gmm sparse matrix More... | |
class | MatrixPetsc |
Wrapper for petsc matrices. More... | |
class | MatrixShell |
matrices that define its action against a vector More... | |
class | MatrixShellSparse |
Allow all sparse matrices to be shell matrices. More... | |
class | MatrixSparse |
class | MatrixTriplet |
brief description More... | |
class | MatrixUBlas |
interface to ublas sparse matrix More... | |
class | MatrixValue |
interface to matrix More... | |
class | SolverBase |
abstract base class for wrapped (linear) solvers More... | |
class | SolverEigen |
base class for eigen solvers More... | |
class | SolverLinear |
class | SolverLinearPetsc |
class | SolverNonLinear |
Non linear solver base interface. More... | |
class | SolverNonLinearPetsc |
Petsc non linear solvers interface. More... | |
class | SolverNonLinearTrilinosInterface |
class | SolverUMFPACK |
Interface for the UMFPACK Solver. More... | |
class | SVD |
Singular Value Decomposition of a rectangular matrix. More... | |
class | SOrth |
class | Vector |
class | VectorPetsc |
Wrapper for petsc matrices. More... | |
class | VectorUblas |
interface to vector More... | |
class | VectorValue |
interface to vector More... | |
class | Exporter |
export Feel generated data to some file formatsUse the visitor and factory pattern. More... | |
class | ExporterEnsight |
exporter to Ensight format More... | |
class | ExporterGmsh |
Exporter to GMSH format. More... | |
class | ExporterGnuplot |
Exporter to GNUPLOT format. More... | |
class | ExporterQuick |
simple interface to exporter More... | |
class | FilterFromVtk |
class | FilterFromVtk3D |
class | Gmsh |
Gmsh Mesh Generator. More... | |
class | GmshEllipsoidDomain |
n-Ellipsoid Domain description for gmsh mesh generation. More... | |
class | GmshOrdering |
class | GmshHypercubeDomain |
Tensorized Domain description for gmsh mesh generation. More... | |
class | GmshSimplexDomain |
Simplex Domain description for gmsh mesh generation. More... | |
class | Importer |
class | ImporterGambit |
gambit(fluent mesh generator) importer class More... | |
class | ImporterGmsh |
gmsh importer class More... | |
class | PointSetToMesh |
transform a point set to a mesh data structure using a Delaunay More... | |
class | BarePoint |
The Point basis class It contains the attributes common to all Points In particular, it contains the one size_type's (first) of the point. More... | |
class | BareEdge |
The Edge basis class It contains the attributes common to all Edges In particular, it contains the two size_type's (first and second) of the points at the two ends of the edge. More... | |
class | BareFace |
The base Face class. More... | |
struct | cmpBareItem< BarePoint > |
< The actual comparison operator More... | |
struct | cmpBareItem< BareEdge > |
< The actual comparison operator More... | |
struct | cmpBareItem< BareFace > |
class | BareItemsHandler |
class | ConvexBase |
class | Convex |
Convex base class. More... | |
class | Geo0D |
class | SubFaceOfNone |
class | SubFaceOf |
class | GeoElement0D |
class | GeoElement1D |
class for 1D elements More... | |
class | GeoElement2D |
Class for 2D elements. More... | |
class | GeoElement3D |
Class for 3D elements. More... | |
class | GeoEntity |
base class for all geometric entities More... | |
class | GeoND |
Base class for Multi-dimensional basis Geometrical Entities. More... | |
class | Hypercube |
class | KDTree |
KDTree class. More... | |
class | Mesh1D |
1D mesh class More... | |
class | Mesh2D |
2D mesh class More... | |
class | Mesh3D |
3D mesh class More... | |
class | MeshBase |
base mesh class More... | |
class | MeshMover |
Move mesh according to a given map. More... | |
class | PointSet |
Class of all PointSet on a Convex. More... | |
class | Entity |
class | Reference |
Reference convex. More... | |
class | Reference< Hypercube< Dim, Order, RDim >, Dim, Order, RDim, T > |
class | Entity< SHAPE_QUAD, T > |
class | Entity< SHAPE_HEXA, T > |
class | Reference< Simplex< Dim, Order, RDim >, Dim, Order, RDim, T > |
class | Entity< SHAPE_LINE, T > |
class | Entity< SHAPE_TRIANGLE, T > |
class | Entity< SHAPE_TETRA, T > |
class | RegionTree |
implements a region-tree for point search in a set of boxes More... | |
class | Simplex |
simplex of dimension Dim More... | |
struct | Line |
struct | Triangle |
struct | Tetrahedron |
class | Sphere |
class | StructuredGrid |
class to represent a Structured Grid More... | |
class | Surface |
class | MeshTraits |
Traits for meshes. More... | |
class | Bratu |
class | NonLinearPow |
class | Stokes |
solves the stokes equations More... | |
Typedefs | |
typedef DebugStream &(* | LManipFunction )(DebugStream &) |
typedef NdebugStream &(* | LNManipFunction )(NdebugStream &) |
typedef double | Real |
typedef double | scalar_type |
typedef std::complex< double > | complex_type |
typedef boost::int8_t | int8_type |
typedef boost::int16_t | int16_type |
typedef boost::int32_t | int32_type |
typedef boost::int64_t | int64_type |
typedef detail::real< 32 >::type | real32_type |
typedef detail::real< 64 >::type | real64_type |
typedef boost::uint8_t | uint8_type |
typedef boost::uint16_t | uint16_type |
typedef boost::uint32_t | uint32_type |
typedef boost::uint64_t | uint64_type |
typedef int64_type | flag_type |
typedef uint16_type | dim_type |
dimension type | |
typedef size_t | size_type |
Indices (starting from 0) | |
typedef Singleton< Factory < Simget, std::string > > | SimgetFactory |
typedef ublas::symmetric_matrix < double, ublas::lower, ublas::row_major, ublas::bounded_array< double, 9 > > | hessian_node_type |
typedef ublas::matrix< double, ublas::column_major, ublas::bounded_array< double, 9 > > | lapack_matrix_type |
typedef ublas::symmetric_adaptor < lapack_matrix_type, ublas::lower > | symmetric_matrix_type |
typedef lapack_matrix_type | transformation_matrix_type |
typedef ublas::compressed_matrix < double, ublas::row_major, 0, ublas::unbounded_array< int > , ublas::unbounded_array < double > > | csr_matrix_type |
typedef ublas::compressed_matrix < double, ublas::column_major, 0, ublas::unbounded_array< int > , ublas::unbounded_array < double > > | csc_matrix_type |
typedef Iteration< double > | iteration_type |
typedef boost::shared_ptr < iteration_type > | iteration_ptrtype |
typedef MatrixSparse< double > | d_sparse_matrix_type |
typedef boost::shared_ptr < d_sparse_matrix_type > | d_sparse_matrix_ptrtype |
typedef Gmsh | gmsh_type |
typedef boost::shared_ptr < gmsh_type > | gmsh_ptrtype |
typedef Geo0D< 3 > | Point |
typedef GeoEntity< Simplex< 0, 1 > > | GeoPoint |
typedef GeoEntity< Simplex< 1, 1 > > | LinearLine |
typedef GeoEntity< Simplex< 2, 1 > > | LinearTriangle |
typedef GeoEntity< Simplex< 3, 1 > > | LinearTetra |
typedef GeoEntity< Simplex< 1, 2 > > | QuadraticLine |
typedef GeoEntity< Simplex< 2, 2 > > | QuadraticTriangle |
typedef GeoEntity< Simplex< 3, 2 > > | QuadraticTetra |
typedef GeoEntity< Hypercube< 2, 1 > > | LinearQuad |
typedef GeoEntity< Hypercube< 3, 1 > > | LinearHexa |
typedef GeoEntity< Hypercube< 2, 2 > > | QuadraticQuad |
typedef GeoEntity< Hypercube< 3, 2 > > | QuadraticHexa |
typedef node< double >::type | node_type |
typedef RegionTree | region_tree_type |
typedef boost::shared_ptr < region_tree_type > | region_tree_ptrtype |
Enumerations | |
enum | DebugLevels { DEBUG_INFO = 0, DEBUG_WARN = 1, DEBUG_ERROR = 2, DEBUG_FATAL = 3 } |
enum | { lvl_warn = 100, lvl_debug = 200, lvl_error = 300, lvl_fatal = 1000 } |
enum | BFGSType { BFGS = 0, DFP } |
enum | on_context_type { ON_NONE = 0x0, ON_ELIMINATION = 0x1, ON_PENALISATION = 0x2, ON_ELIMINATION_KEEP_DIAGONAL = 0x4, ON_ELIMINATION_SYMMETRIC = 0x8 } |
enum | BackendType { BACKEND_GMM = 0, BACKEND_PETSC, BACKEND_TRILINOS } |
enum | SolverType { CG = 0, CGN, CGS, CR, QMR, TCQMR, TFQMR, BICG, BICGSTAB, MINRES, GMRES, LSQR, JACOBI, SOR_FORWARD, SOR_BACKWARD, SSOR, RICHARDSON, CHEBYSHEV, INVALID_SOLVER } |
enum | PreconditionerType { IDENTITY_PRECOND = 0, JACOBI_PRECOND, BLOCK_JACOBI_PRECOND, SOR_PRECOND, SSOR_PRECOND, EISENSTAT_PRECOND, ASM_PRECOND, CHOLESKY_PRECOND, ICC_PRECOND, ILU_PRECOND, LU_PRECOND, USER_PRECOND, SHELL_PRECOND, INVALID_PRECONDITIONER } |
enum | MatrixStructure { SAME_NONZERO_PATTERN, DIFFERENT_NONZERO_PATTERN, SAME_PRECONDITIONER, SUBSET_NONZERO_PATTERN, INVALID_STRUCTURE } |
enum | EigenSolverType { POWER = 0, LAPACK, SUBSPACE, ARNOLDI, LANCZOS, KRYLOVSCHUR, ARPACK, INVALID_EIGENSOLVER } |
enum | EigenProblemType { NHEP = 0, HEP, GNHEP, GHEP, PGNHEP, INVALID_EIGENPROBLEMTYPE } |
enum | PositionOfSpectrum { LARGEST_MAGNITUDE = 0, SMALLEST_MAGNITUDE, LARGEST_REAL, SMALLEST_REAL, LARGEST_IMAGINARY, SMALLEST_IMAGINARY, INVALID_Postion_of_Spectrum } |
enum | SpectralTransformType { SHIFT = 0, SINVERT, FOLD, CAYLEY } |
enum | SolverPackage { SOLVERS_FEEL = 0, SOLVERS_GMM, SOLVERS_PETSC, SOLVERS_TRILINOS, SOLVERS_SLEPC, SOLVER_INVALID_PACKAGE } |
enum | SolverNonLinearType { SELECT_IN_ARGLIST = 0, LINE_SEARCH, TRUST_REGION } |
enum | AitkenType { AITKEN_STANDARD = 0, AITKEN_METHOD_1 = 1, FIXED_RELAXATION_METHOD = 2 } |
enum | file_type { ASCII = 0, BINARY = 1 } |
enum | GMSH_ORDER { GMSH_ORDER_ONE = 1, GMSH_ORDER_TWO = 2, GMSH_ORDER_THREE = 3, GMSH_ORDER_FOUR = 4, GMSH_ORDER_FIVE = 5 } |
enum | GMSH_ENTITY { GMSH_LINE = 1, GMSH_TRIANGLE = 2, GMSH_QUADRANGLE = 3, GMSH_TETRAHEDRON = 4, GMSH_HEXAHEDRON = 5, GMSH_PRISM = 6, GMSH_PYRAMID = 7, GMSH_LINE_2 = 8, GMSH_TRIANGLE_2 = 9, GMSH_QUADRANGLE_2 = 10, GMSH_TETRAHEDRON_2 = 11, GMSH_HEXAHEDRON_2 = 12, GMSH_PRISM_2 = 13, GMSH_PYRAMID_2 = 14, GMSH_POINT = 15, GMSH_TRIANGLE_INCOMPLETE_3 = 20, GMSH_TRIANGLE_3 = 21, GMSH_TRIANGLE_INCOMPLETE_4 = 22, GMSH_TRIANGLE_4 = 23, GMSH_TRIANGLE_INCOMPLETE_5 = 24, GMSH_TRIANGLE_5 = 25, GMSH_LINE_3 = 26, GMSH_LINE_4 = 27, GMSH_LINE_5 = 28, GMSH_TETRAHEDRON_3 = 29, GMSH_TETRAHEDRON_4 = 30, GMSH_TETRAHEDRON_5 = 31 } |
enum | MeshFormat { MESHPP, INRIA, GMSH, NETGEN, GAMBIT } |
enum | FaceLocation { INTERNAL = false, ON_BOUNDARY = true } |
enum | GeoEntityContext { MESH_ENTITY_INTERNAL = ( 1<<0 ), MESH_ENTITY_BOUNDARY = ( 1<<1 ) } |
enum | ReferenceGeometry { GEOMETRY_POINT = ( 1<<0 ), GEOMETRY_LINE = ( 1<<1 ), GEOMETRY_SURFACE = ( 1<<2 ), GEOMETRY_VOLUME = ( 1<<3 ), GEOMETRY_4 = ( 1<<4 ), GEOMETRY_5 = ( 1<<5 ) } |
enum | ReferenceShapes { SHAPE_LINEAR = ( 1<<0 ), SHAPE_BILINEAR = ( 1<<1 ), SHAPE_QUADRATIC = ( 1<<2 ), SHAPE_NONE = ( 1<<3 ), SHAPE_POINT = ( 1<<4 ), SHAPE_LINE = ( 1<<5 ), SHAPE_TRIANGLE = ( 1<<6 ), SHAPE_QUAD = ( 1<<7 ), SHAPE_HEXA = ( 1<<8 ), SHAPE_PRISM = ( 1<<9 ), SHAPE_TETRA = ( 1<<10 ), SHAPE_SP4 = ( 1<<11 ), SHAPE_SP5 = ( 1<<12 ) } |
enum | MESH_CHANGES { MESH_CHANGES_POINTS_COORDINATES = 0, MESH_CHANGES_CONNECTIVITY = 1, MESH_CHANGES_PARTITION = 2 } |
enum | ElementsType { MESH_ELEMENTS = 0, MESH_FACES = 1, MESH_INTERNAL_FACES = 2, MESH_EDGES = 3, MESH_INTERNAL_EDGES = 4, MESH_POINTS = 5 } |
enum | MeshComponents { MESH_UPDATE_EDGES = (1 << 0), MESH_UPDATE_FACES = (1 << 1), MESH_CHECK = (1 << 2), MESH_PARTITION = (1 << 3), MESH_RENUMBER = (1 << 4) } |
Functions | |
std::ostream & | operator<< (std::ostream &os, AboutData const &) |
FEEL_NO_EXPORT std::pair < std::string, std::string > | at_option_parser (std::string const &s) |
FEEL_NO_EXPORT po::options_description | mpiOptions () |
FEEL_NO_EXPORT po::options_description | petscOptions () |
FEEL_NO_EXPORT po::options_description | serialOptions () |
DebugStream | Log (int area, DebugStream::stprintf func) |
DebugStream | Log (bool cond, int area, DebugStream::stprintf) |
DebugStream | Debug (int area, DebugStream::stprintf func) |
DebugStream | Debug (bool cond, int area, DebugStream::stprintf) |
DebugStream | Warning (int area) |
DebugStream | Warning (bool cond, int area) |
DebugStream | Error (int area) |
DebugStream | Error (bool cond, int area) |
DebugStream | Fatal (int area) |
DebugStream | Fatal (bool cond, int area) |
std::string | backtrace () |
std::string | backtrace (int) |
template<typename T > | |
DebugStream & | operator<< (DebugStream &__s, T const *__t) |
NdebugStream & | perror (NdebugStream &s) |
NdebugStream & | endl (NdebugStream &s) |
NdebugStream & | flush (NdebugStream &s) |
BOOST_STATIC_ASSERT ((boost::is_same< real32_type, float >::value)) | |
BOOST_STATIC_ASSERT ((boost::is_same< real64_type, double >::value)) | |
bool | operator== (const TypeInfo &lhs, const TypeInfo &rhs) |
bool | operator< (const TypeInfo &lhs, const TypeInfo &rhs) |
bool | operator!= (const TypeInfo &lhs, const TypeInfo &rhs) |
bool | operator> (const TypeInfo &lhs, const TypeInfo &rhs) |
bool | operator<= (const TypeInfo &lhs, const TypeInfo &rhs) |
bool | operator>= (const TypeInfo &lhs, const TypeInfo &rhs) |
BOOST_PP_LIST_FOR_EACH_PRODUCT (FEEL_TRAITS_OP, 1,(FEEL_TRAITS_TYPES)) | |
template<typename fs_type > | |
void | operator++ (boost::shared_ptr< Aitken< fs_type > > &aitk) |
template<typename SpaceType > | |
boost::shared_ptr< Aitken < SpaceType > > | aitkenNew (boost::shared_ptr< SpaceType > const &_space, AitkenType _type, double _init_theta, double _tol) |
BOOST_PARAMETER_FUNCTION ((typename compute_aitken_return< Args >::type), aitken, tag,(required(space,*(boost::is_convertible< mpl::_, boost::shared_ptr< FunctionSpaceBase > >)))(optional(type,(AitkenType), AITKEN_STANDARD)(initial_theta,*(boost::is_arithmetic< mpl::_ >), 1.0)(tolerance,*(boost::is_arithmetic< mpl::_ >), 1.0e-6))) | |
BOOST_PARAMETER_FUNCTION ((typename compute_aitken_return< Args >::ptrtype), aitkenPtr, tag,(required(space,*(boost::is_convertible< mpl::_, boost::shared_ptr< FunctionSpaceBase > >)))(optional(type,(AitkenType), AITKEN_STANDARD)(initial_theta,*(boost::is_arithmetic< mpl::_ >), 1.0)(tolerance,*(boost::is_arithmetic< mpl::_ >), 1.0e-6))) | |
std::string | _o (std::string const &prefix, std::string const &opt) |
po::options_description | backend_options (std::string const &prefix) |
po::options_description | backend_adaptive_reuse_pc_options (std::string const &prefix, BackendAdaptiveReusePCdefaults defaults) |
po::options_description | backendgmm_options (std::string const &prefix, BackendGmmDefaults defaults) |
po::options_description | backendpetsc_options (std::string const &prefix) |
template<typename FUNCTION , typename DERIVATIVE , typename VECTOR , typename IterationBFGS > | |
void | bfgs (FUNCTION f, DERIVATIVE grad, VECTOR &x, int restart, IterationBFGS &iter, BFGSType version=BFGS, float lambda_init=0.001, float=1.0) |
template<typename FUNCTION , typename DERIVATIVE , typename VECTOR , typename IterationBFGS > | |
void | dfp (FUNCTION f, DERIVATIVE grad, VECTOR &x, int restart, IterationBFGS &iter, BFGSType version=DFP) |
template<class T > | |
T | Min (const T &a, const T &b) |
template<class T > | |
T | Max (const T &a, const T &b) |
template<class T > | |
T | Abs (const T &a) |
template<class T > | |
void | Exchange (T &a, T &b) |
template<class T > | |
T | Max (const T &a, const T &b, const T &c) |
template<class T > | |
T | Min (const T &a, const T &b, const T &c) |
DebugStream & | operator<< (DebugStream &__os, node< real64_type >::type const &__n) |
NdebugStream & | operator<< (NdebugStream &os, node< real64_type >::type const &) |
template<typename T > | |
DebugStream & | operator<< (DebugStream &__os, ublas::vector< T > const &__n) |
template<typename T > | |
NdebugStream & | operator<< (NdebugStream &__os, ublas::vector< T > const &) |
template<typename T , typename Orient > | |
DebugStream & | operator<< (DebugStream &__os, ublas::matrix< T, Orient > const &__n) |
template<typename T , typename Orient > | |
NdebugStream & | operator<< (NdebugStream &__os, ublas::matrix< T, Orient > const &) |
template<typename MatrixType > | |
void | spy (MatrixType const &__m, std::string const &filename) |
template<int Dim, typename Matrix > | |
Matrix::value_type | det (Matrix const &M) |
template<int Dim, typename Matrix > | |
void | inverse (Matrix const &M, Matrix &Minv) |
template<int Dim, typename Matrix > | |
void | inverse (Matrix const &__restrict__ M, Matrix &__restrict__ Minv, typename Matrix::value_type const &J) |
template<typename T > | |
std::ostream & | operator<< (std::ostream &os, const MatrixSparse< T > &m) |
po::options_description | solvereigen_options (std::string const &prefix) |
BOOST_PARAMETER_MEMBER_FUNCTION ((typename SolverEigen< double >::eigenmodes_type), eigs, tag,(required(matrixA,(d_sparse_matrix_ptrtype))(matrixB,(d_sparse_matrix_ptrtype)))(optional(nev,(int), 1)(ncv,(int), 3)(backend,(BackendType), BACKEND_PETSC)(solver,(EigenSolverType), KRYLOVSCHUR)(problem,(EigenProblemType), GHEP)(transform,(SpectralTransformType), SHIFT)(spectrum,(PositionOfSpectrum), LARGEST_MAGNITUDE)(maxit,(size_type), 1000)(tolerance,(double), 1e-11))) | |
po::options_description | solvereigenslepc_options (std::string const &prefix) |
po::options_description | nlsolver_options () |
template<typename T > | |
type_traits< T >::real_type | inner_product (Vector< T > const &v1, Vector< T > const &v2) |
template<typename T > | |
type_traits< T >::real_type | inner_product (boost::shared_ptr< Vector< T > > const &v1, boost::shared_ptr< Vector< T > > const &v2) |
template<typename T > | |
type_traits< T >::real_type | dot (boost::shared_ptr< Vector< T > > const &v1, boost::shared_ptr< Vector< T > > const &v2) |
template<typename T > | |
type_traits< T >::real_type | dot (Vector< T > const &v1, Vector< T > const &v2) |
template<typename ForwardIter , typename T > | |
void | iota (ForwardIter first, ForwardIter last, T value) |
template<typename T > | |
VectorUblas< T > | element_product (VectorUblas< T > const &v1, VectorUblas< T > const &v2) |
template<typename T > | |
VectorUblas< T > | element_product (boost::shared_ptr< VectorUblas< T > > const &v1, boost::shared_ptr< VectorUblas< T > > const &v2) |
po::options_description | exporter_options (std::string const &prefix) |
BOOST_PARAMETER_FUNCTION ((typename detail::mesh< Args >::ptrtype), loadGMSHMesh, tag,(required(mesh,*)(filename,*))(optional(refine,*(boost::is_integral< mpl::_ >), 0)(update,*(boost::is_integral< mpl::_ >), 0))) | |
load a mesh data structure (hold in a shared_ptr<>) using GMSH | |
BOOST_PARAMETER_FUNCTION ((void), saveGMSHMesh, tag,(required(mesh,*)(filename,*))(optional(parametricnodes,*(boost::is_integral< mpl::_ >), 0))) | |
save a mesh data structure (hold in a shared_ptr<>) in the GMSH format | |
BOOST_PARAMETER_FUNCTION ((typename detail::mesh< Args >::ptrtype), createGMSHMesh, tag,(required(mesh,*)(desc,*))(optional(h,*(boost::is_arithmetic< mpl::_ >), 0.1)(order,*(boost::is_integral< mpl::_ >), 1)(parametricnodes,*(boost::is_integral< mpl::_ >), 0)(refine,*(boost::is_integral< mpl::_ >), 0)(update,*(boost::is_integral< mpl::_ >), 0)(force_rebuild,*(boost::is_integral< mpl::_ >), 0))) | |
create a mesh data structure (hold in a shared_ptr<>) using GMSH | |
BOOST_PARAMETER_FUNCTION ((gmsh_ptrtype), domain, tag,(required(name,*(boost::is_convertible< mpl::_, std::string >))(shape,*(boost::is_convertible< mpl::_, std::string >)))(optional(dim,*(boost::is_integral< mpl::_ >), 2)(order,*(boost::is_integral< mpl::_ >), 1)(h,*(boost::is_arithmetic< mpl::_ >), double(0.1))(convex,*(boost::is_convertible< mpl::_, std::string >),"Simplex")(addmidpoint,*(boost::is_integral< mpl::_ >), true)(usenames,*(boost::is_integral< mpl::_ >), false)(xmin,*(boost::is_arithmetic< mpl::_ >), 0.)(xmax,*(boost::is_arithmetic< mpl::_ >), 1)(ymin,*(boost::is_arithmetic< mpl::_ >), 0.)(ymax,*(boost::is_arithmetic< mpl::_ >), 1)(zmin,*(boost::is_arithmetic< mpl::_ >), 0.)(zmax,*(boost::is_arithmetic< mpl::_ >), 1))) | |
BOOST_PARAMETER_FUNCTION ((gmsh_ptrtype), geo, tag,(required(filename,*(boost::is_convertible< mpl::_, std::string >))(dim,*(boost::is_integral< mpl::_ >)))(optional(order,*(boost::is_integral< mpl::_ >), 1)(h,*(boost::is_arithmetic< mpl::_ >), double(0.1)))) | |
std::pair< BareFace, bool > | makeBareFace (size_type const i, size_type const j, size_type const k) |
It creates Bare Face objects from three Point size_type's. | |
std::pair< BareFace, bool > | makeBareFace (size_type const i, size_type const j, size_type const k, size_type const l) |
It creates Bare Face objects from four Point size_type's. | |
std::pair< BarePoint, bool > | makeBarePoint (size_type const i) |
std::pair< BareEdge, bool > | makeBareEdge (size_type const i, size_type const j) |
It creates a BareEdge end returns the orientation of the created edge with respect to the given data. | |
std::pair< BareEdge, bool > | makeBareItem (size_type i, size_type j) |
BareEdge | setBareEdge (size_type const i, size_type const j) |
It creates a BareEdge, ignoring orientation. | |
BareEdge | setBareEdgeNo (size_type const i, size_type const j) |
It creates a non-standard BareEdge. | |
std::pair< BareFace, bool > | makeBareItem (size_type i, size_type j, size_type k) |
std::pair< BareFace, bool > | makeBareItem (size_type i, size_type j, size_type k, size_type l) |
bool | operator!= (const BareEdge &p1, const BareEdge &p2) |
bool | operator== (const BareEdge &p1, const BareEdge &p2) |
bool | operator> (const BareEdge &e1, const BareEdge &e2) |
bool | operator>= (const BareEdge &e1, const BareEdge &e2) |
bool | operator< (const BareEdge &e1, const BareEdge &e2) |
bool | operator<= (const BareEdge &e1, const BareEdge &e2) |
bool | operator!= (const BareFace &p1, const BareFace &p2) |
bool | operator== (const BareFace &p1, const BareFace &p2) |
template<typename BareItem > | |
size_type | getId (std::pair< BareItem, size_type > const &i) |
template<typename BareItem > | |
BareItem | getItem (std::pair< BareItem, size_type > const &i) |
template<typename MeshType > | |
size_type | meshrank (MeshType const &mesh, mpl::bool_< true >) |
template<typename MeshType > | |
size_type | meshrank (MeshType const &mesh, mpl::bool_< false >) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_ELEMENTS >, typename MeshTraits< MeshType > ::element_const_iterator, typename MeshTraits< MeshType > ::element_const_iterator > | allelements (MeshType const &mesh) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_ELEMENTS >, typename MeshTraits< MeshType > ::element_const_iterator, typename MeshTraits< MeshType > ::element_const_iterator > | elements (MeshType const &mesh) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_ELEMENTS >, typename MeshTraits< MeshType > ::location_element_const_iterator, typename MeshTraits< MeshType > ::location_element_const_iterator > | boundaryelements (MeshType const &mesh) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_ELEMENTS >, typename MeshTraits< MeshType > ::location_element_const_iterator, typename MeshTraits< MeshType > ::location_element_const_iterator > | internalelements (MeshType const &mesh) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_ELEMENTS >, typename MeshTraits< MeshType > ::marker_element_const_iterator, typename MeshTraits< MeshType > ::marker_element_const_iterator > | markedelements (MeshType const &mesh, flag_type flag) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_ELEMENTS >, typename MeshTraits< MeshType > ::marker_element_const_iterator, typename MeshTraits< MeshType > ::marker_element_const_iterator > | markedelements (MeshType const &mesh, std::string const &flag) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_ELEMENTS >, typename MeshTraits< MeshType > ::marker2_element_const_iterator, typename MeshTraits< MeshType > ::marker2_element_const_iterator > | marked2elements (MeshType const &mesh, flag_type flag) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_ELEMENTS >, typename MeshTraits< MeshType > ::marker2_element_const_iterator, typename MeshTraits< MeshType > ::marker2_element_const_iterator > | marked2elements (MeshType const &mesh, std::string const &flag) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_ELEMENTS >, typename MeshTraits< MeshType > ::marker3_element_const_iterator, typename MeshTraits< MeshType > ::marker3_element_const_iterator > | marked3elements (MeshType const &mesh, flag_type flag) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_ELEMENTS >, typename MeshTraits< MeshType > ::marker3_element_const_iterator, typename MeshTraits< MeshType > ::marker3_element_const_iterator > | marked3elements (MeshType const &mesh, std::string const &flag) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_ELEMENTS >, typename MeshTraits< MeshType > ::element_const_iterator, typename MeshTraits< MeshType > ::element_const_iterator > | idedelements (MeshType const &mesh, flag_type flag) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_FACES >, typename MeshTraits< MeshType > ::pid_face_const_iterator, typename MeshTraits< MeshType > ::pid_face_const_iterator > | faces (MeshType const &mesh) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_FACES >, typename MeshTraits< MeshType > ::face_const_iterator, typename MeshTraits< MeshType > ::face_const_iterator > | idedfaces (MeshType const &mesh, size_type id) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_FACES >, typename MeshTraits< MeshType > ::marker_face_const_iterator, typename MeshTraits< MeshType > ::marker_face_const_iterator > | markedfaces (MeshType const &mesh) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_FACES >, typename MeshTraits< MeshType > ::marker_face_const_iterator, typename MeshTraits< MeshType > ::marker_face_const_iterator > | markedfaces (MeshType const &mesh, flag_type __marker) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_FACES >, typename MeshTraits< MeshType > ::marker_face_const_iterator, typename MeshTraits< MeshType > ::marker_face_const_iterator > | markedfaces (MeshType const &mesh, std::string const &__marker) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_FACES >, typename MeshTraits< MeshType > ::location_face_const_iterator, typename MeshTraits< MeshType > ::location_face_const_iterator > | boundaryfaces (MeshType const &mesh) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_FACES >, typename MeshTraits< MeshType > ::location_face_const_iterator, typename MeshTraits< MeshType > ::location_face_const_iterator > | internalfaces (MeshType const &mesh) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_FACES >, typename MeshTraits< MeshType > ::interprocess_face_const_iterator, typename MeshTraits< MeshType > ::interprocess_face_const_iterator > | interprocessfaces (MeshType const &mesh) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_EDGES >, typename MeshTraits< MeshType > ::pid_edge_const_iterator, typename MeshTraits< MeshType > ::pid_edge_const_iterator > | edges (MeshType const &mesh) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_EDGES >, typename MeshTraits< MeshType > ::marker_edge_const_iterator, typename MeshTraits< MeshType > ::marker_edge_const_iterator > | markededges (MeshType const &mesh, flag_type __marker) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_EDGES >, typename MeshTraits< MeshType > ::location_edge_const_iterator, typename MeshTraits< MeshType > ::location_edge_const_iterator > | boundaryedges (MeshType const &mesh) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_EDGES >, typename MeshTraits< MeshType > ::location_edge_const_iterator, typename MeshTraits< MeshType > ::location_edge_const_iterator > | internaledges (MeshType const &mesh) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_POINTS >, typename MeshTraits< MeshType > ::point_const_iterator, typename MeshTraits< MeshType > ::point_const_iterator > | points (MeshType const &mesh) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_POINTS >, typename MeshTraits< MeshType > ::marked_point_const_iterator, typename MeshTraits< MeshType > ::marked_point_const_iterator > | markedpoints (MeshType const &mesh, size_type flag) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_POINTS >, typename MeshTraits< MeshType > ::location_point_const_iterator, typename MeshTraits< MeshType > ::location_point_const_iterator > | boundarypoints (MeshType const &mesh) |
template<typename MeshType > | |
boost::tuple< mpl::size_t < MESH_POINTS >, typename MeshTraits< MeshType > ::location_point_const_iterator, typename MeshTraits< MeshType > ::location_point_const_iterator > | internalpoints (MeshType const &mesh) |
template<typename MT , typename Iterator > | |
size_type | nelements (boost::tuple< MT, Iterator, Iterator > const &its) |
template<typename ElementType > | |
boost::tuple< mpl::size_t < MESH_ELEMENTS >, typename std::list< ElementType > ::const_iterator, typename std::list< ElementType > ::const_iterator > | element (ElementType const &elt) |
template<uint16_type Dim, typename T > | |
DebugStream & | operator<< (DebugStream &__os, Geo0D< Dim, T > const &__n) |
template<uint16_type Dim, typename T > | |
NdebugStream & | operator<< (NdebugStream &__os, Geo0D< Dim, T > const &__n) |
template<typename T > | |
T | distance (Geo0D< 1, T > const &p1, Geo0D< 1, T > const &p2) |
template<typename T > | |
T | distance (Geo0D< 2, T > const &p1, Geo0D< 2, T > const &p2) |
template<typename T > | |
T | distance (Geo0D< 3, T > const &p1, Geo0D< 3, T > const &p2) |
template<typename T > | |
Geo0D< 1, T > | middle (Geo0D< 1, T > const &p1, Geo0D< 1, T > const &p2) |
template<typename T > | |
Geo0D< 2, T > | middle (Geo0D< 2, T > const &p1, Geo0D< 2, T > const &p2) |
template<typename T > | |
Geo0D< 3, T > | middle (Geo0D< 3, T > const &p1, Geo0D< 3, T > const &p2) |
template<typename E1 , typename E2 > | |
ublas::vector< double > | cross (ublas::vector_expression< E1 > _p1, ublas::vector_expression< E2 > _p2) |
template<typename T > | |
ublas::vector< double > | cross (Geo0D< 3, T > p1, Geo0D< 3, T > p2) |
template<uint16_type Dim, typename GEOSHAPE , typename T , typename POINTTYPE > | |
DebugStream & | operator<< (DebugStream &__os, GeoND< Dim, GEOSHAPE, T, POINTTYPE > const &__n) |
template<uint16_type Dim, typename GEOSHAPE , typename T , typename POINTTYPE > | |
NdebugStream & | operator<< (NdebugStream &__os, GeoND< Dim, GEOSHAPE, T, POINTTYPE > const &__n) |
template<typename Geo , uint16_type Dim, uint16_type Order, uint16_type RDim, typename T > | |
std::ostream & | operator<< (std::ostream &os, Reference< Geo, Dim, Order, RDim, T > const &ref) |
template<typename RefEntity > | |
void | toPython (RefEntity const &e, std::string str="simplex") |
FEEL_NO_EXPORT bool | splitTest (const RegionTree::pbox_container_type &b, const node_type &bmin, const node_type &bmax, size_type dir, scalar_type &split_v) |
FEEL_NO_EXPORT RegionTree::element_base * | build (RegionTree::pbox_container_type &b, const node_type &bmin, const node_type &bmax, size_type last_dir) |
FEEL_NO_EXPORT void | dump (RegionTree::element_base *p, int level, size_type &count) |
FEEL_NO_EXPORT void | destroy (RegionTree::element_base *n) |
Variables | |
static std::map< unsigned int, std::string > * | DebugAreas = 0 |
static std::string * | StringNull = 0 |
static std::list< int > * | AREAS |
static std::string * | DEBUG_AREA = 0 |
const int64_type | invalid_flag_type_value = std::numeric_limits<int32_type>::min() |
const double | factor_from_eps = 50 |
const float | factor_from_eps_fl = 50 |
const double | Pi = 3.14159265358979323846264338328 |
const double | TGV = 1e20 |
const char * | FEEL_GMSH_FORMAT_VERSION = "2.1" |
const uint16_type | MESH_ALL_COMPONENTS = MESH_UPDATE_EDGES | MESH_UPDATE_FACES | MESH_CHECK | MESH_PARTITION | MESH_RENUMBER |
const uint16_type | MESH_COMPONENTS_DEFAULTS = MESH_RENUMBER | MESH_CHECK |
Constants | |
const uint8_type | invalid_uint8_type_value = uint8_type( -1 ) |
const uint16_type | invalid_uint16_type_value = uint16_type( -1 ) |
const uint32_type | invalid_uint32_type_value = uint32_type( -1 ) |
const uint64_type | invalid_uint64_type_value = uint64_type( -1 ) |
const dim_type | invalid_dim_type_value = dim_type( -1 ) |
const size_type | invalid_size_type_value = size_type( -1 ) |
Namespace for general FEEL functions.
Petsc include files.
Special routines to read meshes and special structures for sides and faces handling
Classes BareFace and BareEdge have been created to give an UNIQUE Representation for mesh faces and edges and thus allow the construction of global tables or Fields.
file GeoEntity.h
typedef ublas::symmetric_matrix<double, ublas::lower, ublas::row_major, ublas::bounded_array<double, 9> > Feel::hessian_node_type |
hessian type
boost::shared_ptr< RegionTree > Feel::region_tree_ptrtype |
pointer type for Region Tree.
an alias for RegionTree
typedef Singleton< Factory< Simget, std::string > > Feel::SimgetFactory |
Simget factory
enum Feel::BackendType |
Backend types
At the moment, we support GMM(serial), PETSC and TRILINOS(serial and parallel)
enum Feel::BFGSType |
BFGS algorithm (Broyden, Fletcher, Goldfarb, Shanno) Quasi Newton method for optimization problems. with Wolfe Line search.
Ripped from getfem++ by Y. Renard
Defines an enum
for eigenproblem types. This can be Hermitian (HEP), generalized Hermitian (GHEP), non-Hermitian (NHEP), generalized non-Hermitian (GNHEP) and Generalized Non-Hermitian GNHEP with positive (semi-)definite B
Defines an enum
for iterative eigenproblem solver types
enum Feel::ElementsType |
enum Feel::GMSH_ENTITY |
enumerate the various elements available in gmsh
GMSH_LINE |
Line (2 nodes). |
GMSH_TRIANGLE |
Triangle (3 nodes). |
GMSH_QUADRANGLE |
Quadrangle (4 nodes). |
GMSH_TETRAHEDRON |
Tetrahedron (4 nodes). |
GMSH_HEXAHEDRON |
Hexahedron (8 nodes). |
GMSH_PRISM |
Prism (6 nodes). |
GMSH_PYRAMID |
Pyramid (5 nodes). |
GMSH_LINE_2 |
Second order line (3 nodes: 2 associated. |
GMSH_TRIANGLE_2 |
Second order triangle (6 nodes: 3. |
GMSH_QUADRANGLE_2 |
Second order quadrangle (9 nodes: 4. |
GMSH_TETRAHEDRON_2 |
Second order tetrahedron (10 nodes: |
GMSH_HEXAHEDRON_2 |
Second order hexahedron (27 nodes: 8. |
GMSH_PRISM_2 |
Second order prism (18 nodes: 6 associated. |
GMSH_PYRAMID_2 |
Second order pyramid (14 nodes: 5. |
GMSH_POINT |
Point (1 node). |
GMSH_TRIANGLE_INCOMPLETE_3 |
triangle of order 3 |
GMSH_TRIANGLE_3 |
triangle of order 3 |
GMSH_TRIANGLE_INCOMPLETE_4 |
triangle of order 4 |
GMSH_TRIANGLE_4 |
triangle of order 4 |
GMSH_TRIANGLE_INCOMPLETE_5 |
triangle of order 5 |
GMSH_TRIANGLE_5 |
triangle of order 5 |
GMSH_LINE_3 |
line of order 3 |
GMSH_LINE_4 |
line of order 4 |
GMSH_LINE_5 |
line of order 5 |
GMSH_TETRAHEDRON_3 |
tetra of order 3 |
GMSH_TETRAHEDRON_4 |
tetra of order 4 |
GMSH_TETRAHEDRON_5 |
tetra of order 5 |
indicates the structure of the matrix versus preconditioner
enum Feel::MeshComponents |
Components of a mesh that can be enabled or disabled when calling updateForUse()
Context for 'on' operation on sparse matrices
Defines an enum
for the position of the spectrum, i.e. the eigenvalues to be computed.
Defines an enum
for preconditioner types
Define an enum
for non linear solver type if SELECT_IN_ARGLIST the choice is done by the arguments in the line command
enum Feel::SolverPackage |
Defines an enum
for various linear solver packages. This allows for run-time switching between solver packages
enum Feel::SolverType |
Defines an enum
for iterative solver types
Spectral transform type
boost::tuple<mpl::size_t<MESH_ELEMENTS>, typename MeshTraits<MeshType>::element_const_iterator, typename MeshTraits<MeshType>::element_const_iterator> Feel::allelements | ( | MeshType const & | mesh | ) |
flag
po::options_description Feel::backend_adaptive_reuse_pc_options | ( | std::string const & | prefix, |
BackendAdaptiveReusePCdefaults | defaults | ||
) |
po::options_description Feel::backend_options | ( | std::string const & | prefix | ) |
prefix | prefix given to the backend option |
Referenced by makeOptions().
po::options_description Feel::backendgmm_options | ( | std::string const & | prefix, |
BackendGmmDefaults | defaults | ||
) |
po::options_description Feel::backendpetsc_options | ( | std::string const & | prefix | ) |
Feel::BOOST_PARAMETER_FUNCTION | ( | (typename detail::mesh< Args >::ptrtype) | , |
loadGMSHMesh | , | ||
tag | , | ||
(required(mesh,*)(filename,*))(optional(refine,*(boost::is_integral< mpl::_ >), 0)(update,*(boost::is_integral< mpl::_ >), 0)) | |||
) |
load a mesh data structure (hold in a shared_ptr<>) using GMSH
refine
levels the mesh (default: 0) References Feel::Gmsh::refine().
Feel::BOOST_PARAMETER_FUNCTION | ( | (void) | , |
saveGMSHMesh | , | ||
tag | , | ||
(required(mesh,*)(filename,*))(optional(parametricnodes,*(boost::is_integral< mpl::_ >), 0)) | |||
) |
save a mesh data structure (hold in a shared_ptr<>) in the GMSH format
References Feel::ExporterGmsh< MeshType, N >::saveMesh().
Feel::BOOST_PP_LIST_FOR_EACH_PRODUCT | ( | FEEL_TRAITS_OP | , |
1 | , | ||
(FEEL_TRAITS_TYPES) | |||
) |
Generate the type traits
boost::tuple<mpl::size_t<MESH_EDGES>, typename MeshTraits<MeshType>::location_edge_const_iterator, typename MeshTraits<MeshType>::location_edge_const_iterator> Feel::boundaryedges | ( | MeshType const & | mesh | ) |
boost::tuple<mpl::size_t<MESH_ELEMENTS>, typename MeshTraits<MeshType>::location_element_const_iterator, typename MeshTraits<MeshType>::location_element_const_iterator> Feel::boundaryelements | ( | MeshType const & | mesh | ) |
boost::tuple<mpl::size_t<MESH_FACES>, typename MeshTraits<MeshType>::location_face_const_iterator, typename MeshTraits<MeshType>::location_face_const_iterator> Feel::boundaryfaces | ( | MeshType const & | mesh | ) |
Referenced by Feel::Stokes::run(), Feel::NonLinearPow< Dim, Order, Entity >::run(), MyIntegrals< Dim >::run(), and Feel::Bratu< Dim, Order, Entity >::run().
boost::tuple<mpl::size_t<MESH_POINTS>, typename MeshTraits<MeshType>::location_point_const_iterator, typename MeshTraits<MeshType>::location_point_const_iterator> Feel::boundarypoints | ( | MeshType const & | mesh | ) |
return the range of iterators [begin,end] over the boundary points of the mesh
boost::tuple<mpl::size_t<MESH_EDGES>, typename MeshTraits<MeshType>::pid_edge_const_iterator, typename MeshTraits<MeshType>::pid_edge_const_iterator> Feel::edges | ( | MeshType const & | mesh | ) |
__pid
mesh | a mesh data structure |
__pid | process id |
Referenced by Feel::Mesh3D< Shape >::clear(), Feel::Mesh3D< Shape >::numEdges(), and Feel::Mesh3D< Shape >::updateEntitiesCoDimensionTwo().
VectorUblas<T> Feel::element_product | ( | VectorUblas< T > const & | v1, |
VectorUblas< T > const & | v2 | ||
) |
Computes the element wise product of two vectors and eventually in parallel
v1 | vector (eventually distributed) |
v2 | vector (eventually distributed) |
v1
and v2
References Feel::Vector< T >::firstLocalIndex(), Feel::Vector< T >::localSize(), and Feel::Vector< T >::size().
Referenced by element_product(), and ResidualEstimator< Dim, Order >::run().
VectorUblas<T> Feel::element_product | ( | boost::shared_ptr< VectorUblas< T > > const & | v1, |
boost::shared_ptr< VectorUblas< T > > const & | v2 | ||
) |
Computes the element wise product of two vectors and eventually in parallel
v1 | vector (eventually distributed) |
v2 | vector (eventually distributed) |
v1
and v2
References element_product().
boost::tuple<mpl::size_t<MESH_ELEMENTS>, typename MeshTraits<MeshType>::element_const_iterator, typename MeshTraits<MeshType>::element_const_iterator> Feel::elements | ( | MeshType const & | mesh | ) |
flag
Referenced by Feel::Mesh3D< Shape >::clear(), Feel::Mesh2D< Shape >::clear(), Feel::Mesh1D< Shape >::clear(), Feel::Mesh3D< Shape >::numElements(), Feel::Mesh2D< Shape >::numElements(), Feel::Mesh1D< Shape >::numElements(), Feel::Stokes::run(), ResidualEstimator< Dim, Order >::run(), Feel::NonLinearPow< Dim, Order, Entity >::run(), MyIntegrals< Dim >::run(), MyFunctionSpace< Dim, Order >::run(), Laplacian< Dim >::run(), Convection< Order_s, Order_p, Order_t >::run(), Feel::Bratu< Dim, Order, Entity >::run(), Feel::Mesh3D< Shape >::updateEntitiesCoDimensionOnePermutation(), Feel::Mesh2D< Shape >::updateEntitiesCoDimensionOnePermutation(), and Feel::Mesh3D< Shape >::updateEntitiesCoDimensionTwo().
po::options_description Feel::exporter_options | ( | std::string const & | prefix | ) |
boost::tuple<mpl::size_t<MESH_FACES>, typename MeshTraits<MeshType>::pid_face_const_iterator, typename MeshTraits<MeshType>::pid_face_const_iterator> Feel::faces | ( | MeshType const & | mesh | ) |
__pid
mesh | a mesh data structure |
__pid | process id |
Referenced by Feel::Mesh3D< Shape >::clear(), Feel::Mesh2D< Shape >::clear(), Feel::Mesh1D< Shape >::clear(), Feel::Mesh2D< Shape >::numEdges(), Feel::Mesh3D< Shape >::numFaces(), Feel::Mesh2D< Shape >::numFaces(), Feel::Mesh1D< Shape >::numFaces(), and Feel::Mesh3D< Shape >::updateEntitiesCoDimensionTwo().
boost::tuple<mpl::size_t<MESH_ELEMENTS>, typename MeshTraits<MeshType>::element_const_iterator, typename MeshTraits<MeshType>::element_const_iterator> Feel::idedelements | ( | MeshType const & | mesh, |
flag_type | flag | ||
) |
flag
boost::tuple<mpl::size_t<MESH_FACES>, typename MeshTraits<MeshType>::face_const_iterator, typename MeshTraits<MeshType>::face_const_iterator> Feel::idedfaces | ( | MeshType const & | mesh, |
size_type | id | ||
) |
id
type_traits<T>::real_type Feel::inner_product | ( | boost::shared_ptr< Vector< T > > const & | v1, |
boost::shared_ptr< Vector< T > > const & | v2 | ||
) |
Computes the inner product of two vectors and eventually in parallel
v1 | vector (eventually distributed) |
v2 | vector (eventually distributed) |
v1
and v2
References inner_product().
type_traits<T>::real_type Feel::inner_product | ( | Vector< T > const & | v1, |
Vector< T > const & | v2 | ||
) |
Computes the inner product of two vectors and eventually in parallel
v1 | vector (eventually distributed) |
v2 | vector (eventually distributed) |
v1
and v2
References Feel::Vector< T >::comm(), Feel::Vector< T >::firstLocalIndex(), Feel::Vector< T >::localSize(), and Feel::Vector< T >::size().
Referenced by inner_product().
boost::tuple<mpl::size_t<MESH_EDGES>, typename MeshTraits<MeshType>::location_edge_const_iterator, typename MeshTraits<MeshType>::location_edge_const_iterator> Feel::internaledges | ( | MeshType const & | mesh | ) |
boost::tuple<mpl::size_t<MESH_ELEMENTS>, typename MeshTraits<MeshType>::location_element_const_iterator, typename MeshTraits<MeshType>::location_element_const_iterator> Feel::internalelements | ( | MeshType const & | mesh | ) |
boost::tuple<mpl::size_t<MESH_FACES>, typename MeshTraits<MeshType>::location_face_const_iterator, typename MeshTraits<MeshType>::location_face_const_iterator> Feel::internalfaces | ( | MeshType const & | mesh | ) |
__pid
Referenced by ResidualEstimator< Dim, Order >::run().
boost::tuple<mpl::size_t<MESH_POINTS>, typename MeshTraits<MeshType>::location_point_const_iterator, typename MeshTraits<MeshType>::location_point_const_iterator> Feel::internalpoints | ( | MeshType const & | mesh | ) |
return the range of iterators [begin,end] over the internal(not on the boundary) points of the mesh
boost::tuple<mpl::size_t<MESH_FACES>, typename MeshTraits<MeshType>::interprocess_face_const_iterator, typename MeshTraits<MeshType>::interprocess_face_const_iterator> Feel::interprocessfaces | ( | MeshType const & | mesh | ) |
__pid
void Feel::iota | ( | ForwardIter | first, |
ForwardIter | last, | ||
T | value | ||
) |
Utility::iota
is a duplication of the SGI STL extension std::iota
. It simply assigns sequentially increasing values to a range. That is, it assigns value
to *first
, value
+ 1 to *
(first + 1) and so on. In general, each iterator i
in the range [first, last) is assigned value
+ (i - first
).
Referenced by Feel::VectorPetsc< T >::localize().
boost::tuple<mpl::size_t<MESH_ELEMENTS>, typename MeshTraits<MeshType>::marker2_element_const_iterator, typename MeshTraits<MeshType>::marker2_element_const_iterator> Feel::marked2elements | ( | MeshType const & | mesh, |
flag_type | flag | ||
) |
Marker2
flag
Referenced by marked2elements().
boost::tuple<mpl::size_t<MESH_ELEMENTS>, typename MeshTraits<MeshType>::marker2_element_const_iterator, typename MeshTraits<MeshType>::marker2_element_const_iterator> Feel::marked2elements | ( | MeshType const & | mesh, |
std::string const & | flag | ||
) |
Marker2
string References marked2elements().
boost::tuple<mpl::size_t<MESH_ELEMENTS>, typename MeshTraits<MeshType>::marker3_element_const_iterator, typename MeshTraits<MeshType>::marker3_element_const_iterator> Feel::marked3elements | ( | MeshType const & | mesh, |
std::string const & | flag | ||
) |
Marker3
string References marked3elements().
boost::tuple<mpl::size_t<MESH_ELEMENTS>, typename MeshTraits<MeshType>::marker3_element_const_iterator, typename MeshTraits<MeshType>::marker3_element_const_iterator> Feel::marked3elements | ( | MeshType const & | mesh, |
flag_type | flag | ||
) |
Marker3
flag
Referenced by marked3elements().
boost::tuple<mpl::size_t<MESH_EDGES>, typename MeshTraits<MeshType>::marker_edge_const_iterator, typename MeshTraits<MeshType>::marker_edge_const_iterator> Feel::markededges | ( | MeshType const & | mesh, |
flag_type | __marker | ||
) |
__marker
mesh | a mesh data structure |
__marker | a marker that identifies edges |
__pid | process id |
boost::tuple<mpl::size_t<MESH_ELEMENTS>, typename MeshTraits<MeshType>::marker_element_const_iterator, typename MeshTraits<MeshType>::marker_element_const_iterator> Feel::markedelements | ( | MeshType const & | mesh, |
flag_type | flag | ||
) |
flag
Referenced by markedelements().
boost::tuple<mpl::size_t<MESH_ELEMENTS>, typename MeshTraits<MeshType>::marker_element_const_iterator, typename MeshTraits<MeshType>::marker_element_const_iterator> Feel::markedelements | ( | MeshType const & | mesh, |
std::string const & | flag | ||
) |
marker
string References markedelements().
boost::tuple<mpl::size_t<MESH_FACES>, typename MeshTraits<MeshType>::marker_face_const_iterator, typename MeshTraits<MeshType>::marker_face_const_iterator> Feel::markedfaces | ( | MeshType const & | mesh, |
std::string const & | __marker | ||
) |
__marker
mesh | a mesh data structure |
__marker | a string marker that identifies faces |
__pid | process id |
References markedfaces().
boost::tuple<mpl::size_t<MESH_FACES>, typename MeshTraits<MeshType>::marker_face_const_iterator, typename MeshTraits<MeshType>::marker_face_const_iterator> Feel::markedfaces | ( | MeshType const & | mesh | ) |
mesh | a mesh data structure |
__pid | process id |
Referenced by markedfaces(), ResidualEstimator< Dim, Order >::run(), Laplacian< Dim >::run(), and Convection< Order_s, Order_p, Order_t >::run().
boost::tuple<mpl::size_t<MESH_FACES>, typename MeshTraits<MeshType>::marker_face_const_iterator, typename MeshTraits<MeshType>::marker_face_const_iterator> Feel::markedfaces | ( | MeshType const & | mesh, |
flag_type | __marker | ||
) |
__marker
mesh | a mesh data structure |
__marker | a marker that identifies faces |
__pid | process id |
References markedfaces().
boost::tuple<mpl::size_t<MESH_POINTS>, typename MeshTraits<MeshType>::marked_point_const_iterator, typename MeshTraits<MeshType>::marked_point_const_iterator> Feel::markedpoints | ( | MeshType const & | mesh, |
size_type | flag | ||
) |
return the range of iterators [begin,end] over the marked points with flag
of the mesh
size_type Feel::nelements | ( | boost::tuple< MT, Iterator, Iterator > const & | its | ) |
return the number of elements given element iterators constructed using the mesh filters
its | the mesh iterators |
The following code prints in the logfile the number of elements in the mesh that are marked with marker1 equal to 1:
Debug() << "number of elements = " << nelements( markedelements(mesh,1) ) << "\n";
po::options_description Feel::nlsolver_options | ( | ) |
command line options
std::ostream & Feel::operator<< | ( | std::ostream & | os, |
AboutData const & | about | ||
) |
outpout stream an AboutData structure
os | ostream to use to stream the about data |
about | data to stream |
boost::tuple<mpl::size_t<MESH_POINTS>, typename MeshTraits<MeshType>::point_const_iterator, typename MeshTraits<MeshType>::point_const_iterator> Feel::points | ( | MeshType const & | mesh | ) |
return the range of iterators [begin,end] over the points of the mesh
Referenced by Feel::Mesh3D< Shape >::clear(), Feel::Mesh2D< Shape >::clear(), Feel::Mesh1D< Shape >::clear(), Feel::Mesh3D< Shape >::numPoints(), Feel::Mesh2D< Shape >::numPoints(), and Feel::Mesh1D< Shape >::numPoints().
po::options_description Feel::solvereigen_options | ( | std::string const & | prefix = "" | ) |
defines solver eigen options
The prefix
parameter allows to set different eigensolver options for different eigensolver. It allows to distinguish between these options
// register two slepc eigensolver options add_options( solvereigen_options( "eigen1" ) ).add_options( solvereigen_options( "eigen2" )); // build an eigen solver associated with option set eigen1 SolverEigen<double>::build( vm, "eigen1" );
prefix | prefix allows to prefix options |
void Feel::spy | ( | MatrixType const & | __m, |
std::string const & | filename | ||
) |
Dump vector to file in Matlab format and spy
const dim_type Feel::invalid_dim_type_value = dim_type( -1 ) |
Invalid dim type value
const size_type Feel::invalid_size_type_value = size_type( -1 ) |
Invalid size type value
Referenced by Feel::DataMap::DataMap(), Feel::DataMap::gid(), Feel::DataMap::lid(), Feel::DataMap::myGID(), and Feel::DataMap::myLID().
const uint16_type Feel::invalid_uint16_type_value = uint16_type( -1 ) |
Invalid uint16_type value
Referenced by Feel::Mesh3D< Shape >::updateEntitiesCoDimensionOnePermutation().
const uint32_type Feel::invalid_uint32_type_value = uint32_type( -1 ) |
Invalid uint32_type value
const uint64_type Feel::invalid_uint64_type_value = uint64_type( -1 ) |
Invalid uint64_type value
const uint8_type Feel::invalid_uint8_type_value = uint8_type( -1 ) |
Invalid uint8_type value