9 #ifndef stk_linsys_LinsysFunctions_hpp 10 #define stk_linsys_LinsysFunctions_hpp 12 #include <stk_linsys/LinearSystemInterface.hpp> 14 #include <stk_mesh/base/Field.hpp> 15 #include <stk_mesh/base/Selector.hpp> 16 #include <stk_mesh/base/BulkData.hpp> 18 #include <Teuchos_ParameterList.hpp> 36 stk_classic::mesh::EntityRank from_type,
37 stk_classic::mesh::EntityRank to_connected_type,
50 void dirichlet_bc(stk_classic::linsys::LinearSystemInterface& ls,
55 unsigned field_component,
56 double prescribed_value);
74 int fei_solve(
int & status, fei::LinearSystem &fei_ls,
const Teuchos::ParameterList & params);
86 const DofMapper & dof,
97 const fei::Matrix& src_matrix,
98 fei::Matrix& dest_matrix);
108 const fei::Vector& src_vector,
109 fei::Vector& dest_vector);
void scale_vector(double scalar, fei::Vector &vec)
void add_connectivities(stk_classic::linsys::LinearSystemInterface &ls, stk_classic::mesh::EntityRank entity_rank, stk_classic::mesh::EntityRank connected_entity_rank, const stk_classic::mesh::FieldBase &field, const stk_classic::mesh::Selector &selector, const stk_classic::mesh::BulkData &mesh_bulk)
int fei_solve(int &status, fei::LinearSystem &fei_ls, const Teuchos::ParameterList ¶ms)
Field base class with an anonymous data type and anonymous multi-dimension.
double compute_residual_norm2(fei::LinearSystem &fei_ls, fei::Vector &r)
This is a class for selecting buckets based on a set of meshparts and set logic.
An application-defined subset of a problem domain.
void dirichlet_bc(stk_classic::linsys::LinearSystemInterface &ls, const stk_classic::mesh::BulkData &mesh, const stk_classic::mesh::Part &bcpart, stk_classic::mesh::EntityRank entity_rank, const stk_classic::mesh::FieldBase &field, unsigned field_component, double prescribed_value)
void copy_vector_to_mesh(fei::Vector &vec, const DofMapper &dof, stk_classic::mesh::BulkData &mesh_bulk_data)
Manager for an integrated collection of entities, entity relations, and buckets of field data...
void add_matrix_to_matrix(double scalar, const fei::Matrix &src_matrix, fei::Matrix &dest_matrix)
void add_vector_to_vector(double scalar, const fei::Vector &src_vector, fei::Vector &dest_vector)
void scale_matrix(double scalar, fei::Matrix &matrix)
EntityRank entity_rank(const EntityKey &key)
Given an entity key, return an entity type (rank).