![]() |
KratosMultiphysics
KRATOS Multiphysics (Kratos) is a framework for building parallel, multi-disciplinary simulation software, aiming at modularity, extensibility, and high performance. Kratos is written in C++, and counts with an extensive Python interface.
|
#include <create_and_destroy.h>
Public Types | |
| typedef DiscreteParticleConfigure< space_dim > | Configure |
| WARNING: generalize to 2d. More... | |
| typedef Configure::ContainerType | ParticlePointerVector |
| typedef ParticlePointerVector::iterator | ParticlePointerIterator |
| typedef Configure::IteratorType | ParticleIterator |
| typedef PointerVectorSet< Element, IndexedObject > | ElementsContainerType |
| typedef ModelPart::ElementsContainerType | ElementsArrayType |
| typedef ModelPart::NodesContainerType | NodesArrayType |
Public Member Functions | |
| KRATOS_CLASS_POINTER_DEFINITION (ParticleCreatorDestructor) | |
| ParticleCreatorDestructor () | |
| Default constructor. More... | |
| ParticleCreatorDestructor (Parameters settings) | |
| ParticleCreatorDestructor (AnalyticWatcher::Pointer p_watcher) | |
| ParticleCreatorDestructor (AnalyticWatcher::Pointer p_watcher, Parameters settings) | |
| virtual | ~ParticleCreatorDestructor () |
| Destructor. More... | |
| int | FindMaxNodeIdInModelPart (ModelPart &r_modelpart) |
| void | FindAndSaveMaxNodeIdInModelPart (ModelPart &r_modelpart) |
| int | FindMaxElementIdInModelPart (ModelPart &r_modelpart) |
| int | FindMaxConditionIdInModelPart (ModelPart &r_modelpart) |
| void | RenumberElementIdsFromGivenValue (ModelPart &r_modelpart, const int initial_id) |
| void | DestroyMarkedParticles (ModelPart &r_model_part) |
| virtual double | SelectRadius (bool initial, ModelPart &r_sub_model_part_with_parameters, std::map< std::string, std::unique_ptr< RandomVariable >> &r_random_variables_map) |
| void | NodeCreatorWithPhysicalParameters (ModelPart &r_modelpart, Node ::Pointer &pnew_node, int aId, Node ::Pointer &reference_node, double radius, Properties ¶ms, ModelPart &r_sub_model_part_with_parameters, bool has_sphericity, bool has_rotation, bool initial) |
| void | NodeForClustersCreatorWithPhysicalParameters (ModelPart &r_modelpart, Node ::Pointer &pnew_node, int aId, Node ::Pointer &reference_node, Properties ¶ms, ModelPart &r_sub_model_part_with_parameters, bool has_sphericity, bool has_rotation, bool initial) |
| SphericParticle * | ElementCreatorWithPhysicalParameters (ModelPart &r_modelpart, int r_Elem_Id, Node ::Pointer reference_node, Element::Pointer injector_element, Properties::Pointer r_params, ModelPart &r_sub_model_part_with_parameters, std::map< std::string, std::unique_ptr< RandomVariable >> &r_random_variables_map, const Element &r_reference_element, PropertiesProxy *p_fast_properties, bool has_sphericity, bool has_rotation, bool initial, ElementsContainerType &array_of_injector_elements) |
| SphericParticle * | AddInitialDataToNewlyCreatedElementAndNode (ModelPart &r_modelpart, Properties::Pointer r_params, const double radius, Node::Pointer &pnew_node, Element::Pointer &p_particle) |
| SphericParticle * | CreateSphericParticleRaw (ModelPart &r_modelpart, int r_Elem_Id, const array_1d< double, 3 > &coordinates, Properties::Pointer r_params, const double radius, const Element &r_reference_element) |
| SphericParticle * | CreateSphericParticleRaw (ModelPart &r_modelpart, int r_Elem_Id, Node ::Pointer reference_node, Properties::Pointer r_params, const double radius, const Element &r_reference_element) |
| SphericParticle * | CreateSphericParticleRaw (ModelPart &r_modelpart, int r_Elem_Id, Node ::Pointer reference_node, Properties::Pointer r_params, const double radius, const std::string &element_type) |
| SphericParticle * | CreateSphericParticleRaw (ModelPart &r_modelpart, Node ::Pointer reference_node, Properties::Pointer r_params, const double radius, const std::string &element_type) |
| SphericParticle * | CreateSphericParticleRaw (ModelPart &r_modelpart, int r_Elem_Id, const array_1d< double, 3 > &coordinates, Properties::Pointer r_params, const double radius, const std::string &element_type) |
| SphericParticle * | CreateSphericParticleRaw (ModelPart &r_modelpart, const array_1d< double, 3 > &coordinates, Properties::Pointer r_params, const double radius, const std::string &element_type) |
| Element::Pointer | CreateSphericParticle (ModelPart &r_modelpart, int r_Elem_Id, const array_1d< double, 3 > &coordinates, Properties::Pointer r_params, const double radius, const Element &r_reference_element) |
| Element::Pointer | CreateSphericParticle (ModelPart &r_modelpart, int r_Elem_Id, Node ::Pointer reference_node, Properties::Pointer r_params, const double radius, const Element &r_reference_element) |
| Element::Pointer | CreateSphericParticle (ModelPart &r_modelpart, int r_Elem_Id, Node ::Pointer reference_node, Properties::Pointer r_params, const double radius, const std::string &element_type) |
| Element::Pointer | CreateSphericParticle (ModelPart &r_modelpart, Node ::Pointer reference_node, Properties::Pointer r_params, const double radius, const std::string &element_type) |
| Element::Pointer | CreateSphericParticle (ModelPart &r_modelpart, int r_Elem_Id, const array_1d< double, 3 > &coordinates, Properties::Pointer r_params, const double radius, const std::string &element_type) |
| Element::Pointer | CreateSphericParticle (ModelPart &r_modelpart, const array_1d< double, 3 > &coordinates, Properties::Pointer r_params, const double radius, const std::string &element_type) |
| Cluster3D * | ClusterCreatorWithPhysicalParameters (ModelPart &r_modelpart, ModelPart &r_clusters_modelpart, int r_Elem_Id, Node ::Pointer reference_node, Element::Pointer injector_element, Properties::Pointer r_params, ModelPart &r_sub_model_part_with_parameters, const Element &r_reference_element, PropertiesProxy *p_fast_properties, bool has_sphericity, bool has_rotation, ElementsContainerType &array_of_injector_elements, int &number_of_added_spheres, const bool mStrategyForContinuum, std::vector< SphericParticle * > &new_component_spheres) |
| void | NodeCreatorForClusters (ModelPart &r_modelpart, Node ::Pointer &pnew_node, int aId, array_1d< double, 3 > &reference_coordinates, double radius, Properties ¶ms) |
| void | CentroidCreatorForRigidBodyElements (ModelPart &r_modelpart, Node::Pointer &pnew_node, int aId, array_1d< double, 3 > &reference_coordinates) |
| SphericParticle * | SphereCreatorForClusters (ModelPart &r_modelpart, Node ::Pointer &pnew_node, int r_Elem_Id, double radius, array_1d< double, 3 > &reference_coordinates, double cluster_mass, Properties::Pointer r_params, const Element &r_reference_element, const int cluster_id, PropertiesProxy *p_fast_properties) |
| SphericParticle * | SphereCreatorForBreakableClusters (ModelPart &r_modelpart, Node ::Pointer &pnew_node, int r_Elem_Id, double radius, array_1d< double, 3 > &reference_coordinates, Properties::Pointer r_params, const Element &r_reference_element, const int cluster_id, PropertiesProxy *p_fast_properties) |
| void | CalculateSurroundingBoundingBox (ModelPart &r_balls_model_part, ModelPart &r_clusters_model_part, ModelPart &r_rigid_faces_model_part, ModelPart &r_dem_inlet_model_part, double scale_factor, bool automatic) |
| void | UpdateSurroundingBoundingBox (ModelPart &spheres_model_part) |
| template<class TParticleType > | |
| bool | CheckParticlePreservationCriteria (const Element::Pointer p_element, const double current_time) |
| template<class TParticleType > | |
| void | DestroyParticles (ModelPart &r_model_part) |
| void | DestroyParticleElements (ModelPart &r_model_part, Flags flag_for_destruction) |
| template<class TParticleType > | |
| void | DestroyParticles (ModelPart::MeshType &rMesh, const double current_time) |
| void | DestroyContactElements (ModelPart &r_model_part) |
| void | MarkIsolatedParticlesForErasing (ModelPart &r_model_part) |
| void | MarkInitialNeighboursThatAreBeingRemoved (ModelPart &r_model_part) |
| void | RemoveUnusedNodesOfTheClustersModelPart (ModelPart &r_clusters_modelpart) |
| template<class TParticleType > | |
| void | MarkDistantParticlesForErasing (ModelPart &r_model_part) |
| void | MarkParticlesForErasingGivenScalarVariableValue (ModelPart &r_model_part, const Variable< double > &rVariable, double value, double tol) |
| void | MarkParticlesForErasingGivenVectorVariableModulus (ModelPart &r_model_part, const Variable< array_1d< double, 3 > > &rVariable, double value, double tol) |
| template<class TParticleType > | |
| void | MarkParticlesForErasingGivenBoundingBox (ModelPart &r_model_part, array_1d< double, 3 > low_point, array_1d< double, 3 > high_point) |
| void | MarkParticlesForErasingGivenCylinder (ModelPart &r_model_part, array_1d< double, 3 > center, array_1d< double, 3 > axis_vector, const double radius) |
| void | MarkContactElementsForErasing (ModelPart &r_model_part, ModelPart &mcontacts_model_part) |
| template<class TParticleType > | |
| void | DestroyParticlesOutsideBoundingBox (ModelPart &r_model_part) |
| void | MoveParticlesOutsideBoundingBoxBackInside (ModelPart &r_model_part) |
| void | DestroyContactElementsOutsideBoundingBox (ModelPart &r_model_part, ModelPart &mcontacts_model_part) |
| Element::Pointer | GetAnalyticReplacement (const Element &sample_element, Geometry< Node >::PointsArrayType nodelist, Element::Pointer p_elem_to_be_replaced, ModelPart &spheres_model_part) |
| array_1d< double, 3 > | GetHighNode () |
| array_1d< double, 3 > | GetLowNode () |
| array_1d< double, 3 > | GetStrictHighNode () |
| array_1d< double, 3 > | GetStrictLowNode () |
| double | GetDiameter () |
| double | GetStrictDiameter () |
| void | SetHighNode (array_1d< double, 3 > node) |
| void | SetLowNode (array_1d< double, 3 > node) |
| unsigned int | GetCurrentMaxNodeId () |
| unsigned int * | pGetCurrentMaxNodeId () |
| void | SetMaxNodeId (unsigned int id) |
| virtual std::string | Info () const |
| Turn back information as a stemplate<class T, std::size_t dim> tring. More... | |
| virtual void | PrintInfo (std::ostream &rOStream) const |
| Print information about this object. More... | |
| virtual void | PrintData (std::ostream &rOStream) const |
| Print object's data. More... | |
Static Public Member Functions | |
| static double | rand_normal (const double mean, const double stddev, const double max_radius, const double min_radius) |
| static double | rand_lognormal (const double mean, const double stddev, const double max_radius, const double min_radius) |
Public Attributes | |
| unsigned int | mMaxNodeId |
Static Public Attributes | |
| static const std::size_t | space_dim = 3 |
Friends | |
| class | ExplicitSolverStrategy |
WARNING: generalize to 2d.
| typedef PointerVectorSet<Element, IndexedObject> Kratos::ParticleCreatorDestructor::ElementsContainerType |
| Kratos::ParticleCreatorDestructor::ParticleCreatorDestructor | ( | ) |
Default constructor.
| Kratos::ParticleCreatorDestructor::ParticleCreatorDestructor | ( | Parameters | settings | ) |
| Kratos::ParticleCreatorDestructor::ParticleCreatorDestructor | ( | AnalyticWatcher::Pointer | p_watcher | ) |
| Kratos::ParticleCreatorDestructor::ParticleCreatorDestructor | ( | AnalyticWatcher::Pointer | p_watcher, |
| Parameters | settings | ||
| ) |
|
virtual |
Destructor.
| SphericParticle * Kratos::ParticleCreatorDestructor::AddInitialDataToNewlyCreatedElementAndNode | ( | ModelPart & | r_modelpart, |
| Properties::Pointer | r_params, | ||
| const double | radius, | ||
| Node::Pointer & | pnew_node, | ||
| Element::Pointer & | p_particle | ||
| ) |
| void Kratos::ParticleCreatorDestructor::CalculateSurroundingBoundingBox | ( | ModelPart & | r_balls_model_part, |
| ModelPart & | r_clusters_model_part, | ||
| ModelPart & | r_rigid_faces_model_part, | ||
| ModelPart & | r_dem_inlet_model_part, | ||
| double | scale_factor, | ||
| bool | automatic | ||
| ) |
| void Kratos::ParticleCreatorDestructor::CentroidCreatorForRigidBodyElements | ( | ModelPart & | r_modelpart, |
| Node::Pointer & | pnew_node, | ||
| int | aId, | ||
| array_1d< double, 3 > & | reference_coordinates | ||
| ) |
| template bool Kratos::ParticleCreatorDestructor::CheckParticlePreservationCriteria< Cluster3D > | ( | const Element::Pointer | p_element, |
| const double | current_time | ||
| ) |
| Cluster3D * Kratos::ParticleCreatorDestructor::ClusterCreatorWithPhysicalParameters | ( | ModelPart & | r_modelpart, |
| ModelPart & | r_clusters_modelpart, | ||
| int | r_Elem_Id, | ||
| Node ::Pointer | reference_node, | ||
| Element::Pointer | injector_element, | ||
| Properties::Pointer | r_params, | ||
| ModelPart & | r_sub_model_part_with_parameters, | ||
| const Element & | r_reference_element, | ||
| PropertiesProxy * | p_fast_properties, | ||
| bool | has_sphericity, | ||
| bool | has_rotation, | ||
| ElementsContainerType & | array_of_injector_elements, | ||
| int & | number_of_added_spheres, | ||
| const bool | mStrategyForContinuum, | ||
| std::vector< SphericParticle * > & | new_component_spheres | ||
| ) |
| Element::Pointer Kratos::ParticleCreatorDestructor::CreateSphericParticle | ( | ModelPart & | r_modelpart, |
| const array_1d< double, 3 > & | coordinates, | ||
| Properties::Pointer | r_params, | ||
| const double | radius, | ||
| const std::string & | element_type | ||
| ) |
| Element::Pointer Kratos::ParticleCreatorDestructor::CreateSphericParticle | ( | ModelPart & | r_modelpart, |
| int | r_Elem_Id, | ||
| const array_1d< double, 3 > & | coordinates, | ||
| Properties::Pointer | r_params, | ||
| const double | radius, | ||
| const Element & | r_reference_element | ||
| ) |
| Element::Pointer Kratos::ParticleCreatorDestructor::CreateSphericParticle | ( | ModelPart & | r_modelpart, |
| int | r_Elem_Id, | ||
| const array_1d< double, 3 > & | coordinates, | ||
| Properties::Pointer | r_params, | ||
| const double | radius, | ||
| const std::string & | element_type | ||
| ) |
| Element::Pointer Kratos::ParticleCreatorDestructor::CreateSphericParticle | ( | ModelPart & | r_modelpart, |
| int | r_Elem_Id, | ||
| Node ::Pointer | reference_node, | ||
| Properties::Pointer | r_params, | ||
| const double | radius, | ||
| const Element & | r_reference_element | ||
| ) |
| Element::Pointer Kratos::ParticleCreatorDestructor::CreateSphericParticle | ( | ModelPart & | r_modelpart, |
| int | r_Elem_Id, | ||
| Node ::Pointer | reference_node, | ||
| Properties::Pointer | r_params, | ||
| const double | radius, | ||
| const std::string & | element_type | ||
| ) |
| Element::Pointer Kratos::ParticleCreatorDestructor::CreateSphericParticle | ( | ModelPart & | r_modelpart, |
| Node ::Pointer | reference_node, | ||
| Properties::Pointer | r_params, | ||
| const double | radius, | ||
| const std::string & | element_type | ||
| ) |
| SphericParticle * Kratos::ParticleCreatorDestructor::CreateSphericParticleRaw | ( | ModelPart & | r_modelpart, |
| const array_1d< double, 3 > & | coordinates, | ||
| Properties::Pointer | r_params, | ||
| const double | radius, | ||
| const std::string & | element_type | ||
| ) |
| SphericParticle * Kratos::ParticleCreatorDestructor::CreateSphericParticleRaw | ( | ModelPart & | r_modelpart, |
| int | r_Elem_Id, | ||
| const array_1d< double, 3 > & | coordinates, | ||
| Properties::Pointer | r_params, | ||
| const double | radius, | ||
| const Element & | r_reference_element | ||
| ) |
| SphericParticle * Kratos::ParticleCreatorDestructor::CreateSphericParticleRaw | ( | ModelPart & | r_modelpart, |
| int | r_Elem_Id, | ||
| const array_1d< double, 3 > & | coordinates, | ||
| Properties::Pointer | r_params, | ||
| const double | radius, | ||
| const std::string & | element_type | ||
| ) |
| SphericParticle * Kratos::ParticleCreatorDestructor::CreateSphericParticleRaw | ( | ModelPart & | r_modelpart, |
| int | r_Elem_Id, | ||
| Node ::Pointer | reference_node, | ||
| Properties::Pointer | r_params, | ||
| const double | radius, | ||
| const Element & | r_reference_element | ||
| ) |
| SphericParticle * Kratos::ParticleCreatorDestructor::CreateSphericParticleRaw | ( | ModelPart & | r_modelpart, |
| int | r_Elem_Id, | ||
| Node ::Pointer | reference_node, | ||
| Properties::Pointer | r_params, | ||
| const double | radius, | ||
| const std::string & | element_type | ||
| ) |
| SphericParticle * Kratos::ParticleCreatorDestructor::CreateSphericParticleRaw | ( | ModelPart & | r_modelpart, |
| Node ::Pointer | reference_node, | ||
| Properties::Pointer | r_params, | ||
| const double | radius, | ||
| const std::string & | element_type | ||
| ) |
| void Kratos::ParticleCreatorDestructor::DestroyContactElements | ( | ModelPart & | r_model_part | ) |
| void Kratos::ParticleCreatorDestructor::DestroyContactElementsOutsideBoundingBox | ( | ModelPart & | r_model_part, |
| ModelPart & | mcontacts_model_part | ||
| ) |
| void Kratos::ParticleCreatorDestructor::DestroyMarkedParticles | ( | ModelPart & | r_model_part | ) |
| void Kratos::ParticleCreatorDestructor::DestroyParticleElements | ( | ModelPart & | r_model_part, |
| Flags | flag_for_destruction | ||
| ) |
| void Kratos::ParticleCreatorDestructor::DestroyParticles | ( | ModelPart & | r_model_part | ) |
| void Kratos::ParticleCreatorDestructor::DestroyParticles | ( | ModelPart::MeshType & | rMesh, |
| const double | current_time | ||
| ) |
| template void Kratos::ParticleCreatorDestructor::DestroyParticlesOutsideBoundingBox< Cluster3D > | ( | ModelPart & | r_model_part | ) |
| SphericParticle * Kratos::ParticleCreatorDestructor::ElementCreatorWithPhysicalParameters | ( | ModelPart & | r_modelpart, |
| int | r_Elem_Id, | ||
| Node ::Pointer | reference_node, | ||
| Element::Pointer | injector_element, | ||
| Properties::Pointer | r_params, | ||
| ModelPart & | r_sub_model_part_with_parameters, | ||
| std::map< std::string, std::unique_ptr< RandomVariable >> & | r_random_variables_map, | ||
| const Element & | r_reference_element, | ||
| PropertiesProxy * | p_fast_properties, | ||
| bool | has_sphericity, | ||
| bool | has_rotation, | ||
| bool | initial, | ||
| ElementsContainerType & | array_of_injector_elements | ||
| ) |
| void Kratos::ParticleCreatorDestructor::FindAndSaveMaxNodeIdInModelPart | ( | ModelPart & | r_modelpart | ) |
| Element::Pointer Kratos::ParticleCreatorDestructor::GetAnalyticReplacement | ( | const Element & | sample_element, |
| Geometry< Node >::PointsArrayType | nodelist, | ||
| Element::Pointer | p_elem_to_be_replaced, | ||
| ModelPart & | spheres_model_part | ||
| ) |
| unsigned int Kratos::ParticleCreatorDestructor::GetCurrentMaxNodeId | ( | ) |
| double Kratos::ParticleCreatorDestructor::GetDiameter | ( | ) |
| double Kratos::ParticleCreatorDestructor::GetStrictDiameter | ( | ) |
|
virtual |
Turn back information as a stemplate<class T, std::size_t dim> tring.
| Kratos::ParticleCreatorDestructor::KRATOS_CLASS_POINTER_DEFINITION | ( | ParticleCreatorDestructor | ) |
| void Kratos::ParticleCreatorDestructor::MarkContactElementsForErasing | ( | ModelPart & | r_model_part, |
| ModelPart & | mcontacts_model_part | ||
| ) |
| template void Kratos::ParticleCreatorDestructor::MarkDistantParticlesForErasing< Cluster3D > | ( | ModelPart & | r_model_part | ) |
| void Kratos::ParticleCreatorDestructor::MarkInitialNeighboursThatAreBeingRemoved | ( | ModelPart & | r_model_part | ) |
| void Kratos::ParticleCreatorDestructor::MarkIsolatedParticlesForErasing | ( | ModelPart & | r_model_part | ) |
| template void Kratos::ParticleCreatorDestructor::MarkParticlesForErasingGivenBoundingBox< Cluster3D > | ( | ModelPart & | r_model_part, |
| array_1d< double, 3 > | low_point, | ||
| array_1d< double, 3 > | high_point | ||
| ) |
| void Kratos::ParticleCreatorDestructor::MarkParticlesForErasingGivenCylinder | ( | ModelPart & | r_model_part, |
| array_1d< double, 3 > | center, | ||
| array_1d< double, 3 > | axis_vector, | ||
| const double | radius | ||
| ) |
| void Kratos::ParticleCreatorDestructor::MarkParticlesForErasingGivenScalarVariableValue | ( | ModelPart & | r_model_part, |
| const Variable< double > & | rVariable, | ||
| double | value, | ||
| double | tol | ||
| ) |
| void Kratos::ParticleCreatorDestructor::MarkParticlesForErasingGivenVectorVariableModulus | ( | ModelPart & | r_model_part, |
| const Variable< array_1d< double, 3 > > & | rVariable, | ||
| double | value, | ||
| double | tol | ||
| ) |
| void Kratos::ParticleCreatorDestructor::MoveParticlesOutsideBoundingBoxBackInside | ( | ModelPart & | r_model_part | ) |
| void Kratos::ParticleCreatorDestructor::NodeCreatorForClusters | ( | ModelPart & | r_modelpart, |
| Node ::Pointer & | pnew_node, | ||
| int | aId, | ||
| array_1d< double, 3 > & | reference_coordinates, | ||
| double | radius, | ||
| Properties & | params | ||
| ) |
| void Kratos::ParticleCreatorDestructor::NodeCreatorWithPhysicalParameters | ( | ModelPart & | r_modelpart, |
| Node ::Pointer & | pnew_node, | ||
| int | aId, | ||
| Node ::Pointer & | reference_node, | ||
| double | radius, | ||
| Properties & | params, | ||
| ModelPart & | r_sub_model_part_with_parameters, | ||
| bool | has_sphericity, | ||
| bool | has_rotation, | ||
| bool | initial | ||
| ) |
| void Kratos::ParticleCreatorDestructor::NodeForClustersCreatorWithPhysicalParameters | ( | ModelPart & | r_modelpart, |
| Node ::Pointer & | pnew_node, | ||
| int | aId, | ||
| Node ::Pointer & | reference_node, | ||
| Properties & | params, | ||
| ModelPart & | r_sub_model_part_with_parameters, | ||
| bool | has_sphericity, | ||
| bool | has_rotation, | ||
| bool | initial | ||
| ) |
| unsigned int * Kratos::ParticleCreatorDestructor::pGetCurrentMaxNodeId | ( | ) |
|
virtual |
Print object's data.
|
virtual |
Print information about this object.
|
static |
|
static |
| void Kratos::ParticleCreatorDestructor::RemoveUnusedNodesOfTheClustersModelPart | ( | ModelPart & | r_clusters_modelpart | ) |
| void Kratos::ParticleCreatorDestructor::RenumberElementIdsFromGivenValue | ( | ModelPart & | r_modelpart, |
| const int | initial_id | ||
| ) |
|
virtual |
| void Kratos::ParticleCreatorDestructor::SetMaxNodeId | ( | unsigned int | id | ) |
| SphericParticle * Kratos::ParticleCreatorDestructor::SphereCreatorForBreakableClusters | ( | ModelPart & | r_modelpart, |
| Node ::Pointer & | pnew_node, | ||
| int | r_Elem_Id, | ||
| double | radius, | ||
| array_1d< double, 3 > & | reference_coordinates, | ||
| Properties::Pointer | r_params, | ||
| const Element & | r_reference_element, | ||
| const int | cluster_id, | ||
| PropertiesProxy * | p_fast_properties | ||
| ) |
| Kratos::SphericParticle * Kratos::ParticleCreatorDestructor::SphereCreatorForClusters | ( | ModelPart & | r_modelpart, |
| Node ::Pointer & | pnew_node, | ||
| int | r_Elem_Id, | ||
| double | radius, | ||
| array_1d< double, 3 > & | reference_coordinates, | ||
| double | cluster_mass, | ||
| Properties::Pointer | r_params, | ||
| const Element & | r_reference_element, | ||
| const int | cluster_id, | ||
| PropertiesProxy * | p_fast_properties | ||
| ) |
| void Kratos::ParticleCreatorDestructor::UpdateSurroundingBoundingBox | ( | ModelPart & | spheres_model_part | ) |
|
friend |
| unsigned int Kratos::ParticleCreatorDestructor::mMaxNodeId |
|
static |