Rheolef
7.2
an efficient C++ finite element environment
|
This file is part of Rheolef. More...
Namespaces | |
namespace | algo |
namespace | custom_cgal |
namespace | details |
namespace | edge |
namespace | element_constant |
namespace | hexahedron |
namespace | io |
namespace | prism |
namespace | quadrangle |
namespace | space_constant |
namespace | space_numbering |
namespace | tetrahedron |
namespace | triangle |
Functions | |
std::istream & | operator>> (std::istream &is, const catchmark &m) |
std::ostream & | operator<< (std::ostream &os, const catchmark &m) |
template<typename T1 > | |
bool | operator== (const heap_allocator< T1 > &lhs, const heap_allocator< T1 > &rhs) throw () |
template<typename T1 > | |
bool | operator!= (const heap_allocator< T1 > &lhs, const heap_allocator< T1 > &rhs) throw () |
template<class T > | |
std::istream & | operator>> (std::istream &is, const irheomanip1< T > &m) |
template<class T > | |
std::ostream & | operator<< (std::ostream &os, const orheomanip1< T > &m) |
template<class T > | |
std::istream & | operator>> (std::istream &is, const iorheomanip1< T > &m) |
template<class T > | |
std::ostream & | operator<< (std::ostream &os, const iorheomanip1< T > &m) |
template<typename InputPairIterator , typename OutputPairIterator , typename UnaryOperation > | |
OutputPairIterator | pair_transform_second (InputPairIterator first, InputPairIterator last, OutputPairIterator result, UnaryOperation unary_op) |
template<class T1 , class T2 > | |
std::ostream & | operator<< (std::ostream &out, const std::pair< T1, T2 > &x) |
std::string | indent (std::string str, const std::string &indent=" ") |
std::string | typeid_name (const char *name, bool do_indent) |
std::string | get_tmpdir () |
get_tmpdir: see the rheostream page for the full documentation | |
string | ftos (const Float &x) |
itof: see the rheostream page for the full documentation | |
bool | has_suffix (const std::string &name, const std::string &suffix) |
has_suffix: see the rheostream page for the full documentation | |
string | delete_suffix (const std::string &name, const std::string &suffix) |
delete_suffix: see the rheostream page for the full documentation | |
bool | has_any_suffix (const std::string &name) |
has_any_suffix: see the rheostream page for the full documentation | |
string | delete_any_suffix (const std::string &name) |
delete_any_suffix: see the rheostream page for the full documentation | |
string | get_basename (const std::string &name) |
get_basename: see the rheostream page for the full documentation | |
string | get_dirname (const std::string &name) |
get_dirname: see the rheostream page for the full documentation | |
void | append_dir_to_rheo_path (const std::string &dir) |
append_dir_to_rheo_path: see the rheostream page for the full documentation | |
void | prepend_dir_to_rheo_path (const std::string &dir) |
prepend_dir_to_rheo_path: see the rheostream page for the full documentation | |
string | get_full_name_from_rheo_path (const std::string &rootname, const std::string &suffix) |
get_full_name_from_rheo_path: see the rheostream page for the full documentation | |
bool | is_float (const std::string &) |
is_float: see the rheostream page for the full documentation | |
Float | to_float (const std::string &) |
to_float: see the rheostream page for the full documentation | |
bool | scatch (std::istream &in, const std::string &ch, bool full_match=true) |
scatch: see the rheostream page for the full documentation | |
bool | file_exists (const std::string &filename) |
file_exists: see the rheostream page for the full documentation | |
std::string | itos (std::size_t i) |
template<class T > | |
rounder_type< T > | rounder (const T &prec) |
template<class T > | |
floorer_type< T > | floorer (const T &prec) |
template<class T > | |
ceiler_type< T > | ceiler (const T &prec) |
template<typename T1 > | |
bool | operator== (const stack_allocator< T1 > &lhs, const stack_allocator< T1 > &rhs) throw () |
template<typename T1 > | |
bool | operator!= (const stack_allocator< T1 > &lhs, const stack_allocator< T1 > &rhs) throw () |
_RHEOLEF_instanciation (Float, sequential, std::allocator< Float >) _RHEOLEF_instanciation(Float | |
template<class T , class M , class A > | |
idiststream & | operator>> (idiststream &s, asr< T, M, A > &x) |
template<class T , class M , class A > | |
odiststream & | operator<< (odiststream &s, const asr< T, M, A > &x) |
template<class InputPtrIterator , class Predicate , class Operation , class OutputPtrIterator , class OutputDataIterator > | |
OutputPtrIterator | asr_to_csr (InputPtrIterator iter_ptr_a, InputPtrIterator last_ptr_a, Predicate pred, Operation op, OutputPtrIterator iter_ptr_b, OutputDataIterator iter_data_b) |
template<class InputPtrIterator , class Predicate , class Set > | |
Set::value_type | asr_to_csr_dist_logical (InputPtrIterator iter_ptr_a, InputPtrIterator last_ptr_a, Predicate is_dia, Set &colext) |
template<class Matrix , class Vector , class Vector2 , class Preconditioner > | |
int | cg (const Matrix &A, Vector &x, const Vector2 &Mb, const Preconditioner &M, const solver_option &sopt=solver_option()) |
template<class T , class M > | |
csr< T, M > | diag (const vec< T, M > &d) |
_RHEOLEF_instanciation (Float, sequential) _RHEOLEF_instanciation(Float | |
template<class T > | |
csr< T, sequential > | operator* (const T &lambda, const csr< T, sequential > &a) |
template<class T > | |
csr< T, sequential > | operator- (const csr< T, sequential > &a) |
template<class T > | |
csr< T, sequential > | trans (const csr< T, sequential > &a) |
trans(a): see the form page for the full documentation | |
template<class T > | |
csr< T, distributed > | operator* (const T &lambda, const csr< T, distributed > &a) |
template<class T > | |
csr< T, distributed > | operator- (const csr< T, distributed > &a) |
template<class T > | |
csr< T, distributed > | trans (const csr< T, distributed > &a) |
template<class T , class M , class Function > | |
csr< T, M > | csr_apply (Function f, const csr< T, M > &a) |
template<class T , class M , class Function > | |
csr< T, M > | csr_apply (T(*f)(const T &), const csr< T, M > &a) |
template<class T , class M > | |
idiststream & | operator>> (idiststream &s, csr< T, M > &x) |
template<class T , class M > | |
odiststream & | operator<< (odiststream &s, const csr< T, M > &x) |
template<class InputIterator , class InputRandomAcessIterator , class SetOperator , class OutputIterator > | |
void | csr_amux (InputIterator ia, InputIterator last_ia, InputRandomAcessIterator x, SetOperator set_op, OutputIterator y) |
template<class T , class M > | |
details::vec_trans< T, M > | trans (const vec< T, M > &w) |
template<class T , class M > | |
details::vector_vec_trans< T, M > | trans (const std::vector< vec< T, M > > &w) |
template<class InputIterator1 , class InputIterator3 , class SetOperator , class RandomAccessMutableIterator > | |
void | csr_cumul_trans_mult (InputIterator1 ia, InputIterator1 last_ia, InputIterator3 x, SetOperator set_op, RandomAccessMutableIterator y) |
template<class T , class BinaryOp > | |
void | csr_ext_add (const csr_rep< T, sequential > &a, const std::vector< typename csr< T >::size_type > &jext_a2dis_j, const csr_rep< T, sequential > &b, const std::vector< typename csr< T >::size_type > &jext_b2dis_j, csr_rep< T, sequential > &c, std::vector< typename csr< T >::size_type > &jext_c2dis_j, BinaryOp binop) |
template<class T > | |
csr_rep< T, sequential >::size_type | csr_csr_mult_size (const csr_rep< T, sequential > &a, const csr_rep< T, sequential > &b) |
template<class InputPtrIterator , class InputDataIterator , class UnaryOperation , class OutputPtrIterator > | |
OutputPtrIterator | csr_to_asr (InputPtrIterator iter_ptr_a, InputPtrIterator last_ptr_a, InputDataIterator iter_data_a, UnaryOperation op, OutputPtrIterator iter_ptr_b) |
template<class T , class M > | |
dia< T, M > | operator/ (const T &lambda, const dia< T, M > &d) |
template<class T , class M > | |
vec< T, M > | operator* (const dia< T, M > &d, const vec< T, M > &x) |
template<class T , class M > | |
dia< T, M > | diag (const csr< T, M > &a) |
template<class InputIterator , class Size > | |
std::iterator_traits< InputIterator >::value_type | dis_accumulate (InputIterator first, Size n, const distributor::communicator_type &comm, sequential) |
template<class InputIterator , class Size > | |
std::iterator_traits< InputIterator >::value_type | dis_accumulate (InputIterator first, Size n, const distributor::communicator_type &comm, distributed) |
template<class InputIterator , class Size > | |
std::iterator_traits< InputIterator >::value_type | dis_accumulate (InputIterator first, Size n, const distributor::communicator_type &comm) |
double | dis_cpu_time () |
double | seq_wall_time () |
double | seq_cpu_time () |
double | dis_wall_time () |
template<class InputIterator1 , class InputIterator2 , class Size > | |
promote< typenamestd::iterator_traits< InputIterator1 >::value_type, typenamestd::iterator_traits< InputIterator2 >::value_type >::type | dis_inner_product (InputIterator1 first1, InputIterator2 first2, Size n, const distributor::communicator_type &comm, sequential) |
template<class InputIterator1 , class InputIterator2 , class Size > | |
promote< typenamestd::iterator_traits< InputIterator1 >::value_type, typenamestd::iterator_traits< InputIterator2 >::value_type >::type | dis_inner_product (InputIterator1 first1, InputIterator2 first2, Size n, const distributor::communicator_type &comm, distributed) |
template<class InputIterator1 , class InputIterator2 , class Size > | |
promote< typenamestd::iterator_traits< InputIterator1 >::value_type, typenamestd::iterator_traits< InputIterator2 >::value_type >::type | dis_inner_product (InputIterator1 first1, InputIterator2 first2, Size n, const distributor::communicator_type &comm) |
size_t | seq_peak_memory_usage () |
size_t | seq_memory_usage () |
size_t | memory_size () |
size_t | dis_memory_usage () |
size_t | dis_peak_memory_usage () |
template<class T , class A > | |
idiststream & | operator>> (idiststream &ips, disarray< T, sequential, A > &x) |
template<class T , class A > | |
odiststream & | operator<< (odiststream &ops, const disarray< T, sequential, A > &x) |
template<class T , class A > | |
idiststream & | operator>> (idiststream &ips, disarray< T, distributed, A > &x) |
template<class T , class A > | |
odiststream & | operator<< (odiststream &ops, const disarray< T, distributed, A > &x) |
template<class OutputRandomIterator , class SetOp , class Size , class IsContainer > | |
disarray_store< OutputRandomIterator, SetOp, Size, IsContainer > | disarray_make_store (OutputRandomIterator x, SetOp op, Size, IsContainer) |
bool | dis_scatch (idiststream &ips, const communicator &comm, std::string ch) |
distributed version of scatch(istream&,string) | |
int | dis_system (const std::string &command, const communicator &comm) |
bool | dis_file_exists (const std::string &filename, const communicator &comm) |
_RHEOLEF_define_sequential_odiststream_macro (char) _RHEOLEF_define_sequential_odiststream_macro(int) _RHEOLEF_define_sequential_odiststream_macro(unsigned int) _RHEOLEF_define_sequential_odiststream_macro(long int) _RHEOLEF_define_sequential_odiststream_macro(long unsigned int) _RHEOLEF_define_sequential_odiststream_macro(float) _RHEOLEF_define_sequential_odiststream_macro(double) _RHEOLEF_define_sequential_odiststream_macro(long double) _RHEOLEF_define_sequential_odiststream_macro(char *const) _RHEOLEF_define_sequential_odiststream_macro(std | |
_RHEOLEF_define_sequential_idiststream_macro (char) _RHEOLEF_define_sequential_idiststream_macro(int) _RHEOLEF_define_sequential_idiststream_macro(long int) _RHEOLEF_define_sequential_idiststream_macro(unsigned int) _RHEOLEF_define_sequential_idiststream_macro(long unsigned int) _RHEOLEF_define_sequential_idiststream_macro(float) _RHEOLEF_define_sequential_idiststream_macro(double) _RHEOLEF_define_sequential_idiststream_macro(long double) _RHEOLEF_define_sequential_idiststream_macro(std | |
bool | dis_scatch (idiststream &ips, std::string ch) |
idiststream & | operator>> (idiststream &ids, const catchmark &m) |
odiststream & | operator<< (odiststream &ods, const catchmark &m) |
template<class T , class M = rheo_default_memory_model> | |
solver_basic< T, M > | eye_basic () |
solver_basic< Float > | eye () |
see the eye page for the full documentation | |
template<class _Operation1 , class _Operation2 > | |
unary_compose< _Operation1, _Operation2 > | compose1 (const _Operation1 &__fn1, const _Operation2 &__fn2) |
template<class _Operation1 , class _Operation2 , class _Operation3 > | |
binary_compose< _Operation1, _Operation2, _Operation3 > | compose2 (const _Operation1 &__fn1, const _Operation2 &__fn2, const _Operation3 &__fn3) |
template<class Iterator > | |
std::iterator_traits< Iterator >::pointer | get_pointer_from_iterator (Iterator iter) |
template<class T > | |
std::iterator_traits< T * >::pointer | get_pointer_from_iterator (T *iter) |
template<class Matrix , class Vector , class Preconditioner , class SmallMatrix , class SmallVector > | |
int | gmres (const Matrix &A, Vector &x, const Vector &b, const Preconditioner &M, SmallMatrix &H, const SmallVector &V, const solver_option &sopt=solver_option()) |
template<class T , class M > | |
solver_basic< T, M > | ilut (const csr< T, M > &a, size_t fill_factor=10, T drop_tol=1e3 *std::numeric_limits< T >::epsilon()) |
std::istream & | operator>> (std::istream &is, index_set &x) |
std::ostream & | operator<< (std::ostream &os, const index_set &x) |
void | set_union (const index_set &a, const index_set &b, index_set &c) |
void | set_intersection (const index_set &a, const index_set &b, index_set &c) |
template<class RandomIterator > | |
bool | load_chunk (std::istream &s, RandomIterator iter, RandomIterator last) |
template<class RandomIterator , class GetFunction > | |
bool | load_chunk (std::istream &s, RandomIterator iter, RandomIterator last, GetFunction get_element) |
template<class T , class M > | |
solver_basic< T, M > | mic (const csr< T, M > &a, const T &shift=1e-3) |
template<class Matrix , class Vector , class Preconditioner > | |
int | minres (const Matrix &A, Vector &x, const Vector &Mb, const Preconditioner &M, const solver_option &sopt=solver_option()) |
template<class Matrix , class Vector , class Solver , class Preconditioner > | |
int | uzawa_abtbc (const Matrix &A, const Matrix &B, const Matrix &C, Vector &u, Vector &p, const Vector &Mf, const Vector &Mg, const Preconditioner &S1, const Solver &inner_solver_A, const Float &rho, const solver_option &sopt=solver_option()) |
template<class Matrix , class Vector , class Solver , class Preconditioner , class Real > | |
int | uzawa_abtb (const Matrix &A, const Matrix &B, Vector &u, Vector &p, const Vector &Mf, const Vector &Mg, const Preconditioner &S1, const Solver &inner_solver_A, const Real &rho, const solver_option &sopt=solver_option()) |
template<class Matrix , class Vector , class VectorExpr1 , class VectorExpr2 , class Solver , class Preconditioner > | |
int | cg_abtbc (const Matrix &A, const Matrix &B, const Matrix &C, Vector &u, Vector &p, const VectorExpr1 &Mf, const VectorExpr2 &Mg, const Preconditioner &S1, const Solver &inner_solver_A, const solver_option &sopt=solver_option()) |
template<class Matrix , class Vector , class VectorExpr1 , class VectorExpr2 , class Solver , class Preconditioner > | |
int | cg_abtb (const Matrix &A, const Matrix &B, Vector &u, Vector &p, const VectorExpr1 &Mf, const VectorExpr2 &Mg, const Preconditioner &S1, const Solver &inner_solver_A, const solver_option &sopt=solver_option()) |
template<class Matrix , class Vector , class Solver , class Preconditioner > | |
int | minres_abtbc (const Matrix &A, const Matrix &B, const Matrix &C, Vector &u, Vector &p, const Vector &Mf, const Vector &Mg, const Preconditioner &S1, const Solver &inner_solver_A, const solver_option &sopt=solver_option()) |
template<class Matrix , class Vector , class Solver , class Preconditioner > | |
int | minres_abtb (const Matrix &A, const Matrix &B, Vector &u, Vector &p, const Vector &Mf, const Vector &Mg, const Preconditioner &S1, const Solver &inner_solver_A, const solver_option &sopt=solver_option()) |
struct matrix_market | read_matrix_market_header (idiststream &ips) |
template<class Stash , class Message , class InputIterator > | |
Stash::size_type | mpi_assembly_begin (const Stash &stash, InputIterator first_stash_idx, InputIterator last_stash_idx, const distributor &ownership, Message &receive, Message &send) |
template<class Container , class Message , class Size > | |
Size | mpi_assembly_end (Message &receive, Message &send, Size receive_max_size, Container x) |
template<class InputIterator , class Message , class Tag , class Comm > | |
void | mpi_scatter_begin_global (InputIterator x, Message &from, Message &to, Tag tag, Comm comm) |
template<class InputIterator , class OutputIterator , class SetOp , class Message > | |
void | mpi_scatter_begin_local (InputIterator x, OutputIterator y, Message &from, Message &to, SetOp op) |
template<class InputIterator , class OutputIterator , class Message > | |
void | mpi_scatter_begin_local (InputIterator x, OutputIterator y, Message &from, Message &to, details::generic_set_op op) |
template<class InputIterator , class OutputIterator , class Message , class SetOp , class Tag , class Comm > | |
void | mpi_scatter_begin (InputIterator x, OutputIterator y, Message &from, Message &to, SetOp op, Tag tag, Comm comm) |
template<class InputIterator , class OutputIterator , class Message , class SetOp , class Tag , class Comm > | |
void | mpi_scatter_end (InputIterator x, OutputIterator y, Message &from, Message &to, SetOp op, Tag tag, Comm comm) |
template<class Message , class Size , class SizeRandomIterator1 , class SizeRandomIterator2 , class SizeRandomIterator3 , class Tag > | |
void | mpi_scatter_init (Size nidx, SizeRandomIterator1 idx, Size nidy, SizeRandomIterator2 idy, Size idy_maxval, SizeRandomIterator3 ownership, Tag tag, const distributor::communicator_type &comm, Message &from, Message &to) |
template<class InputIterator , class InputSet , class OutputMap > | |
void | mpi_scatter_map (const distributor &ownership, InputIterator local_data, const InputSet &ext_idx_set, OutputMap &ext_idx_map) |
template<class InputIterator1 , class InputIterator2 , class InputRandomIterator , class SetOp , class OutputRandomIterator > | |
void | msg_both_permutation_apply (InputIterator1 px, InputIterator1 last_px, InputRandomIterator x, SetOp set_op, InputIterator2 py, OutputRandomIterator y) |
template<class InputIterator1 , class InputIterator2 , class InputRandomIterator , class Proc , class Size , class MutableRandomIterator , class OutputIterator > | |
void | msg_from_context_indices (InputIterator1 owner, InputIterator1 last_owner, InputIterator2 idy, InputRandomIterator proc2from_proc, Proc my_proc, Size idy_maxval, MutableRandomIterator ptr, OutputIterator from_idx) |
template<class InputIterator1 , class OutputIterator1 , class OutputIterator2 , class OutputIterator3 > | |
void | msg_from_context_pattern (InputIterator1 msg_size, InputIterator1 last_msg_size, OutputIterator1 from_proc, OutputIterator2 from_ptr, OutputIterator3 proc2from_proc) |
template<class InputIterator1 , class InputIterator2 , class SetOp , class OutputRandomIterator > | |
void | msg_left_permutation_apply (InputIterator1 x, SetOp op, InputIterator2 py, InputIterator2 last_py, OutputRandomIterator y) |
template<class InputIterator1 , class InputIterator2 , class Size , class OutputIterator1 , class OutputIterator2 > | |
void | msg_local_context (InputIterator1 idx, InputIterator1 last_idx, InputIterator2 idy, Size idy_maxval, Size istart, Size ilast, OutputIterator1 to_loc_idx, OutputIterator1 last_to_loc_idx, OutputIterator2 from_loc_idy) |
template<class InputIterator1 , class InputIterator2 > | |
bool | msg_local_optimize (InputIterator1 to_loc_idx, InputIterator1 last_to_loc_idx, InputIterator2 from_loc_idy) |
template<class InputIterator , class InputRandomIterator , class OutputIterator , class SetOp > | |
OutputIterator | msg_right_permutation_apply (InputIterator perm, InputIterator last_perm, const InputRandomIterator &x, OutputIterator y, SetOp set_op) |
template<class InputIterator , class InputRandomIterator , class OutputIterator > | |
OutputIterator | msg_right_permutation_apply (InputIterator perm, InputIterator last_perm, const InputRandomIterator &x, OutputIterator y) |
template<class RandomIterator , class SizeRandomIterator , class Size > | |
void | quick_sort_with_permutation (RandomIterator v, SizeRandomIterator p, Size start, Size end) |
template<class RandomIterator , class SizeRandomIterator , class Size > | |
void | bubble_sort_with_permutation (RandomIterator v, SizeRandomIterator p, Size n) |
template<class RandomIterator , class SizeRandomIterator , class Size > | |
void | sort_with_permutation (RandomIterator v, SizeRandomIterator p, Size n) |
template<class InputIterator1 , class InputRandomIterator2 , class InputRandomIterator3 , class InputRandomIterator4 , class Size , class OutputIterator1 , class OutputIterator2 , class OutputIterator3 > | |
void | msg_to_context (InputIterator1 perm, InputIterator1 last_perm, InputRandomIterator2 r_iproc, InputRandomIterator3 r_size, InputRandomIterator4 r_idx, Size receive_max_size, Size istart, OutputIterator1 to_proc, OutputIterator2 to_ptr, OutputIterator3 to_idx) |
template<class Iterator , class Operator > | |
apply_iterator< Iterator, Operator > | make_apply_iterator (Iterator i, Operator op) |
template<class InputIterator , class OutputIterator > | |
OutputIterator | msg_pair_copy (InputIterator input, InputIterator last, OutputIterator result) |
template<class T , class A > | |
std::istream & | operator>> (std::istream &is, pair_set< T, A > &a) |
template<class T , class A > | |
std::ostream & | operator<< (std::ostream &os, const pair_set< T, A > &b) |
template<class Matrix , class Vector , class Preconditioner , class Real2 > | |
int | uzawa (const Matrix &A, Vector &x, const Vector &Mb, const Preconditioner &M, const Real2 &rho, const solver_option &sopt=solver_option()) |
template<class T > | |
idiststream & | operator>> (idiststream &ips, vec< T, sequential > &x) |
template<class T , class M > | |
odiststream & | operator<< (odiststream &ods, const vec< T, M > &x) |
template<class T > | |
idiststream & | operator>> (idiststream &ips, vec< T, distributed > &x) |
template<class T , class M > | |
T | norm2 (const vec< T, M > &x) |
norm2(x): see the expression page for the full documentation | |
template<class T , class M > | |
T | norm (const vec< T, M > &x) |
norm(x): see the expression page for the full documentation | |
_RHEOLEF_vec_expr_v2_unary_operator (+, details::generic_unary_plus<>) _RHEOLEF_vec_expr_v2_unary_operator(- | |
_RHEOLEF_vec_expr_v2_binary_operator (+, details::generic_plus<>) _RHEOLEF_vec_expr_v2_binary_operator(- | |
template<class Expr1 , class Expr2 > | |
details::generic_minus std::enable_if<(details::is_rheolef_arithmetic< Expr1 >::value &&details::is_vec_expr_v2_arg< Expr2 >::value)||(details::is_vec_expr_v2_arg< Expr1 >::value &&details::is_rheolef_arithmetic< Expr2 >::value), typenamedetails::vec_expr_v2_binary_traits< details::generic_multiplies<>, Expr1, Expr2 >::type >::type | operator* (const Expr1 &expr1, const Expr2 &expr2) |
template<class Expr1 , class Expr2 > | |
std::enable_if<(details::is_vec_expr_v2_arg< Expr1 >::value &&details::is_rheolef_arithmetic< Expr2 >::value), typenamedetails::vec_expr_v2_binary_traits< details::generic_divides<>, Expr1, Expr2 >::type >::type | operator/ (const Expr1 &expr1, const Expr2 &expr2) |
_RHEOLEF_vec_expr_v2_op_assign (+=, details::plus_assign) _RHEOLEF_vec_expr_v2_op_assign(- | |
_RHEOLEF_vec_expr_v2_op_assign_constant (+=, details::plus_assign) _RHEOLEF_vec_expr_v2_op_assign_constant(- | |
details::minus_assign _RHEOLEF_vec_expr_v2_op_assign_constant details::multiplies_assign | _RHEOLEF_vec_expr_v2_op_assign_constant (/=, details::divides_assign) template< class Expr1 |
dot(x,y): see the expression page for the full documentation | |
rheolef::std enable_if ::type dot const Expr1 expr1, const Expr2 expr2 | dot (const Expr1 &expr1, const Expr2 &expr2) |
template<class Expr1 , class Expr2 > | |
std::enable_if< details::is_vec_expr_v2_arg< Expr1 >::value &&details::is_rheolef_arithmetic< Expr2 >::value, typenameExpr1::float_type >::type | dot (const Expr1 &expr1, const Expr2 &expr2) |
dot(x,y): see the expression page for the full documentation | |
template<class T > | |
T | my_gamma (const T &x) |
template<class Size , class OutputIterator1 , class OutputIterator2 > | |
void | gauss_jacobi (Size R, typename std::iterator_traits< OutputIterator1 >::value_type alpha, typename std::iterator_traits< OutputIterator1 >::value_type beta, OutputIterator1 zeta, OutputIterator2 omega) |
template<class Size , class OutputIterator1 , class OutputIterator2 > | |
void | gauss_lobatto_jacobi (Size R, typename std::iterator_traits< OutputIterator1 >::value_type alpha, typename std::iterator_traits< OutputIterator1 >::value_type beta, OutputIterator1 zeta, OutputIterator2 omega) |
template<class Size , class OutputIterator1 , class OutputIterator2 > | |
void | gauss_radau_jacobi (Size R, typename std::iterator_traits< OutputIterator1 >::value_type alpha, typename std::iterator_traits< OutputIterator1 >::value_type beta, OutputIterator1 zeta, OutputIterator2 omega) |
template<class Size , class T , class OutputIterator > | |
void | jacobi_roots (Size R, T alpha, T beta, OutputIterator zeta) |
char | skip_blancs_and_tabs (std::istream &is) |
std::istream & | operator>> (std::istream &is, geo_element &K) |
std::ostream & | operator<< (std::ostream &os, const geo_element &K) |
std::istream & | operator>> (std::istream &is, geo_element_indirect &x) |
std::ostream & | operator<< (std::ostream &os, const geo_element_indirect &x) |
template<class T > | |
std::istream & | operator>> (std::istream &s, point_basic< T > &p) |
template<class T > | |
std::ostream & | operator<< (std::ostream &s, const point_basic< T > &p) |
template<class T , class U > | |
std::enable_if< details::is_rheolef_arithmetic< U >::value, point_basic< T > >::type | operator* (const U &a, const point_basic< T > &u) |
template<class T > | |
point_basic< T > | vect (const point_basic< T > &v, const point_basic< T > &w) |
template<class T > | |
T | dot (const point_basic< T > &x, const point_basic< T > &y) |
template<class T > | |
T | norm2 (const point_basic< T > &x) |
template<class T > | |
T | norm (const point_basic< T > &x) |
template<class T > | |
T | dist2 (const point_basic< T > &x, const point_basic< T > &y) |
template<class T > | |
T | dist (const point_basic< T > &x, const point_basic< T > &y) |
template<class T > | |
T | dist_infty (const point_basic< T > &x, const point_basic< T > &y) |
template<class T > | |
T | vect2d (const point_basic< T > &v, const point_basic< T > &w) |
template<class T > | |
T | mixt (const point_basic< T > &u, const point_basic< T > &v, const point_basic< T > &w) |
template<class T > | |
int | sign_orient2d (const point_basic< T > &a, const point_basic< T > &b, const point_basic< T > &c) |
template<class T > | |
int | sign_orient3d (const point_basic< T > &a, const point_basic< T > &b, const point_basic< T > &c, const point_basic< T > &d) |
template<class T > | |
T | orient2d (const point_basic< T > &a, const point_basic< T > &b, const point_basic< T > &c) |
template<class T > | |
T | orient3d (const point_basic< T > &a, const point_basic< T > &b, const point_basic< T > &c, const point_basic< T > &d) |
template<class T > | |
std::string | ptos (const point_basic< T > &x, int d=3) |
template<class T , size_t d> | |
bool | lexicographically_less (const point_basic< T > &a, const point_basic< T > &b) |
def_point_function (sqr) def_point_function(sqrt) def_point_function(log) def_point_function(log10) def_point_function(exp) template< class T > bool point_basic< T > | |
template<class T1 , class T2 > | |
point_basic< T1 > | operator/ (const T2 &a, const point_basic< T1 > &x) |
template<class T > | |
std::ostream & | operator<< (std::ostream &os, const quadrature< T > &q) |
template<class T > | |
ostream & | operator<< (ostream &out, const quadrature_on_geo< T > &x) |
template<class T > | |
ostream & | operator<< (ostream &out, const quadrature_rep< T > &x) |
Float | measure (reference_element hat_K) |
template<class T > | |
point_basic< T > | reference_element_face_transformation (reference_element tilde_K, const side_information_type &sid, const point_basic< T > &sid_hat_x) |
template<class T > | |
point_basic< T > | reference_element_face_inverse_transformation (reference_element tilde_K, const side_information_type &sid, const point_basic< T > &tilde_x) |
point_basic< size_t > | reference_element_face_transformation (reference_element tilde_K, const side_information_type &sid, size_t k, const point_basic< size_t > &sid_ilat) |
template<typename T , int N> | |
Eigen::Matrix< T, N, N > | expm_eig (const Eigen::Matrix< T, N, N > &a) |
template<class T > | |
tensor_basic< T > | exp (const tensor_basic< T > &a, size_t d) |
template<class T > | |
point_basic< T > | operator* (const point_basic< T > &x, const tensor_basic< T > &a) |
template<class T > | |
tensor_basic< T > | trans (const tensor_basic< T > &a, size_t d) |
template<class T > | |
tensor_basic< T > | inv (const tensor_basic< T > &a, size_t d) |
template<class T > | |
void | prod (const tensor_basic< T > &a, const tensor_basic< T > &b, tensor_basic< T > &result, size_t di, size_t dj, size_t dk) |
template<class T > | |
T | ddot (const tensor_basic< T > &a, const tensor_basic< T > &b) |
ddot(x,y): see the expression page for the full documentation | |
template<class T > | |
void | cumul_otimes (tensor_basic< T > &t, const point_basic< T > &a, const point_basic< T > &b, size_t na, size_t nb) |
template<class T > | |
bool | invert_3x3 (const tensor_basic< T > &A, tensor_basic< T > &result) |
template<class U > | |
point_basic< U > | operator* (const point_basic< U > &yt, const tensor_basic< U > &a) |
template<class U > | |
tensor_basic< U > | trans (const tensor_basic< U > &a, size_t d=3) |
template<class U > | |
void | prod (const tensor_basic< U > &a, const tensor_basic< U > &b, tensor_basic< U > &result, size_t di=3, size_t dj=3, size_t dk=3) |
template<class U > | |
U | tr (const tensor_basic< U > &a, size_t d=3) |
template<class U > | |
U | ddot (const tensor_basic< U > &, const tensor_basic< U > &) |
template<class U > | |
tensor_basic< U > | otimes (const point_basic< U > &u, const point_basic< U > &v, size_t d=3) |
template<class U > | |
tensor_basic< U > | inv (const tensor_basic< U > &a, size_t d=3) |
template<class U > | |
tensor_basic< U > | diag (const point_basic< U > &d) |
template<class U > | |
point_basic< U > | diag (const tensor_basic< U > &a) |
template<class U > | |
U | determinant (const tensor_basic< U > &A, size_t d=3) |
template<class U > | |
bool | invert_3x3 (const tensor_basic< U > &A, tensor_basic< U > &result) |
template<class T > | |
std::istream & | operator>> (std::istream &in, tensor_basic< T > &a) |
template<class T > | |
std::ostream & | operator<< (std::ostream &out, const tensor_basic< T > &a) |
template<class T > | |
void | cumul_otimes (tensor_basic< T > &t, const point_basic< T > &a, const point_basic< T > &b, size_t na=3) |
template<class T , class U > | |
std::enable_if< details::is_rheolef_arithmetic< U >::value, tensor_basic< T > >::type | operator* (const U &k, const tensor_basic< T > &a) |
template<class T > | |
tensor_basic< T > | otimes (const point_basic< T > &u, const point_basic< T > &v, size_t d) |
template<class T > | |
T | determinant (const tensor_basic< T > &A, size_t d) |
template<class T > | |
tensor_basic< T > | diag (const point_basic< T > &d) |
template<class T > | |
point_basic< T > | diag (const tensor_basic< T > &a) |
template<class T > | |
T | tr (const tensor_basic< T > &a, size_t d) |
template<class T > | |
T | norm2 (const tensor_basic< T > &a) |
template<class T > | |
T | dist2 (const tensor_basic< T > &a, const tensor_basic< T > &b) |
template<class U > | |
U | norm (const tensor_basic< U > &a) |
template<class U > | |
U | dist (const tensor_basic< U > &a, const tensor_basic< U > &b) |
template<class T > | |
T | dddot (const tensor3_basic< T > &a, const tensor3_basic< T > &b) |
template<class T , class U > | |
std::enable_if< details::is_rheolef_arithmetic< U >::value, tensor3_basic< T > >::type | operator* (const U &k, const tensor3_basic< T > &a) |
template<class U > | |
U | dddot (const tensor3_basic< U > &, const tensor3_basic< U > &) |
template<class T > | |
T | norm2 (const tensor3_basic< T > &a) |
template<class T > | |
T | dist2 (const tensor3_basic< T > &a, const tensor3_basic< T > &b) |
template<class U > | |
U | norm (const tensor3_basic< U > &a) |
template<class U > | |
U | dist (const tensor3_basic< U > &a, const tensor3_basic< U > &b) |
template<class T > | |
std::istream & | operator>> (std::istream &in, tensor3_basic< T > &a) |
template<class T > | |
std::ostream & | operator<< (std::ostream &out, const tensor3_basic< T > &a) |
template<class T > | |
tensor4_basic< T > | dexp (const tensor_basic< T > &chi, size_t dim) |
template<class T > | |
tensor_basic< T > | ddot (const tensor4_basic< T > &a, const tensor_basic< T > &x) |
template<class T > | |
tensor_basic< T > | ddot (const tensor_basic< T > &y, const tensor4_basic< T > &a) |
template<class T > | |
T | norm2 (const tensor4_basic< T > &a) |
template<class T > | |
T | norm (const tensor4_basic< T > &a) |
template<class T , class U > | |
std::enable_if< details::is_rheolef_arithmetic< U >::value, tensor4_basic< T > >::type | operator* (const U &k, const tensor4_basic< T > &a) |
template<class T > | |
std::ostream & | operator<< (std::ostream &out, const tensor4_basic< T > &a) |
template<class T > | |
void | lu (tiny_matrix< T > &a, tiny_vector< size_t > &piv) |
template<class T > | |
void | solve (tiny_matrix< T > &a, tiny_vector< size_t > &piv, const tiny_vector< T > &b, tiny_vector< T > &x) |
template<class T > | |
void | invert (tiny_matrix< T > &a, tiny_matrix< T > &inv_a) |
template<class T > | |
void | put (std::ostream &out, std::string name, const tiny_matrix< T > &a) |
template<class T > | |
void | trans (const tiny_matrix< T > &a, tiny_matrix< T > &b) |
template<class T > | |
tiny_matrix< T > | operator* (const tiny_matrix< T > &a, const tiny_matrix< T > &b) |
template<class T > | |
tiny_vector< T > | operator* (const tiny_matrix< T > &a, const tiny_vector< T > &u) |
template<class T > | |
std::ostream & | operator<< (std::ostream &os, const ad3_basic< T > &a) |
template<class T , class U > | |
std::enable_if< details::is_rheolef_arithmetic< U >::value, ad3_basic< T > >::type | operator+ (const U &a, const ad3_basic< T > &b) |
template<class T , class U > | |
std::enable_if< details::is_rheolef_arithmetic< U >::value, ad3_basic< T > >::type | operator+ (const ad3_basic< T > &a, const U &b) |
template<class T , class U > | |
std::enable_if< details::is_rheolef_arithmetic< U >::value, ad3_basic< T > >::type | operator- (const U &a, const ad3_basic< T > &b) |
template<class T , class U > | |
std::enable_if< details::is_rheolef_arithmetic< U >::value, ad3_basic< T > >::type | operator- (const ad3_basic< T > &a, const U &b) |
template<class T , class U > | |
std::enable_if< details::is_rheolef_arithmetic< U >::value, ad3_basic< T > & >::type | operator+= (ad3_basic< T > &a, const U &b) |
template<class T , class U > | |
std::enable_if< details::is_rheolef_arithmetic< U >::value, ad3_basic< T > & >::type | operator-= (ad3_basic< T > &a, const U &b) |
template<class T , class U > | |
std::enable_if< details::is_rheolef_arithmetic< U >::value, ad3_basic< T > >::type | operator* (const U &a, const ad3_basic< T > &b) |
template<class T , class U > | |
std::enable_if< details::is_rheolef_arithmetic< U >::value, ad3_basic< T > >::type | operator* (const ad3_basic< T > &a, const U &b) |
template<class T , class U > | |
std::enable_if< details::is_rheolef_arithmetic< U >::value, ad3_basic< T > & >::type | operator*= (ad3_basic< T > &a, const U &b) |
template<class T , class U > | |
std::enable_if< details::is_rheolef_arithmetic< U >::value, ad3_basic< T > >::type | operator/ (const U &a, const ad3_basic< T > &b) |
template<class T , class U > | |
std::enable_if< details::is_rheolef_arithmetic< U >::value, ad3_basic< T > >::type | operator/ (const ad3_basic< T > &a, const U &b) |
template<class T , class U > | |
std::enable_if< details::is_rheolef_arithmetic< U >::value, ad3_basic< T > & >::type | operator/= (ad3_basic< T > &a, const U &b) |
int | basis_lex () |
void | basis_error (const char *msg) |
int | basis_wrap () |
void | basis_parse_from_string (const std::string &str, family_index_option_type &fio) |
template<class T > | |
void | eigen_dense2sparse (const Eigen::Matrix< T, Eigen::Dynamic, Eigen::Dynamic > &a, Eigen::SparseMatrix< T, Eigen::RowMajor > &as) |
template<class T > | |
T | cond (const Eigen::Matrix< T, Eigen::Dynamic, Eigen::Dynamic > &a) |
template<class T , int Nrows, int Ncols> | |
bool | invert (const Eigen::Matrix< T, Nrows, Ncols > &a, Eigen::Matrix< T, Nrows, Ncols > &inv_a) |
template<class T > | |
void | put_matrix_market (std::ostream &out, const Eigen::SparseMatrix< T, Eigen::RowMajor > &a) |
template<class T > | |
void | put_matrix_market (std::ostream &out, const Eigen::Matrix< T, Eigen::Dynamic, Eigen::Dynamic > &a) |
template<class T > | |
void | pointset_lagrange_equispaced (reference_element hat_K, size_t order_in, Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > &hat_xnod, size_t internal=0) |
template<class T > | |
void | set_simplex_leb_gll (size_t degree, Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > &pts) |
template<class T > | |
void | pointset_lagrange_fekete (reference_element hat_K, size_t degree, Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > &hat_xnod, bool map_on_reference_element=true) |
_RHEOLEF_inline_value_g ("scalar", T, point_basic< T >) _RHEOLEF_inline_value_g("vector" | |
tensor_basic< T > | _RHEOLEF_inline_value_g ("tensor", tensor_basic< T >, tensor3_basic< T >) _RHEOLEF_inline_value_g("tensor3" |
template<class T > | |
void | reference_element_barycenter (reference_element hat_K, point_basic< T > &c) |
template<class T , class Container > | |
bool | eval_sherwin_basis_is_singular_point (const point_basic< T > &tilde_x, reference_element hat_K, size_t degree, Container &value) |
template<class T > | |
void | warburton_e (size_t degree, Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > &x, bool map_on_reference_element=true) |
template<class T > | |
void | warburton_q (size_t degree, Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > &x, bool dummy=true) |
template<class T > | |
void | warburton_H (size_t degree, Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > &x, bool dummy=true) |
template<class T > | |
void | warburton_t (size_t degree, Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > &x, bool map_on_reference_element=true) |
template<class T > | |
void | warburton_P (size_t degree, Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > &x, bool map_on_reference_element=true) |
template<class T > | |
void | equispaced_T (size_t degree, Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > &x) |
template<class T > | |
void | evalwarp (size_t degree, const std::vector< T > &xnodes, const std::vector< T > &xout, std::vector< T > &warp) |
template<class T > | |
void | evalshift (size_t degree, const T &alpha, const std::vector< T > &L0, const std::vector< T > &L1, const std::vector< T > &L2, std::vector< T > &dx, std::vector< T > &dy) |
template<class T > | |
void | WarpShiftFace3D (size_t degree, const T &alpha, const T &dummy, const std::vector< T > &Ldummy, const std::vector< T > &L1, const std::vector< T > &L2, const std::vector< T > &L3, std::vector< T > &warpx, std::vector< T > &warpy) |
template<class T > | |
void | warburton_T (size_t degree, Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > &x, bool map_on_reference_element=true) |
template<class T > | |
void | pointset_lagrange_warburton (reference_element hat_K, size_t degree, Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > &hat_xnod, bool map_on_reference_element=true) |
template<class T , class M > | |
geo_basic< T, M > | adapt_gmsh (const field_basic< T, M > &uh, const adapt_option &opts) |
template<class T , class M > | |
geo_basic< T, M > | adapt_bamg (const field_basic< T, M > &uh, const adapt_option &opts) |
template<class T , class M > | |
field_basic< T, M > | proj (const field_basic< T, M > &uh, const std::string &approx="P1") |
template<class T , class M > | |
field_basic< T, M > | smooth (const field_basic< T, M > &uh, size_t n=1) |
template<class T , class M > | |
field_basic< T, M > | hessian (const field_basic< T, M > &uh) |
template<class T , class M > | |
field_basic< T, M > | hessian_criterion (const field_basic< T, M > &uh0, const adapt_option &opts) |
template<class T , class M > | |
geo_basic< T, M > | adapt (const field_basic< T, M > &uh, const adapt_option &opts) |
adapt(uh,opts): see the adapt page for the full documentation | |
std::string | bamgcad_catch_name (idiststream &bamg_in) |
template<class T , class M > | |
geo_basic< T, M > | level_set_internal (const field_basic< T, M > &, const level_set_option &, std::vector< size_t > &, disarray< size_t, M > &) |
template<class T > | |
void | get_header (idiststream &in, branch_basic< T, sequential > &b) |
template<class T > | |
void | get_event (idiststream &in, branch_basic< T, sequential > &b) |
template<class T > | |
void | get_header (idiststream &in, branch_basic< T, distributed > &b) |
template<class T > | |
void | get_event (idiststream &in, branch_basic< T, distributed > &b) |
template<class T , class M > | |
idiststream & | operator>> (idiststream &in, branch_basic< T, M > &b) |
template<class T > | |
void | put_header (odiststream &out, const branch_basic< T, sequential > &b) |
template<class T > | |
void | put_header (odiststream &out, const branch_basic< T, distributed > &b) |
template<class T > | |
void | put_event (odiststream &out, const branch_basic< T, sequential > &b) |
template<class T > | |
void | put_event (odiststream &out, const branch_basic< T, distributed > &b) |
template<class T , class M > | |
odiststream & | operator<< (odiststream &out, const branch_basic< T, M > &b) |
template<class T > | |
void | put_finalize (odiststream &out, const branch_basic< T, sequential > &b) |
template<class T > | |
void | put_finalize (odiststream &out, const branch_basic< T, distributed > &b) |
rheolef_instanciate (Float, sequential) rheolef_instanciate(Float | |
template<class T , class M > | |
odiststream & | operator<< (odiststream &os, __iobranch< T, M > m) |
template<class T , class M > | |
idiststream & | operator>> (idiststream &is, __iobranch< T, M > m) |
template<class T > | |
idiststream & | geo_get_vtk (idiststream &ips, geo_basic< T, sequential > &omega) |
template<class T > | |
void | get_header_vtk (idiststream &ips, branch_basic< T, sequential > &b) |
template<class T > | |
void | get_event_vtk (idiststream &ips, branch_basic< T, sequential > &b) |
template void | get_header_vtk< Float > (idiststream &, branch_basic< Float, sequential > &) |
template void | get_event_vtk< Float > (idiststream &, branch_basic< Float, sequential > &) |
template<class T > | |
odiststream & | field_put_vtk (odiststream &, const field_basic< T, sequential > &, std::string, bool) |
template<class T > | |
void | put_header_vtk (odiststream &out, const branch_basic< T, sequential > &b) |
template<class T > | |
void | put_event_vtk_stream (odiststream &out_vtk, const branch_basic< T, sequential > &b) |
template<class T > | |
void | put_event_vtk (odiststream &out, const branch_basic< T, sequential > &b) |
template<class T > | |
void | put_finalize_vtk (odiststream &out, const branch_basic< T, sequential > &b) |
template void | put_header_vtk (odiststream &, const branch_basic< Float, sequential > &) |
template void | put_event_vtk (odiststream &, const branch_basic< Float, sequential > &) |
template void | put_event_vtk_stream (odiststream &, const branch_basic< Float, sequential > &) |
template void | put_finalize_vtk (odiststream &, const branch_basic< Float, sequential > &) |
template<class T > | |
void | put_header_gnuplot (odiststream &ops, const branch_basic< T, sequential > &b) |
template<class T > | |
void | put_event_gnuplot (odiststream &ops, const branch_basic< T, sequential > &b) |
template<class T > | |
void | put_finalize_gnuplot (odiststream &ops, const branch_basic< T, sequential > &b) |
template void | put_header_gnuplot (odiststream &, const branch_basic< Float, sequential > &) |
template void | put_event_gnuplot (odiststream &, const branch_basic< Float, sequential > &) |
template void | put_finalize_gnuplot (odiststream &, const branch_basic< Float, sequential > &) |
template<class T > | |
std::string | python (const point_basic< T > &x, size_t d=3) |
template<class T > | |
void | put_header_paraview (odiststream &out, const branch_basic< T, sequential > &b) |
template<class T > | |
void | put_event_paraview (odiststream &out, const branch_basic< T, sequential > &b) |
template<class T > | |
void | put_finalize_paraview (odiststream &out, const branch_basic< T, sequential > &b) |
template void | put_header_paraview (odiststream &, const branch_basic< Float, sequential > &) |
template void | put_event_paraview (odiststream &, const branch_basic< Float, sequential > &) |
template void | put_finalize_paraview (odiststream &, const branch_basic< Float, sequential > &) |
details::field_expr_v2_nonlinear_node_nary< typename details::function_traits< Function >::functor_type, typename details::field_expr_v2_nonlinear_terminal_wrapper_traits< Exprs >::type... > ::type | compose (const Function &f, const Exprs &... exprs) |
see the compose page for the full documentation | |
template<class Problem > | |
void | continuation (Problem &F, typename Problem::value_type &uh, odiststream *p_out, odiststream *p_err, const continuation_option &opts=continuation_option()) |
see the continuation page for the full documentation | |
template<class Problem > | |
void | continuation (keller< Problem > &F, typename keller< Problem >::value_type &uh, odiststream *p_out, odiststream *p_err, const continuation_option &opts=continuation_option()) |
template<class Problem , class Preconditioner , class Field , class Real , class Size > | |
int | damped_newton (const Problem &P, const Preconditioner &T, Field &u, Real &tol, Size &max_iter, odiststream *p_derr=0) |
see the damped_newton page for the full documentation | |
template<class Problem , class Field , class Real , class Size > | |
int | damped_newton (const Problem &F, Field &u, Real &tol, Size &max_iter, odiststream *p_derr=0) |
template<class T > | |
domain_indirect_basic< sequential > | build_union (const geo_basic< T, sequential > &omega, const domain_indirect_basic< sequential > &a, const domain_indirect_basic< sequential > &b) |
template<class T > | |
domain_indirect_basic< distributed > | build_union (const geo_basic< T, distributed > &omega, const domain_indirect_basic< distributed > &a, const domain_indirect_basic< distributed > &b) |
void | build_set_that_contains_S (const geo_element &S, const std::vector< index_set > &ball, index_set &contains_S) |
builds a set of elements that all contain S. | |
template<class T , class M > | |
void | div_evaluate_internal (const fem_on_pointset_rep< T > &obj, const geo_basic< T, M > &omega_K, const geo_element &K, const details::differentiate_option &gopt, const Eigen::Matrix< tensor_basic< T >, Eigen::Dynamic, Eigen::Dynamic > &grad_value, Eigen::Matrix< T, Eigen::Dynamic, Eigen::Dynamic > &value) |
template<class T , class M > | |
void | curl_evaluate_internal (const fem_on_pointset_rep< T > &obj, const geo_basic< T, M > &omega_K, const geo_element &K, const details::differentiate_option &gopt, Eigen::Matrix< T, Eigen::Dynamic, Eigen::Dynamic > &value) |
template<class T , class M > | |
void | curl_evaluate_internal (const fem_on_pointset_rep< T > &obj, const geo_basic< T, M > &omega_K, const geo_element &K, const details::differentiate_option &gopt, Eigen::Matrix< point_basic< T >, Eigen::Dynamic, Eigen::Dynamic > &value) |
_RHEOLEF_instanciation (Float) _RHEOLEF_instanciation_evaluate(Float | |
template<class T , class M > | |
void | space_constitution_old_get (idiststream &ids, space_constitution< T, M > &constit) |
template<class T > | |
odiststream & | visu_gnuplot (odiststream &, const field_basic< T, sequential > &) |
template<class T > | |
odiststream & | visu_gmsh (odiststream &, const field_basic< T, sequential > &) |
template<class T > | |
odiststream & | visu_vtk_paraview (odiststream &, const field_basic< T, sequential > &) |
template<class T > | |
odiststream & | field_put_gmsh (odiststream &, const field_basic< T, sequential > &, std::string) |
template<class T > | |
odiststream & | field_put_gmsh_pos (odiststream &, const field_basic< T, sequential > &) |
template<class T > | |
odiststream & | field_put_bamg_bb (odiststream &, const field_basic< T, sequential > &) |
template<class T , class M > | |
idiststream & | operator>> (odiststream &ips, field_basic< T, M > &u) |
template<class T , class M > | |
odiststream & | operator<< (odiststream &ops, const field_basic< T, M > &uh) |
template<class T , class M > | |
idiststream & | operator>> (idiststream &ips, field_basic< T, M > &uh) |
template<class T , class M > | |
field_basic< T, M > | lazy_interpolate (const space_basic< T, M > &X2h, const field_basic< T, M > &u1h) |
see the interpolate page for the full documentation | |
template<class T , class M , class FieldRdof > | |
std::enable_if< details::has_field_rdof_interface< FieldRdof >::value &&!details::is_field< FieldRdof >::value, field_basic< T, M > >::type | lazy_interpolate (const space_basic< T, M > &Xh, const FieldRdof &uh) |
see the interpolate page for the full documentation | |
template<class FieldLazy > | |
std::enable_if< details::has_field_lazy_interface< FieldLazy >::value &&!details::is_field< FieldLazy >::value, odiststream & >::type | operator<< (odiststream &out, const FieldLazy &expr) |
template<class T , class M > | |
void | field_evaluate (const field_basic< T, M > &uh, const basis_on_pointset< T > &bops, reference_element hat_K, const std::vector< size_t > &dis_idof, Eigen::Matrix< T, Eigen::Dynamic, 1 > &value) |
template<class T , class M > | |
void | vector_field_evaluate (const field_basic< T, M > &uh, const basis_on_pointset< T > &bops, reference_element hat_K, const std::vector< size_t > &dis_idof_tab, const basis_on_pointset< T > &piola_on_geo_basis, std::vector< size_t > &dis_inod_geo, Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > &value) |
template<class T , class M > | |
void | tensor_field_evaluate (const field_basic< T, M > &uh, const basis_on_pointset< T > &bops, reference_element hat_K, const std::vector< size_t > &dis_idof_tab, Eigen::Matrix< tensor_basic< T >, Eigen::Dynamic, 1 > &value) |
template<class T , class M > | |
void | field_component_evaluate (const field_basic< T, M > &uh, const basis_on_pointset< T > &bops, reference_element hat_K, const std::vector< size_t > &dis_idof_tab, size_t k_comp, Eigen::Matrix< T, Eigen::Dynamic, 1 > &value) |
template<class T , class M , class Value > | |
void | field_evaluate_continued (const field_basic< T, M > &uh, const geo_basic< T, M > &omega_K, const geo_element &K, const Eigen::Matrix< Value, Eigen::Dynamic, Eigen::Dynamic > &phij_xi, Eigen::Matrix< Value, Eigen::Dynamic, 1 > &value) |
template<class T , class M , class Value > | |
void | field_evaluate (const field_basic< T, M > &uh, const fem_on_pointset< T > &fops, const geo_basic< T, M > &omega_K, const geo_element &K, Eigen::Matrix< Value, Eigen::Dynamic, 1 > &value) |
template<class T , class M > | |
void | general_field_evaluate (const field_basic< T, M > &uh, const basis_on_pointset< T > &bops, reference_element hat_K, const std::vector< size_t > &dis_idof, const basis_on_pointset< T > &piola_on_geo_basis, std::vector< size_t > &dis_inod_geo, Eigen::Matrix< T, Eigen::Dynamic, 1 > &value) |
template<class T , class M > | |
void | general_field_evaluate (const field_basic< T, M > &uh, const basis_on_pointset< T > &bops, reference_element hat_K, const std::vector< size_t > &dis_idof, const basis_on_pointset< T > &piola_on_geo_basis, std::vector< size_t > &dis_inod_geo, Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > &value) |
template<class T , class M > | |
void | general_field_evaluate (const field_basic< T, M > &uh, const basis_on_pointset< T > &bops, reference_element hat_K, const std::vector< size_t > &dis_idof, const basis_on_pointset< T > &piola_on_geo_basis, std::vector< size_t > &dis_inod_geo, Eigen::Matrix< tensor_basic< T >, Eigen::Dynamic, 1 > &value) |
template<class T , class M > | |
void | general_field_evaluate (const field_basic< T, M > &uh, const basis_on_pointset< T > &bops, reference_element hat_K, const std::vector< size_t > &dis_idof, const basis_on_pointset< T > &piola_on_geo_basis, std::vector< size_t > &dis_inod_geo, Eigen::Matrix< tensor3_basic< T >, Eigen::Dynamic, 1 > &value) |
template<class T , class M > | |
void | general_field_evaluate (const field_basic< T, M > &uh, const basis_on_pointset< T > &bops, reference_element hat_K, const std::vector< size_t > &dis_idof, const basis_on_pointset< T > &piola_on_geo_basis, std::vector< size_t > &dis_inod_geo, Eigen::Matrix< tensor4_basic< T >, Eigen::Dynamic, 1 > &value) |
_RHEOLEF_field_expr_v2_op_assign (+=, details::plus_assign) _RHEOLEF_field_expr_v2_op_assign(- | |
_RHEOLEF_field_expr_v2_op_assign_constant (+=, details::plus_assign) _RHEOLEF_field_expr_v2_op_assign_constant(- | |
details::minus_assign _RHEOLEF_field_expr_v2_op_assign_constant details::multiplies_assign | _RHEOLEF_field_expr_v2_op_assign_constant (/=, details::divides_assign) template< class Expr1 |
rheolef::std enable_if ::type dual const Expr1 expr1, const Expr2 expr2 | dual (const Expr1 &expr1, const Expr2 &expr2) |
template<class Expr1 , class Expr2 > | |
std::enable_if< details::is_field_expr_affine_homogeneous< Expr1 >::value &&details::is_field_expr_v2_constant< Expr2 >::value, typenameExpr1::float_type >::type | dual (const Expr1 &expr1, const Expr2 &expr2) |
template<class Expr > | |
std::enable_if< details::has_field_rdof_interface< Expr >::value &&!details::is_field< Expr >::value, form_basic< typenameExpr::value_type, typenameExpr::memory_type > >::type | diag (const Expr &expr) |
template<class Expr > | |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_quadrature_on_sides< Expr > >::type | on_local_sides (const Expr &expr) |
on_local_sides(expr): see the expression page for the full documentation | |
_RHEOLEF_field_expr_quadrature_binary (operator+, details::plus) _RHEOLEF_field_expr_quadrature_binary(operator- | |
_RHEOLEF_make_field_expr_v2_nonlinear_unary_operator (operator+, details::unary_plus) _RHEOLEF_make_field_expr_v2_nonlinear_unary_operator(operator- | |
_RHEOLEF_make_field_expr_v2_nonlinear_unary_function (cos) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(sin) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(tan) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(acos) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(asin) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(atan) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(cosh) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(sinh) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(tanh) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(exp) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(log) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(log10) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(sqrt) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(abs) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(fabs) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(floor) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(ceil) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(sqr) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(norm) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(norm2) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(tr) _RHEOLEF_make_field_expr_v2_nonlinear_unary_function(trans) template< class Function | |
field_expr_v2_nonlinear_node_binary (const BinaryFunction &f, const Expr1 &expr1, const Expr2 &expr2) | |
bool | have_homogeneous_space (space_basic< scalar_type, memory_type > &Vh) const |
const_iterator | begin_dof () const |
space_constant::valued_type | valued_tag () const |
void | initialize (const piola_on_pointset< float_type > &pops, const integrate_option &iopt) |
void | initialize (const space_basic< float_type, memory_type > &Xh, const piola_on_pointset< float_type > &pops, const integrate_option &iopt) |
template<class Result , class Arg1 , class Arg2 , class M > | |
void | evaluate_internal2 (const geo_basic< float_type, M > &omega_K, const geo_element &K, Eigen::Matrix< Result, Eigen::Dynamic, 1 > &value) const |
template<class Result , class Arg1 , class Arg2 , class M > | |
void | evaluate_internal2 (const geo_basic< float_type, M > &omega_K, const geo_element &K, const side_information_type &sid, Eigen::Matrix< Result, Eigen::Dynamic, 1 > &value) const |
template<class Result , class Arg1 , class Arg2 , class M > | |
void | evaluate_call (const geo_basic< float_type, M > &omega_K, const geo_element &K, Eigen::Matrix< Result, Eigen::Dynamic, 1 > &value) const |
template<class Result , class Arg1 , class Arg2 , class M > | |
void | evaluate_call (const geo_basic< float_type, M > &omega_K, const geo_element &K, const side_information_type &sid, Eigen::Matrix< Result, Eigen::Dynamic, 1 > &value) const |
template<class Result , class M > | |
void | evaluate (const geo_basic< float_type, M > &omega_K, const geo_element &K, Eigen::Matrix< Result, Eigen::Dynamic, 1 > &value) const |
template<class Result , class M > | |
void | evaluate_on_side (const geo_basic< float_type, M > &omega_K, const geo_element &K, const side_information_type &sid, Eigen::Matrix< Result, Eigen::Dynamic, 1 > &value) const |
template<class Result > | |
bool | valued_check () const |
_RHEOLEF_make_field_expr_v2_nonlinear_binary (operator+, details::plus) _RHEOLEF_make_field_expr_v2_nonlinear_binary(operator- | |
_RHEOLEF_make_field_expr_v2_nonlinear_binary (operator*, details::multiplies) _RHEOLEF_make_field_expr_v2_nonlinear_binary(operator/ | |
_RHEOLEF_make_field_expr_v2_nonlinear_binary_function (atan2) _RHEOLEF_make_field_expr_v2_nonlinear_binary_function(pow) _RHEOLEF_make_field_expr_v2_nonlinear_binary_function(fmod) _RHEOLEF_make_field_expr_v2_nonlinear_binary_function(min) _RHEOLEF_make_field_expr_v2_nonlinear_binary_function(max) _RHEOLEF_make_field_expr_v2_nonlinear_binary_function(dot) _RHEOLEF_make_field_expr_v2_nonlinear_binary_function(ddot) _RHEOLEF_make_field_expr_v2_nonlinear_binary_function(dddot) template< class Function | |
rheolef::std enable_if ::type compose const Function f, const Expr1 expr1, const Expr2 expr2 | compose (const Function &f, const Expr1 &expr1, const Expr2 &expr2) |
template<class Function , class Expr1 , class Expr2 > | |
std::enable_if< details::is_field_expr_v2_nonlinear_arg< Expr1 >::value &&!details::is_field_expr_v2_constant< Expr1 >::value &&details::is_field_expr_v2_constant< Expr2 >::value, details::field_expr_v2_nonlinear_node_unary< details::binder_second< typenamedetails::function_traits< Function >::functor_type, typenamepromote< typenamedetails::field_expr_v2_nonlinear_terminal_wrapper_traits< Expr1 >::type::value_type, Expr2 >::type >, typenamedetails::field_expr_v2_nonlinear_terminal_wrapper_traits< Expr1 >::type > >::type | compose (const Function &f, const Expr1 &expr1, const Expr2 &expr2) |
template<class T > | |
details::field_expr_v2_nonlinear_terminal_function< details::normal_pseudo_function< T > > | normal_basic () |
details::field_expr_v2_nonlinear_terminal_function< details::normal_pseudo_function< Float > > | normal () |
normal: see the expression page for the full documentation | |
template<class T > | |
details::field_expr_v2_nonlinear_terminal_function< details::h_local_pseudo_function< T > > | h_local_basic () |
details::field_expr_v2_nonlinear_terminal_function< details::h_local_pseudo_function< Float > > | h_local () |
h_local: see the expression page for the full documentation | |
template<class T > | |
details::field_expr_v2_nonlinear_terminal_function< details::penalty_pseudo_function< T > > | penalty_basic () |
details::field_expr_v2_nonlinear_terminal_function< details::penalty_pseudo_function< Float > > | penalty () |
penalty(): see the expression page for the full documentation | |
template<class Expr > | |
std::enable_if< details::has_field_rdof_interface< Expr >::value, details::field_expr_v2_nonlinear_terminal_field< typenameExpr::scalar_type, typenameExpr::memory_type, details::differentiate_option::gradient > >::type | grad (const Expr &expr) |
grad(uh): see the expression page for the full documentation | |
template<class Expr > | |
std::enable_if< details::has_field_rdof_interface< Expr >::value, details::field_expr_v2_nonlinear_terminal_field< typenameExpr::scalar_type, typenameExpr::memory_type, details::differentiate_option::gradient > >::type | grad_s (const Expr &expr) |
grad_s(uh): see the expression page for the full documentation | |
template<class Expr > | |
std::enable_if< details::has_field_rdof_interface< Expr >::value, details::field_expr_v2_nonlinear_terminal_field< typenameExpr::scalar_type, typenameExpr::memory_type, details::differentiate_option::gradient > >::type | grad_h (const Expr &expr) |
grad_h(uh): see the expression page for the full documentation | |
template<class Expr > | |
std::enable_if< details::has_field_rdof_interface< Expr >::value, details::field_expr_v2_nonlinear_terminal_field< typenameExpr::scalar_type, typenameExpr::memory_type, details::differentiate_option::gradient > >::type | D (const Expr &expr) |
D(uh): see the expression page for the full documentation. | |
template<class Expr > | |
std::enable_if< details::has_field_rdof_interface< Expr >::value, details::field_expr_v2_nonlinear_terminal_field< typenameExpr::scalar_type, typenameExpr::memory_type, details::differentiate_option::gradient > >::type | Ds (const Expr &expr) |
Ds(uh): see the expression page for the full documentation. | |
template<class Expr > | |
std::enable_if< details::has_field_rdof_interface< Expr >::value, details::field_expr_v2_nonlinear_terminal_field< typenameExpr::scalar_type, typenameExpr::memory_type, details::differentiate_option::gradient > >::type | Dh (const Expr &expr) |
Dh(uh): see the expression page for the full documentation. | |
template<class Expr > | |
std::enable_if< details::has_field_rdof_interface< Expr >::value, details::field_expr_v2_nonlinear_terminal_field< typenameExpr::scalar_type, typenameExpr::memory_type, details::differentiate_option::divergence > >::type | div (const Expr &expr) |
div(uh): see the expression page for the full documentation | |
template<class Expr > | |
std::enable_if< details::has_field_rdof_interface< Expr >::value, details::field_expr_v2_nonlinear_terminal_field< typenameExpr::scalar_type, typenameExpr::memory_type, details::differentiate_option::divergence > >::type | div_s (const Expr &expr) |
div_s(uh): see the expression page for the full documentation | |
template<class Expr > | |
std::enable_if< details::has_field_rdof_interface< Expr >::value, details::field_expr_v2_nonlinear_terminal_field< typenameExpr::scalar_type, typenameExpr::memory_type, details::differentiate_option::divergence > >::type | div_h (const Expr &expr) |
div_h(uh): see the expression page for the full documentation | |
template<class Expr > | |
std::enable_if< details::has_field_rdof_interface< Expr >::value, details::field_expr_v2_nonlinear_terminal_field< typenameExpr::scalar_type, typenameExpr::memory_type, details::differentiate_option::curl > >::type | curl (const Expr &expr) |
curl(uh): see the expression page for the full documentation | |
_RHEOLEF_make_field_expr_v2_nonlinear_terminal_field_dg (jump, 1, -1) _RHEOLEF_make_field_expr_v2_nonlinear_terminal_field_dg(average | |
_RHEOLEF_make_field_expr_v2_nonlinear_terminal_field_dg (inner, 1, 0) _RHEOLEF_make_field_expr_v2_nonlinear_terminal_field_dg(outer | |
template<class T , class M > | |
details::field_expr_v2_nonlinear_terminal_field_o_characteristic< T, M > | compose (const field_basic< T, M > &uh, const characteristic_basic< T, M > &X) |
_RHEOLEF_make_field_expr_v2_variational_unary_operator (operator+, details::unary_plus) _RHEOLEF_make_field_expr_v2_variational_unary_operator(operator- | |
details::negate | _RHEOLEF_make_field_expr_v2_variational_unary_operator (tr, details::tr_) _RHEOLEF_make_field_expr_v2_variational_unary_operator(trans |
_RHEOLEF_make_field_expr_v2_variational_binary_operator_plus_minus (operator+, details::plus) _RHEOLEF_make_field_expr_v2_variational_binary_operator_plus_minus(operator- | |
_RHEOLEF_make_field_expr_v2_variational_binary_operator_multiplies_divides (operator*, details::multiplies) _RHEOLEF_make_field_expr_v2_variational_binary_operator_multiplies_divides_right(operator/ | |
details::divides | _RHEOLEF_make_field_expr_v2_variational_binary_operator_multiplies_divides (dot, details::dot_) _RHEOLEF_make_field_expr_v2_variational_binary_operator_multiplies_divides(ddot |
details::divides details::ddot_ | _RHEOLEF_make_field_expr_v2_variational_binary_operator_multiplies_divides (dddot, details::dddot_) namespace details |
_RHEOLEF_make_field_expr_v2_variational_binary_operator_multiplies_divides_constant (operator*, details::multiplies) _RHEOLEF_make_field_expr_v2_variational_binary_operator_multiplies_divides_constant_right(operator/ | |
details::divides | _RHEOLEF_make_field_expr_v2_variational_binary_operator_multiplies_divides_constant (dot, details::dot_) _RHEOLEF_make_field_expr_v2_variational_binary_operator_multiplies_divides_constant(ddot |
template<class Expr > | |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_grad< Expr > >::type | grad (const Expr &expr) |
template<class Expr > | |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_grad< Expr > >::type | grad_s (const Expr &expr) |
template<class Expr > | |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_grad< Expr > >::type | grad_h (const Expr &expr) |
template<class Expr > | |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_grad< Expr > >::type | D (const Expr &expr) |
template<class Expr > | |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_grad< Expr > >::type | Ds (const Expr &expr) |
template<class Expr > | |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_grad< Expr > >::type | Dh (const Expr &expr) |
template<class Expr > | |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_div< Expr > >::type | div (const Expr &expr) |
template<class Expr > | |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_div< Expr > >::type | div_s (const Expr &expr) |
template<class Expr > | |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_div< Expr > >::type | div_h (const Expr &expr) |
template<class Expr > | |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_curl< Expr > >::type | curl (const Expr &expr) |
template<class Expr > | |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_curl< Expr > >::type | bcurl (const Expr &expr) |
_RHEOLEF_make_field_expr_v2_variational_dg (jump, 1, -1) _RHEOLEF_make_field_expr_v2_variational_dg(average | |
_RHEOLEF_make_field_expr_v2_variational_dg (inner, 1, 0) _RHEOLEF_make_field_expr_v2_variational_dg(outer | |
template<class F > | |
field_function_s< std::function< F >, typename F::result_type > | field_function (F f) |
template<class FormExpr , class FieldExpr , class Sfinae1 = typename std::enable_if<details:: is_form_lazy<FormExpr> ::value, FormExpr>::type, class Sfinae2 = typename std::enable_if<details::is_field_lazy<FieldExpr>::value, FieldExpr>::type> | |
details::field_lazy_mult_form< FormExpr, FieldExpr > | operator* (const FormExpr &a, const FieldExpr &u) |
a*u: see the form page for the full documentation | |
template<class FormExpr , class Sfinae = typename std::enable_if<details::is_form_lazy<FormExpr>::value, FormExpr>::type> | |
details::field_lazy_mult_form< FormExpr, details::field_lazy_terminal_field< typename FormExpr::scalar_type, typename FormExpr::memory_type > > | operator* (const FormExpr &a, const field_basic< typename FormExpr::scalar_type, typename FormExpr::memory_type > &u) |
a*u: see the form page for the full documentation | |
_RHEOLEF_field_lazy_unop (+, details::unary_plus) _RHEOLEF_field_lazy_unop(- | |
_RHEOLEF_field_lazy_add (+, plus) _RHEOLEF_field_lazy_add(- | |
template<class Expr > | |
std::enable_if< details::is_field_expr_quadrature_arg< Expr >::value, details::field_lazy_terminal_integrate< Expr > >::type | lazy_integrate (const typename Expr::geo_type &domain, const Expr &expr, const integrate_option &iopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_lazy_terminal_integrate< details::field_expr_quadrature_on_element< Expr > > >::type | lazy_integrate (const geo_basic< typename Expr::scalar_type, typename Expr::memory_type > &domain, const Expr &expr, const integrate_option &iopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_field_expr_quadrature_arg< Expr >::value, details::field_lazy_terminal_integrate< Expr > >::type | lazy_integrate (const Expr &expr, const integrate_option &iopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_lazy_terminal_integrate< details::field_expr_quadrature_on_element< Expr > > >::type | lazy_integrate (const Expr &expr, const integrate_option &iopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_field_expr_quadrature_arg< Expr >::value, details::field_lazy_terminal_integrate< Expr > >::type | lazy_integrate (const std::string &domname, const Expr &expr, const integrate_option &iopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_lazy_terminal_integrate< details::field_expr_quadrature_on_element< Expr > > >::type | lazy_integrate (const std::string &domname, const Expr &expr, const integrate_option &iopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_field_expr_quadrature_arg< Expr >::value, details::field_lazy_terminal_integrate_band< Expr > >::type | lazy_integrate (const band_basic< typename float_traits< typename Expr::scalar_type >::type, typename Expr::memory_type > &gh, const Expr &expr, const integrate_option &iopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_lazy_terminal_integrate_band< details::field_expr_quadrature_on_element< Expr > > >::type | lazy_integrate (const band_basic< typename float_traits< typename Expr::scalar_type >::type, typename Expr::memory_type > &gh, const Expr &expr, const integrate_option &iopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_field_expr_v2_nonlinear_arg< Expr >::value &&!details::has_field_rdof_interface< Expr >::value &&!details::is_field_function< Expr >::value, details::field_lazy_terminal_interpolate< typenamedetails::field_expr_v2_nonlinear_terminal_wrapper_traits< Expr >::type > >::type | lazy_interpolate (const space_basic< typename float_traits< typename Expr::scalar_type >::type, typename Expr::memory_type > &Xh, const Expr &expr) |
see the interpolate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_field_function< Expr >::value, details::field_lazy_terminal_interpolate< details::field_expr_v2_nonlinear_terminal_function< Expr > > >::type | lazy_interpolate (const space_basic< typename float_traits< typename details::field_expr_v2_nonlinear_terminal_function< Expr >::scalar_type >::type, typename details::field_expr_v2_nonlinear_terminal_function< Expr >::memory_type > &Xh, const Expr &expr) |
see the interpolate page for the full documentation | |
_RHEOLEF_make_field_rdof_unary (operator+, details::unary_plus) _RHEOLEF_make_field_rdof_unary(operator- | |
_RHEOLEF_make_field_rdof_unary_scalar_first (operator+, details::plus) _RHEOLEF_make_field_rdof_unary_scalar_first(operator- | |
details::minus | _RHEOLEF_make_field_rdof_unary_scalar_first (operator*, details::multiplies) _RHEOLEF_make_field_rdof_unary_scalar_second(operator+ |
details::minus details::plus | _RHEOLEF_make_field_rdof_unary_scalar_second (operator-, details::minus) _RHEOLEF_make_field_rdof_unary_scalar_second(operator* |
template odiststream & | field_put_bamg_bb< Float > (odiststream &, const field_basic< Float, sequential > &) |
template<class T > | |
odiststream & | geo_put_gmsh (odiststream &ods, const geo_basic< T, sequential > &) |
template<class T > | |
odiststream & | field_put_gmsh (odiststream &ods, const field_basic< T, sequential > &uh) |
template odiststream & | field_put_gmsh< Float > (odiststream &, const field_basic< Float, sequential > &, std::string) |
template odiststream & | field_put_gmsh< Float > (odiststream &, const field_basic< Float, sequential > &) |
template<class T > | |
odiststream & | field_put_gmsh_pos (odiststream &ods, const field_basic< T, sequential > &uh, std::string name) |
template odiststream & | field_put_gmsh_pos< Float > (odiststream &, const field_basic< Float, sequential > &, std::string) |
template odiststream & | field_put_gmsh_pos< Float > (odiststream &, const field_basic< Float, sequential > &) |
template<class T > | |
odiststream & | put_vtk_scalar_values (odiststream &ods, const field_basic< T, sequential > &uh, std::string name, bool put_header) |
template<class T > | |
odiststream & | put_vtk_vector_values (odiststream &ods, const field_basic< T, sequential > &uh, std::string name, bool put_header) |
template<class T > | |
odiststream & | put_vtk_tensor_values (odiststream &ods, const field_basic< T, sequential > &tau_h, std::string name, bool put_header) |
template<class T > | |
odiststream & | field_put_vtk (odiststream &ods, const field_basic< T, sequential > &uh) |
template odiststream & | field_put_vtk< Float > (odiststream &, const field_basic< Float, sequential > &, std::string, bool) |
template odiststream & | field_put_vtk< Float > (odiststream &, const field_basic< Float, sequential > &) |
template odiststream & | visu_gmsh< Float > (odiststream &, const field_basic< Float, sequential > &) |
template<class T > | |
odiststream & | visu_gnuplot (odiststream &ops, const geo_basic< T, sequential > &omega) |
template<class T > | |
void | put (std::ostream &gdat, const geo_basic< T, sequential > &omega, const geo_element &K, const field_basic< T, sequential > &uh, const fem_on_pointset< T > &fops, size_t my_order, bound_type< T > &bbox) |
template<class T > | |
odiststream & | visu_gnuplot_scalar (odiststream &ods, const field_basic< T, sequential > &uh) |
template<class T > | |
odiststream & | visu_gnuplot_vector (odiststream &ods, const field_basic< T, sequential > &uh) |
template<class T > | |
field_basic< T, sequential > | paraview_plane_cut (const field_basic< T, sequential > &uh, const point_basic< T > &origin, const point_basic< T > &normal) |
template<class T > | |
geo_basic< T, sequential > | paraview_extract_isosurface (const field_basic< T, sequential > &uh) |
template<class T > | |
std::valarray< field_basic< T > > | operator* (const T &a, const std::valarray< field_basic< T > > &xh) |
template<class T , class M > | |
form_basic< T, M > | trans (const form_basic< T, M > &a) |
template<class T , class M > | |
form_basic< T, M > | diag (const field_basic< T, M > &dh) |
template<class T , class M > | |
field_basic< T, M > | diag (const form_basic< T, M > &a) |
_RHEOLEF_instanciate (Float, sequential) _RHEOLEF_instanciate(Float | |
template<class T , class M > | |
form_basic< T, M > | operator* (const T &lambda, const form_basic< T, M > &a) |
template<class T , class M > | |
form_basic< T, M > | operator- (const form_basic< T, M > &a) |
template<class T , class M > | |
details::vector_field_trans< T, M > | trans (const std::vector< field_basic< T, M > > &vv) |
template<class Expr > | |
std::enable_if< details::is_form_expr_v2_variational_arg< Expr >::value, details::form_expr_quadrature_on_sides< Expr > >::type | on_local_sides (const Expr &expr) |
_RHEOLEF_make_form_expr_quadrature_unary (operator+, details::unary_plus) _RHEOLEF_make_form_expr_quadrature_unary(operator- | |
_RHEOLEF_form_expr_quadrature_binary (operator+, details::plus) _RHEOLEF_form_expr_quadrature_binary(operator- | |
_RHEOLEF_make_form_expr_quadrature_binary_operator_multiplies_divides_constant (operator*, details::multiplies) _RHEOLEF_make_form_expr_quadrature_binary_operator_multiplies_divides_constant_right(operator/ | |
_RHEOLEF_make_form_expr_v2_variational_unary (operator+, details::unary_plus) _RHEOLEF_make_form_expr_v2_variational_unary(operator- | |
_RHEOLEF_form_expr_v2_variational_binary (operator+, details::plus) _RHEOLEF_form_expr_v2_variational_binary(operator- | |
_RHEOLEF_form_expr_v2_variational_binary_field (operator*, details::multiplies) _RHEOLEF_form_expr_v2_variational_binary_field(dot | |
details::dot_ | _RHEOLEF_form_expr_v2_variational_binary_field (ddot, details::ddot_) _RHEOLEF_form_expr_v2_variational_binary_field(dddot |
_RHEOLEF_make_form_expr_v2_variational_binary_operator_multiplies_divides (operator*, details::multiplies) _RHEOLEF_make_form_expr_v2_variational_binary_operator_multiplies_divides_right(operator/ | |
details::divides | _RHEOLEF_make_form_expr_v2_variational_binary_operator_multiplies_divides (dot, details::dot_) _RHEOLEF_make_form_expr_v2_variational_binary_operator_multiplies_divides(ddot |
details::divides details::ddot_ | _RHEOLEF_make_form_expr_v2_variational_binary_operator_multiplies_divides (dddot, details::dddot_) namespace details |
_RHEOLEF_make_form_expr_v2_variational_binary_operator_multiplies_divides_constant (operator*, details::multiplies) _RHEOLEF_make_form_expr_v2_variational_binary_operator_multiplies_divides_constant_right(operator/ | |
details::divides | _RHEOLEF_make_form_expr_v2_variational_binary_operator_multiplies_divides_constant (dot, details::dot_) _RHEOLEF_make_form_expr_v2_variational_binary_operator_multiplies_divides_constant(ddot |
_RHEOLEF_form_mult_field_var (details::field_wdof_sliced) _RHEOLEF_form_mult_field_var(details | |
_RHEOLEF_form_lazy_unop (+, details::unary_plus) _RHEOLEF_form_lazy_unop(- | |
template<class Expr , class Sfinae = typename std::enable_if<details::is_form_lazy<Expr>::value, Expr>::type> | |
details::form_lazy_invert< Expr > | inv (const Expr &a) |
inv: see the form page for the full documentation | |
template<class Expr , class Sfinae = typename std::enable_if<details::is_form_lazy<Expr>::value, Expr>::type> | |
details::form_lazy_transpose< Expr > | trans (const Expr &a) |
trans: see the form page for the full documentation | |
_RHEOLEF_form_lazy_add (+, plus) _RHEOLEF_form_lazy_add(- | |
template<class Expr1 , class Expr2 , class Sfinae1 = typename std::enable_if<details::is_form_lazy<Expr1>::value, Expr1>::type, class Sfinae2 = typename std::enable_if<details::is_form_lazy<Expr2>::value, Expr2>::type> | |
details::form_lazy_multiply< Expr1, Expr2 > | operator* (const Expr1 &a, const Expr2 &b) |
a*b: see the form page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_form_expr_quadrature_arg< Expr >::value, details::form_lazy_terminal_integrate_band< Expr > >::type | lazy_integrate (const band_basic< typename float_traits< typename Expr::scalar_type >::type, typename Expr::memory_type > &gh, const Expr &expr, const integrate_option &iopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_form_expr_v2_variational_arg< Expr >::value, details::form_lazy_terminal_integrate_band< details::form_expr_quadrature_on_element< Expr > > >::type | lazy_integrate (const band_basic< typename float_traits< typename Expr::scalar_type >::type, typename Expr::memory_type > &gh, const Expr &expr, const integrate_option &iopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class R , class... Args> | |
std::function< R(Args...)> | functor (R(*f)(Args...)) |
template<class T , class M > | |
geo_basic< T, M > | geo_load (const std::string &name) |
sequential mesh with reference counting | |
template<class T , class M > | |
geo_basic< T, M > | compact (const geo_basic< T, M > &gamma) |
_RHEOLEF_save (sequential) _RHEOLEF_set_name(sequential) _RHEOLEF_set_serial_number(sequential) _RHEOLEF_reset_order(sequential) _RHEOLEF_set_nodes(sequential) _RHEOLEF_set_coordinate_system(sequential) _RHEOLEF_set_dimension(sequential) _RHEOLEF_build_by_subdividing(sequential) _RHEOLEF_build_from_data(sequential) _RHEOLEF_save(distributed) _RHEOLEF_set_name(distributed) _RHEOLEF_set_serial_number(distributed) _RHEOLEF_reset_order(distributed) _RHEOLEF_set_nodes(distributed) _RHEOLEF_set_coordinate_system(distributed) _RHEOLEF_set_dimension(distributed) _RHEOLEF_build_by_subdividing(distributed) _RHEOLEF_reset_order(sequential) _RHEOLEF_reset_order(distributed) template< class T | |
template<class T , class M > | |
void | boundary_guard (const geo_basic< T, M > &omega) |
template<class T , class M > | |
void | internal_sides_guard (const geo_basic< T, M > &omega) |
template<class T , class M > | |
void | sides_guard (const geo_basic< T, M > &omega) |
template<class T , class M > | |
void | geo_build_by_subdividing (geo_rep< T, M > &new_omega, const geo_basic< T, M > &old_omega, typename geo_rep< T, M >::size_type k) |
template<class T , class M > | |
idiststream & | operator>> (idiststream &ips, geo_basic< T, M > &omega) |
template<class T , class M > | |
odiststream & | operator<< (odiststream &ops, const geo_basic< T, M > &omega) |
_RHEOLEF_zero_dimension (sequential) _RHEOLEF_zero_dimension(distributed) _RHEOLEF_instanciation(Float | |
_RHEOLEF_geo_domain_cstor (sequential) _RHEOLEF_geo_domain_cstor(distributed) _RHEOLEF_instanciation(Float | |
idiststream & | operator>> (idiststream &ips, geo_header &h) |
odiststream & | operator<< (odiststream &ops, const geo_header &h) |
template<class T , class M > | |
void | compute_bbox (const geo_base_rep< T, M > &omega, const geo_element &K, point_basic< T > &xmin, point_basic< T > &xmax) |
void | geo_dual (my_idxtype *elmdist, my_idxtype *eptr, vector< my_idxtype > &eind, int *ncommonnodes, vector< my_idxtype > &xadj, vector< my_idxtype > &adjncy, const mpi::communicator &comm) |
disarray< size_t > | geo_mpi_partition (const std::array< hack_array< geo_element_hack >, reference_element::max_variant > &ios_geo_element, const distributor &ownership_by_dimension, size_t map_dim, size_t dis_nv) |
void | geo_element_renumbering_part1_new (const std::array< hack_array< geo_element_hack >, reference_element::max_variant > &ios_geo_element, const geo_size &ios_gs, size_t S_dim, std::array< std::vector< size_t >, 4 > &massive_partition_by_dimension, std::array< disarray< size_t >, reference_element::max_variant > &partition_by_variant) |
void | geo_element_renumbering_part2 (const std::array< hack_array< geo_element_hack >, reference_element::max_variant > &ios_geo_element, const geo_size &ios_gs, size_t dis_nv, size_t side_dim, std::array< hack_array< geo_element_hack >, reference_element::max_variant > &geo_element, geo_size &gs, std::array< disarray< size_t >, reference_element::max_variant > &igev2ios_dis_igev, std::array< disarray< size_t >, reference_element::max_variant > &ios_igev2dis_igev, std::array< disarray< size_t >, 4 > &ios_ige2dis_ige, std::array< disarray< size_t >, reference_element::max_variant > &partition_by_variant) |
void | geo_element_renumbering_propagate (const std::vector< geo_element::size_type > &new_global_node_num, size_t dis_nnod, hack_array< geo_element_hack > &gev) |
void | ParMETIS_V3_PartKway (const int *const, int *const, int *const, int *const, int *const, const int *const, const int *const, const int *const, const int *const, const float *const, const float *const, const int *const, int *const, int *const, MPI_Comm *const) |
void | geo_partition_scotch (my_idxtype *elmdist, my_idxtype *eptr, vector< my_idxtype > &eind, my_idxtype *elmwgt, int *ncon, int *ncommonnodes, int *nparts, float *tpwgts, float *ubvec, int *edgecut, my_idxtype *part, const mpi::communicator &comm) |
int | idxamin (int n, const std::vector< my_idxtype > &x) |
int | idxamax (int n, const std::vector< my_idxtype > &x) |
template<class T > | |
idiststream & | geo_get_bamg (idiststream &ips, geo_basic< T, sequential > &omega) |
template idiststream & | geo_get_bamg< Float > (idiststream &, geo_basic< Float, sequential > &) |
template idiststream & | geo_get_vtk< Float > (idiststream &, geo_basic< Float, sequential > &) |
template<class T > | |
odiststream & | visu_vtk_paraview (odiststream &, const geo_basic< T, sequential > &) |
template<class T > | |
odiststream & | geo_put_bamg (odiststream &, const geo_basic< T, sequential > &) |
template<class T > | |
odiststream & | geo_put_bamg (odiststream &ops, const geo_basic< T, sequential > &omega, const basis_basic< T > &my_numb, const disarray< point_basic< T >, sequential > &my_node) |
template odiststream & | geo_put_bamg< Float > (odiststream &, const geo_basic< Float, sequential > &, const basis_basic< Float > &, const disarray< point_basic< Float >, sequential > &) |
template odiststream & | geo_put_bamg< Float > (odiststream &, const geo_basic< Float, sequential > &) |
template<class T > | |
odiststream & | geo_put_gmsh (odiststream &ops, const geo_basic< T, sequential > &omega, const basis_basic< T > &my_numb, const disarray< point_basic< T >, sequential > &my_node) |
template odiststream & | geo_put_gmsh< Float > (odiststream &, const geo_basic< Float, sequential > &, const basis_basic< Float > &, const disarray< point_basic< Float >, sequential > &) |
template odiststream & | geo_put_gmsh< Float > (odiststream &, const geo_basic< Float, sequential > &) |
template<class T > | |
odiststream & | geo_put_vtk_old (odiststream &ops, const geo_basic< T, sequential > &omega, const basis_basic< T > &my_numb, const disarray< point_basic< T >, sequential > &my_node, bool append_data) |
template<class T > | |
odiststream & | geo_put_vtk_high (odiststream &ops, const geo_basic< T, sequential > &omega, const basis_basic< T > &my_numb, const disarray< point_basic< T >, sequential > &my_node, bool append_data=true, size_t subgeo_dim=std::numeric_limits< size_t >::max()) |
template<class T > | |
odiststream & | geo_put_vtk (odiststream &ops, const geo_basic< T, sequential > &omega, const basis_basic< T > &my_numb, const disarray< point_basic< T >, sequential > &my_node, bool append_data, size_t subgeo_dim) |
template odiststream & | visu_gnuplot (odiststream &ops, const geo_basic< Float, sequential > &omega) |
template odiststream & | visu_vtk_paraview< Float > (odiststream &, const geo_basic< Float, sequential > &) |
_RHEOLEF_geo_build_by_subdividing (sequential) _RHEOLEF_geo_build_by_subdividing(distributed) _RHEOLEF_instanciate(Float | |
template<class T , class A > | |
idiststream & | operator>> (idiststream &ips, hack_array< T, sequential, A > &x) |
template<class T , class A > | |
odiststream & | operator<< (odiststream &ops, const hack_array< T, sequential, A > &x) |
template<class T , class A > | |
idiststream & | operator>> (idiststream &ips, hack_array< T, distributed, A > &x) |
template<class T , class A > | |
odiststream & | operator<< (odiststream &ops, const hack_array< T, distributed, A > &x) |
template<class T , class M , class Expr , class Result = typename details::field_expr_v2_nonlinear_terminal_wrapper_traits<Expr>::type::value_type> | |
std::enable_if< details::is_field_expr_v2_nonlinear_arg< Expr >::value &&!is_undeterminated< Result >::value, Result >::type | integrate (const geo_basic< T, M > &omega, const Expr &expr, const integrate_option &iopt, Result dummy=Result()) |
see the integrate page for the full documentation | |
template<class T , class M > | |
T | integrate (const geo_basic< T, M > &omega, integrate_option &&iopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class T , class M , class Expr > | |
std::enable_if< details::is_field_expr_v2_nonlinear_arg< Expr >::value &&is_undeterminated< typenamedetails::field_expr_v2_nonlinear_terminal_wrapper_traits< Expr >::type::value_type >::value, typenamescalar_traits< typenamedetails::field_expr_v2_nonlinear_terminal_wrapper_traits< Expr >::type::value_type >::type >::type | integrate (const geo_basic< T, M > &omega, const Expr &expr, const integrate_option &iopt) |
see the integrate page for the full documentation | |
template<class T , class M , class Expr > | |
std::enable_if< details::is_field_expr_quadrature_arg< Expr >::value, field_basic< T, M > >::type | integrate (const geo_basic< T, M > &domain, const Expr &expr, const integrate_option &iopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class T , class M , class Expr > | |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, field_basic< T, M > >::type | integrate (const geo_basic< T, M > &domain, const Expr &expr, const integrate_option &fopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_field_expr_quadrature_arg< Expr >::value, field_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type | integrate (const Expr &expr, const integrate_option &iopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, field_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type | integrate (const Expr &expr, const integrate_option &fopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_field_expr_quadrature_arg< Expr >::value, field_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type | integrate (const std::string &domname, const Expr &expr, const integrate_option &iopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, field_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type | integrate (const std::string &domname, const Expr &expr, const integrate_option &fopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class T , class M , class Expr > | |
std::enable_if< details::is_form_expr_quadrature_arg< Expr >::value, form_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type | integrate (const geo_basic< T, M > &domain, const Expr &expr, const integrate_option &fopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class T , class M , class Expr > | |
std::enable_if< details::is_form_expr_v2_variational_arg< Expr >::value, form_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type | integrate (const geo_basic< T, M > &domain, const Expr &expr, const integrate_option &fopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_form_expr_quadrature_arg< Expr >::value, form_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type | integrate (const Expr &expr, const integrate_option &fopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_form_expr_v2_variational_arg< Expr >::value, form_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type | integrate (const Expr &expr, const integrate_option &fopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_form_expr_quadrature_arg< Expr >::value, form_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type | integrate (const std::string &domname, const Expr &expr, const integrate_option &fopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_form_expr_v2_variational_arg< Expr >::value, form_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type | integrate (const std::string &domname, const Expr &expr, const integrate_option &fopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class T , class M , class Expr > | |
std::enable_if< details::is_field_expr_quadrature_arg< Expr >::value, field_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type | integrate (const band_basic< T, M > &gh, const Expr &expr, const integrate_option &iopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class T , class M , class Expr > | |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, field_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type | integrate (const band_basic< T, M > &gh, const Expr &expr, const integrate_option &iopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class T , class M , class Expr > | |
std::enable_if< details::is_form_expr_quadrature_arg< Expr >::value, form_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type | integrate (const band_basic< T, M > &gh, const Expr &expr, const integrate_option &fopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class T , class M , class Expr > | |
std::enable_if< details::is_form_expr_v2_variational_arg< Expr >::value, form_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type | integrate (const band_basic< T, M > &gh, const Expr &expr, const integrate_option &fopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_form_expr_quadrature_arg< Expr >::value, details::form_lazy_terminal_integrate< Expr > >::type | lazy_integrate (const geo_basic< typename Expr::scalar_type, typename Expr::memory_type > &domain, const Expr &expr, const integrate_option &iopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_form_expr_v2_variational_arg< Expr >::value, details::form_lazy_terminal_integrate< details::form_expr_quadrature_on_element< Expr > > >::type | lazy_integrate (const geo_basic< typename Expr::scalar_type, typename Expr::memory_type > &domain, const Expr &expr, const integrate_option &iopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_form_expr_quadrature_arg< Expr >::value, details::form_lazy_terminal_integrate< Expr > >::type | lazy_integrate (const Expr &expr, const integrate_option &fopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_form_expr_v2_variational_arg< Expr >::value, details::form_lazy_terminal_integrate< details::form_expr_quadrature_on_element< Expr > > >::type | lazy_integrate (const Expr &expr, const integrate_option &fopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_form_expr_quadrature_arg< Expr >::value, details::form_lazy_terminal_integrate< Expr > >::type | lazy_integrate (const std::string &domname, const Expr &expr, const integrate_option &fopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class Expr > | |
std::enable_if< details::is_form_expr_v2_variational_arg< Expr >::value, details::form_lazy_terminal_integrate< details::form_expr_quadrature_on_element< Expr > > >::type | lazy_integrate (const std::string &domname, const Expr &expr, const integrate_option &fopt=integrate_option()) |
see the integrate page for the full documentation | |
template<class T , class M > | |
field_basic< T, M > | interpolate (const space_basic< T, M > &V2h, const field_basic< T, M > &u1h) |
see the interpolate page for the full documentation | |
template<class T , class M , class Expr > | |
std::enable_if< std::conjunction< details::is_field_expr_v2_nonlinear_arg< Expr >, std::negation< std::disjunction< details::is_field< Expr >, details::has_field_rdof_interface< Expr >, details::is_field_function< Expr > > > >::value, field_basic< T, M > >::type | interpolate (const space_basic< T, M > &Xh, const Expr &expr) |
see the interpolate page for the full documentation | |
template<class T , class M , class Expr > | |
std::enable_if< details::has_field_rdof_interface< Expr >::value &&!details::is_field< Expr >::value, field_basic< T, M > >::type | interpolate (const space_basic< T, M > &Xh, const Expr &expr) |
see the interpolate page for the full documentation | |
template<class T , class M , class Expr > | |
std::enable_if< details::is_field_function< Expr >::value, field_basic< T, M > >::type | interpolate (const space_basic< T, M > &Xh, const Expr &expr) |
see the interpolate page for the full documentation | |
o_scalar (field_sequential, topography) o_scalar(point | |
origin | o_scalar (point, normal) o_scalar(point_basic< size_t > |
template<class T > | |
bool | intersection_is_quadrilateral_T (const std::vector< T > &f, quadruplet &q) |
template<class T , class M > | |
void | gamma_list2disarray (const std::list< point_basic< T > > &gamma_node_list, std::array< std::list< std::pair< element_type, size_t > >, reference_element::max_variant > gamma_side_list, const communicator &comm, size_t d, disarray< point_basic< T >, M > &gamma_node, std::array< disarray< element_type, M >, reference_element::max_variant > &gamma_side, disarray< size_t, M > &sid_ie2bnd_ie) |
template<class T , class M > | |
geo_basic< T, M > | level_set (const field_basic< T, M > &fh, const level_set_option &opt) |
template<class T , class M > | |
field_basic< T, M > | limiter (const field_basic< T, M > &uh, const T &bar_g_S, const limiter_option &opt) |
see the limiter page for the full documentation | |
template<class Problem , class Preconditioner , class Field , class Real > | |
int | newton_backtrack (const Problem &P, const Preconditioner &T, const Field &u_old, Float Tu_old, Field &delta_u, Real slope, Real norm_delta_u_max, Field &u, Field &Fu, Real &Tu, Real &lambda, odiststream *p_derr=0) |
template<class Problem , class Field > | |
int | newton (const Problem &P, Field &uh, Float &tol, size_t &max_iter, odiststream *p_derr=0) |
see the newton page for the full documentation | |
template<class T , class M > | |
void | piola_transformation (const geo_basic< T, M > &omega, const basis_on_pointset< T > &piola_on_pointset, reference_element hat_K, const std::vector< size_t > &dis_inod, Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > &x) |
template<class T , class M > | |
void | jacobian_piola_transformation (const geo_basic< T, M > &omega, const basis_on_pointset< T > &piola_on_pointset, reference_element hat_K, const std::vector< size_t > &dis_inod, Eigen::Matrix< tensor_basic< T >, Eigen::Dynamic, 1 > &DF) |
template<class T , class M > | |
void | jacobian_piola_transformation (const geo_basic< T, M > &omega, const basis_basic< T > &piola_basis, reference_element hat_K, const std::vector< size_t > &dis_inod, const point_basic< T > &hat_x, tensor_basic< T > &DF) |
template<class T > | |
T | det_jacobian_piola_transformation (const tensor_basic< T > &DF, size_t d, size_t map_d) |
template<class T , class M > | |
point_basic< T > | normal_from_piola_transformation (const geo_basic< T, M > &omega, const geo_element &S, const tensor_basic< T > &DF, size_t d) |
template<class T > | |
tensor_basic< T > | pseudo_inverse_jacobian_piola_transformation (const tensor_basic< T > &DF, size_t d, size_t map_d) |
template<class T > | |
T | weight_coordinate_system (space_constant::coordinate_type sys_coord, const point_basic< T > &xq) |
template<class T , class M > | |
void | piola_transformation_and_weight_integration (const geo_basic< T, M > &omega, const basis_on_pointset< T > &piola_on_quad, reference_element hat_K, const std::vector< size_t > &dis_inod, bool ignore_sys_coord, Eigen::Matrix< tensor_basic< T >, Eigen::Dynamic, 1 > &DF, Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > &x, Eigen::Matrix< T, Eigen::Dynamic, 1 > &w) |
template<class T > | |
void | map_projector (const tensor_basic< T > &DF, size_t d, size_t map_d, tensor_basic< T > &P) |
template<class T , class M > | |
point_basic< T > | inverse_piola_transformation (const geo_basic< T, M > &omega, const reference_element &hat_K, const std::vector< size_t > &dis_inod, const point_basic< T > &x) |
_RHEOLEF_instanciation1 (Float) _RHEOLEF_instanciation2(Float | |
std::ostream & | operator<< (std::ostream &py, const render_option &popt) |
template<class T , class M , class Function > | |
field_basic< T, M > | riesz (const space_basic< T, M > &Xh, const Function &f, const quadrature_option &qopt=quadrature_option()) |
template<class T , class M , class Function > | |
field_basic< T, M > | riesz (const space_basic< T, M > &Xh, const Function &f, const geo_basic< T, M > &dom, const quadrature_option &qopt=quadrature_option()) |
template<class T , class M , class Function > | |
field_basic< T, M > | riesz (const space_basic< T, M > &Xh, const Function &f, std::string dom_name, const quadrature_option &qopt=quadrature_option()) |
template<class T , class M , class Function > | |
field_basic< T, M > | riesz (const space_basic< T, M > &Xh, const Function &f, const band_basic< T, M > &gh, const quadrature_option &qopt=quadrature_option()) |
template<class Expr , class T2 > | |
std::enable_if< details::is_field_expr_affine_homogeneous< Expr >::value, field_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type | round (const Expr &expr, const T2 &prec) |
_RHEOLEF_space_real (sequential) _RHEOLEF_space_real(distributed) template< class T | |
t | operator() (const t &a, const t &b) |
template<class T , class M > | |
idiststream & | operator>> (idiststream &ids, space_constitution< T, M > &constit) |
template<class T , class M > | |
const geo_element & | assembly2space_geo_element (const geo_basic< T, M > &space_geo, const geo_basic< T, M > &omega_K, const geo_element &K_in) |
int | space_constitution_lex () |
void | space_constitution_error (const char *msg) |
int | space_constitution_wrap () |
template idiststream & | operator>> (idiststream &, space_constitution< Float, sequential > &) |
template idiststream & | operator>> (idiststream &, space_constitution< Float, distributed > &) |
int | space_constitution_old_lex () |
void | space_constitution_old_error (const char *msg) |
int | space_constitution_old_wrap () |
template void | space_constitution_old_get (idiststream &, space_constitution< Float, sequential > &) |
template void | space_constitution_old_get (idiststream &, space_constitution< Float, distributed > &) |
template<class T , class M > | |
space_mult_list< T, M > | operator* (const space_basic< T, M > &X, const space_basic< T, M > &Y) |
template<class T , class M > | |
space_mult_list< T, M > | operator* (const space_mult_list< T, M > &Xm, const space_basic< T, M > &Y) |
template<class T , class M > | |
space_mult_list< T, M > & | operator*= (space_mult_list< T, M > &Xm, const space_basic< T, M > &Y) |
template<class T , class M > | |
space_mult_list< T, M > | operator* (const space_basic< T, M > &X, const space_mult_list< T, M > &Ym) |
template<class T , class M > | |
space_mult_list< T, M > | pow (const space_basic< T, M > &X, size_t n) |
size_t | vtk_cell_type2variant (size_t vtk_cell_type) |
size_t | nv2vtk_cell_type (size_t map_dim, size_t nv) |
void | msh2geo_node_renum (vector< size_t > &element, size_t variant, size_t order) |
This file is part of Rheolef.
This file is part of Rheolef.
Copyright (C) 2000-2009 Pierre Saramito Pierr.nosp@m.e.Sa.nosp@m.ramit.nosp@m.o@im.nosp@m.ag.fr
Rheolef is free software; you can redistribute it and/or modify it under the terms of the GNU General Public License as published by the Free Software Foundation; either version 2 of the License, or (at your option) any later version.
Rheolef is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details.
You should have received a copy of the GNU General Public License along with Rheolef; if not, write to the Free Software Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA 02111-1307 USA
This file is part of Rheolef.
Copyright (C) 2000-2009 Pierre Saramito Pierr.nosp@m.e.Sa.nosp@m.ramit.nosp@m.o@im.nosp@m.ag.fr
Rheolef is free software; you can redistribute it and/or modify it under the terms of the GNU General Public License as published by the Free Software Foundation; either version 2 of the License, or (at your option) any later version.
Rheolef is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details.
You should have received a copy of the GNU General Public License along with Rheolef; if not, write to the Free Software Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA 02111-1307 USA
various algorithms that cannot go elsewhere
This file is part of Rheolef.
Copyright (C) 2000-2018 Pierre Saramito Pierr.nosp@m.e.Sa.nosp@m.ramit.nosp@m.o@im.nosp@m.ag.fr
Rheolef is free software; you can redistribute it and/or modify it under the terms of the GNU General Public License as published by the Free Software Foundation; either version 2 of the License, or (at your option) any later version.
Rheolef is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details.
You should have received a copy of the GNU General Public License along with Rheolef; if not, write to the Free Software Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA 02111-1307 USA
This file is part of Rheolef.
Copyright (C) 2000-2009 Pierre Saramito
Rheolef is free software; you can redistribute it and/or modify it under the terms of the GNU General Public License as published by the Free Software Foundation; either version 2 of the License, or (at your option) any later version.
Rheolef is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details.
You should have received a copy of the GNU General Public License along with Rheolef; if not, write to the Free Software Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA 02111-1307 USA
This file is part of Rheolef.
Copyright (C) 2000-2009 Pierre Saramito Pierr.nosp@m.e.Sa.nosp@m.ramit.nosp@m.o@im.nosp@m.ag.fr
Rheolef is free software; you can redistribute it and/or modify it under the terms of the GNU General Public License as published by the Free Software Foundation; either version 2 of the License, or (at your option) any later version.
Rheolef is sequential in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details.
You should have received a copy of the GNU General Public License along with Rheolef; if not, write to the Free Software Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA 02111-1307 USA
This file is part of Rheolef.
Copyright (C) 2000-2009 Pierre Saramito Pierr.nosp@m.e.Sa.nosp@m.ramit.nosp@m.o@im.nosp@m.ag.fr
Rheolef is free software; you can redistribute it and/or modify it under the terms of the GNU General Public License as published by the Free Software Foundation; either version 2 of the License, or (at your option) any later version.
Rheolef is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License for more details.
You should have received a copy of the GNU General Public License along with Rheolef; if not, write to the Free Software Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA 02111-1307 USA
Banded level set routines
Authors: Lara Aborm, Jocelyn Etienne, Pierre Saramito
std::istream & operator>> | ( | std::istream & | is, |
const catchmark & | m | ||
) |
Definition at line 88 of file catchmark.h.
std::ostream & operator<< | ( | std::ostream & | os, |
const catchmark & | m | ||
) |
Definition at line 98 of file catchmark.h.
bool operator== | ( | const heap_allocator< T1 > & | lhs, |
const heap_allocator< T1 > & | rhs | ||
) | |||
throw | ( | ||
) |
Definition at line 171 of file heap_allocator.h.
bool operator!= | ( | const heap_allocator< T1 > & | lhs, |
const heap_allocator< T1 > & | rhs | ||
) | |||
throw | ( | ||
) |
Definition at line 176 of file heap_allocator.h.
std::istream & operator>> | ( | std::istream & | is, |
const irheomanip1< T > & | m | ||
) |
Definition at line 112 of file iorheobase.h.
std::ostream & operator<< | ( | std::ostream & | os, |
const orheomanip1< T > & | m | ||
) |
Definition at line 127 of file iorheobase.h.
std::istream & operator>> | ( | std::istream & | is, |
const iorheomanip1< T > & | m | ||
) |
Definition at line 144 of file iorheobase.h.
std::ostream & operator<< | ( | std::ostream & | os, |
const iorheomanip1< T > & | m | ||
) |
Definition at line 151 of file iorheobase.h.
OutputPairIterator pair_transform_second | ( | InputPairIterator | first, |
InputPairIterator | last, | ||
OutputPairIterator | result, | ||
UnaryOperation | unary_op | ||
) |
Definition at line 41 of file pair_util.h.
std::ostream & operator<< | ( | std::ostream & | out, |
const std::pair< T1, T2 > & | x | ||
) |
Definition at line 53 of file pair_util.h.
std::string indent | ( | std::string | str, |
const std::string & | indent = " " |
||
) |
Definition at line 35 of file pretty_name.cc.
std::string typeid_name | ( | const char * | name, |
bool | do_indent | ||
) |
Definition at line 78 of file pretty_name.cc.
std::string get_tmpdir | ( | ) |
get_tmpdir: see the rheostream
page for the full documentation
Definition at line 54 of file rheostream.cc.
string ftos | ( | const Float & | x | ) |
itof: see the rheostream
page for the full documentation
Definition at line 59 of file rheostream.cc.
bool has_suffix | ( | const string & | name, |
const string & | suffix | ||
) |
has_suffix: see the rheostream
page for the full documentation
Definition at line 212 of file rheostream.cc.
string delete_suffix | ( | const string & | name, |
const string & | suffix | ||
) |
delete_suffix: see the rheostream
page for the full documentation
Definition at line 226 of file rheostream.cc.
bool has_any_suffix | ( | const string & | name | ) |
has_any_suffix: see the rheostream
page for the full documentation
Definition at line 233 of file rheostream.cc.
string delete_any_suffix | ( | const string & | name | ) |
delete_any_suffix: see the rheostream
page for the full documentation
Definition at line 243 of file rheostream.cc.
string get_basename | ( | const string & | name | ) |
get_basename: see the rheostream
page for the full documentation
Definition at line 258 of file rheostream.cc.
string get_dirname | ( | const string & | name | ) |
get_dirname: see the rheostream
page for the full documentation
Definition at line 267 of file rheostream.cc.
void append_dir_to_rheo_path | ( | const string & | dir | ) |
append_dir_to_rheo_path: see the rheostream
page for the full documentation
Definition at line 334 of file rheostream.cc.
void prepend_dir_to_rheo_path | ( | const string & | dir | ) |
prepend_dir_to_rheo_path: see the rheostream
page for the full documentation
Definition at line 343 of file rheostream.cc.
string get_full_name_from_rheo_path | ( | const string & | rootname, |
const string & | suffix | ||
) |
get_full_name_from_rheo_path: see the rheostream
page for the full documentation
Definition at line 449 of file rheostream.cc.
bool is_float | ( | const string & | s | ) |
is_float: see the rheostream
page for the full documentation
Definition at line 480 of file rheostream.cc.
Float to_float | ( | const string & | s | ) |
to_float: see the rheostream
page for the full documentation
Definition at line 498 of file rheostream.cc.
bool scatch | ( | std::istream & | in, |
const std::string & | ch, | ||
bool | full_match = true |
||
) |
scatch: see the rheostream
page for the full documentation
Definition at line 44 of file scatch.icc.
bool file_exists | ( | const std::string & | filename | ) |
file_exists: see the rheostream
page for the full documentation
Definition at line 34 of file scatch.icc.
std::string itos | ( | std::size_t | i | ) |
Definition at line 279 of file rheostream.h.
rounder_type< T > rounder | ( | const T & | prec | ) |
floorer_type< T > floorer | ( | const T & | prec | ) |
ceiler_type< T > ceiler | ( | const T & | prec | ) |
bool operator== | ( | const stack_allocator< T1 > & | lhs, |
const stack_allocator< T1 > & | rhs | ||
) | |||
throw | ( | ||
) |
Definition at line 193 of file stack_allocator.h.
bool operator!= | ( | const stack_allocator< T1 > & | lhs, |
const stack_allocator< T1 > & | rhs | ||
) | |||
throw | ( | ||
) |
Definition at line 198 of file stack_allocator.h.
_RHEOLEF_instanciation | ( | Float | , |
sequential | , | ||
std::allocator< Float > | |||
) |
idiststream & operator>> | ( | idiststream & | s, |
asr< T, M, A > & | x | ||
) |
odiststream & operator<< | ( | odiststream & | s, |
const asr< T, M, A > & | x | ||
) |
OutputPtrIterator asr_to_csr | ( | InputPtrIterator | iter_ptr_a, |
InputPtrIterator | last_ptr_a, | ||
Predicate | pred, | ||
Operation | op, | ||
OutputPtrIterator | iter_ptr_b, | ||
OutputDataIterator | iter_data_b | ||
) |
Definition at line 70 of file asr_to_csr.h.
Set::value_type asr_to_csr_dist_logical | ( | InputPtrIterator | iter_ptr_a, |
InputPtrIterator | last_ptr_a, | ||
Predicate | is_dia, | ||
Set & | colext | ||
) |
Definition at line 73 of file asr_to_csr_dist_logical.h.
int cg | ( | const Matrix & | A, |
Vector & | x, | ||
const Vector2 & | Mb, | ||
const Preconditioner & | M, | ||
const solver_option & | sopt = solver_option() |
||
) |
_RHEOLEF_instanciation | ( | Float | , |
sequential | |||
) |
csr< T, sequential > operator* | ( | const T & | lambda, |
const csr< T, sequential > & | a | ||
) |
csr< T, sequential > operator- | ( | const csr< T, sequential > & | a | ) |
csr< T, sequential > trans | ( | const csr< T, sequential > & | a | ) |
csr< T, distributed > operator* | ( | const T & | lambda, |
const csr< T, distributed > & | a | ||
) |
csr< T, distributed > operator- | ( | const csr< T, distributed > & | a | ) |
csr< T, distributed > trans | ( | const csr< T, distributed > & | a | ) |
idiststream & operator>> | ( | idiststream & | s, |
csr< T, M > & | x | ||
) |
odiststream & operator<< | ( | odiststream & | s, |
const csr< T, M > & | x | ||
) |
void csr_amux | ( | InputIterator | ia, |
InputIterator | last_ia, | ||
InputRandomAcessIterator | x, | ||
SetOperator | set_op, | ||
OutputIterator | y | ||
) |
Definition at line 77 of file csr_amux.h.
Definition at line 219 of file csr_concat.h.
Definition at line 225 of file csr_concat.h.
void csr_cumul_trans_mult | ( | InputIterator1 | ia, |
InputIterator1 | last_ia, | ||
InputIterator3 | x, | ||
SetOperator | set_op, | ||
RandomAccessMutableIterator | y | ||
) |
Definition at line 67 of file csr_cumul_trans_mult.h.
void csr_ext_add | ( | const csr_rep< T, sequential > & | a, |
const std::vector< typename csr< T >::size_type > & | jext_a2dis_j, | ||
const csr_rep< T, sequential > & | b, | ||
const std::vector< typename csr< T >::size_type > & | jext_b2dis_j, | ||
csr_rep< T, sequential > & | c, | ||
std::vector< typename csr< T >::size_type > & | jext_c2dis_j, | ||
BinaryOp | binop | ||
) |
Definition at line 367 of file csr_mpi.cc.
csr_rep< T, sequential >::size_type csr_csr_mult_size | ( | const csr_rep< T, sequential > & | a, |
const csr_rep< T, sequential > & | b | ||
) |
Definition at line 405 of file csr_seq.cc.
OutputPtrIterator csr_to_asr | ( | InputPtrIterator | iter_ptr_a, |
InputPtrIterator | last_ptr_a, | ||
InputDataIterator | iter_data_a, | ||
UnaryOperation | op, | ||
OutputPtrIterator | iter_ptr_b | ||
) |
Definition at line 71 of file csr_to_asr.h.
std::iterator_traits< InputIterator >::value_type dis_accumulate | ( | InputIterator | first, |
Size | n, | ||
const distributor::communicator_type & | comm, | ||
sequential | |||
) |
Definition at line 61 of file dis_accumulate.h.
std::iterator_traits< InputIterator >::value_type dis_accumulate | ( | InputIterator | first, |
Size | n, | ||
const distributor::communicator_type & | comm, | ||
distributed | |||
) |
Definition at line 78 of file dis_accumulate.h.
std::iterator_traits< InputIterator >::value_type dis_accumulate | ( | InputIterator | first, |
Size | n, | ||
const distributor::communicator_type & | comm | ||
) |
Definition at line 93 of file dis_accumulate.h.
double dis_cpu_time | ( | ) |
Definition at line 45 of file dis_cpu_time.cc.
double seq_wall_time | ( | ) |
Definition at line 57 of file dis_cpu_time.cc.
double seq_cpu_time | ( | ) |
Definition at line 107 of file dis_cpu_time.cc.
double dis_wall_time | ( | ) |
Definition at line 130 of file dis_cpu_time.cc.
promote< typenamestd::iterator_traits< InputIterator1 >::value_type, typenamestd::iterator_traits< InputIterator2 >::value_type >::type dis_inner_product | ( | InputIterator1 | first1, |
InputIterator2 | first2, | ||
Size | n, | ||
const distributor::communicator_type & | comm, | ||
sequential | |||
) |
Definition at line 72 of file dis_inner_product.h.
promote< typenamestd::iterator_traits< InputIterator1 >::value_type, typenamestd::iterator_traits< InputIterator2 >::value_type >::type dis_inner_product | ( | InputIterator1 | first1, |
InputIterator2 | first2, | ||
Size | n, | ||
const distributor::communicator_type & | comm, | ||
distributed | |||
) |
Definition at line 93 of file dis_inner_product.h.
promote< typenamestd::iterator_traits< InputIterator1 >::value_type, typenamestd::iterator_traits< InputIterator2 >::value_type >::type dis_inner_product | ( | InputIterator1 | first1, |
InputIterator2 | first2, | ||
Size | n, | ||
const distributor::communicator_type & | comm | ||
) |
Definition at line 112 of file dis_inner_product.h.
size_t seq_peak_memory_usage | ( | ) |
Definition at line 57 of file dis_memory_usage.cc.
size_t seq_memory_usage | ( | ) |
Definition at line 103 of file dis_memory_usage.cc.
size_t memory_size | ( | ) |
Definition at line 170 of file dis_memory_usage.cc.
size_t dis_memory_usage | ( | ) |
Definition at line 255 of file dis_memory_usage.cc.
size_t dis_peak_memory_usage | ( | ) |
Definition at line 262 of file dis_memory_usage.cc.
idiststream & operator>> | ( | idiststream & | ips, |
disarray< T, sequential, A > & | x | ||
) |
Definition at line 780 of file disarray.h.
odiststream & operator<< | ( | odiststream & | ops, |
const disarray< T, sequential, A > & | x | ||
) |
Definition at line 786 of file disarray.h.
idiststream & operator>> | ( | idiststream & | ips, |
disarray< T, distributed, A > & | x | ||
) |
Definition at line 795 of file disarray.h.
odiststream & operator<< | ( | odiststream & | ops, |
const disarray< T, distributed, A > & | x | ||
) |
Definition at line 801 of file disarray.h.
disarray_store< OutputRandomIterator, SetOp, Size, IsContainer > disarray_make_store | ( | OutputRandomIterator | x, |
SetOp | op, | ||
Size | , | ||
IsContainer | |||
) |
Definition at line 60 of file disarray_store.h.
bool dis_scatch | ( | idiststream & | ips, |
const communicator & | comm, | ||
std::string | ch | ||
) |
distributed version of scatch(istream&,string)
Definition at line 44 of file diststream.cc.
int dis_system | ( | const std::string & | command, |
const communicator & | comm | ||
) |
Definition at line 214 of file diststream.cc.
bool dis_file_exists | ( | const std::string & | filename, |
const communicator & | comm | ||
) |
Definition at line 233 of file diststream.cc.
_RHEOLEF_define_sequential_odiststream_macro | ( | char | ) | const |
Definition at line 271 of file diststream.h.
_RHEOLEF_define_sequential_idiststream_macro | ( | char | ) |
Definition at line 437 of file diststream.h.
bool dis_scatch | ( | idiststream & | ips, |
std::string | ch | ||
) |
Definition at line 478 of file diststream.h.
idiststream & operator>> | ( | idiststream & | ids, |
const catchmark & | m | ||
) |
Definition at line 484 of file diststream.h.
odiststream & operator<< | ( | odiststream & | ods, |
const catchmark & | m | ||
) |
Definition at line 496 of file diststream.h.
solver_basic< T, M > eye_basic | ( | ) |
solver_basic< Float > eye | ( | ) |
unary_compose< _Operation1, _Operation2 > compose1 | ( | const _Operation1 & | __fn1, |
const _Operation2 & | __fn2 | ||
) |
Definition at line 44 of file functional_sgi_ext.h.
binary_compose< _Operation1, _Operation2, _Operation3 > compose2 | ( | const _Operation1 & | __fn1, |
const _Operation2 & | __fn2, | ||
const _Operation3 & | __fn3 | ||
) |
Definition at line 69 of file functional_sgi_ext.h.
std::iterator_traits< Iterator >::pointer get_pointer_from_iterator | ( | Iterator | iter | ) |
Definition at line 26 of file get_pointer_from_iterator.h.
Definition at line 31 of file get_pointer_from_iterator.h.
int gmres | ( | const Matrix & | A, |
Vector & | x, | ||
const Vector & | b, | ||
const Preconditioner & | M, | ||
SmallMatrix & | H, | ||
const SmallVector & | V, | ||
const solver_option & | sopt = solver_option() |
||
) |
std::istream & operator>> | ( | std::istream & | is, |
index_set & | x | ||
) |
Definition at line 57 of file index_set_body.icc.
std::ostream & operator<< | ( | std::ostream & | os, |
const index_set & | x | ||
) |
Definition at line 70 of file index_set_body.icc.
Definition at line 82 of file index_set_body.icc.
Definition at line 89 of file index_set_body.icc.
bool load_chunk | ( | std::istream & | s, |
RandomIterator | iter, | ||
RandomIterator | last | ||
) |
Definition at line 27 of file load_chunk.h.
bool load_chunk | ( | std::istream & | s, |
RandomIterator | iter, | ||
RandomIterator | last, | ||
GetFunction | get_element | ||
) |
Definition at line 36 of file load_chunk.h.
int minres | ( | const Matrix & | A, |
Vector & | x, | ||
const Vector & | Mb, | ||
const Preconditioner & | M, | ||
const solver_option & | sopt = solver_option() |
||
) |
int uzawa_abtbc | ( | const Matrix & | A, |
const Matrix & | B, | ||
const Matrix & | C, | ||
Vector & | u, | ||
Vector & | p, | ||
const Vector & | Mf, | ||
const Vector & | Mg, | ||
const Preconditioner & | S1, | ||
const Solver & | inner_solver_A, | ||
const Float & | rho, | ||
const solver_option & | sopt = solver_option() |
||
) |
Definition at line 49 of file mixed_solver.h.
int uzawa_abtb | ( | const Matrix & | A, |
const Matrix & | B, | ||
Vector & | u, | ||
Vector & | p, | ||
const Vector & | Mf, | ||
const Vector & | Mg, | ||
const Preconditioner & | S1, | ||
const Solver & | inner_solver_A, | ||
const Real & | rho, | ||
const solver_option & | sopt = solver_option() |
||
) |
Definition at line 63 of file mixed_solver.h.
int cg_abtbc | ( | const Matrix & | A, |
const Matrix & | B, | ||
const Matrix & | C, | ||
Vector & | u, | ||
Vector & | p, | ||
const VectorExpr1 & | Mf, | ||
const VectorExpr2 & | Mg, | ||
const Preconditioner & | S1, | ||
const Solver & | inner_solver_A, | ||
const solver_option & | sopt = solver_option() |
||
) |
Definition at line 152 of file mixed_solver.h.
int cg_abtb | ( | const Matrix & | A, |
const Matrix & | B, | ||
Vector & | u, | ||
Vector & | p, | ||
const VectorExpr1 & | Mf, | ||
const VectorExpr2 & | Mg, | ||
const Preconditioner & | S1, | ||
const Solver & | inner_solver_A, | ||
const solver_option & | sopt = solver_option() |
||
) |
Definition at line 166 of file mixed_solver.h.
int minres_abtbc | ( | const Matrix & | A, |
const Matrix & | B, | ||
const Matrix & | C, | ||
Vector & | u, | ||
Vector & | p, | ||
const Vector & | Mf, | ||
const Vector & | Mg, | ||
const Preconditioner & | S1, | ||
const Solver & | inner_solver_A, | ||
const solver_option & | sopt = solver_option() |
||
) |
Definition at line 179 of file mixed_solver.h.
int minres_abtb | ( | const Matrix & | A, |
const Matrix & | B, | ||
Vector & | u, | ||
Vector & | p, | ||
const Vector & | Mf, | ||
const Vector & | Mg, | ||
const Preconditioner & | S1, | ||
const Solver & | inner_solver_A, | ||
const solver_option & | sopt = solver_option() |
||
) |
Definition at line 192 of file mixed_solver.h.
struct matrix_market read_matrix_market_header | ( | idiststream & | ips | ) |
Stash::size_type mpi_assembly_begin | ( | const Stash & | stash, |
InputIterator | first_stash_idx, | ||
InputIterator | last_stash_idx, | ||
const distributor & | ownership, | ||
Message & | receive, | ||
Message & | send | ||
) |
Definition at line 57 of file mpi_assembly_begin.h.
Size mpi_assembly_end | ( | Message & | receive, |
Message & | send, | ||
Size | receive_max_size, | ||
Container | x | ||
) |
Definition at line 55 of file mpi_assembly_end.h.
void mpi_scatter_begin_global | ( | InputIterator | x, |
Message & | from, | ||
Message & | to, | ||
Tag | tag, | ||
Comm | comm | ||
) |
Definition at line 67 of file mpi_scatter_begin.h.
void mpi_scatter_begin_local | ( | InputIterator | x, |
OutputIterator | y, | ||
Message & | from, | ||
Message & | to, | ||
SetOp | op | ||
) |
Definition at line 123 of file mpi_scatter_begin.h.
void mpi_scatter_begin_local | ( | InputIterator | x, |
OutputIterator | y, | ||
Message & | from, | ||
Message & | to, | ||
details::generic_set_op | op | ||
) |
Definition at line 146 of file mpi_scatter_begin.h.
void mpi_scatter_begin | ( | InputIterator | x, |
OutputIterator | y, | ||
Message & | from, | ||
Message & | to, | ||
SetOp | op, | ||
Tag | tag, | ||
Comm | comm | ||
) |
Definition at line 196 of file mpi_scatter_begin.h.
void mpi_scatter_end | ( | InputIterator | x, |
OutputIterator | y, | ||
Message & | from, | ||
Message & | to, | ||
SetOp | op, | ||
Tag | tag, | ||
Comm | comm | ||
) |
Definition at line 60 of file mpi_scatter_end.h.
void mpi_scatter_init | ( | Size | nidx, |
SizeRandomIterator1 | idx, | ||
Size | nidy, | ||
SizeRandomIterator2 | idy, | ||
Size | idy_maxval, | ||
SizeRandomIterator3 | ownership, | ||
Tag | tag, | ||
const distributor::communicator_type & | comm, | ||
Message & | from, | ||
Message & | to | ||
) |
Definition at line 73 of file mpi_scatter_init.h.
void mpi_scatter_map | ( | const distributor & | ownership, |
InputIterator | local_data, | ||
const InputSet & | ext_idx_set, | ||
OutputMap & | ext_idx_map | ||
) |
Definition at line 57 of file mpi_scatter_map.h.
void msg_both_permutation_apply | ( | InputIterator1 | px, |
InputIterator1 | last_px, | ||
InputRandomIterator | x, | ||
SetOp | set_op, | ||
InputIterator2 | py, | ||
OutputRandomIterator | y | ||
) |
Definition at line 58 of file msg_both_permutation_apply.h.
void msg_from_context_indices | ( | InputIterator1 | owner, |
InputIterator1 | last_owner, | ||
InputIterator2 | idy, | ||
InputRandomIterator | proc2from_proc, | ||
Proc | my_proc, | ||
Size | idy_maxval, | ||
MutableRandomIterator | ptr, | ||
OutputIterator | from_idx | ||
) |
Definition at line 76 of file msg_from_context_indices.h.
void msg_from_context_pattern | ( | InputIterator1 | msg_size, |
InputIterator1 | last_msg_size, | ||
OutputIterator1 | from_proc, | ||
OutputIterator2 | from_ptr, | ||
OutputIterator3 | proc2from_proc | ||
) |
Definition at line 72 of file msg_from_context_pattern.h.
void msg_left_permutation_apply | ( | InputIterator1 | x, |
SetOp | op, | ||
InputIterator2 | py, | ||
InputIterator2 | last_py, | ||
OutputRandomIterator | y | ||
) |
Definition at line 57 of file msg_left_permutation_apply.h.
void msg_local_context | ( | InputIterator1 | idx, |
InputIterator1 | last_idx, | ||
InputIterator2 | idy, | ||
Size | idy_maxval, | ||
Size | istart, | ||
Size | ilast, | ||
OutputIterator1 | to_loc_idx, | ||
OutputIterator1 | last_to_loc_idx, | ||
OutputIterator2 | from_loc_idy | ||
) |
Definition at line 73 of file msg_local_context.h.
bool msg_local_optimize | ( | InputIterator1 | to_loc_idx, |
InputIterator1 | last_to_loc_idx, | ||
InputIterator2 | from_loc_idy | ||
) |
Definition at line 75 of file msg_local_optimize.h.
OutputIterator msg_right_permutation_apply | ( | InputIterator | perm, |
InputIterator | last_perm, | ||
const InputRandomIterator & | x, | ||
OutputIterator | y, | ||
SetOp | set_op | ||
) |
Definition at line 57 of file msg_right_permutation_apply.h.
OutputIterator msg_right_permutation_apply | ( | InputIterator | perm, |
InputIterator | last_perm, | ||
const InputRandomIterator & | x, | ||
OutputIterator | y | ||
) |
Definition at line 87 of file msg_right_permutation_apply.h.
void quick_sort_with_permutation | ( | RandomIterator | v, |
SizeRandomIterator | p, | ||
Size | start, | ||
Size | end | ||
) |
Definition at line 42 of file msg_sort_with_permutation.h.
void bubble_sort_with_permutation | ( | RandomIterator | v, |
SizeRandomIterator | p, | ||
Size | n | ||
) |
Definition at line 74 of file msg_sort_with_permutation.h.
void sort_with_permutation | ( | RandomIterator | v, |
SizeRandomIterator | p, | ||
Size | n | ||
) |
Definition at line 91 of file msg_sort_with_permutation.h.
void msg_to_context | ( | InputIterator1 | perm, |
InputIterator1 | last_perm, | ||
InputRandomIterator2 | r_iproc, | ||
InputRandomIterator3 | r_size, | ||
InputRandomIterator4 | r_idx, | ||
Size | receive_max_size, | ||
Size | istart, | ||
OutputIterator1 | to_proc, | ||
OutputIterator2 | to_ptr, | ||
OutputIterator3 | to_idx | ||
) |
Definition at line 78 of file msg_to_context.h.
apply_iterator< Iterator, Operator > make_apply_iterator | ( | Iterator | i, |
Operator | op | ||
) |
Definition at line 114 of file msg_util.h.
OutputIterator msg_pair_copy | ( | InputIterator | input, |
InputIterator | last, | ||
OutputIterator | result | ||
) |
Definition at line 120 of file msg_util.h.
Definition at line 217 of file pair_set.h.
Definition at line 232 of file pair_set.h.
int uzawa | ( | const Matrix & | A, |
Vector & | x, | ||
const Vector & | Mb, | ||
const Preconditioner & | M, | ||
const Real2 & | rho, | ||
const solver_option & | sopt = solver_option() |
||
) |
idiststream & operator>> | ( | idiststream & | ips, |
vec< T, sequential > & | x | ||
) |
odiststream & operator<< | ( | odiststream & | ods, |
const vec< T, M > & | x | ||
) |
idiststream & operator>> | ( | idiststream & | ips, |
vec< T, distributed > & | x | ||
) |
norm2(x): see the expression
page for the full documentation
norm(x): see the expression
page for the full documentation
_RHEOLEF_vec_expr_v2_unary_operator | ( | + | , |
details::generic_unary_plus<> | |||
) |
_RHEOLEF_vec_expr_v2_binary_operator | ( | + | , |
details::generic_plus<> | |||
) |
details::generic_minus std::enable_if<(details::is_rheolef_arithmetic< Expr1 >::value &&details::is_vec_expr_v2_arg< Expr2 >::value)||(details::is_vec_expr_v2_arg< Expr1 >::value &&details::is_rheolef_arithmetic< Expr2 >::value), typenamedetails::vec_expr_v2_binary_traits< details::generic_multiplies<>, Expr1, Expr2 >::type >::type operator* | ( | const Expr1 & | expr1, |
const Expr2 & | expr2 | ||
) |
Definition at line 289 of file vec_expr_v2.h.
std::enable_if<(details::is_vec_expr_v2_arg< Expr1 >::value &&details::is_rheolef_arithmetic< Expr2 >::value), typenamedetails::vec_expr_v2_binary_traits< details::generic_divides<>, Expr1, Expr2 >::type >::type operator/ | ( | const Expr1 & | expr1, |
const Expr2 & | expr2 | ||
) |
Definition at line 309 of file vec_expr_v2.h.
_RHEOLEF_vec_expr_v2_op_assign | ( | + | , |
details::plus_assign | |||
) |
_RHEOLEF_vec_expr_v2_op_assign_constant | ( | + | , |
details::plus_assign | |||
) |
details::minus_assign _RHEOLEF_vec_expr_v2_op_assign_constant details::multiplies_assign _RHEOLEF_vec_expr_v2_op_assign_constant | ( | / | , |
details::divides_assign | |||
) |
dot(x,y): see the expression
page for the full documentation
rheolef::std enable_if ::type dot const Expr1 expr1, const Expr2 expr2 dot | ( | const Expr1 & | expr1, |
const Expr2 & | expr2 | ||
) |
Definition at line 394 of file vec_expr_v2.h.
std::enable_if< details::is_vec_expr_v2_arg< Expr1 >::value &&details::is_rheolef_arithmetic< Expr2 >::value, typenameExpr1::float_type >::type dot | ( | const Expr1 & | expr1, |
const Expr2 & | expr2 | ||
) |
dot(x,y): see the expression
page for the full documentation
Definition at line 429 of file vec_expr_v2.h.
void gauss_jacobi | ( | Size | R, |
typename std::iterator_traits< OutputIterator1 >::value_type | alpha, | ||
typename std::iterator_traits< OutputIterator1 >::value_type | beta, | ||
OutputIterator1 | zeta, | ||
OutputIterator2 | omega | ||
) |
Definition at line 29 of file gauss_jacobi.icc.
void gauss_lobatto_jacobi | ( | Size | R, |
typename std::iterator_traits< OutputIterator1 >::value_type | alpha, | ||
typename std::iterator_traits< OutputIterator1 >::value_type | beta, | ||
OutputIterator1 | zeta, | ||
OutputIterator2 | omega | ||
) |
Definition at line 28 of file gauss_lobatto_jacobi.icc.
void gauss_radau_jacobi | ( | Size | R, |
typename std::iterator_traits< OutputIterator1 >::value_type | alpha, | ||
typename std::iterator_traits< OutputIterator1 >::value_type | beta, | ||
OutputIterator1 | zeta, | ||
OutputIterator2 | omega | ||
) |
Definition at line 28 of file gauss_radau_jacobi.icc.
void jacobi_roots | ( | Size | R, |
T | alpha, | ||
T | beta, | ||
OutputIterator | zeta | ||
) |
Definition at line 26 of file jacobi_roots.icc.
char skip_blancs_and_tabs | ( | std::istream & | is | ) |
Definition at line 32 of file geo_element.cc.
std::istream & operator>> | ( | std::istream & | is, |
geo_element & | K | ||
) |
Definition at line 360 of file geo_element.h.
std::ostream & operator<< | ( | std::ostream & | os, |
const geo_element & | K | ||
) |
Definition at line 366 of file geo_element.h.
std::istream & operator>> | ( | std::istream & | is, |
geo_element_indirect & | x | ||
) |
Definition at line 26 of file geo_element_indirect.cc.
std::ostream & operator<< | ( | std::ostream & | os, |
const geo_element_indirect & | x | ||
) |
Definition at line 42 of file geo_element_indirect.cc.
std::istream & operator>> | ( | std::istream & | s, |
point_basic< T > & | p | ||
) |
std::ostream & operator<< | ( | std::ostream & | s, |
const point_basic< T > & | p | ||
) |
std::enable_if< details::is_rheolef_arithmetic< U >::value, point_basic< T > >::type operator* | ( | const U & | a, |
const point_basic< T > & | u | ||
) |
point_basic< T > vect | ( | const point_basic< T > & | v, |
const point_basic< T > & | w | ||
) |
T dot | ( | const point_basic< T > & | x, |
const point_basic< T > & | y | ||
) |
T dist2 | ( | const point_basic< T > & | x, |
const point_basic< T > & | y | ||
) |
T dist | ( | const point_basic< T > & | x, |
const point_basic< T > & | y | ||
) |
T dist_infty | ( | const point_basic< T > & | x, |
const point_basic< T > & | y | ||
) |
T vect2d | ( | const point_basic< T > & | v, |
const point_basic< T > & | w | ||
) |
T mixt | ( | const point_basic< T > & | u, |
const point_basic< T > & | v, | ||
const point_basic< T > & | w | ||
) |
int sign_orient2d | ( | const point_basic< T > & | a, |
const point_basic< T > & | b, | ||
const point_basic< T > & | c | ||
) |
Definition at line 72 of file point_predicate.cc.
int sign_orient3d | ( | const point_basic< T > & | a, |
const point_basic< T > & | b, | ||
const point_basic< T > & | c, | ||
const point_basic< T > & | d | ||
) |
Definition at line 89 of file point_predicate.cc.
T orient2d | ( | const point_basic< T > & | a, |
const point_basic< T > & | b, | ||
const point_basic< T > & | c | ||
) |
Definition at line 107 of file point_predicate.cc.
T orient3d | ( | const point_basic< T > & | a, |
const point_basic< T > & | b, | ||
const point_basic< T > & | c, | ||
const point_basic< T > & | d | ||
) |
Definition at line 124 of file point_predicate.cc.
std::string ptos | ( | const point_basic< T > & | x, |
int | d = 3 |
||
) |
bool lexicographically_less | ( | const point_basic< T > & | a, |
const point_basic< T > & | b | ||
) |
point_basic< T1 > operator/ | ( | const T2 & | a, |
const point_basic< T1 > & | x | ||
) |
std::ostream & operator<< | ( | std::ostream & | os, |
const quadrature< T > & | q | ||
) |
Definition at line 228 of file quadrature.h.
ostream & operator<< | ( | ostream & | out, |
const quadrature_on_geo< T > & | x | ||
) |
Definition at line 217 of file quadrature_rep.cc.
ostream & operator<< | ( | ostream & | out, |
const quadrature_rep< T > & | x | ||
) |
Definition at line 227 of file quadrature_rep.cc.
Float measure | ( | reference_element | hat_K | ) |
Definition at line 65 of file reference_element.cc.
point_basic< T > reference_element_face_transformation | ( | reference_element | tilde_K, |
const side_information_type & | sid, | ||
const point_basic< T > & | sid_hat_x | ||
) |
Definition at line 33 of file reference_element_face_transformation.cc.
point_basic< T > reference_element_face_inverse_transformation | ( | reference_element | tilde_K, |
const side_information_type & | sid, | ||
const point_basic< T > & | tilde_x | ||
) |
Definition at line 87 of file reference_element_face_transformation.cc.
point_basic< size_t > reference_element_face_transformation | ( | reference_element | tilde_K, |
const side_information_type & | sid, | ||
size_t | k, | ||
const point_basic< size_t > & | sid_ilat | ||
) |
Definition at line 142 of file reference_element_face_transformation.cc.
Eigen::Matrix< T, N, N > expm_eig | ( | const Eigen::Matrix< T, N, N > & | a | ) |
Definition at line 70 of file tensor-exp.cc.
tensor_basic< T > exp | ( | const tensor_basic< T > & | a, |
size_t | d | ||
) |
Definition at line 92 of file tensor-exp.cc.
point_basic< T > operator* | ( | const point_basic< T > & | x, |
const tensor_basic< T > & | a | ||
) |
tensor_basic< T > trans | ( | const tensor_basic< T > & | a, |
size_t | d | ||
) |
tensor_basic< T > inv | ( | const tensor_basic< T > & | a, |
size_t | d | ||
) |
void prod | ( | const tensor_basic< T > & | a, |
const tensor_basic< T > & | b, | ||
tensor_basic< T > & | result, | ||
size_t | di, | ||
size_t | dj, | ||
size_t | dk | ||
) |
T ddot | ( | const tensor_basic< T > & | a, |
const tensor_basic< T > & | b | ||
) |
ddot(x,y): see the expression
page for the full documentation
void cumul_otimes | ( | tensor_basic< T > & | t, |
const point_basic< T > & | a, | ||
const point_basic< T > & | b, | ||
size_t | na, | ||
size_t | nb | ||
) |
bool invert_3x3 | ( | const tensor_basic< T > & | A, |
tensor_basic< T > & | result | ||
) |
point_basic< U > operator* | ( | const point_basic< U > & | yt, |
const tensor_basic< U > & | a | ||
) |
tensor_basic< U > trans | ( | const tensor_basic< U > & | a, |
size_t | d = 3 |
||
) |
void prod | ( | const tensor_basic< U > & | a, |
const tensor_basic< U > & | b, | ||
tensor_basic< U > & | result, | ||
size_t | di = 3 , |
||
size_t | dj = 3 , |
||
size_t | dk = 3 |
||
) |
U tr | ( | const tensor_basic< U > & | a, |
size_t | d = 3 |
||
) |
U ddot | ( | const tensor_basic< U > & | , |
const tensor_basic< U > & | |||
) |
tensor_basic< U > otimes | ( | const point_basic< U > & | u, |
const point_basic< U > & | v, | ||
size_t | d = 3 |
||
) |
tensor_basic< U > inv | ( | const tensor_basic< U > & | a, |
size_t | d = 3 |
||
) |
tensor_basic< U > diag | ( | const point_basic< U > & | d | ) |
point_basic< U > diag | ( | const tensor_basic< U > & | a | ) |
U determinant | ( | const tensor_basic< U > & | A, |
size_t | d = 3 |
||
) |
bool invert_3x3 | ( | const tensor_basic< U > & | A, |
tensor_basic< U > & | result | ||
) |
std::istream & operator>> | ( | std::istream & | in, |
tensor_basic< T > & | a | ||
) |
std::ostream & operator<< | ( | std::ostream & | out, |
const tensor_basic< T > & | a | ||
) |
void cumul_otimes | ( | tensor_basic< T > & | t, |
const point_basic< T > & | a, | ||
const point_basic< T > & | b, | ||
size_t | na = 3 |
||
) |
std::enable_if< details::is_rheolef_arithmetic< U >::value, tensor_basic< T > >::type operator* | ( | const U & | k, |
const tensor_basic< T > & | a | ||
) |
tensor_basic< T > otimes | ( | const point_basic< T > & | u, |
const point_basic< T > & | v, | ||
size_t | d | ||
) |
T determinant | ( | const tensor_basic< T > & | A, |
size_t | d | ||
) |
tensor_basic< T > diag | ( | const point_basic< T > & | d | ) |
point_basic< T > diag | ( | const tensor_basic< T > & | a | ) |
T tr | ( | const tensor_basic< T > & | a, |
size_t | d | ||
) |
T dist2 | ( | const tensor_basic< T > & | a, |
const tensor_basic< T > & | b | ||
) |
U norm | ( | const tensor_basic< U > & | a | ) |
U dist | ( | const tensor_basic< U > & | a, |
const tensor_basic< U > & | b | ||
) |
T dddot | ( | const tensor3_basic< T > & | a, |
const tensor3_basic< T > & | b | ||
) |
Definition at line 94 of file tensor3.cc.
std::enable_if< details::is_rheolef_arithmetic< U >::value, tensor3_basic< T > >::type operator* | ( | const U & | k, |
const tensor3_basic< T > & | a | ||
) |
U dddot | ( | const tensor3_basic< U > & | , |
const tensor3_basic< U > & | |||
) |
T norm2 | ( | const tensor3_basic< T > & | a | ) |
T dist2 | ( | const tensor3_basic< T > & | a, |
const tensor3_basic< T > & | b | ||
) |
U norm | ( | const tensor3_basic< U > & | a | ) |
U dist | ( | const tensor3_basic< U > & | a, |
const tensor3_basic< U > & | b | ||
) |
std::istream & operator>> | ( | std::istream & | in, |
tensor3_basic< T > & | a | ||
) |
std::ostream & operator<< | ( | std::ostream & | out, |
const tensor3_basic< T > & | a | ||
) |
tensor4_basic< T > dexp | ( | const tensor_basic< T > & | chi, |
size_t | dim | ||
) |
Definition at line 37 of file tensor4-dexp.cc.
tensor_basic< T > ddot | ( | const tensor4_basic< T > & | a, |
const tensor_basic< T > & | x | ||
) |
Definition at line 39 of file tensor4.cc.
tensor_basic< T > ddot | ( | const tensor_basic< T > & | y, |
const tensor4_basic< T > & | a | ||
) |
Definition at line 52 of file tensor4.cc.
T norm2 | ( | const tensor4_basic< T > & | a | ) |
Definition at line 184 of file tensor4.cc.
std::enable_if< details::is_rheolef_arithmetic< U >::value, tensor4_basic< T > >::type operator* | ( | const U & | k, |
const tensor4_basic< T > & | a | ||
) |
std::ostream & operator<< | ( | std::ostream & | out, |
const tensor4_basic< T > & | a | ||
) |
void lu | ( | tiny_matrix< T > & | a, |
tiny_vector< size_t > & | piv | ||
) |
void solve | ( | tiny_matrix< T > & | a, |
tiny_vector< size_t > & | piv, | ||
const tiny_vector< T > & | b, | ||
tiny_vector< T > & | x | ||
) |
void invert | ( | tiny_matrix< T > & | a, |
tiny_matrix< T > & | inv_a | ||
) |
void put | ( | std::ostream & | out, |
std::string | name, | ||
const tiny_matrix< T > & | a | ||
) |
void trans | ( | const tiny_matrix< T > & | a, |
tiny_matrix< T > & | b | ||
) |
Definition at line 156 of file tiny_matvec.h.
tiny_matrix< T > operator* | ( | const tiny_matrix< T > & | a, |
const tiny_matrix< T > & | b | ||
) |
Definition at line 166 of file tiny_matvec.h.
tiny_vector< T > operator* | ( | const tiny_matrix< T > & | a, |
const tiny_vector< T > & | u | ||
) |
Definition at line 181 of file tiny_matvec.h.
|
extern |
Definition at line 111 of file basis_get.cc.
void basis_error | ( | const char * | msg | ) |
Definition at line 83 of file basis_get.cc.
int basis_wrap | ( | ) |
Definition at line 88 of file basis_get.cc.
void basis_parse_from_string | ( | const std::string & | str, |
family_index_option_type & | fio | ||
) |
Definition at line 142 of file basis_get.cc.
void eigen_dense2sparse | ( | const Eigen::Matrix< T, Eigen::Dynamic, Eigen::Dynamic > & | a, |
Eigen::SparseMatrix< T, Eigen::RowMajor > & | as | ||
) |
Definition at line 39 of file eigen_util.h.
Definition at line 60 of file eigen_util.h.
bool invert | ( | const Eigen::Matrix< T, Nrows, Ncols > & | a, |
Eigen::Matrix< T, Nrows, Ncols > & | inv_a | ||
) |
Definition at line 68 of file eigen_util.h.
void put_matrix_market | ( | std::ostream & | out, |
const Eigen::SparseMatrix< T, Eigen::RowMajor > & | a | ||
) |
Definition at line 78 of file eigen_util.h.
void put_matrix_market | ( | std::ostream & | out, |
const Eigen::Matrix< T, Eigen::Dynamic, Eigen::Dynamic > & | a | ||
) |
Definition at line 92 of file eigen_util.h.
void pointset_lagrange_equispaced | ( | reference_element | hat_K, |
size_t | order_in, | ||
Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > & | hat_xnod, | ||
size_t | internal = 0 |
||
) |
Definition at line 44 of file equispaced.icc.
void set_simplex_leb_gll | ( | size_t | degree, |
Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > & | pts | ||
) |
Definition at line 34 of file set_simplex_leb_gll.cc.
void pointset_lagrange_fekete | ( | reference_element | hat_K, |
size_t | degree, | ||
Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > & | hat_xnod, | ||
bool | map_on_reference_element = true |
||
) |
Definition at line 42 of file fekete.icc.
_RHEOLEF_inline_value_g | ( | "scalar" | , |
T | , | ||
point_basic< T > | |||
) |
tensor_basic< T > _RHEOLEF_inline_value_g | ( | "tensor" | , |
tensor_basic< T > | , | ||
tensor3_basic< T > | |||
) |
void reference_element_barycenter | ( | reference_element | hat_K, |
point_basic< T > & | c | ||
) |
Definition at line 38 of file reference_element_aux.icc.
bool eval_sherwin_basis_is_singular_point | ( | const point_basic< T > & | tilde_x, |
reference_element | hat_K, | ||
size_t | degree, | ||
Container & | value | ||
) |
Definition at line 109 of file sherwin.icc.
void warburton_e | ( | size_t | degree, |
Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > & | x, | ||
bool | map_on_reference_element = true |
||
) |
Definition at line 45 of file warburton.icc.
void warburton_q | ( | size_t | degree, |
Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > & | x, | ||
bool | dummy = true |
||
) |
Definition at line 73 of file warburton.icc.
void warburton_H | ( | size_t | degree, |
Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > & | x, | ||
bool | dummy = true |
||
) |
Definition at line 91 of file warburton.icc.
void warburton_t | ( | size_t | degree, |
Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > & | x, | ||
bool | map_on_reference_element = true |
||
) |
Definition at line 176 of file warburton.icc.
void warburton_P | ( | size_t | degree, |
Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > & | x, | ||
bool | map_on_reference_element = true |
||
) |
Definition at line 276 of file warburton.icc.
void equispaced_T | ( | size_t | degree, |
Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > & | x | ||
) |
Definition at line 303 of file warburton.icc.
void evalwarp | ( | size_t | degree, |
const std::vector< T > & | xnodes, | ||
const std::vector< T > & | xout, | ||
std::vector< T > & | warp | ||
) |
Definition at line 323 of file warburton.icc.
void evalshift | ( | size_t | degree, |
const T & | alpha, | ||
const std::vector< T > & | L0, | ||
const std::vector< T > & | L1, | ||
const std::vector< T > & | L2, | ||
std::vector< T > & | dx, | ||
std::vector< T > & | dy | ||
) |
Definition at line 363 of file warburton.icc.
void WarpShiftFace3D | ( | size_t | degree, |
const T & | alpha, | ||
const T & | dummy, | ||
const std::vector< T > & | Ldummy, | ||
const std::vector< T > & | L1, | ||
const std::vector< T > & | L2, | ||
const std::vector< T > & | L3, | ||
std::vector< T > & | warpx, | ||
std::vector< T > & | warpy | ||
) |
Definition at line 427 of file warburton.icc.
void warburton_T | ( | size_t | degree, |
Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > & | x, | ||
bool | map_on_reference_element = true |
||
) |
Definition at line 443 of file warburton.icc.
void pointset_lagrange_warburton | ( | reference_element | hat_K, |
size_t | degree, | ||
Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > & | hat_xnod, | ||
bool | map_on_reference_element = true |
||
) |
Definition at line 574 of file warburton.icc.
geo_basic< T, M > adapt_gmsh | ( | const field_basic< T, M > & | uh, |
const adapt_option & | opts | ||
) |
Definition at line 41 of file adapt_gmsh.cc.
geo_basic< T, M > adapt_bamg | ( | const field_basic< T, M > & | uh, |
const adapt_option & | opts | ||
) |
Definition at line 63 of file adapt_bamg.cc.
field_basic< T, M > proj | ( | const field_basic< T, M > & | uh, |
const std::string & | approx = "P1" |
||
) |
field_basic< T, M > smooth | ( | const field_basic< T, M > & | uh, |
size_t | n = 1 |
||
) |
field_basic< T, M > hessian | ( | const field_basic< T, M > & | uh | ) |
field_basic< T, M > hessian_criterion | ( | const field_basic< T, M > & | uh0, |
const adapt_option & | opts | ||
) |
geo_basic< T, M > adapt | ( | const field_basic< T, M > & | uh, |
const adapt_option & | opts | ||
) |
std::string bamgcad_catch_name | ( | idiststream & | bamg_in | ) |
Definition at line 44 of file adapt_bamg.cc.
geo_basic< T, M > level_set_internal | ( | const field_basic< T, M > & | fh, |
const level_set_option & | opt, | ||
std::vector< size_t > & | bnd_dom_ie_list, | ||
disarray< size_t, M > & | sid_ie2bnd_ie | ||
) |
Definition at line 416 of file level_set.cc.
void get_header | ( | idiststream & | in, |
branch_basic< T, sequential > & | b | ||
) |
void get_event | ( | idiststream & | in, |
branch_basic< T, sequential > & | b | ||
) |
void get_header | ( | idiststream & | in, |
branch_basic< T, distributed > & | b | ||
) |
void get_event | ( | idiststream & | in, |
branch_basic< T, distributed > & | b | ||
) |
idiststream & operator>> | ( | idiststream & | in, |
branch_basic< T, M > & | b | ||
) |
void put_header | ( | odiststream & | out, |
const branch_basic< T, sequential > & | b | ||
) |
void put_header | ( | odiststream & | out, |
const branch_basic< T, distributed > & | b | ||
) |
void put_event | ( | odiststream & | out, |
const branch_basic< T, sequential > & | b | ||
) |
void put_event | ( | odiststream & | out, |
const branch_basic< T, distributed > & | b | ||
) |
odiststream & operator<< | ( | odiststream & | out, |
const branch_basic< T, M > & | b | ||
) |
void put_finalize | ( | odiststream & | out, |
const branch_basic< T, sequential > & | b | ||
) |
void put_finalize | ( | odiststream & | out, |
const branch_basic< T, distributed > & | b | ||
) |
rheolef_instanciate | ( | Float | , |
sequential | |||
) |
odiststream & operator<< | ( | odiststream & | os, |
__iobranch< T, M > | m | ||
) |
idiststream & operator>> | ( | idiststream & | is, |
__iobranch< T, M > | m | ||
) |
idiststream & geo_get_vtk | ( | idiststream & | ips, |
geo_basic< T, sequential > & | omega | ||
) |
Definition at line 64 of file geo_seq_get_vtk.cc.
void get_header_vtk | ( | idiststream & | ips, |
branch_basic< T, sequential > & | b | ||
) |
Definition at line 41 of file branch_seq_get_vtk.cc.
void get_event_vtk | ( | idiststream & | ips, |
branch_basic< T, sequential > & | b | ||
) |
Definition at line 51 of file branch_seq_get_vtk.cc.
template void get_header_vtk< Float > | ( | idiststream & | , |
branch_basic< Float, sequential > & | |||
) |
template void get_event_vtk< Float > | ( | idiststream & | , |
branch_basic< Float, sequential > & | |||
) |
odiststream & field_put_vtk | ( | odiststream & | ods, |
const field_basic< T, sequential > & | uh, | ||
std::string | name, | ||
bool | put_geo | ||
) |
Definition at line 154 of file field_seq_put_vtk.cc.
void put_header_vtk | ( | odiststream & | out, |
const branch_basic< T, sequential > & | b | ||
) |
Definition at line 40 of file branch_seq_put_vtk.cc.
void put_event_vtk_stream | ( | odiststream & | out_vtk, |
const branch_basic< T, sequential > & | b | ||
) |
Definition at line 49 of file branch_seq_put_vtk.cc.
void put_event_vtk | ( | odiststream & | out, |
const branch_basic< T, sequential > & | b | ||
) |
Definition at line 78 of file branch_seq_put_vtk.cc.
void put_finalize_vtk | ( | odiststream & | out, |
const branch_basic< T, sequential > & | b | ||
) |
Definition at line 93 of file branch_seq_put_vtk.cc.
template void put_header_vtk | ( | odiststream & | , |
const branch_basic< Float, sequential > & | |||
) |
template void put_event_vtk | ( | odiststream & | , |
const branch_basic< Float, sequential > & | |||
) |
template void put_event_vtk_stream | ( | odiststream & | , |
const branch_basic< Float, sequential > & | |||
) |
template void put_finalize_vtk | ( | odiststream & | , |
const branch_basic< Float, sequential > & | |||
) |
void put_header_gnuplot | ( | odiststream & | ops, |
const branch_basic< T, sequential > & | b | ||
) |
Definition at line 41 of file branch_seq_visu_gnuplot.cc.
void put_event_gnuplot | ( | odiststream & | ops, |
const branch_basic< T, sequential > & | b | ||
) |
Definition at line 66 of file branch_seq_visu_gnuplot.cc.
void put_finalize_gnuplot | ( | odiststream & | ops, |
const branch_basic< T, sequential > & | b | ||
) |
Definition at line 155 of file branch_seq_visu_gnuplot.cc.
template void put_header_gnuplot | ( | odiststream & | , |
const branch_basic< Float, sequential > & | |||
) |
template void put_event_gnuplot | ( | odiststream & | , |
const branch_basic< Float, sequential > & | |||
) |
template void put_finalize_gnuplot | ( | odiststream & | , |
const branch_basic< Float, sequential > & | |||
) |
std::string python | ( | const point_basic< T > & | x, |
size_t | d = 3 |
||
) |
void put_header_paraview | ( | odiststream & | out, |
const branch_basic< T, sequential > & | b | ||
) |
Definition at line 45 of file branch_seq_visu_vtk_paraview.cc.
void put_event_paraview | ( | odiststream & | out, |
const branch_basic< T, sequential > & | b | ||
) |
Definition at line 55 of file branch_seq_visu_vtk_paraview.cc.
void put_finalize_paraview | ( | odiststream & | out, |
const branch_basic< T, sequential > & | b | ||
) |
Definition at line 97 of file branch_seq_visu_vtk_paraview.cc.
template void put_header_paraview | ( | odiststream & | , |
const branch_basic< Float, sequential > & | |||
) |
template void put_event_paraview | ( | odiststream & | , |
const branch_basic< Float, sequential > & | |||
) |
template void put_finalize_paraview | ( | odiststream & | , |
const branch_basic< Float, sequential > & | |||
) |
details::field_expr_v2_nonlinear_node_nary< typename details::function_traits< Function >::functor_type,typename details::field_expr_v2_nonlinear_terminal_wrapper_traits< Exprs >::type... > ::type compose | ( | const Function & | f, |
const Exprs &... | exprs | ||
) |
void continuation | ( | Problem & | F, |
typename Problem::value_type & | uh, | ||
odiststream * | p_out, | ||
odiststream * | p_err, | ||
const continuation_option & | opts = continuation_option() |
||
) |
see the continuation
page for the full documentation
Definition at line 303 of file continuation.h.
void continuation | ( | keller< Problem > & | F, |
typename keller< Problem >::value_type & | uh, | ||
odiststream * | p_out, | ||
odiststream * | p_err, | ||
const continuation_option & | opts = continuation_option() |
||
) |
Definition at line 321 of file continuation.h.
int damped_newton | ( | const Problem & | P, |
const Preconditioner & | T, | ||
Field & | u, | ||
Real & | tol, | ||
Size & | max_iter, | ||
odiststream * | p_derr = 0 |
||
) |
see the damped_newton
page for the full documentation
Definition at line 29 of file damped-newton-generic.h.
int damped_newton | ( | const Problem & | F, |
Field & | u, | ||
Real & | tol, | ||
Size & | max_iter, | ||
odiststream * | p_derr = 0 |
||
) |
Definition at line 95 of file damped_newton.h.
domain_indirect_basic< sequential > build_union | ( | const geo_basic< T, sequential > & | omega, |
const domain_indirect_basic< sequential > & | a, | ||
const domain_indirect_basic< sequential > & | b | ||
) |
Definition at line 546 of file domain_indirect.h.
domain_indirect_basic< distributed > build_union | ( | const geo_basic< T, distributed > & | omega, |
const domain_indirect_basic< distributed > & | a, | ||
const domain_indirect_basic< distributed > & | b | ||
) |
Definition at line 775 of file domain_indirect.h.
void build_set_that_contains_S | ( | const geo_element & | S, |
const std::vector< index_set > & | ball, | ||
index_set & | contains_S | ||
) |
builds a set of elements that all contain S.
Definition at line 99 of file domain_indirect_seq.cc.
void div_evaluate_internal | ( | const fem_on_pointset_rep< T > & | obj, |
const geo_basic< T, M > & | omega_K, | ||
const geo_element & | K, | ||
const details::differentiate_option & | gopt, | ||
const Eigen::Matrix< tensor_basic< T >, Eigen::Dynamic, Eigen::Dynamic > & | grad_value, | ||
Eigen::Matrix< T, Eigen::Dynamic, Eigen::Dynamic > & | value | ||
) |
Definition at line 265 of file fem_on_pointset.cc.
void curl_evaluate_internal | ( | const fem_on_pointset_rep< T > & | obj, |
const geo_basic< T, M > & | omega_K, | ||
const geo_element & | K, | ||
const details::differentiate_option & | gopt, | ||
Eigen::Matrix< T, Eigen::Dynamic, Eigen::Dynamic > & | value | ||
) |
Definition at line 334 of file fem_on_pointset.cc.
void curl_evaluate_internal | ( | const fem_on_pointset_rep< T > & | obj, |
const geo_basic< T, M > & | omega_K, | ||
const geo_element & | K, | ||
const details::differentiate_option & | gopt, | ||
Eigen::Matrix< point_basic< T >, Eigen::Dynamic, Eigen::Dynamic > & | value | ||
) |
Definition at line 356 of file fem_on_pointset.cc.
_RHEOLEF_instanciation | ( | Float | ) |
void space_constitution_old_get | ( | idiststream & | ids, |
space_constitution< T, M > & | constit | ||
) |
Definition at line 86 of file space_constitution_old_get.cc.
odiststream & visu_gnuplot | ( | odiststream & | ods, |
const field_basic< T, sequential > & | uh | ||
) |
Definition at line 461 of file field_seq_visu_gnuplot.cc.
odiststream & visu_gmsh | ( | odiststream & | ops, |
const field_basic< T, sequential > & | uh | ||
) |
Definition at line 48 of file field_seq_visu_gmsh.cc.
odiststream & visu_vtk_paraview | ( | odiststream & | ops, |
const field_basic< T, sequential > & | uh | ||
) |
Definition at line 47 of file field_seq_visu_vtk_paraview.cc.
odiststream & field_put_gmsh | ( | odiststream & | , |
const field_basic< T, sequential > & | , | ||
std::string | |||
) |
Definition at line 46 of file field_seq_put_gmsh.cc.
odiststream & field_put_gmsh_pos | ( | odiststream & | ods, |
const field_basic< T, sequential > & | uh | ||
) |
Definition at line 173 of file field_seq_put_gmsh_pos.cc.
odiststream & field_put_bamg_bb | ( | odiststream & | ods, |
const field_basic< T, sequential > & | uh | ||
) |
Definition at line 41 of file field_seq_put_bamg_bb.cc.
idiststream & operator>> | ( | odiststream & | ips, |
field_basic< T, M > & | u | ||
) |
odiststream & operator<< | ( | odiststream & | ops, |
const field_basic< T, M > & | uh | ||
) |
idiststream & operator>> | ( | idiststream & | ips, |
field_basic< T, M > & | uh | ||
) |
field_basic< T, M > lazy_interpolate | ( | const space_basic< T, M > & | X2h, |
const field_basic< T, M > & | u1h | ||
) |
see the interpolate
page for the full documentation
std::enable_if< details::has_field_rdof_interface< FieldRdof >::value &&!details::is_field< FieldRdof >::value, field_basic< T, M > >::type lazy_interpolate | ( | const space_basic< T, M > & | Xh, |
const FieldRdof & | uh | ||
) |
see the interpolate
page for the full documentation
std::enable_if< details::has_field_lazy_interface< FieldLazy >::value &&!details::is_field< FieldLazy >::value, odiststream & >::type operator<< | ( | odiststream & | out, |
const FieldLazy & | expr | ||
) |
void field_evaluate | ( | const field_basic< T, M > & | uh, |
const basis_on_pointset< T > & | bops, | ||
reference_element | hat_K, | ||
const std::vector< size_t > & | dis_idof, | ||
Eigen::Matrix< T, Eigen::Dynamic, 1 > & | value | ||
) |
Definition at line 39 of file field_evaluate.cc.
void vector_field_evaluate | ( | const field_basic< T, M > & | uh, |
const basis_on_pointset< T > & | bops, | ||
reference_element | hat_K, | ||
const std::vector< size_t > & | dis_idof_tab, | ||
const basis_on_pointset< T > & | piola_on_geo_basis, | ||
std::vector< size_t > & | dis_inod_geo, | ||
Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > & | value | ||
) |
Definition at line 64 of file field_evaluate.cc.
void tensor_field_evaluate | ( | const field_basic< T, M > & | uh, |
const basis_on_pointset< T > & | bops, | ||
reference_element | hat_K, | ||
const std::vector< size_t > & | dis_idof_tab, | ||
Eigen::Matrix< tensor_basic< T >, Eigen::Dynamic, 1 > & | value | ||
) |
Definition at line 137 of file field_evaluate.cc.
void field_component_evaluate | ( | const field_basic< T, M > & | uh, |
const basis_on_pointset< T > & | bops, | ||
reference_element | hat_K, | ||
const std::vector< size_t > & | dis_idof_tab, | ||
size_t | k_comp, | ||
Eigen::Matrix< T, Eigen::Dynamic, 1 > & | value | ||
) |
Definition at line 181 of file field_evaluate.cc.
void field_evaluate_continued | ( | const field_basic< T, M > & | uh, |
const geo_basic< T, M > & | omega_K, | ||
const geo_element & | K, | ||
const Eigen::Matrix< Value, Eigen::Dynamic, Eigen::Dynamic > & | phij_xi, | ||
Eigen::Matrix< Value, Eigen::Dynamic, 1 > & | value | ||
) |
Definition at line 217 of file field_evaluate.cc.
void field_evaluate | ( | const field_basic< T, M > & | uh, |
const fem_on_pointset< T > & | fops, | ||
const geo_basic< T, M > & | omega_K, | ||
const geo_element & | K, | ||
Eigen::Matrix< Value, Eigen::Dynamic, 1 > & | value | ||
) |
Definition at line 251 of file field_evaluate.cc.
void general_field_evaluate | ( | const field_basic< T, M > & | uh, |
const basis_on_pointset< T > & | bops, | ||
reference_element | hat_K, | ||
const std::vector< size_t > & | dis_idof, | ||
const basis_on_pointset< T > & | piola_on_geo_basis, | ||
std::vector< size_t > & | dis_inod_geo, | ||
Eigen::Matrix< T, Eigen::Dynamic, 1 > & | value | ||
) |
Definition at line 84 of file field_evaluate.h.
void general_field_evaluate | ( | const field_basic< T, M > & | uh, |
const basis_on_pointset< T > & | bops, | ||
reference_element | hat_K, | ||
const std::vector< size_t > & | dis_idof, | ||
const basis_on_pointset< T > & | piola_on_geo_basis, | ||
std::vector< size_t > & | dis_inod_geo, | ||
Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > & | value | ||
) |
Definition at line 98 of file field_evaluate.h.
void general_field_evaluate | ( | const field_basic< T, M > & | uh, |
const basis_on_pointset< T > & | bops, | ||
reference_element | hat_K, | ||
const std::vector< size_t > & | dis_idof, | ||
const basis_on_pointset< T > & | piola_on_geo_basis, | ||
std::vector< size_t > & | dis_inod_geo, | ||
Eigen::Matrix< tensor_basic< T >, Eigen::Dynamic, 1 > & | value | ||
) |
Definition at line 112 of file field_evaluate.h.
void general_field_evaluate | ( | const field_basic< T, M > & | uh, |
const basis_on_pointset< T > & | bops, | ||
reference_element | hat_K, | ||
const std::vector< size_t > & | dis_idof, | ||
const basis_on_pointset< T > & | piola_on_geo_basis, | ||
std::vector< size_t > & | dis_inod_geo, | ||
Eigen::Matrix< tensor3_basic< T >, Eigen::Dynamic, 1 > & | value | ||
) |
Definition at line 126 of file field_evaluate.h.
void general_field_evaluate | ( | const field_basic< T, M > & | uh, |
const basis_on_pointset< T > & | bops, | ||
reference_element | hat_K, | ||
const std::vector< size_t > & | dis_idof, | ||
const basis_on_pointset< T > & | piola_on_geo_basis, | ||
std::vector< size_t > & | dis_inod_geo, | ||
Eigen::Matrix< tensor4_basic< T >, Eigen::Dynamic, 1 > & | value | ||
) |
Definition at line 143 of file field_evaluate.h.
_RHEOLEF_field_expr_v2_op_assign | ( | + | , |
details::plus_assign | |||
) |
_RHEOLEF_field_expr_v2_op_assign_constant | ( | + | , |
details::plus_assign | |||
) |
details::minus_assign _RHEOLEF_field_expr_v2_op_assign_constant details::multiplies_assign _RHEOLEF_field_expr_v2_op_assign_constant | ( | / | , |
details::divides_assign | |||
) |
rheolef::std enable_if ::type dual const Expr1 expr1, const Expr2 expr2 dual | ( | const Expr1 & | expr1, |
const Expr2 & | expr2 | ||
) |
Definition at line 200 of file field_expr.h.
std::enable_if< details::is_field_expr_affine_homogeneous< Expr1 >::value &&details::is_field_expr_v2_constant< Expr2 >::value, typenameExpr1::float_type >::type dual | ( | const Expr1 & | expr1, |
const Expr2 & | expr2 | ||
) |
Definition at line 247 of file field_expr.h.
std::enable_if< details::has_field_rdof_interface< Expr >::value &&!details::is_field< Expr >::value, form_basic< typenameExpr::value_type, typenameExpr::memory_type > >::type diag | ( | const Expr & | expr | ) |
Definition at line 267 of file field_expr.h.
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_quadrature_on_sides< Expr > >::type on_local_sides | ( | const Expr & | expr | ) |
on_local_sides(expr): see the expression
page for the full documentation
Definition at line 323 of file field_expr_quadrature.h.
_RHEOLEF_field_expr_quadrature_binary | ( | operator+ | , |
details::plus | |||
) |
_RHEOLEF_make_field_expr_v2_nonlinear_unary_operator | ( | operator+ | , |
details::unary_plus | |||
) |
_RHEOLEF_make_field_expr_v2_nonlinear_unary_function | ( | cos | ) |
field_expr_v2_nonlinear_node_binary | ( | const BinaryFunction & | f, |
const Expr1 & | expr1, | ||
const Expr2 & | expr2 | ||
) |
bool have_homogeneous_space | ( | space_basic< scalar_type, memory_type > & | Vh | ) | const |
Definition at line 586 of file field_expr_recursive.h.
const_iterator begin_dof | ( | ) | const |
Definition at line 611 of file field_expr_recursive.h.
space_constant::valued_type valued_tag | ( | ) | const |
Definition at line 621 of file field_expr_recursive.h.
void initialize | ( | const piola_on_pointset< float_type > & | pops, |
const integrate_option & | iopt | ||
) |
Definition at line 627 of file field_expr_recursive.h.
void initialize | ( | const space_basic< float_type, memory_type > & | Xh, |
const piola_on_pointset< float_type > & | pops, | ||
const integrate_option & | iopt | ||
) |
Definition at line 634 of file field_expr_recursive.h.
void evaluate_internal2 | ( | const geo_basic< float_type, M > & | omega_K, |
const geo_element & | K, | ||
Eigen::Matrix< Result, Eigen::Dynamic, 1 > & | value | ||
) | const |
Definition at line 646 of file field_expr_recursive.h.
void evaluate_internal2 | ( | const geo_basic< float_type, M > & | omega_K, |
const geo_element & | K, | ||
const side_information_type & | sid, | ||
Eigen::Matrix< Result, Eigen::Dynamic, 1 > & | value | ||
) | const |
Definition at line 660 of file field_expr_recursive.h.
void evaluate_call | ( | const geo_basic< float_type, M > & | omega_K, |
const geo_element & | K, | ||
Eigen::Matrix< Result, Eigen::Dynamic, 1 > & | value | ||
) | const |
Definition at line 726 of file field_expr_recursive.h.
void evaluate_call | ( | const geo_basic< float_type, M > & | omega_K, |
const geo_element & | K, | ||
const side_information_type & | sid, | ||
Eigen::Matrix< Result, Eigen::Dynamic, 1 > & | value | ||
) | const |
Definition at line 737 of file field_expr_recursive.h.
void evaluate | ( | const geo_basic< float_type, M > & | omega_K, |
const geo_element & | K, | ||
Eigen::Matrix< Result, Eigen::Dynamic, 1 > & | value | ||
) | const |
Definition at line 915 of file field_expr_recursive.h.
void evaluate_on_side | ( | const geo_basic< float_type, M > & | omega_K, |
const geo_element & | K, | ||
const side_information_type & | sid, | ||
Eigen::Matrix< Result, Eigen::Dynamic, 1 > & | value | ||
) | const |
Definition at line 936 of file field_expr_recursive.h.
bool valued_check | ( | ) | const |
Definition at line 957 of file field_expr_recursive.h.
|
protected |
|
protected |
|
protected |
|
protected |
Definition at line 1421 of file field_expr_recursive.h.
|
protected |
Definition at line 1492 of file field_expr_recursive.h.
details::field_expr_v2_nonlinear_terminal_function< details::normal_pseudo_function< T > > normal_basic | ( | ) |
Definition at line 423 of file field_expr_terminal.h.
details::field_expr_v2_nonlinear_terminal_function< details::normal_pseudo_function< Float > > normal | ( | ) |
normal: see the expression
page for the full documentation
Definition at line 432 of file field_expr_terminal.h.
details::field_expr_v2_nonlinear_terminal_function< details::h_local_pseudo_function< T > > h_local_basic | ( | ) |
Definition at line 511 of file field_expr_terminal.h.
details::field_expr_v2_nonlinear_terminal_function< details::h_local_pseudo_function< Float > > h_local | ( | ) |
h_local: see the expression
page for the full documentation
Definition at line 520 of file field_expr_terminal.h.
details::field_expr_v2_nonlinear_terminal_function< details::penalty_pseudo_function< T > > penalty_basic | ( | ) |
Definition at line 610 of file field_expr_terminal.h.
details::field_expr_v2_nonlinear_terminal_function< details::penalty_pseudo_function< Float > > penalty | ( | ) |
penalty(): see the expression
page for the full documentation
Definition at line 619 of file field_expr_terminal.h.
std::enable_if< details::has_field_rdof_interface< Expr >::value, details::field_expr_v2_nonlinear_terminal_field< typenameExpr::scalar_type, typenameExpr::memory_type, details::differentiate_option::gradient > >::type grad | ( | const Expr & | expr | ) |
grad(uh): see the expression
page for the full documentation
Definition at line 930 of file field_expr_terminal.h.
std::enable_if< details::has_field_rdof_interface< Expr >::value, details::field_expr_v2_nonlinear_terminal_field< typenameExpr::scalar_type, typenameExpr::memory_type, details::differentiate_option::gradient > >::type grad_s | ( | const Expr & | expr | ) |
grad_s(uh): see the expression
page for the full documentation
Definition at line 948 of file field_expr_terminal.h.
std::enable_if< details::has_field_rdof_interface< Expr >::value, details::field_expr_v2_nonlinear_terminal_field< typenameExpr::scalar_type, typenameExpr::memory_type, details::differentiate_option::gradient > >::type grad_h | ( | const Expr & | expr | ) |
grad_h(uh): see the expression
page for the full documentation
Definition at line 968 of file field_expr_terminal.h.
std::enable_if< details::has_field_rdof_interface< Expr >::value, details::field_expr_v2_nonlinear_terminal_field< typenameExpr::scalar_type, typenameExpr::memory_type, details::differentiate_option::gradient > >::type D | ( | const Expr & | expr | ) |
D(uh): see the expression
page for the full documentation.
Definition at line 988 of file field_expr_terminal.h.
std::enable_if< details::has_field_rdof_interface< Expr >::value, details::field_expr_v2_nonlinear_terminal_field< typenameExpr::scalar_type, typenameExpr::memory_type, details::differentiate_option::gradient > >::type Ds | ( | const Expr & | expr | ) |
Ds(uh): see the expression
page for the full documentation.
Definition at line 1008 of file field_expr_terminal.h.
std::enable_if< details::has_field_rdof_interface< Expr >::value, details::field_expr_v2_nonlinear_terminal_field< typenameExpr::scalar_type, typenameExpr::memory_type, details::differentiate_option::gradient > >::type Dh | ( | const Expr & | expr | ) |
Dh(uh): see the expression
page for the full documentation.
Definition at line 1029 of file field_expr_terminal.h.
std::enable_if< details::has_field_rdof_interface< Expr >::value, details::field_expr_v2_nonlinear_terminal_field< typenameExpr::scalar_type, typenameExpr::memory_type, details::differentiate_option::divergence > >::type div | ( | const Expr & | expr | ) |
div(uh): see the expression
page for the full documentation
Definition at line 1050 of file field_expr_terminal.h.
std::enable_if< details::has_field_rdof_interface< Expr >::value, details::field_expr_v2_nonlinear_terminal_field< typenameExpr::scalar_type, typenameExpr::memory_type, details::differentiate_option::divergence > >::type div_s | ( | const Expr & | expr | ) |
div_s(uh): see the expression
page for the full documentation
Definition at line 1068 of file field_expr_terminal.h.
std::enable_if< details::has_field_rdof_interface< Expr >::value, details::field_expr_v2_nonlinear_terminal_field< typenameExpr::scalar_type, typenameExpr::memory_type, details::differentiate_option::divergence > >::type div_h | ( | const Expr & | expr | ) |
div_h(uh): see the expression
page for the full documentation
Definition at line 1088 of file field_expr_terminal.h.
std::enable_if< details::has_field_rdof_interface< Expr >::value, details::field_expr_v2_nonlinear_terminal_field< typenameExpr::scalar_type, typenameExpr::memory_type, details::differentiate_option::curl > >::type curl | ( | const Expr & | expr | ) |
curl(uh): see the expression
page for the full documentation
Definition at line 1108 of file field_expr_terminal.h.
_RHEOLEF_make_field_expr_v2_nonlinear_terminal_field_dg | ( | jump | , |
1 | , | ||
- | 1 | ||
) |
_RHEOLEF_make_field_expr_v2_nonlinear_terminal_field_dg | ( | inner | , |
1 | , | ||
0 | |||
) |
details::field_expr_v2_nonlinear_terminal_field_o_characteristic< T, M > compose | ( | const field_basic< T, M > & | uh, |
const characteristic_basic< T, M > & | X | ||
) |
Definition at line 1419 of file field_expr_terminal.h.
_RHEOLEF_make_field_expr_v2_variational_unary_operator | ( | operator+ | , |
details::unary_plus | |||
) |
details::negate _RHEOLEF_make_field_expr_v2_variational_unary_operator | ( | tr | , |
details::tr_ | |||
) |
_RHEOLEF_make_field_expr_v2_variational_binary_operator_plus_minus | ( | operator+ | , |
details::plus | |||
) |
_RHEOLEF_make_field_expr_v2_variational_binary_operator_multiplies_divides | ( | operator* | , |
details::multiplies | |||
) |
details::divides _RHEOLEF_make_field_expr_v2_variational_binary_operator_multiplies_divides | ( | dot | , |
details::dot_ | |||
) |
details::divides details::ddot_ _RHEOLEF_make_field_expr_v2_variational_binary_operator_multiplies_divides | ( | dddot | , |
details::dddot_ | |||
) |
Definition at line 1447 of file field_expr_variational.h.
_RHEOLEF_make_field_expr_v2_variational_binary_operator_multiplies_divides_constant | ( | operator* | , |
details::multiplies | |||
) |
details::divides _RHEOLEF_make_field_expr_v2_variational_binary_operator_multiplies_divides_constant | ( | dot | , |
details::dot_ | |||
) |
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_grad< Expr > >::type grad | ( | const Expr & | expr | ) |
Definition at line 182 of file field_expr_variational_terminal.h.
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_grad< Expr > >::type grad_s | ( | const Expr & | expr | ) |
Definition at line 194 of file field_expr_variational_terminal.h.
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_grad< Expr > >::type grad_h | ( | const Expr & | expr | ) |
Definition at line 208 of file field_expr_variational_terminal.h.
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_grad< Expr > >::type D | ( | const Expr & | expr | ) |
Definition at line 222 of file field_expr_variational_terminal.h.
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_grad< Expr > >::type Ds | ( | const Expr & | expr | ) |
Definition at line 236 of file field_expr_variational_terminal.h.
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_grad< Expr > >::type Dh | ( | const Expr & | expr | ) |
Definition at line 251 of file field_expr_variational_terminal.h.
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_div< Expr > >::type div | ( | const Expr & | expr | ) |
Definition at line 370 of file field_expr_variational_terminal.h.
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_div< Expr > >::type div_s | ( | const Expr & | expr | ) |
Definition at line 382 of file field_expr_variational_terminal.h.
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_div< Expr > >::type div_h | ( | const Expr & | expr | ) |
Definition at line 396 of file field_expr_variational_terminal.h.
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_curl< Expr > >::type curl | ( | const Expr & | expr | ) |
Definition at line 525 of file field_expr_variational_terminal.h.
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_expr_v2_variational_curl< Expr > >::type bcurl | ( | const Expr & | expr | ) |
Definition at line 537 of file field_expr_variational_terminal.h.
_RHEOLEF_make_field_expr_v2_variational_dg | ( | jump | , |
1 | , | ||
- | 1 | ||
) |
_RHEOLEF_make_field_expr_v2_variational_dg | ( | inner | , |
1 | , | ||
0 | |||
) |
field_function_s< std::function< F >, typename F::result_type > field_function | ( | F | f | ) |
Definition at line 102 of file field_functor.h.
details::field_lazy_mult_form< FormExpr, FieldExpr > operator* | ( | const FormExpr & | a, |
const FieldExpr & | u | ||
) |
a*u: see the form
page for the full documentation
Definition at line 193 of file field_lazy_form_mult.h.
details::field_lazy_mult_form< FormExpr,details::field_lazy_terminal_field< typename FormExpr::scalar_type,typename FormExpr::memory_type > > operator* | ( | const FormExpr & | a, |
const field_basic< typename FormExpr::scalar_type, typename FormExpr::memory_type > & | u | ||
) |
a*u: see the form
page for the full documentation
Definition at line 209 of file field_lazy_form_mult.h.
_RHEOLEF_field_lazy_unop | ( | + | , |
details::unary_plus | |||
) |
_RHEOLEF_field_lazy_add | ( | + | , |
plus | |||
) |
std::enable_if< details::is_field_expr_quadrature_arg< Expr >::value, details::field_lazy_terminal_integrate< Expr > >::type lazy_integrate | ( | const typename Expr::geo_type & | domain, |
const Expr & | expr, | ||
const integrate_option & | iopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 588 of file field_lazy_terminal.h.
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_lazy_terminal_integrate< details::field_expr_quadrature_on_element< Expr > > >::type lazy_integrate | ( | const geo_basic< typename Expr::scalar_type, typename Expr::memory_type > & | domain, |
const Expr & | expr, | ||
const integrate_option & | iopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 603 of file field_lazy_terminal.h.
std::enable_if< details::is_field_expr_quadrature_arg< Expr >::value, details::field_lazy_terminal_integrate< Expr > >::type lazy_integrate | ( | const Expr & | expr, |
const integrate_option & | iopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 620 of file field_lazy_terminal.h.
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_lazy_terminal_integrate< details::field_expr_quadrature_on_element< Expr > > >::type lazy_integrate | ( | const Expr & | expr, |
const integrate_option & | iopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 634 of file field_lazy_terminal.h.
std::enable_if< details::is_field_expr_quadrature_arg< Expr >::value, details::field_lazy_terminal_integrate< Expr > >::type lazy_integrate | ( | const std::string & | domname, |
const Expr & | expr, | ||
const integrate_option & | iopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 650 of file field_lazy_terminal.h.
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_lazy_terminal_integrate< details::field_expr_quadrature_on_element< Expr > > >::type lazy_integrate | ( | const std::string & | domname, |
const Expr & | expr, | ||
const integrate_option & | iopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 665 of file field_lazy_terminal.h.
std::enable_if< details::is_field_expr_quadrature_arg< Expr >::value, details::field_lazy_terminal_integrate_band< Expr > >::type lazy_integrate | ( | const band_basic< typename float_traits< typename Expr::scalar_type >::type, typename Expr::memory_type > & | gh, |
const Expr & | expr, | ||
const integrate_option & | iopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 820 of file field_lazy_terminal.h.
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, details::field_lazy_terminal_integrate_band< details::field_expr_quadrature_on_element< Expr > > >::type lazy_integrate | ( | const band_basic< typename float_traits< typename Expr::scalar_type >::type, typename Expr::memory_type > & | gh, |
const Expr & | expr, | ||
const integrate_option & | iopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 835 of file field_lazy_terminal.h.
std::enable_if< details::is_field_expr_v2_nonlinear_arg< Expr >::value &&!details::has_field_rdof_interface< Expr >::value &&!details::is_field_function< Expr >::value, details::field_lazy_terminal_interpolate< typenamedetails::field_expr_v2_nonlinear_terminal_wrapper_traits< Expr >::type > >::type lazy_interpolate | ( | const space_basic< typename float_traits< typename Expr::scalar_type >::type, typename Expr::memory_type > & | Xh, |
const Expr & | expr | ||
) |
see the interpolate
page for the full documentation
Definition at line 1105 of file field_lazy_terminal.h.
std::enable_if< details::is_field_function< Expr >::value, details::field_lazy_terminal_interpolate< details::field_expr_v2_nonlinear_terminal_function< Expr > > >::type lazy_interpolate | ( | const space_basic< typename float_traits< typename details::field_expr_v2_nonlinear_terminal_function< Expr >::scalar_type >::type, typename details::field_expr_v2_nonlinear_terminal_function< Expr >::memory_type > & | Xh, |
const Expr & | expr | ||
) |
see the interpolate
page for the full documentation
Definition at line 1124 of file field_lazy_terminal.h.
_RHEOLEF_make_field_rdof_unary | ( | operator+ | , |
details::unary_plus | |||
) |
_RHEOLEF_make_field_rdof_unary_scalar_first | ( | operator+ | , |
details::plus | |||
) |
details::minus _RHEOLEF_make_field_rdof_unary_scalar_first | ( | operator* | , |
details::multiplies | |||
) |
details::minus details::plus _RHEOLEF_make_field_rdof_unary_scalar_second | ( | operator- | , |
details::minus | |||
) |
template odiststream & field_put_bamg_bb< Float > | ( | odiststream & | , |
const field_basic< Float, sequential > & | |||
) |
odiststream & geo_put_gmsh | ( | odiststream & | ods, |
const geo_basic< T, sequential > & | omega | ||
) |
Definition at line 305 of file geo_seq_put_gmsh.cc.
odiststream & field_put_gmsh | ( | odiststream & | ods, |
const field_basic< T, sequential > & | uh | ||
) |
Definition at line 216 of file field_seq_put_gmsh.cc.
template odiststream & field_put_gmsh< Float > | ( | odiststream & | , |
const field_basic< Float, sequential > & | , | ||
std::string | |||
) |
template odiststream & field_put_gmsh< Float > | ( | odiststream & | , |
const field_basic< Float, sequential > & | |||
) |
odiststream & field_put_gmsh_pos | ( | odiststream & | ods, |
const field_basic< T, sequential > & | uh, | ||
std::string | name | ||
) |
Definition at line 41 of file field_seq_put_gmsh_pos.cc.
template odiststream & field_put_gmsh_pos< Float > | ( | odiststream & | , |
const field_basic< Float, sequential > & | , | ||
std::string | |||
) |
template odiststream & field_put_gmsh_pos< Float > | ( | odiststream & | , |
const field_basic< Float, sequential > & | |||
) |
odiststream & put_vtk_scalar_values | ( | odiststream & | ods, |
const field_basic< T, sequential > & | uh, | ||
std::string | name, | ||
bool | put_header | ||
) |
Definition at line 49 of file field_seq_put_vtk.cc.
odiststream & put_vtk_vector_values | ( | odiststream & | ods, |
const field_basic< T, sequential > & | uh, | ||
std::string | name, | ||
bool | put_header | ||
) |
Definition at line 69 of file field_seq_put_vtk.cc.
odiststream & put_vtk_tensor_values | ( | odiststream & | ods, |
const field_basic< T, sequential > & | tau_h, | ||
std::string | name, | ||
bool | put_header | ||
) |
Definition at line 99 of file field_seq_put_vtk.cc.
odiststream & field_put_vtk | ( | odiststream & | ods, |
const field_basic< T, sequential > & | uh | ||
) |
Definition at line 218 of file field_seq_put_vtk.cc.
template odiststream & field_put_vtk< Float > | ( | odiststream & | , |
const field_basic< Float, sequential > & | , | ||
std::string | , | ||
bool | |||
) |
template odiststream & field_put_vtk< Float > | ( | odiststream & | , |
const field_basic< Float, sequential > & | |||
) |
template odiststream & visu_gmsh< Float > | ( | odiststream & | , |
const field_basic< Float, sequential > & | |||
) |
odiststream & visu_gnuplot | ( | odiststream & | ops, |
const geo_basic< T, sequential > & | omega | ||
) |
Definition at line 280 of file geo_seq_visu_gnuplot.cc.
void put | ( | std::ostream & | gdat, |
const geo_basic< T, sequential > & | omega, | ||
const geo_element & | K, | ||
const field_basic< T, sequential > & | uh, | ||
const fem_on_pointset< T > & | fops, | ||
size_t | my_order, | ||
bound_type< T > & | bbox | ||
) |
Definition at line 139 of file field_seq_visu_gnuplot.cc.
odiststream & visu_gnuplot_scalar | ( | odiststream & | ods, |
const field_basic< T, sequential > & | uh | ||
) |
Definition at line 160 of file field_seq_visu_gnuplot.cc.
odiststream & visu_gnuplot_vector | ( | odiststream & | ods, |
const field_basic< T, sequential > & | uh | ||
) |
Definition at line 419 of file field_seq_visu_gnuplot.cc.
field_basic< T, sequential > paraview_plane_cut | ( | const field_basic< T, sequential > & | uh, |
const point_basic< T > & | origin, | ||
const point_basic< T > & | normal | ||
) |
Definition at line 179 of file field_seq_visu_vtk_paraview.cc.
geo_basic< T, sequential > paraview_extract_isosurface | ( | const field_basic< T, sequential > & | uh | ) |
Definition at line 331 of file field_seq_visu_vtk_paraview.cc.
std::valarray< field_basic< T > > operator* | ( | const T & | a, |
const std::valarray< field_basic< T > > & | xh | ||
) |
Definition at line 35 of file field_valarray.h.
form_basic< T, M > trans | ( | const form_basic< T, M > & | a | ) |
form_basic< T, M > diag | ( | const field_basic< T, M > & | dh | ) |
field_basic< T, M > diag | ( | const form_basic< T, M > & | a | ) |
_RHEOLEF_instanciate | ( | Float | , |
sequential | |||
) |
form_basic< T, M > operator* | ( | const T & | lambda, |
const form_basic< T, M > & | a | ||
) |
form_basic< T, M > operator- | ( | const form_basic< T, M > & | a | ) |
details::vector_field_trans< T, M > trans | ( | const std::vector< field_basic< T, M > > & | vv | ) |
Definition at line 48 of file form_concat.h.
std::enable_if< details::is_form_expr_v2_variational_arg< Expr >::value, details::form_expr_quadrature_on_sides< Expr > >::type on_local_sides | ( | const Expr & | expr | ) |
Definition at line 387 of file form_expr_quadrature.h.
_RHEOLEF_make_form_expr_quadrature_unary | ( | operator+ | , |
details::unary_plus | |||
) |
_RHEOLEF_form_expr_quadrature_binary | ( | operator+ | , |
details::plus | |||
) |
_RHEOLEF_make_form_expr_quadrature_binary_operator_multiplies_divides_constant | ( | operator* | , |
details::multiplies | |||
) |
_RHEOLEF_make_form_expr_v2_variational_unary | ( | operator+ | , |
details::unary_plus | |||
) |
_RHEOLEF_form_expr_v2_variational_binary | ( | operator+ | , |
details::plus | |||
) |
_RHEOLEF_form_expr_v2_variational_binary_field | ( | operator* | , |
details::multiplies | |||
) |
details::dot_ _RHEOLEF_form_expr_v2_variational_binary_field | ( | ddot | , |
details::ddot_ | |||
) |
_RHEOLEF_make_form_expr_v2_variational_binary_operator_multiplies_divides | ( | operator* | , |
details::multiplies | |||
) |
details::divides _RHEOLEF_make_form_expr_v2_variational_binary_operator_multiplies_divides | ( | dot | , |
details::dot_ | |||
) |
details::divides details::ddot_ _RHEOLEF_make_form_expr_v2_variational_binary_operator_multiplies_divides | ( | dddot | , |
details::dddot_ | |||
) |
Definition at line 844 of file form_expr_variational.h.
_RHEOLEF_make_form_expr_v2_variational_binary_operator_multiplies_divides_constant | ( | operator* | , |
details::multiplies | |||
) |
details::divides _RHEOLEF_make_form_expr_v2_variational_binary_operator_multiplies_divides_constant | ( | dot | , |
details::dot_ | |||
) |
_RHEOLEF_form_mult_field_var | ( | details::field_wdof_sliced | ) |
Definition at line 57 of file form_field_expr.h.
_RHEOLEF_form_lazy_unop | ( | + | , |
details::unary_plus | |||
) |
details::form_lazy_invert< Expr > inv | ( | const Expr & | a | ) |
inv: see the form
page for the full documentation
Definition at line 425 of file form_lazy_expr.h.
details::form_lazy_transpose< Expr > trans | ( | const Expr & | a | ) |
trans: see the form
page for the full documentation
Definition at line 495 of file form_lazy_expr.h.
_RHEOLEF_form_lazy_add | ( | + | , |
plus | |||
) |
details::form_lazy_multiply< Expr1, Expr2 > operator* | ( | const Expr1 & | a, |
const Expr2 & | b | ||
) |
a*b: see the form
page for the full documentation
Definition at line 778 of file form_lazy_expr.h.
std::enable_if< details::is_form_expr_quadrature_arg< Expr >::value, details::form_lazy_terminal_integrate_band< Expr > >::type lazy_integrate | ( | const band_basic< typename float_traits< typename Expr::scalar_type >::type, typename Expr::memory_type > & | gh, |
const Expr & | expr, | ||
const integrate_option & | iopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 373 of file form_lazy_terminal.h.
std::enable_if< details::is_form_expr_v2_variational_arg< Expr >::value, details::form_lazy_terminal_integrate_band< details::form_expr_quadrature_on_element< Expr > > >::type lazy_integrate | ( | const band_basic< typename float_traits< typename Expr::scalar_type >::type, typename Expr::memory_type > & | gh, |
const Expr & | expr, | ||
const integrate_option & | iopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 388 of file form_lazy_terminal.h.
std::function< R(Args...)> functor | ( | R(*)(Args...) | f | ) |
_RHEOLEF_save | ( | sequential | ) |
void geo_build_by_subdividing | ( | geo_rep< T, M > & | new_omega, |
const geo_basic< T, M > & | old_omega, | ||
typename geo_rep< T, M >::size_type | k | ||
) |
Definition at line 129 of file geo_subdivide.cc.
idiststream & operator>> | ( | idiststream & | ips, |
geo_basic< T, M > & | omega | ||
) |
odiststream & operator<< | ( | odiststream & | ops, |
const geo_basic< T, M > & | omega | ||
) |
_RHEOLEF_zero_dimension | ( | sequential | ) |
_RHEOLEF_geo_domain_cstor | ( | sequential | ) |
idiststream & operator>> | ( | idiststream & | ips, |
geo_header & | h | ||
) |
Definition at line 36 of file geo_header.cc.
odiststream & operator<< | ( | odiststream & | ops, |
const geo_header & | h | ||
) |
Definition at line 83 of file geo_header.cc.
void compute_bbox | ( | const geo_base_rep< T, M > & | omega, |
const geo_element & | K, | ||
point_basic< T > & | xmin, | ||
point_basic< T > & | xmax | ||
) |
Definition at line 50 of file geo_locate.cc.
void geo_dual | ( | my_idxtype * | elmdist, |
my_idxtype * | eptr, | ||
vector< my_idxtype > & | eind, | ||
int * | ncommonnodes, | ||
vector< my_idxtype > & | xadj, | ||
vector< my_idxtype > & | adjncy, | ||
const mpi::communicator & | comm | ||
) |
Definition at line 35 of file geo_mpi_dual.cc.
|
extern |
Definition at line 38 of file geo_mpi_partition.cc.
void geo_element_renumbering_part1_new | ( | const std::array< hack_array< geo_element_hack >, reference_element::max_variant > & | ios_geo_element, |
const geo_size & | ios_gs, | ||
size_t | S_dim, | ||
std::array< std::vector< size_t >, 4 > & | massive_partition_by_dimension, | ||
std::array< disarray< size_t >, reference_element::max_variant > & | partition_by_variant | ||
) |
Definition at line 120 of file geo_mpi_get.cc.
void geo_element_renumbering_part2 | ( | const std::array< hack_array< geo_element_hack >, reference_element::max_variant > & | ios_geo_element, |
const geo_size & | ios_gs, | ||
size_t | dis_nv, | ||
size_t | side_dim, | ||
std::array< hack_array< geo_element_hack >, reference_element::max_variant > & | geo_element, | ||
geo_size & | gs, | ||
std::array< disarray< size_t >, reference_element::max_variant > & | igev2ios_dis_igev, | ||
std::array< disarray< size_t >, reference_element::max_variant > & | ios_igev2dis_igev, | ||
std::array< disarray< size_t >, 4 > & | ios_ige2dis_ige, | ||
std::array< disarray< size_t >, reference_element::max_variant > & | partition_by_variant | ||
) |
Definition at line 238 of file geo_mpi_get.cc.
void geo_element_renumbering_propagate | ( | const std::vector< geo_element::size_type > & | new_global_node_num, |
size_t | dis_nnod, | ||
hack_array< geo_element_hack > & | gev | ||
) |
Definition at line 317 of file geo_mpi_get.cc.
void ParMETIS_V3_PartKway | ( | const int * const | , |
int * const | , | ||
int * const | , | ||
int * const | , | ||
int * const | , | ||
const int * const | , | ||
const int * const | , | ||
const int * const | , | ||
const int * const | , | ||
const float * const | , | ||
const float * const | , | ||
const int * const | , | ||
int * const | , | ||
int * const | , | ||
MPI_Comm * const | |||
) |
void geo_partition_scotch | ( | my_idxtype * | elmdist, |
my_idxtype * | eptr, | ||
vector< my_idxtype > & | eind, | ||
my_idxtype * | elmwgt, | ||
int * | ncon, | ||
int * | ncommonnodes, | ||
int * | nparts, | ||
float * | tpwgts, | ||
float * | ubvec, | ||
int * | edgecut, | ||
my_idxtype * | part, | ||
const mpi::communicator & | comm | ||
) |
Definition at line 48 of file geo_mpi_partition_scotch.cc.
int idxamin | ( | int | n, |
const std::vector< my_idxtype > & | x | ||
) |
Definition at line 150 of file geo_partition_scotch.h.
int idxamax | ( | int | n, |
const std::vector< my_idxtype > & | x | ||
) |
Definition at line 160 of file geo_partition_scotch.h.
idiststream & geo_get_bamg | ( | idiststream & | ips, |
geo_basic< T, sequential > & | omega | ||
) |
Definition at line 189 of file geo_seq_get_bamg.cc.
template idiststream & geo_get_bamg< Float > | ( | idiststream & | , |
geo_basic< Float, sequential > & | |||
) |
template idiststream & geo_get_vtk< Float > | ( | idiststream & | , |
geo_basic< Float, sequential > & | |||
) |
odiststream & visu_vtk_paraview | ( | odiststream & | ops, |
const geo_basic< T, sequential > & | omega | ||
) |
Definition at line 61 of file geo_seq_visu_vtk_paraview.cc.
odiststream & geo_put_bamg | ( | odiststream & | ops, |
const geo_basic< T, sequential > & | omega | ||
) |
Definition at line 195 of file geo_seq_put_bamg.cc.
odiststream & geo_put_bamg | ( | odiststream & | ops, |
const geo_basic< T, sequential > & | omega, | ||
const basis_basic< T > & | my_numb, | ||
const disarray< point_basic< T >, sequential > & | my_node | ||
) |
Definition at line 158 of file geo_seq_put_bamg.cc.
template odiststream & geo_put_bamg< Float > | ( | odiststream & | , |
const geo_basic< Float, sequential > & | , | ||
const basis_basic< Float > & | , | ||
const disarray< point_basic< Float >, sequential > & | |||
) |
template odiststream & geo_put_bamg< Float > | ( | odiststream & | , |
const geo_basic< Float, sequential > & | |||
) |
odiststream & geo_put_gmsh | ( | odiststream & | ops, |
const geo_basic< T, sequential > & | omega, | ||
const basis_basic< T > & | my_numb, | ||
const disarray< point_basic< T >, sequential > & | my_node | ||
) |
Definition at line 265 of file geo_seq_put_gmsh.cc.
template odiststream & geo_put_gmsh< Float > | ( | odiststream & | , |
const geo_basic< Float, sequential > & | , | ||
const basis_basic< Float > & | , | ||
const disarray< point_basic< Float >, sequential > & | |||
) |
template odiststream & geo_put_gmsh< Float > | ( | odiststream & | , |
const geo_basic< Float, sequential > & | |||
) |
odiststream & geo_put_vtk_old | ( | odiststream & | ops, |
const geo_basic< T, sequential > & | omega, | ||
const basis_basic< T > & | my_numb, | ||
const disarray< point_basic< T >, sequential > & | my_node, | ||
bool | append_data | ||
) |
Definition at line 275 of file geo_seq_put_vtk.cc.
odiststream & geo_put_vtk_high | ( | odiststream & | ops, |
const geo_basic< T, sequential > & | omega, | ||
const basis_basic< T > & | my_numb, | ||
const disarray< point_basic< T >, sequential > & | my_node, | ||
bool | append_data = true , |
||
size_t | subgeo_dim = std::numeric_limits<size_t>::max() |
||
) |
Definition at line 421 of file geo_seq_put_vtk.cc.
odiststream & geo_put_vtk | ( | odiststream & | ops, |
const geo_basic< T, sequential > & | omega, | ||
const basis_basic< T > & | my_numb, | ||
const disarray< point_basic< T >, sequential > & | my_node, | ||
bool | append_data, | ||
size_t | subgeo_dim | ||
) |
Definition at line 557 of file geo_seq_put_vtk.cc.
template odiststream & visu_gnuplot | ( | odiststream & | ops, |
const geo_basic< Float, sequential > & | omega | ||
) |
template odiststream & visu_vtk_paraview< Float > | ( | odiststream & | , |
const geo_basic< Float, sequential > & | |||
) |
_RHEOLEF_geo_build_by_subdividing | ( | sequential | ) |
idiststream & operator>> | ( | idiststream & | ips, |
hack_array< T, sequential, A > & | x | ||
) |
Definition at line 646 of file hack_array.h.
odiststream & operator<< | ( | odiststream & | ops, |
const hack_array< T, sequential, A > & | x | ||
) |
Definition at line 652 of file hack_array.h.
idiststream & operator>> | ( | idiststream & | ips, |
hack_array< T, distributed, A > & | x | ||
) |
Definition at line 661 of file hack_array.h.
odiststream & operator<< | ( | odiststream & | ops, |
const hack_array< T, distributed, A > & | x | ||
) |
Definition at line 667 of file hack_array.h.
std::enable_if< details::is_field_expr_v2_nonlinear_arg< Expr >::value &&!is_undeterminated< Result >::value, Result >::type integrate | ( | const geo_basic< T, M > & | omega, |
const Expr & | expr, | ||
const integrate_option & | iopt, | ||
Result | dummy = Result() |
||
) |
see the integrate
page for the full documentation
Definition at line 211 of file integrate.h.
T integrate | ( | const geo_basic< T, M > & | omega, |
integrate_option && | iopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 228 of file integrate.h.
std::enable_if< details::is_field_expr_v2_nonlinear_arg< Expr >::value &&is_undeterminated< typenamedetails::field_expr_v2_nonlinear_terminal_wrapper_traits< Expr >::type::value_type >::value, typenamescalar_traits< typenamedetails::field_expr_v2_nonlinear_terminal_wrapper_traits< Expr >::type::value_type >::type >::type integrate | ( | const geo_basic< T, M > & | omega, |
const Expr & | expr, | ||
const integrate_option & | iopt | ||
) |
see the integrate
page for the full documentation
Definition at line 248 of file integrate.h.
std::enable_if< details::is_field_expr_quadrature_arg< Expr >::value, field_basic< T, M > >::type integrate | ( | const geo_basic< T, M > & | domain, |
const Expr & | expr, | ||
const integrate_option & | iopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 279 of file integrate.h.
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, field_basic< T, M > >::type integrate | ( | const geo_basic< T, M > & | domain, |
const Expr & | expr, | ||
const integrate_option & | fopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 296 of file integrate.h.
std::enable_if< details::is_field_expr_quadrature_arg< Expr >::value, field_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type integrate | ( | const Expr & | expr, |
const integrate_option & | iopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 315 of file integrate.h.
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, field_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type integrate | ( | const Expr & | expr, |
const integrate_option & | fopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 333 of file integrate.h.
std::enable_if< details::is_field_expr_quadrature_arg< Expr >::value, field_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type integrate | ( | const std::string & | domname, |
const Expr & | expr, | ||
const integrate_option & | iopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 351 of file integrate.h.
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, field_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type integrate | ( | const std::string & | domname, |
const Expr & | expr, | ||
const integrate_option & | fopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 370 of file integrate.h.
std::enable_if< details::is_form_expr_quadrature_arg< Expr >::value, form_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type integrate | ( | const geo_basic< T, M > & | domain, |
const Expr & | expr, | ||
const integrate_option & | fopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 391 of file integrate.h.
std::enable_if< details::is_form_expr_v2_variational_arg< Expr >::value, form_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type integrate | ( | const geo_basic< T, M > & | domain, |
const Expr & | expr, | ||
const integrate_option & | fopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 408 of file integrate.h.
std::enable_if< details::is_form_expr_quadrature_arg< Expr >::value, form_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type integrate | ( | const Expr & | expr, |
const integrate_option & | fopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 427 of file integrate.h.
std::enable_if< details::is_form_expr_v2_variational_arg< Expr >::value, form_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type integrate | ( | const Expr & | expr, |
const integrate_option & | fopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 464 of file integrate.h.
std::enable_if< details::is_form_expr_quadrature_arg< Expr >::value, form_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type integrate | ( | const std::string & | domname, |
const Expr & | expr, | ||
const integrate_option & | fopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 482 of file integrate.h.
std::enable_if< details::is_form_expr_v2_variational_arg< Expr >::value, form_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type integrate | ( | const std::string & | domname, |
const Expr & | expr, | ||
const integrate_option & | fopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 501 of file integrate.h.
std::enable_if< details::is_field_expr_quadrature_arg< Expr >::value, field_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type integrate | ( | const band_basic< T, M > & | gh, |
const Expr & | expr, | ||
const integrate_option & | iopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 520 of file integrate.h.
std::enable_if< details::is_field_expr_v2_variational_arg< Expr >::value, field_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type integrate | ( | const band_basic< T, M > & | gh, |
const Expr & | expr, | ||
const integrate_option & | iopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 537 of file integrate.h.
std::enable_if< details::is_form_expr_quadrature_arg< Expr >::value, form_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type integrate | ( | const band_basic< T, M > & | gh, |
const Expr & | expr, | ||
const integrate_option & | fopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 554 of file integrate.h.
std::enable_if< details::is_form_expr_v2_variational_arg< Expr >::value, form_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type integrate | ( | const band_basic< T, M > & | gh, |
const Expr & | expr, | ||
const integrate_option & | fopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 571 of file integrate.h.
std::enable_if< details::is_form_expr_quadrature_arg< Expr >::value, details::form_lazy_terminal_integrate< Expr > >::type lazy_integrate | ( | const geo_basic< typename Expr::scalar_type, typename Expr::memory_type > & | domain, |
const Expr & | expr, | ||
const integrate_option & | iopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 696 of file integrate.h.
std::enable_if< details::is_form_expr_v2_variational_arg< Expr >::value, details::form_lazy_terminal_integrate< details::form_expr_quadrature_on_element< Expr > > >::type lazy_integrate | ( | const geo_basic< typename Expr::scalar_type, typename Expr::memory_type > & | domain, |
const Expr & | expr, | ||
const integrate_option & | iopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 711 of file integrate.h.
std::enable_if< details::is_form_expr_quadrature_arg< Expr >::value, details::form_lazy_terminal_integrate< Expr > >::type lazy_integrate | ( | const Expr & | expr, |
const integrate_option & | fopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 730 of file integrate.h.
std::enable_if< details::is_form_expr_v2_variational_arg< Expr >::value, details::form_lazy_terminal_integrate< details::form_expr_quadrature_on_element< Expr > > >::type lazy_integrate | ( | const Expr & | expr, |
const integrate_option & | fopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 770 of file integrate.h.
std::enable_if< details::is_form_expr_quadrature_arg< Expr >::value, details::form_lazy_terminal_integrate< Expr > >::type lazy_integrate | ( | const std::string & | domname, |
const Expr & | expr, | ||
const integrate_option & | fopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 788 of file integrate.h.
std::enable_if< details::is_form_expr_v2_variational_arg< Expr >::value, details::form_lazy_terminal_integrate< details::form_expr_quadrature_on_element< Expr > > >::type lazy_integrate | ( | const std::string & | domname, |
const Expr & | expr, | ||
const integrate_option & | fopt = integrate_option() |
||
) |
see the integrate
page for the full documentation
Definition at line 806 of file integrate.h.
field_basic< T, M > interpolate | ( | const space_basic< T, M > & | V2h, |
const field_basic< T, M > & | u1h | ||
) |
see the interpolate
page for the full documentation
Definition at line 233 of file interpolate.cc.
std::enable_if< std::conjunction< details::is_field_expr_v2_nonlinear_arg< Expr >, std::negation< std::disjunction< details::is_field< Expr >, details::has_field_rdof_interface< Expr >, details::is_field_function< Expr > > > >::value, field_basic< T, M > >::type interpolate | ( | const space_basic< T, M > & | Xh, |
const Expr & | expr | ||
) |
see the interpolate
page for the full documentation
Definition at line 292 of file interpolate.h.
std::enable_if< details::has_field_rdof_interface< Expr >::value &&!details::is_field< Expr >::value, field_basic< T, M > >::type interpolate | ( | const space_basic< T, M > & | Xh, |
const Expr & | expr | ||
) |
see the interpolate
page for the full documentation
Definition at line 308 of file interpolate.h.
std::enable_if< details::is_field_function< Expr >::value, field_basic< T, M > >::type interpolate | ( | const space_basic< T, M > & | Xh, |
const Expr & | expr | ||
) |
see the interpolate
page for the full documentation
Definition at line 325 of file interpolate.h.
o_scalar | ( | field_sequential | , |
topography | |||
) |
bool intersection_is_quadrilateral_T | ( | const std::vector< T > & | f, |
quadruplet & | q | ||
) |
Definition at line 222 of file level_set.cc.
void gamma_list2disarray | ( | const std::list< point_basic< T > > & | gamma_node_list, |
std::array< std::list< std::pair< element_type, size_t > >, reference_element::max_variant > | gamma_side_list, | ||
const communicator & | comm, | ||
size_t | d, | ||
disarray< point_basic< T >, M > & | gamma_node, | ||
std::array< disarray< element_type, M >, reference_element::max_variant > & | gamma_side, | ||
disarray< size_t, M > & | sid_ie2bnd_ie | ||
) |
Definition at line 351 of file level_set.cc.
geo_basic< T, M > level_set | ( | const field_basic< T, M > & | fh, |
const level_set_option & | opt | ||
) |
Definition at line 925 of file level_set.cc.
field_basic< T, M > limiter | ( | const field_basic< T, M > & | uh, |
const T & | bar_g_S, | ||
const limiter_option & | opt | ||
) |
see the limiter
page for the full documentation
Definition at line 65 of file limiter.cc.
int newton_backtrack | ( | const Problem & | P, |
const Preconditioner & | T, | ||
const Field & | u_old, | ||
Float | Tu_old, | ||
Field & | delta_u, | ||
Real | slope, | ||
Real | norm_delta_u_max, | ||
Field & | u, | ||
Field & | Fu, | ||
Real & | Tu, | ||
Real & | lambda, | ||
odiststream * | p_derr = 0 |
||
) |
Definition at line 26 of file newton-backtrack.h.
int newton | ( | const Problem & | P, |
Field & | uh, | ||
Float & | tol, | ||
size_t & | max_iter, | ||
odiststream * | p_derr = 0 |
||
) |
void piola_transformation | ( | const geo_basic< T, M > & | omega, |
const basis_on_pointset< T > & | piola_on_pointset, | ||
reference_element | hat_K, | ||
const std::vector< size_t > & | dis_inod, | ||
Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > & | x | ||
) |
Definition at line 43 of file piola_util.cc.
void jacobian_piola_transformation | ( | const geo_basic< T, M > & | omega, |
const basis_on_pointset< T > & | piola_on_pointset, | ||
reference_element | hat_K, | ||
const std::vector< size_t > & | dis_inod, | ||
Eigen::Matrix< tensor_basic< T >, Eigen::Dynamic, 1 > & | DF | ||
) |
Definition at line 80 of file piola_util.cc.
void jacobian_piola_transformation | ( | const geo_basic< T, M > & | omega, |
const basis_basic< T > & | piola_basis, | ||
reference_element | hat_K, | ||
const std::vector< size_t > & | dis_inod, | ||
const point_basic< T > & | hat_x, | ||
tensor_basic< T > & | DF | ||
) |
Definition at line 116 of file piola_util.cc.
T det_jacobian_piola_transformation | ( | const tensor_basic< T > & | DF, |
size_t | d, | ||
size_t | map_d | ||
) |
Definition at line 137 of file piola_util.cc.
point_basic< T > normal_from_piola_transformation | ( | const geo_basic< T, M > & | omega, |
const geo_element & | S, | ||
const tensor_basic< T > & | DF, | ||
size_t | d | ||
) |
Definition at line 229 of file piola_util.cc.
tensor_basic< T > pseudo_inverse_jacobian_piola_transformation | ( | const tensor_basic< T > & | DF, |
size_t | d, | ||
size_t | map_d | ||
) |
Definition at line 279 of file piola_util.cc.
T weight_coordinate_system | ( | space_constant::coordinate_type | sys_coord, |
const point_basic< T > & | xq | ||
) |
Definition at line 321 of file piola_util.cc.
void piola_transformation_and_weight_integration | ( | const geo_basic< T, M > & | omega, |
const basis_on_pointset< T > & | piola_on_quad, | ||
reference_element | hat_K, | ||
const std::vector< size_t > & | dis_inod, | ||
bool | ignore_sys_coord, | ||
Eigen::Matrix< tensor_basic< T >, Eigen::Dynamic, 1 > & | DF, | ||
Eigen::Matrix< point_basic< T >, Eigen::Dynamic, 1 > & | x, | ||
Eigen::Matrix< T, Eigen::Dynamic, 1 > & | w | ||
) |
Definition at line 340 of file piola_util.cc.
void map_projector | ( | const tensor_basic< T > & | DF, |
size_t | d, | ||
size_t | map_d, | ||
tensor_basic< T > & | P | ||
) |
Definition at line 382 of file piola_util.cc.
point_basic< T > inverse_piola_transformation | ( | const geo_basic< T, M > & | omega, |
const reference_element & | hat_K, | ||
const std::vector< size_t > & | dis_inod, | ||
const point_basic< T > & | x | ||
) |
Definition at line 473 of file piola_util.cc.
_RHEOLEF_instanciation1 | ( | Float | ) |
std::ostream & operator<< | ( | std::ostream & | py, |
const render_option & | popt | ||
) |
Definition at line 44 of file render_option.cc.
field_basic< T, M > riesz | ( | const space_basic< T, M > & | Xh, |
const Function & | f, | ||
const quadrature_option & | qopt = quadrature_option() |
||
) |
field_basic< T, M > riesz | ( | const space_basic< T, M > & | Xh, |
const Function & | f, | ||
const geo_basic< T, M > & | dom, | ||
const quadrature_option & | qopt = quadrature_option() |
||
) |
field_basic< T, M > riesz | ( | const space_basic< T, M > & | Xh, |
const Function & | f, | ||
std::string | dom_name, | ||
const quadrature_option & | qopt = quadrature_option() |
||
) |
field_basic< T, M > riesz | ( | const space_basic< T, M > & | Xh, |
const Function & | f, | ||
const band_basic< T, M > & | gh, | ||
const quadrature_option & | qopt = quadrature_option() |
||
) |
std::enable_if< details::is_field_expr_affine_homogeneous< Expr >::value, field_basic< typenameExpr::scalar_type, typenameExpr::memory_type > >::type round | ( | const Expr & | expr, |
const T2 & | prec | ||
) |
_RHEOLEF_space_real | ( | sequential | ) |
idiststream & operator>> | ( | idiststream & | ids, |
space_constitution< T, M > & | constit | ||
) |
Definition at line 86 of file space_constitution_get.cc.
const geo_element & assembly2space_geo_element | ( | const geo_basic< T, M > & | space_geo, |
const geo_basic< T, M > & | omega_K, | ||
const geo_element & | K_in | ||
) |
Definition at line 115 of file space_constitution_assembly.cc.
|
extern |
Definition at line 79 of file space_constitution_get.cc.
void space_constitution_error | ( | const char * | msg | ) |
Definition at line 58 of file space_constitution_get.cc.
int space_constitution_wrap | ( | ) |
Definition at line 63 of file space_constitution_get.cc.
template idiststream & operator>> | ( | idiststream & | , |
space_constitution< Float, sequential > & | |||
) |
template idiststream & operator>> | ( | idiststream & | , |
space_constitution< Float, distributed > & | |||
) |
|
extern |
Definition at line 79 of file space_constitution_old_get.cc.
void space_constitution_old_error | ( | const char * | msg | ) |
Definition at line 58 of file space_constitution_old_get.cc.
int space_constitution_old_wrap | ( | ) |
Definition at line 63 of file space_constitution_old_get.cc.
template void space_constitution_old_get | ( | idiststream & | , |
space_constitution< Float, sequential > & | |||
) |
template void space_constitution_old_get | ( | idiststream & | , |
space_constitution< Float, distributed > & | |||
) |
space_mult_list< T, M > operator* | ( | const space_basic< T, M > & | X, |
const space_basic< T, M > & | Y | ||
) |
Definition at line 85 of file space_mult.h.
space_mult_list< T, M > operator* | ( | const space_mult_list< T, M > & | Xm, |
const space_basic< T, M > & | Y | ||
) |
Definition at line 95 of file space_mult.h.
space_mult_list< T, M > & operator*= | ( | space_mult_list< T, M > & | Xm, |
const space_basic< T, M > & | Y | ||
) |
Definition at line 104 of file space_mult.h.
space_mult_list< T, M > operator* | ( | const space_basic< T, M > & | X, |
const space_mult_list< T, M > & | Ym | ||
) |
Definition at line 112 of file space_mult.h.
space_mult_list< T, M > pow | ( | const space_basic< T, M > & | X, |
size_t | n | ||
) |
Definition at line 120 of file space_mult.h.
size_t vtk_cell_type2variant | ( | size_t | vtk_cell_type | ) |
Definition at line 34 of file vtk_cell_type.cc.
size_t nv2vtk_cell_type | ( | size_t | map_dim, |
size_t | nv | ||
) |
Definition at line 71 of file vtk_cell_type.cc.
void msh2geo_node_renum | ( | vector< size_t > & | element, |
size_t | variant, | ||
size_t | order | ||
) |
Definition at line 447 of file msh2geo_node_renum.icc.