Common class

struct geo_curve_type
#include <openfdem_geometry.h>

Public Members

int n_line
int *line
struct geo_group_type
#include <openfdem_geometry.h>

Public Members

char *tag
int size
int line_size
int new_dfn_size
int embed_id
int *nodes
int *lines
int *new_dfn
struct geo_line_type
#include <openfdem_geometry.h>

Public Members

char *group
int embed
int embed_id
int node_1
int node_2
struct geo_node_type
#include <openfdem_geometry.h>

Public Members

Real x
Real y
Real z
Real mesh_size
struct geo_surface_type
#include <openfdem_geometry.h>

Public Members

char *tag
int embed_id
int n_curve
int embed
int *curve
struct Geometry_structure
#include <openfdem_geometry.h>

Public Members

Real x0
Real x1
Real y0
Real y1
int node_num
int line_num
int curve_num
int surface_num
int group_num
double mesh_size
double min_size
geo_node_type *node
geo_line_type *line
geo_curve_type *curve
geo_surface_type *surface
geo_group_type *group
file openfdem_geometry.h
#include “../common/openfdem_struct.h”

Typedefs

typedef struct Geometry_structure *Geometry
file push_geometry.h
#include “../io/parser/parser_geometry.h”

Functions

void push_geometry_square(General general, Geometry geometry, int embed_flag)
void push_geometry_polygon(General general, Geometry geometry, int embed_flag)
void push_geometry_table(General general, Geometry geometry, int embed_flag)
void push_geometry_circle(General general, Geometry geometry, int embed_flag)
void push_geometry_ellipse(General general, Geometry geometry, int embed_flag)
void push_geometry_arc(General general, Geometry geometry)
void push_geometry_joint(General general, Geometry geometry)
void push_geometry_jset(General general, Geometry geometry)
void push_geometry_DFN(General general, Geometry geometry)
void get_geo_node_group_square(Geometry geometry, char *tag, double x_lef, double x_rig, double y_bot, double y_top)
void get_geo_node_group_square_on(Geometry geometry, char *tag, double x_lef, double x_rig, double y_bot, double y_top)
void get_geo_node_group_plane_left(Geometry geometry, char *tag, double x1, double y1, double x2, double y2)
void get_geo_node_group_plane_right(Geometry geometry, char *tag, double x1, double y1, double x2, double y2)
void get_geo_node_group_plane(Geometry geometry, char *tag, double x1, double y1, double x2, double y2)
void get_geo_node_group_circle_inner(Geometry geometry, char *tag, double x0, double y0, double radius)
void get_geo_node_group_circle_outer(Geometry geometry, char *tag, double x0, double y0, double radius)
void get_geo_node_group_circle(Geometry geometry, char *tag, double x0, double y0, double radius)
void push_mesh_size(Geometry geometry, General general, char *keyword)
void gmsh_api(Openfdem openfdem, Geometry geometry, char **argv, char *keyword, int write_flag)
void geometry_free(Geometry geometry)
void push_geometry_rdfns(General general, Geometry geometry)
dir /Users/ekaterinaossetchkina/CProjects/openfdem_solver/openfdem src/src/geometry
dir /Users/ekaterinaossetchkina/CProjects/openfdem_solver/openfdem src/src

Geometry class

struct energy_type
#include <openfdem_general.h>

Public Members

Real external_work
Real internal_energy
Real gravity_energy
Real kinetic_energy
Real damping_energy
Real absorbing_energy
Real contact_energy
Real contact_nenergy
Real element_energy
Real cohesive_energy
struct General_structure
#include <openfdem_general.h>

Public Members

long TotalStep
config_type_enum config_type
config_module_enum config_module
short config_GBM
int config_large
long NowStep
char RunTime[256]
char InputFileName[256]
FILE *InputFile
FILE *CheckFile
FILE *FilePointer[10]
long FileID
long debug
char save_path[300]
short save_file_flag
of_vector gravity
double TimeStep
double CurrentTime
Real global_damp
long ShowTimeInterval
short save_flag
char save_filename[300]
short thread
energy_type energy
Real kinetic_ratio
solver_base solver
struct of_fracture
#include <openfdem_struct.h>

Public Members

Real I
Real II
Real III
struct of_principal
#include <openfdem_struct.h>

Public Members

Real p1
Real p2
Real p3
struct of_tensor
#include <openfdem_struct.h>

Public Members

Real xx
Real xy
Real yy
Real yx
Real zz
struct of_vector
#include <openfdem_struct.h>

Public Members

Real x
Real y
struct of_vectorn
#include <openfdem_struct.h>

Public Members

Real normal
Real shear
struct solver_base
#include <openfdem_general.h>

Public Members

UInt last_node_n
UInt last_ele_n
UInt last_cohele_n
UInt run_times
file openfdem_commom.h
#include <stdlib.h>#include <stdio.h>#include <string.h>#include <limits.h>#include <signal.h>#include “openfdem_message.h”#include “openfdem_enum.h”#include “openfdem_struct.h”

Defines

FileNull
Char2DNull
Double1DNull
Double2DNull
Double3DNull
Int1DNull
Int2DNull
Edge2Length(l, x1, y1, x2, y2)
V2Darea(s, l1, l2, l3)

Functions

void get_filename_no_path(char *return_string, char *input_string)
void get_path(char *return_string, char *input_string)
void parse_string(FILE *InputFile, char *string)
void get_filename_no_suffix(char *return_string, char *input_string)
void get_suffix(char *return_string, char *input_string)
void strip_ext(char *fname)
double *malloc_1D_double_array(long m1)
double *initialize_1D_double_array(long m1, double dini)
double **malloc_2D_double_array(long m2, long m1)
double **initialize_2D_double_array(long m2, long m1, double dini)
double ***malloc_3D_double_array(long m3, long m2, long m1)
double ***initialize_3D_double_array(long m3, long m2, long m1, double dini)
long *malloc_1D_int_array(long m1)
long *initialize_1D_int_array(Int m1, Int iini)
UInt *initialize_1D_UInt_array(UInt m1, UInt iini)
long **malloc_2D_int_array(long m2, long m1)
long **initialize_2D_int_array(long m2, long m1, long iini)
void parse_1D_double_array(FILE *fileptr, double initial_double, long max_size, long actual_size, double **d1aray)
void parse_2D_double_array(FILE *fileptr, double initial_double, long max_size1, long max_size2, long read_way, long actual_size1, long actual_size2, double ***d2aray)
void parse_3D_double_array(FILE *fileptr, double dinit, long n1, long n2, long n3, double ****d3aray)
void parse_1D_int_array(FILE *fileptr, long initial_int, long max_size, long actual_size, long **i1aray)
void parse_2D_int_array(FILE *fileptr, long initial_int, long max_size1, long max_size2, long read_way, long actual_size1, long actual_size2, long ***i2aray)
void get_vector_unit(double *e1x, double *e1y, double rx, double ry)
void get_vector_rotated(double *e1x, double *e1y, double e2x, double e2y)
void get_vector_global_to_local(double *u, double *v, double rx, double ry, double e1x, double e1y, double e2x, double e2y)
int openfdem_run_usr_break(double dctime, long ncstep, long mcstep)
long get_line_current_position(FILE *fileptr)
void create_result_store_folder(char *Result_store_folder)
void NULL_vector(of_vector *d1aray)
void parse_vector(FILE *fileptr, double dinit, of_vector *d1aray)
void parse_1D_vector(FILE *fileptr, double dinit, long max_size, long actual_size, of_vector **d1aray)
of_tensor *initialize_1D_tensor(unsigned int size, double double_ini)
of_tensor *parse_1D_tensor(FILE *fileptr, UInt size, Real double_ini)
UInt *realloc_UInt_array(UInt *array, UInt size)
int *realloc_Int_array(int *array, int size)
file openfdem_enum.h

Enums

enum config_type_enum

Values:

enumerator CONFIG_NONE
enumerator PLANESTRESS
enumerator PLANESTRAIN
enum mesh_enum

Values:

enumerator INSERT
enumerator SPLIT
enumerator REMESH3
enumerator REMESH4
enumerator REMESH6
enumerator IMPLICIT
enum boundary_fluid_enum

Values:

enumerator POREPRESSURE
enumerator WATER_LEVEL
enumerator PRESSURE
enumerator FLOW
enumerator IMPERMABLE
enum boundary_thermal_enum

Values:

enumerator INI_TEMPERATURE
enumerator TEMPERATURE
enumerator CONVECTION
enumerator FLUX
enumerator RADIATION
enumerator SOURCE
enum boundary_node_enum

Values:

enumerator FORCE
enumerator FORCE_X
enumerator FORCE_Y
enumerator VEL
enumerator VEL_X
enumerator VEL_Y
enumerator INIVEL
enumerator INIVEL_X
enumerator INIVEL_Y
enumerator VISCOUS
enumerator VISCOUS_X
enumerator VISCOUS_Y
enumerator ACCEL
enumerator ACCEL_X
enumerator ACCEL_Y
enumerator FORCE_LOCAL
enumerator FORCE_LOCAL_X
enumerator FORCE_LOCAL_Y
enumerator VEL_LOCAL
enumerator VEL_LOCAL_X
enumerator VEL_LOCAL_Y
enumerator INIVEL_LOCAL
enumerator INIVEL_LOCAL_X
enumerator INIVEL_LOCAL_Y
enumerator ACCEL_LOCAL
enumerator ACCEL_LOCAL_X
enumerator ACCEL_LOCAL_Y
enumerator NORMAL
enumerator SHEAR
enum cohelement_enum

Values:

enumerator INTACT
enumerator DAMAGE
enumerator BROKEN
enum DFN_enum

Values:

enumerator NDFN
enumerator DFN_COHESIVE
enumerator DFN_BROKEN
enum boundary_element_enum

Values:

enumerator STRESS
enumerator GRADIENT_X
enumerator GRADIENT_Y
enum config_module_enum

Values:

enumerator MECHANICAL
enumerator HYDRO
enumerator THERMAL
enumerator BLAST
enumerator BLAST_HYDRO
enumerator DYNAMIC
enum element_cons

Values:

enumerator ELASTIC
enumerator RIGID
enumerator SOFTEN
enumerator TRANSVERSE
enumerator MC
enumerator DP
enumerator OTHERS
enum cohelement_cons

Values:

enumerator COH_EM
enumerator COH_EM_FRIC
enumerator COH_LINEAR
enumerator COH_OP
enumerator COH_BB
enumerator COH_EM_HET
enumerator COH_EM_ANI
enumerator COH_EM_DYNAMIC
enumerator COH_OTHERS
enum contact_cons

Values:

enumerator CON_MC
enumerator CON_DYNAMIC_MC
enumerator CON_HERTZ
enumerator CON_BB
enumerator CON_FRICTION
enumerator CON_OTHERS
enum contact_detection

Values:

enumerator LIG
enumerator NBS
enumerator mNBS
enumerator CELL
enum contact_force

Values:

enumerator DEFAULT_MUNJIZA
enumerator LIG_F
enum random_method

Values:

enumerator RANDOM_NULL
enumerator RANDOM_CONSTANT
enumerator RANDOM_GAUSSE
enumerator RANDOM_UNIFORM
enumerator RANDOM_EXPONENTINAL
enumerator RANDOM_LOG_NORMAL
enumerator RANDOM_POWER
enumerator RANDOM_FISHER
enum his_nodal_t

Values:

enumerator HIS_DIS
enumerator HIS_VEL
enumerator HIS_FOR
enumerator HIS_FLUID_P
enumerator HIS_FRAC_P
enumerator HIS_MATRIX_P
enumerator HIS_TEMP
enum his_ele_t

Values:

enumerator HIS_STRESS
enumerator HIS_STRAIN
enumerator HIS_STRAIN_R
enumerator HIS_PLASTIC
enum his_cohele_t

Values:

enumerator HIS_COH_DIS
enumerator HIS_COH_FOR
enumerator HIS_COH_VEL
enumerator HIS_COH_SHEAR
enum his_contact_t

Values:

enumerator HIS_CON_DIS
enumerator HIS_CON_FOR
enumerator HIS_CON_VEL
enum his_general_t

Values:

enumerator HIS_TIME
enumerator HIS_CYCLE
enumerator HIS_N_FRACTURE
enumerator HIS_N_DAMAGE
enumerator HIS_N_AE
enumerator HIS_ENERGY_KINETIC
enumerator HIS_ENERGY_ELEMENT_STRAIN
enumerator HIS_ENERGY_FRACTURE
enumerator HIS_ENERGY_AE
enumerator HIS_ENERGY_DAMP
enumerator HIS_ENERGY_SLIP
enumerator HIS_ENERGY_PLASTIC
enumerator HIS_UNBALANCE_FORCE
enumerator HIST_ENERGY_RATIO
file openfdem_general.h
#include “openfdem_commom.h”

Typedefs

typedef struct General_structure *General
file openfdem_io_binary.h
#include “../solve/openfdem.h”

Functions

void openfdem_save_binary(char *filename, struct OpenFDEM_structure openfdem)

filename openfdem_math.c

author Xiaofeng Li xfli@whrsm.ac.cn

date creation: Fri Jun 18 2010 date last modification: Tue Sep 29 2020

function: common math

LICENSE

This library is free software; you can redistribute it and/or modify it under the terms of the GNU Lesser General Public License as published by the Free Software Foundation; either version 2.1 of the License, or (at your option) any later version.

This program 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 Lesser General Public License for more details.

void openfdem_restore_binary(char *filename, struct OpenFDEM_structure openfdem)
file openfdem_math.h
#include <math.h>#include “openfdem_struct.h”

Defines

Openfdem_pos_epsilon

filename openfdem_math.h

author Xiaofeng Li xfli@whrsm.ac.cn

date creation: Fri Jun 18 2010 date last modification: Tue Sep 29 2020

function: common math

LICENSE

This library is free software; you can redistribute it and/or

modify it under the terms of the GNU Lesser General Public

License as published by the Free Software Foundation; either

version 2.1 of the License, or (at your option) any later version.

This program 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

Lesser General Public License for more details.

Openfdem_neg_epsilon
Openfdem_max_value
Openfdem_PI
Openfdem_e
Openfdem_double_abs(x)
Openfdem_max(x, y)
Openfdem_min(x, y)
Openfdem_sign(x)
Matrix2Inverse(m, minv, det)
Vector2DotProduct(s, x1, y1, x2, y2)
Vector2Normalize(s, x1, y1)
Vector2Cro(s, x1, y1, x2, y2)

Functions

Real random_normal(Real mu, Real sigma)
file openfdem_message.h
#include <stdlib.h>#include <stdio.h>#include <string.h>#include <limits.h>#include <signal.h>

Defines

Parse_int(file, x)
Parse_double(file, x)
parse_keyword(file, x)
Dump_int(file, x, ndigit)
Dump_double(file, x, ndigit)
dump_string(file, x)
Dump_statement(file, x, ndigit)

Functions

void dump_message(char *c1)
void dump_message_keyword(char *c1, char *c2)
void check_parse_status(FILE *checkfile, char *keyword)
void dump_message_mat(char *c1, int c2)
void dump_message_group(int n1, char *c1, char *c2)
void dump_message_type2(int c2, char *c1)

Variables

static char *DoubleString[20] = {"%le", "%+1.0le", "%+2.0le", "%+3.0le", "%+4.0le", "%+5.0le", "%+6.0le", "%+7.0le", "%+8.1le", "%+9.2le", "%+10.3le", "%+11.4le", "%+12.5le", "%+13.6le", "%+14.7le", "%+15.8le", "%+16.9le", "%+17.10le", "%+18.11le", "%+19.12le"}

filename openfdem_message.h

author Xiaofeng Li xfli@whrsm.ac.cn

date creation: Fri Jun 18 2010 date last modification: Tue Sep 29 2020

function: message

LICENSE

This library is free software; you can redistribute it and/or modify it under the terms of the GNU Lesser General Public License as published by the Free Software Foundation; either version 2.1 of the License, or (at your option) any later version.

This program 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 Lesser General Public License for more details.

static char *IntString[20] = {"%ld", "%1ld", "%2ld", "%3ld", "%4ld", "%5ld", "%6ld", "%7ld", "%8ld", "%9ld", "%10ld", "%11ld", "%12ld", "%13ld", "%14ld", "%15ld", "%16ld", "%17ld", "%18ld", "%19ld"}
static char *CharString[30] = {"%s", "%1s", "%2s", "%3s", "%4s", "%5s", "%6s", "%7s", "%8s", "%9s", "%10s", "%11s", "%12s", "%13s", "%14s", "%15s", "%16s", "%17s", "%18s", "%19s", "%20s", "%21s", "%22s", "%23s", "%24s", "%25s", "%26s", "%27s", "%28s", "%29s"}
file openfdem_struct.h

Defines

UInt
Int
Real
file openfdem_time.h
#include “../solve/openfdem.h”

Functions

void Openfdem_show_time(General general, Nodal nodal, Contact contact)

filename openfdem_time.h

author Xiaofeng Li xfli@whrsm.ac.cn

date creation: Fri Jun 18 2010 date last modification: Tue Sep 29 2020

function: time

LICENSE

This library is free software; you can redistribute it and/or

modify it under the terms of the GNU Lesser General Public

License as published by the Free Software Foundation; either

version 2.1 of the License, or (at your option) any later version.

This program 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

Lesser General Public License for more details.

void openfdem_date_time(char *date_time)
void openfdem_stamp_time(void)
double openfdem_time_count(void)
file openfdem_tools.h
#include <stdlib.h>#include <stdio.h>#include <string.h>#include <limits.h>#include <signal.h>#include “openfdem_struct.h”#include “../solid/solid_mechanics_cohesive/openfdem_solid_cohesive.h”#include “../solid/solid_mechanics_cohesive/sesmic/openfdem_sesmic.h”#include “../solid/openfdem_nodal.h”#include “../common/openfdem_general.h”

Functions

fracture_type *realloc_fracture_structure(fracture_type *array, UInt size)
damage_type *realloc_damage_structure(damage_type *array, UInt size)
ae_type *realloc_ae_structure(ae_type *array, UInt size)
void parse_node(FILE *fileptr, long max_size, long actual_size, node_type **d1aray, General general)

Solid class

struct ae_type
#include <openfdem_sesmic.h>

this structure is responsible for…

ae_type(5,6,7,magnitude=9)
param time

param win_time

param win_kinetic

Public Members

Real time
Real win_time
Real win_kinetic
Real kinetic
Real magnitue
UInt coele
union any_cohmat_type
#include <openfdem_solid_cohesive_materials.h>
union any_conmat_type
#include <openfdem_solid_contact_materials.h>

Public Members

solidcon_MC_t MC
solidcon_dynamic_MC_t D_MC
union any_mat_type
#include <openfdem_solid_materials.h>

Public Members

solid_elastic_t elastic
solid_soften_t soften
solid_rigid_t rigid
solid_transverse_t transverse
solid_MC_t MC
struct Coh_element_structure
#include <openfdem_solid_cohesive.h>

Public Members

cohelement_type *cohele
UInt cohe_num
UInt cohe_ini_num
UInt broken_num
UInt damage_num
Real *shear_strength
of_vectorn *force
of_vectorn *dis
of_vectorn *vel
fracture_type *fracture
damage_type *damage
Real *het_value
of_vectorn *DIF_0
of_vectorn *DIF_1
of_vectorn *DIF_2
Int *flag
struct cohelement_type
#include <openfdem_solid_cohesive.h>

Public Members

Real x
Real y
UInt matid
UInt n_node
cohelement_enum state
Int stater
DFN_enum dfn
UInt *nodes
UInt *ele
UInt *edge
of_fracture damage
Real energy
Real area
UInt old_map
struct Contact_structure
#include <openfdem_solid_contact.h>

Public Members

UInt n_contact
short *potentional_contact_element
contact_type *con
Int detection_count
Int contact_count
contact_detection detection
contact_force force_model
Real contact_trigger
Real contact_buffer
Real fn
Real fs
struct contact_type
#include <openfdem_solid_contact.h>

Public Members

UInt con_n
Int head
Int *hold
Real *sliding_distance[6]
short *sliding_state[6]
Int *target
short *type
short *slip_flag
struct damage_type
#include <openfdem_solid_cohesive.h>

Public Members

Real time
Real length
Real type
UInt coele
struct DFN_structure
#include <openfdem_DFN.h>

Public Members

UInt n_dfn
dfn_type *dfn
struct dfn_type
#include <openfdem_DFN.h>

Public Members

char *tag
UInt n_1
UInt n_2
DFN_enum type
Int cohele
struct Element_structure
#include <openfdem_solid.h>

Public Members

element_type *ele
UInt e_num
UInt e_ini_num
Real e_min_size
Real e_mean_size
Real **soften_state
of_tensor *stress
of_tensor *strain
of_tensor *strain_rate
struct element_type
#include <openfdem_solid.h>

Public Members

UInt matid
Real x
Real y
UInt n_node
Real area
UInt *nodes
Int *couple
Real radius
Real energy
UInt n_group
UInt *group
Real minedge
short excavation
short uncontacted
struct fracture_type
#include <openfdem_solid_cohesive.h>

Public Members

Real time
Real length
Real energy
Real type
UInt coele
struct mat_cohelement_t
#include <openfdem_mat.h>

Public Members

char *tag
cohelement_cons cons
any_cohmat_type *mat
struct mat_contact_t
#include <openfdem_mat.h>

Public Members

Int emat1
Int emat2
contact_cons cons
any_conmat_type *mat
struct mat_element_t
#include <openfdem_mat.h>

Public Members

char *tag
element_cons cons
any_mat_type *mat
Real damp
struct mat_fluid_cohesive_t
#include <openfdem_mat.h>

Public Members

Real a_0
Real a_min
Real para_exp
Real para_b
struct mat_fluid_element_t
#include <openfdem_mat.h>

Public Members

Real permiability
Real Biot_modulus
Real Biot_c
struct mat_fluid_t
#include <openfdem_mat.h>

Public Members

Real den
Real bulk
Real viscosity
Real cohesion
struct mat_gas_t
#include <openfdem_mat.h>

Public Members

Real initial_den
Real initial_bulk
Real permiability
Real constant_B
Real alpha
struct mat_thermal_element_t
#include <openfdem_mat.h>

Public Members

Real conductivity
Real specific_heat
Real expansion
struct Nodal_structure
#include <openfdem_nodal.h>

Public Members

UInt dimension
UInt n_num
UInt n_ini_num
node_type *node
of_vector *total_force
of_vector *nodal_vel
of_vector *dis_excavate
Int **net_connect
Real element_maximuum_unbalance_force
Real cohesive_maximuum_unbalance_force
Real contact_maximuum_unbalance_force
Real max_velocity
Real unbalance_force
struct node_type
#include <openfdem_nodal.h>

Public Members

Real mass
Real x0
Real y0
Real x
Real y
UInt n_group
UInt *group
UInt old_map
struct Seismic_structure
#include <openfdem_sesmic.h>

this is a brief description

seismic_structure(method, window, 4);
param method

this variable does…

param window

Public Members

UInt method
Real window
UInt ae_num
ae_type *ae
struct solid_elastic_t
#include <openfdem_solid_materials.h>

Public Members

Real E
Real v
Real den
Real K
Real G
struct Solid_mat_structure
#include <openfdem_mat.h>

Public Members

UInt n_mat
UInt n_cohmat
UInt n_conmat
UInt n_hydro_mat
UInt n_hydro_coh
UInt n_thermal_mat
mat_element_t *elemat
mat_cohelement_t *cohelemat
mat_contact_t *conmat
mat_fluid_t water
mat_gas_t gas
mat_fluid_element_t *hydro_ele
mat_fluid_cohesive_t *hydro_coh
mat_thermal_element_t *thermal_ele
short hysteretic_flag
struct solid_MC_t
#include <openfdem_solid_materials.h>

Public Members

Real E
Real v
Real den
Real K
Real G
Real ten
Real coh
Real fri
struct solid_rigid_t
#include <openfdem_solid_materials.h>

Public Members

Real den
struct solid_soften_t
#include <openfdem_solid_materials.h>

Public Members

Real E
Real v
Real den
Real K
Real G
Real stretch
Real coh
Int damage
struct solid_transverse_t
#include <openfdem_solid_materials.h>

Public Members

Real E_x
Real E_y
Real den
Real v_xy
Real v_yx
Real G
struct solidcoh_EM_t
#include <openfdem_solid_cohesive_materials.h>

Public Members

Real pn
Real pt
Real ten
Real coh
Real fri
Real GI
Real GII
Real beta_n
Real beta_t
Real thermal_h
struct solidcoh_linear_t
#include <openfdem_solid_cohesive_materials.h>

Public Members

Real pn
Real pt
Real ten
Real coh
Real fri
Real GI
Real GII
struct solidcoh_OP_t
#include <openfdem_solid_cohesive_materials.h>

Public Members

Real pn
Real pt
Real ten
Real coh
Real delta_n
Real delta_s
struct solidcohani_EM_t
#include <openfdem_solid_cohesive_materials.h>

Public Members

Real power
Real dip
Real pn
Real pt
Real *ten
Real *coh
Real *fri
Real *GI
Real *GII
struct solidcohdyn_EM_t
#include <openfdem_solid_cohesive_materials.h>

Public Members

Real pn
Real pt
Real ten
Real coh
Real fri
Real GI
Real GII
Real c_rate_n
Real c_rate_s
Real exp_n
Real exp_s
struct solidcohhet_EM_t
#include <openfdem_solid_cohesive_materials.h>

Public Members

Real pn
Real pt
Real *ten
Real *coh
Real *fri
Real *GI
Real *GII
struct solidcon_dynamic_MC_t
#include <openfdem_solid_contact_materials.h>

Public Members

Real kn
Real ks
Real static_fri
Real residual_fri
Real slip_rate
struct solidcon_MC_t
#include <openfdem_solid_contact_materials.h>

Public Members

Real fri
Real kn
Real ks
file openfdem_mat.h
#include “../../common/openfdem_enum.h”#include “solid_mat/openfdem_solid_materials.h”#include “solid_mat_cohesive/openfdem_solid_cohesive_materials.h”#include “solid_mat_contact/openfdem_solid_contact_materials.h”

Typedefs

typedef struct Solid_mat_structure *Solidmat
file openfdem_solid_materials.h
file push_element_materials.h
#include “../../../io/parser.h”

Functions

void push_element_materials(General general, Element element, Group group, Solidmat solidmat, char *keyword)
file openfdem_solid_cohesive_materials.h
file push_cohesive_element_materials.h
#include “../../../io/parser.h”

Functions

void push_cohesive_element_materials(General general, Cohelement cohelement, Group group, Solidmat solidmat, char *keyword)
file openfdem_solid_contact_materials.h
file push_contact_materials.h
#include “../../../io/parser.h”

Functions

void push_contact_materials(General general, Solidmat solidmat, Contact contact, char *keyword)
file openfdem_nodal.h
#include “../common/openfdem_struct.h”

Typedefs

typedef struct Nodal_structure *Nodal
file solid_mechanics.h
#include “../solve/openfdem.h”#include “../common/openfdem_math.h”

Functions

void Openfdem_element_force_update(Openfdem openfdem)
Parameters

openfdem

  • nodal forces **

void Openfdem_cohesive_force_update(Openfdem openfdem)
Parameters

openfdem

  • nodal forces **

file openfdem_solid.h
#include “../../common/openfdem_struct.h”#include “../../common/openfdem_commom.h”

Typedefs

typedef struct Element_structure *Element
file solid_mechanics_elastic_triangle.h
#include “../../solve/openfdem.h”

Functions

void Solid_mechanics_elastic_triangle(Element element, Solidmat solidmat, General general, UInt elementid, Nodal nodal)
file solid_mechanics_soften_triangle.h
#include “../../solve/openfdem.h”

Functions

void Solid_mechanics_soften_triangle(Element element, Solidmat solidmat, UInt elementid, Nodal nodal, Real *soften_state)
file solid_mechanics_transverse_triangle.h
#include “../../solve/openfdem.h”

Functions

void Solid_mechanics_transverse_triangle(Element element, Solidmat solidmat, General general, UInt elementid, Nodal nodal)
file openfdem_DFN.h

Typedefs

typedef struct DFN_structure *DFN
file openfdem_solid_cohesive.h
#include “../../common/openfdem_struct.h”#include “../../common/openfdem_commom.h”

Typedefs

typedef struct Coh_element_structure *Cohelement
file openfdem_sesmic.h

Typedefs

typedef struct Seismic_structure *Seismic
file solid_mechanics_cohesive_4_node_EM.h
#include “../../solve/openfdem.h”

Functions

void Solid_mechanics_cohesive_4_node_EM(Nodal nodal, UInt cohelement_id, Real CurrentTime, Real TimeStep, Cohelement cohelement, Element element, Contact contact, Solidmat solidmat, Seismic seismic, General general)
file solid_mechanics_cohesive_4_node_EM_anisotropic.h
#include “../../solve/openfdem.h”

Functions

void solid_mechanics_cohesive_4_node_EM_anisotropic(Nodal nodal, UInt cohelement_id, Real CurrentTime, Real TimeStep, Cohelement cohelement, Element element, Solidmat solidmat, Seismic seismic)
file solid_mechanics_cohesive_4_node_EM_hetero.h
#include “../../solve/openfdem.h”

Functions

void solid_mechanics_cohesive_4_node_EM_hetero(Nodal nodal, UInt cohelement_id, Real CurrentTime, Real TimeStep, Cohelement cohelement, Element element, Solidmat solidmat, Seismic seismic)
file solid_mechanics_cohesive_4_node_linear.h
#include “../../solve/openfdem.h”

Functions

void Solid_mechanics_cohesive_4_node_linear(Nodal nodal, UInt cohelement_id, Real CurrentTime, Real TimeStep, Cohelement cohelement, Element element, Solidmat solidmat, Seismic seismic)
file contact_add_list_from_cohesive.h
#include “../../solid/solid_mechanics_contact/openfdem_solid_contact.h”#include “../../common/openfdem_math.h”

Functions

void contact_add_list_from_cohesive(Contact contact, UInt ielem, UInt jelem, short slip)
void malloc_contact(Contact contact, UInt ielem, UInt jelem)
void realloc_contact(Contact contact, UInt ielem, UInt jelem)
file contact_detection.h
#include “../../solve/openfdem.h”

Functions

void Openfdem_contact_dection(Openfdem openfdem)
Parameters

openfdem

  • contact detection **

file contact_detection_method.h
#include “../../solve/openfdem.h”

Functions

void Contact_dection_method_NBS(Contact contact, General general, Element element, Cohelement cohelement, Nodal nodal)
void Contact_dection_method_mNBS(Contact contact, General general, Element element, Cohelement cohelement, Nodal nodal)
void Contact_dection_method_LIG(Contact contact, General general, Element element, Cohelement cohelement, Nodal nodal)
file contact_force.h
#include “../../solve/openfdem.h”

Functions

void Openfdem_contact_force(Openfdem openfdem)
Parameters

openfdem

  • nodal forces **

file contact_force_triangle_interact.h
#include “../../solve/openfdem.h”

Functions

void Contact_force_triangle(General general, Element element, Solidmat solidmat, UInt conmat, Contact contact, Nodal nodal)
void Contact_force_triangle_LIG(General general, Element element, Solidmat solidmat, UInt conmat, Contact contact, Nodal nodal)
file get_potentional_contact_couple.h
#include “../../solid/solid_mechanics/openfdem_solid.h”#include “../../solid/solid_mechanics_cohesive/openfdem_solid_cohesive.h”#include “../../solid/solid_mechanics_contact/openfdem_solid_contact.h”#include “../../common/openfdem_struct.h”

Functions

UInt get_potentional_contact_couple(Element element, Contact contact, Cohelement cohelement)
file openfdem_solid_contact.h
#include “../../common/openfdem_struct.h”#include “../../common/openfdem_commom.h”

Typedefs

typedef struct Contact_structure *Contact
dir /Users/ekaterinaossetchkina/CProjects/openfdem_solver/openfdem src/src/solid/solid_mechanics_cohesive/DFN
dir /Users/ekaterinaossetchkina/CProjects/openfdem_solver/openfdem src/src/solid/materials
dir /Users/ekaterinaossetchkina/CProjects/openfdem_solver/openfdem src/src/solid/solid_mechanics_cohesive/sesmic
dir /Users/ekaterinaossetchkina/CProjects/openfdem_solver/openfdem src/src/solid
dir /Users/ekaterinaossetchkina/CProjects/openfdem_solver/openfdem src/src/solid/materials/solid_mat
dir /Users/ekaterinaossetchkina/CProjects/openfdem_solver/openfdem src/src/solid/materials/solid_mat_cohesive
dir /Users/ekaterinaossetchkina/CProjects/openfdem_solver/openfdem src/src/solid/materials/solid_mat_contact
dir /Users/ekaterinaossetchkina/CProjects/openfdem_solver/openfdem src/src/solid/solid_mechanics
dir /Users/ekaterinaossetchkina/CProjects/openfdem_solver/openfdem src/src/solid/solid_mechanics_cohesive
dir /Users/ekaterinaossetchkina/CProjects/openfdem_solver/openfdem src/src/solid/solid_mechanics_contact
dir /Users/ekaterinaossetchkina/CProjects/openfdem_solver/openfdem src/src