SIFEL/GEFEL/vector.h File Reference

#include <stdio.h>
#include <assert.h>
#include "iotools.h"

Go to the source code of this file.

Classes

struct  atsel
struct  ivector
struct  vector

Functions

void absv (ivector &a)
 absolute value of vector components
void absv (vector &a)
 absolute value of vector components
void addmultv (double *a, double *b, double bc, double *c, long n)
 adds 2 double arrays, 2nd array is multplied by constant, the result is stored in the third array
void addmultv (double *a, double *b, double bc, long n)
 adds 2 double arrays, 2nd array is multplied by constant and added to the first array
void addmultv (vector &a, const vector &b, double bc)
 adds 2 double arrays, 2nd array is multplied by constant a = a + bc*b
void addmultv (const vector &a, const vector &b, double bc, vector &c)
 adds 2 double arrays, 2nd array is multplied by constant a = a + bc*b
void addv (double *a, double *b, double *c, long n)
 adds 2 double arrays c = a+b
void addv (double *a, double *b, long n)
 adds 2 double arrays a = a+b
long addv (const ivector &a, const ivector &b, ivector &c)
 adds 2 ivectors c = a+b
long addv (const vector &a, const vector &b, vector &c)
 adds 2 vectors c = a+b
long allocv (long n, ivector &vec)
 allocates ivector
long allocv (long n, vector &vec)
 allocates vector
void cmulv (double c, double *a, double *u, long n)
 multiplies double array by constant
void cmulv (double c, double *a, long n)
 multiplies double array by constant
long cmulv (long c, ivector &a)
 multiplies ivector by constant of type long
long cmulv (double c, vector &a)
 multiplies vector by constant
long cmulv (long c, const ivector &a, ivector &u)
 multiplies ivector by constant of type long
long cmulv (double c, const ivector &a, vector &u)
 multiplies ivector by constant of type double
long cmulv (double c, const vector &a, vector &u)
 multiplies vector by constant
long copymultv (const double *src, double *dest, const double c, long n)
 copies contents of array multiplied by scalar
long copymultv (const ivector &src, ivector &dest, const long c)
 copies contents of ivector multiplied by scalar
long copymultv (const vector &src, vector &dest, const double c)
 copies contents of vector multiplied by scalar
long copyv (const vector &src, double *dest)
 copies contents of vector to array
long copyv (const double *src, vector &dest)
 copies contents of array to vector
long copyv (const double *src, double *dest, long n)
 copies contents of array
long copyv (const long *src, long *dest, long n)
long copyv (const ivector &src, ivector &dest)
 copies contents of ivector
long copyv (const vector &src, vector &dest)
 copies contents of vector
long cosav (const ivector &a, const ivector &b, double &cos)
 cosine angle of 2 ivectors
long cosav (const vector &a, const vector &b, double &cos)
 cosine angle of 2 vectors
long crprd (const ivector &a, const ivector &b, ivector &c)
 performs cross product of 2 ivectors
long crprd (const vector &a, const vector &b, vector &c)
 performs cross product of 2 vectors
long destrv (ivector &vec)
 deallocates ivector
long destrv (vector &vec)
 deallocates vector
void extract (vector &a, vector &b, long fi, long ncomp)
 function extracts ncomp components (from index fi) from vector b
long extractnegv (vector &a, vector &b)
 extracts only negative components from vector a and stores them to vector b
long extractposv (vector &a, vector &b)
 extracts only positive components from vector a and stores them to vector b
void fillv (double c, double *vec, long n)
 fills contents of vector given by array with value c
void fillv (long c, long *vec, long n)
 fills contents of integer vector given by array with value c
long fillv (long c, ivector &vec)
 fills contents of ivector with value c
long fillv (double c, vector &vec)
 fills contents of vector with value c
double normv (const ivector &a)
 computes norm of ivector
double normv (const double *a, long n)
 computes norm of vector
double normv (const vector &a)
 computes norm of vector
long nullv (ivector &a)
long nullv (double *a, long n)
 fills array with zeros
long printv (const long *u, long n, FILE *out=stdout, int width=11)
 prints contents of integer vector given by array
long printv (const ivector &u, FILE *out=stdout, int width=11)
 prints contents of ivector
long printv (FILE *out, vector &u)
 prints vector u to the file out
long printv (const double *u, long n, FILE *out=stdout, int prec=3, int width=11)
 prints contents of vector given by array to the file out with given precision and field width
long printv (const vector &u, FILE *out=stdout, int prec=3, int width=11)
 prints contents of vector to the file out with given precision and field width
long readv (char *in, vector &u)
 reads contents of vector from string
long readv (XFILE *in, vector &u)
 reads contents of vector from file
long reallocv (long n, ivector &vec)
 reallocates ivector
long reallocv (long n, vector &vec)
 reallocates vector
double scprd (const double *a, const double *b, long n)
 performs scalar product of 2 arrays
long scprd (const ivector &a, const ivector &b, long &scalar)
 performs scalar product of 2 ivectors
long scprd (const vector &a, const vector &b, double &scalar)
 performs scalar product of 2 vectors
void shell_sort (long *v, long n)
 Shell sort for long integer array.
void shell_sort (ivector &v)
 Shell sort of ivector.
double ss (double *a, double *b, long n)
 performs scalar product of 2 arrays
void subv (double *a, double *b, double *c, long n)
 subtracts 2 arrays, result is stored to the another array
void subv (double *a, double *b, long n)
 subtracts 2 arrays
long subv (const ivector &a, const ivector &b, ivector &c)
 subtracts 2 ivectors
long subv (const vector &a, const vector &b)
 subtracts 2 vectors
long subv (const vector &a, const vector &b, vector &c)
 subtracts 2 vectors

Function Documentation

void absv ( ivector a  ) 

absolute value of vector components

The function changes components of vector a to their absolute value

Parameters:
a is the structure of the first ivector

created 7.2008 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 1562 of file vector.cpp.

References ivector::n.

void absv ( vector a  ) 

absolute value of vector components

The function changes components of vector a to their absolute value

Parameters:
a is the structure of the first ivector

created 7.2008 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 1546 of file vector.cpp.

References vector::n.

void addmultv ( double *  a,
double *  b,
double  bc,
double *  c,
long  n 
)

adds 2 double arrays, 2nd array is multplied by constant, the result is stored in the third array

The function adds double array b multiplied by scalar bc to double array given by a, the result is stored in c

Parameters:
a is result array
b is added array
bc is scalar
c is scalar
n is the number of vector components
Returns:
The result is stored in the array c.

created by TKo

Definition at line 865 of file vector.cpp.

void addmultv ( double *  a,
double *  b,
double  bc,
long  n 
)

adds 2 double arrays, 2nd array is multplied by constant and added to the first array

The function adds double array b multiplied by scalar c to double array given by a, the result is stored in a

Parameters:
a is result array
b is added array
bc is scalar
n is the number of vector components
Returns:
The result is stored in the array a.

created by JK

Definition at line 844 of file vector.cpp.

void addmultv ( vector a,
const vector b,
double  bc 
)

adds 2 double arrays, 2nd array is multplied by constant a = a + bc*b

The function adds vector given by a to vector given by b which is multiplied by bc, the result is stored in a.

Parameters:
a is the structure of the first added vector
b is the structure of the second added vector

Requests : a and b must have the same dimensions, c must have allocated memory array for elements which is large enough to hold contents of the result.

Returns:
The function returns the result in the parameter a.

created 08.2011 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 748 of file vector.cpp.

References vector::n, and print_err().

void addmultv ( const vector a,
const vector b,
double  bc,
vector c 
)

adds 2 double arrays, 2nd array is multplied by constant a = a + bc*b

The function adds vector given by a to vector given by b, the result is stored in c.

Parameters:
a is the structure of the first added vector
b is the structure of the second added vector
c is the structure of the result vector

Requests : a, b and c must be the same dimensions, c must have allocated memory array for elements which is large enough to hold contents of the result.

Returns:
The function returns the result in the parameter c.

created 08.2011 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 720 of file vector.cpp.

References vector::n, and print_err().

Referenced by arclengthrv(), assamble_attained_load_vector(), assemble_attained_load_vector(), garclength(), gnewton_raphson(), gnewton_raphson2(), drprag2::nlstresses(), one_step_arcl(), one_step_nonlinear_dform(), drprag2::tangentstiff(), and update_attained_load_vector().

void addv ( double *  a,
double *  b,
double *  c,
long  n 
)

adds 2 double arrays c = a+b

The function adds two double arrays a and b, the result is stored in c

Parameters:
a is added array
b is added array
c is result array
n is the number of vector components

created by JK

Definition at line 824 of file vector.cpp.

void addv ( double *  a,
double *  b,
long  n 
)

adds 2 double arrays a = a+b

The function adds double array b to double array given by a, the result is stored in a

Parameters:
a is result array
b is added array
n is the number of vector components
Return values:
always zero

created by JK

Definition at line 806 of file vector.cpp.

long addv ( const ivector a,
const ivector b,
ivector c 
)

adds 2 ivectors c = a+b

The function adds ivector given by a to ivector given by b, the result is stored in c

Parameters:
a is the structure of the first added ivector
b is the structure of the second added ivector
c is the structure of the result ivector

Requests : a, b and c should have same dimensions, c has to have allocated memory array for elements which is enough large to hold contents of the result.

Return values:
0 on succes
1 in case incompatibility sizes of a, b and c vectors

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 779 of file vector.cpp.

References ivector::a, ivector::n, and print_err().

long addv ( const vector a,
const vector b,
vector c 
)

adds 2 vectors c = a+b

The function adds vector given by a to vector given by b, the result is stored in c

Parameters:
a is the structure of the first added vector
b is the structure of the second added vector
c is the structure of the result vector

Requests : a, b and c have to be same dimensions, c has to have allocated memory array for elements which is enough large to hold contents of the result.

Return values:
0 : on succes
1 : in case incompatibility sizes of a, b and c vectors

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 689 of file vector.cpp.

References vector::a, vector::n, and print_err().

Referenced by axisymlq::allip_strains(), axisymlq::allip_stresses(), arclength(), arclengthadapt(), arclengthrv(), arclengthrv1(), linhext::average_flux(), trlineart::boundary_flux(), trlinaxisym::boundary_flux(), quadquadrilattax::boundary_flux(), quadquadrilatt::boundary_flux(), quadlineart::boundary_flux(), quadlinaxisym::boundary_flux(), quadhext::boundary_flux(), quadbartax::boundary_flux(), quadbart::boundary_flux(), lintett::boundary_flux(), linhext::boundary_flux(), linbartax::boundary_flux(), linbart::boundary_flux(), seqfeti::coarse_local(), trlineart::convection_vector(), trlinaxisym::convection_vector(), quadquadrilattax::convection_vector(), quadquadrilatt::convection_vector(), quadlineart::convection_vector(), quadlinaxisym::convection_vector(), quadhext::convection_vector(), quadbartax::convection_vector(), quadbart::convection_vector(), lintett::convection_vector(), linhext::convection_vector(), linbartax::convection_vector(), linbart::convection_vector(), creep_giveirrstrains(), mohrcoulomb::cutting_plane(), glasgmech::depseqdepsel(), difference_method(), axisymlt::edgeload(), axisymlq::edgeload(), soilplatetr::elem_integration(), soilplateq::elem_integration(), quadtet::elem_integration(), quadhex::elem_integration(), q4plate::elem_integration(), plquadcontact::elem_integration(), planeelemsubqt::elem_integration(), planeelemrotlt::elem_integration(), planeelemrotlq::elem_integration(), planeelemqt::elem_integration(), planeelemqq::elem_integration(), planeelemlt::elem_integration(), planeelemlq::elem_integration(), lintetrot::elem_integration(), lintet::elem_integration(), linhexrot::elem_integration(), linhex::elem_integration(), dstelem::elem_integration(), dktelem::elem_integration(), cctelem::elem_integration(), barelq3d::elem_integration(), barelq2d::elem_integration(), barel3d::elem_integration(), barel2d::elem_integration(), axisymqq::elem_integration(), axisymlt::elem_integration(), axisymlq::elem_integration(), ArgyrisTriangle::elem_integration(), planeelemsubqt::elem_stresses(), planeelemrotlt::elem_stresses(), planeelemqt::elem_stresses(), linhex::elem_stresses(), axisymqq::elem_stresses(), axisymlq::elem_stresses(), femplast_epressure(), garclength(), planeelemlq::gl_ip_strains(), gnewton_raphson(), gnewton_raphson_one_step(), linhexrot::gnl_internal_forces(), linhex::gnl_internal_forces(), incr_internal_gforces(), trlineart::internal_fluxes(), trlinaxisym::internal_fluxes(), quadquadrilattax::internal_fluxes(), quadquadrilatt::internal_fluxes(), quadlineart::internal_fluxes(), quadlinaxisym::internal_fluxes(), quadhext::internal_fluxes(), quadbartax::internal_fluxes(), quadbart::internal_fluxes(), lintett::internal_fluxes(), linhext::internal_fluxes(), linbartax::internal_fluxes(), linbart::internal_fluxes(), beamel2d::internal_forces(), internal_gforces(), linhext::intpointflux(), feti1::lagrmultdispl(), loadincr(), seqfeti::local_coarse(), barelc::lower_internal_fluxes(), planeelemsubqt::mainip_stresses(), planeelemrotlt::mainip_stresses(), planeelemqt::mainip_stresses(), linhex::mainip_stresses(), barelq3d::mainip_stresses(), barelq2d::mainip_stresses(), axisymqq::mainip_stresses(), axisymlq::mainip_stresses(), mohrcoulomb::mc_msurf_cp(), metr_right_hand_side(), newmark_method(), newton_raphson_gparcoupl_nonlin(), ortodamrot::nlstresses(), hissplas::nlstresses(), drprag2::nlstresses(), planeelemsubqt::nod_stresses(), planeelemrotlt::nod_stresses(), planeelemqt::nod_stresses(), linhex::nod_stresses(), axisymlq::nod_stresses(), axisymqq::nod_stresses_old(), quadtet::node_forces_surf(), quadhex::node_forces_surf(), lintetrot::node_forces_surf(), lintet::node_forces_surf(), linhexrot::node_forces_surf(), linhex::node_forces_surf(), lintetrot::node_forces_surf_old(), lintet::node_forces_surf_old(), linhexrot::node_forces_surf_old(), linhex::node_forces_surf_old(), planeelemsubqt::nodeforces(), planeelemqt::nodeforces(), planeelemqq::nodeforces(), planeelemlt::nodeforces(), planeelemlq::nodeforces(), axisymqq::nodeforces(), axisymlq::nodeforces(), nonlin_newmark_method(), one_step(), one_step_arcl(), one_step_nonlinear_dform(), par_gnewton_raphson_one_step(), par_gnewton_raphson_one_step_mefel(), par_newton_raphson_gparcoupl_lin(), par_newton_raphson_gparcoupl_nonlin(), par_one_step(), par_one_step_mefel(), par_solve_prob_constr_phases(), least_square::polynom_coefficients_ae(), patch_averaging::polynom_coefficients_ae(), least_square::polynom_coefficients_inv_ae(), trlineart::quantity_source_vector(), trlinaxisym::quantity_source_vector(), quadquadrilattax::quantity_source_vector(), quadquadrilatt::quantity_source_vector(), quadlineart::quantity_source_vector(), quadlinaxisym::quantity_source_vector(), quadhext::quantity_source_vector(), quadbartax::quantity_source_vector(), quadbart::quantity_source_vector(), lintett::quantity_source_vector(), linhext::quantity_source_vector(), linbartax::quantity_source_vector(), linbart::quantity_source_vector(), barelc::res_upper_internal_forces(), residuum(), right_hand_side(), solve_incremental_floating_subdomains(), solve_prob_constr_phases(), shefplast::stress_return(), dloadcase::tempercontrib(), trlineart::transmission_vector(), trlinaxisym::transmission_vector(), quadquadrilattax::transmission_vector(), quadquadrilatt::transmission_vector(), quadlineart::transmission_vector(), quadlinaxisym::transmission_vector(), quadhext::transmission_vector(), quadbartax::transmission_vector(), quadbart::transmission_vector(), lintett::transmission_vector(), linhext::transmission_vector(), linbartax::transmission_vector(), linbart::transmission_vector(), trfel_bound_flux(), trfel_right_hand_side(), quadrilatc::upper_cond_coup_vector(), hexahedc::upper_cond_coup_vector(), barelc::upper_cond_coup_vector(), axiquadc::upper_cond_coup_vector(), and barelc::upper_internal_forces().

long allocv ( long  n,
ivector vec 
)

allocates ivector

The function allocates memory from heap to the ivector's member array a.

Parameters:
n is the number of the ivector elements
vec is the structure for allocated ivector
Return values:
0 - on success
1 - if fails allocating memory

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 237 of file vector.cpp.

References ivector::a, memset(), ivector::n, and print_err().

long allocv ( long  n,
vector vec 
)

allocates vector

The function allocates memory from heap to the vector's member array a.

Parameters:
n is the number of the vector elements
vec is the structure for allocated vector

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 165 of file vector.cpp.

References vector::a, memset(), vector::n, and print_err().

Referenced by soilplateq::allip_strains(), planeelemsubqt::allip_strains(), planeelemrotlt::allip_strains(), planeelemqt::allip_strains(), linhex::allip_strains(), soilplatetr::allip_stresses(), soilplateq::allip_stresses(), planeelemsubqt::allip_stresses(), planeelemrotlt::allip_stresses(), planeelemqt::allip_stresses(), linhex::allip_stresses(), transtop::alloc_nodes(), soilplateq::appstrain(), planeelemsubqt::appstrain(), planeelemqt::appstrain(), axisymqq::appstrain(), axisymlq::appstrain(), planeelemsubqt::appstress(), planeelemqt::appstress(), axisymqq::appstress(), axisymlt::appstress(), axisymlq::appstress(), soilplateq::appval(), q4plate::appval(), planeelemsubqt::appval(), planeelemrotlt::appval(), planeelemqt::appval(), planeelemlt::appval(), dstelem::appval(), dktelem::appval(), axisymqq::appval(), axisymlt::appval(), axisymlq::appval(), assemble_coup(), loadcaset::assemble_flux(), assemble_gradients_contrib(), assemble_init(), assemble_init_coup_upper(), transmat::aux_values(), quadtet::aver_strains(), quadhex::aver_strains(), linhexrot::aver_strains(), linhex::aver_strains(), capacity_matrix(), stochdrivert::changevalues(), z2_smoothing::column_lengths_nn(), gtopology::comptop(), z2_smoothing::compute_ainv(), compute_cycles(), adaptivityt::compute_error(), adaptivity::compute_error(), q4plate::compute_nlstress(), planeelemqt::compute_nlstress(), dstelem::compute_nlstress(), cctelem::compute_nlstress(), ArgyrisTriangle::compute_nlstress(), planeelemqt::compute_nlstressincr(), planeelemrotlt::compute_nonloc_nlstress(), planeelemqt::compute_nonloc_nlstress(), z2_smoothing::compute_ntdbr(), z2_smoothing::compute_ntn_sky(), least_square::compute_patches_sp2sp(), least_square::compute_patches_spr(), patch_averaging::compute_patches_spr(), adaptivityt::compute_refsizel_lin(), adaptivity::compute_refsizel_lin(), condense_matrix(), condense_vector(), conductivity_matrix(), creep_aeging_strains(), creep_givestressincr(), creep_incrtotstresses(), creep_initmaterialmodel(), creep_matstiffchange(), creep_nlstresses(), creep_nlstressesincr(), creep_updateval(), creepb::creepb(), creepbbeam::creepbbeam(), creepbs::creepbs(), crsec3dbeam::crsec3dbeam(), scaldamcc::damfuncpar(), scaldam::damfuncpar(), glasgowdam::damfuncpar(), glasgmech::damfuncpar(), scaldamcc::damfunction(), gtopology::dof_transfer_hangnod(), gtopology::edge_allelem(), gtopology::edge_elem(), loadel::edgeload(), mechmat::eigenstresses(), linhex::eigstrain_forces(), planeelemlt::elchar(), soilplatetr::elem_integration(), soilplateq::elem_integration(), quadtet::elem_integration(), quadhex::elem_integration(), q4plate::elem_integration(), planeelemsubqt::elem_integration(), planeelemrotlt::elem_integration(), planeelemrotlq::elem_integration(), planeelemqt::elem_integration(), planeelemqq::elem_integration(), planeelemlq::elem_integration(), linhexrot::elem_integration(), linhex::elem_integration(), dstelem::elem_integration(), dktelem::elem_integration(), cctelem::elem_integration(), barelq3d::elem_integration(), barelq2d::elem_integration(), axisymqq::elem_integration(), axisymlt::elem_integration(), axisymlq::elem_integration(), ArgyrisTriangle::elem_integration(), soilplateq::elem_strains(), planeelemsubqt::elem_strains(), planeelemrotlt::elem_strains(), planeelemqt::elem_strains(), linhex::elem_strains(), axisymqq::elem_strains(), axisymlq::elem_strains(), planeelemsubqt::elem_stresses(), planeelemrotlt::elem_stresses(), planeelemqt::elem_stresses(), linhex::elem_stresses(), axisymqq::elem_stresses(), axisymlq::elem_stresses(), elemnode::elemnodes(), elemvalues(), elemvalues_puc(), gtopology::enodes_allelem(), export_gid_gauss_pt(), export_gid_gauss_ptt(), femplast_epressure(), find_extreme_ipstresses(), first_order_matrix(), fixortodam::fixortodam(), bmatrix::gen_indices(), transtop::give_edge_nodes(), mechtop::give_edge_nodes(), gtopology::give_edge_nodes(), transtop::give_end_nodes(), gtopology::give_end_nodes(), loadelt::give_external_nodval(), gtopology::give_gcode_numbers(), loadelt::give_nodval(), planeelemqt::give_sig_roof(), gtopology::give_surf_nodes(), transtop::give_surface_nodes(), loadelt::give_trc(), loadelt::give_trr(), give_valuesinpoints(), linhex::gl_internal_forces(), planeelemlq::gl_ip_strains(), linhexrot::gl_ip_strains(), linhex::gl_ip_strains(), linhex::gl_mainip_strains(), planeelemlq::gl_stiffness_matrix(), linhexrot::gl_stiffness_matrix(), linhex::gl_stiffness_matrix(), glvectortransfblock(), planeelemlq::gnl_internal_forces(), linhexrot::gnl_internal_forces(), linhex::gnl_internal_forces(), planeelemlq::gnl_ip_strains(), linhexrot::gnl_ip_strains(), linhex::gnl_ip_strains(), linhex::gnl_mainip_strains(), planeelemlq::gnl_stiffness_matrix(), linhexrot::gnl_stiffness_matrix(), linhex::gnl_stiffness_matrix(), stochdrivert::importvalues(), shelltr::inicipval(), shellq::inicipval(), quadtet::inicipval(), quadhex::inicipval(), q4plate::inicipval(), planeelemsubqt::inicipval(), planeelemrotlt::inicipval(), planeelemrotlq::inicipval(), planeelemqt::inicipval(), planeelemqq::inicipval(), planeelemlt::inicipval(), planeelemlq::inicipval(), mechbclc::inicipval(), lintetrot::inicipval(), lintet::inicipval(), linhexrot::inicipval(), linhex::inicipval(), dstelem::inicipval(), dktelem::inicipval(), cctelem::inicipval(), barelq3d::inicipval(), barelq2d::inicipval(), barel3d::inicipval(), barel2d::inicipval(), axisymqq::inicipval(), axisymlt::inicipval(), axisymlq::inicipval(), ArgyrisTriangle::inicipval(), q4plate::initstr_matrix(), input_elem_lcs(), input_nod_lcs(), internal_coup_fluxes(), internal_coup_forces(), internal_fluxes(), linhex::internal_forces(), axisymqq::internal_forces(), axisymlq::internal_forces(), linhex::internal_forces2(), interpolate(), linbart::intpointgrad(), quadrilatc::intpointgrad(), barelc::intpointgrad(), linbart::intpointval(), quadrilatc::intpointval(), barelc::intpointval(), quadtet::intpointval(), quadhex::intpointval(), planeelemqq::intpointval(), planeelemlq::intpointval(), linhexrot::intpointval(), linhex::intpointval(), barelq3d::intpointval(), barelq2d::intpointval(), barel3d::intpointval(), barel2d::intpointval(), axisymqq::intpointval(), axisymlq::intpointval(), quadtet::intpointval2(), quadhex::intpointval2(), planeelemqq::intpointval2(), barelq3d::intpointval2(), barelq2d::intpointval2(), axisymqq::intpointval2(), quadhex::ip_elast_stresses(), linhexrot::ip_elast_stresses(), linhex::ip_elast_stresses(), quadtet::ip_strains(), quadhex::ip_strains(), q4plate::ip_strains(), planeelemrotlt::ip_strains(), planeelemrotlq::ip_strains(), planeelemqq::ip_strains(), lintetrot::ip_strains(), lintet::ip_strains(), dstelem::ip_strains(), dktelem::ip_strains(), cctelem::ip_strains(), axisymlq::ip_strains(), ArgyrisTriangle::ip_strains(), planeelemsubqt::ipcoord(), barelq3d::ipcoord(), barelq2d::ipcoord(), barel3d::ipcoord(), axisymlt::ipcoord(), quadtet::ipvolume(), quadhex::ipvolume(), planeelemrotlt::ipvolume(), planeelemrotlq::ipvolume(), planeelemqt::ipvolume(), planeelemqq::ipvolume(), planeelemlq::ipvolume(), linhexrot::ipvolume(), linhex::ipvolume(), jac1d_2d(), jac2d_3d(), lgvectortransfblock(), local_global_displ_transf(), planeelemrotlt::local_values(), planeelemqt::local_values(), linhex::local_values(), quadrilatc::mainip_strains(), barelc::mainip_strains(), soilplatetr::mainip_strains(), soilplateq::mainip_strains(), planeelemsubqt::mainip_strains(), planeelemrotlt::mainip_strains(), planeelemqt::mainip_strains(), linhex::mainip_strains(), barelq3d::mainip_strains(), barelq2d::mainip_strains(), axisymqq::mainip_strains(), axisymlt::mainip_strains(), axisymlq::mainip_strains(), planeelemsubqt::mainip_stresses(), planeelemrotlt::mainip_stresses(), planeelemqt::mainip_stresses(), linhex::mainip_stresses(), barelq3d::mainip_stresses(), barelq2d::mainip_stresses(), axisymqq::mainip_stresses(), axisymlt::mainip_stresses(), axisymlq::mainip_stresses(), mohrcoulomb::mc_msurf_cp(), mechmat::mult_surf_cutting_plane(), quadtet::nod_eqother_ip(), quadhex::nod_eqother_ip(), planeelemqq::nod_eqother_ip(), lintetrot::nod_eqother_ip(), lintet::nod_eqother_ip(), linhexrot::nod_eqother_ip(), linhex::nod_eqother_ip(), barelq3d::nod_eqother_ip(), barelq2d::nod_eqother_ip(), barel3d::nod_eqother_ip(), barel2d::nod_eqother_ip(), axisymqq::nod_eqother_ip(), axisymlt::nod_eqother_ip(), axisymlq::nod_eqother_ip(), linbart::nod_others(), planeelemrotlt::nod_others(), planeelemlt::nod_others(), linhex::nod_others(), quadbart::nod_others_comp(), soilplateq::nod_strains(), planeelemsubqt::nod_strains(), planeelemrotlt::nod_strains(), planeelemqt::nod_strains(), linhex::nod_strains(), axisymqq::nod_strains(), axisymlq::nod_strains(), quadtet::nod_strains_comp(), quadhex::nod_strains_comp(), planeelemrotlq::nod_strains_comp(), planeelemlt::nod_strains_comp(), planeelemlq::nod_strains_comp(), linhexrot::nod_strains_comp(), linhex::nod_strains_comp(), barelq3d::nod_strains_comp(), barelq2d::nod_strains_comp(), axisymqq::nod_strains_comp(), axisymlt::nod_strains_comp(), quadtet::nod_strains_ip(), axisymqq::nod_strains_old(), planeelemsubqt::nod_stresses(), planeelemrotlt::nod_stresses(), planeelemqt::nod_stresses(), linhex::nod_stresses(), axisymqq::nod_stresses(), axisymlq::nod_stresses(), axisymqq::nod_stresses_comp(), quadtet::nod_stresses_ip(), axisymqq::nod_stresses_old(), noddispl(), linhexrot::node_forces_surf(), linhex::node_forces_surf(), nodforce(), linhex::nonloc_internal_forces(), normmat::normmat(), gtopology::normvectorient(), least_square::nsp_spcoord_maxcoord_assembling(), patch_averaging::nsp_spcoord_maxcoord_assembling(), shefplast::numdiff_dfdsdkc(), shefplast::numdiff_dhdkc(), shefplast::numdiff_dhdsc(), mechtop::other_nodal_values(), least_square::polynom_coefficients_inv_ae(), print_contoures(), elemoutm::print_stra(), nodeoutm::print_stra(), elemoutm::print_stre(), nodeoutm::print_stre(), stochdriver::replace_values(), quadbart::res_boundary_flux(), linbart::res_boundary_flux(), linbart::res_convection_vector(), linbart::res_internal_fluxes(), shelltr::res_internal_forces(), shelltr::res_ip_strains(), shellq::res_ip_strains(), quadtet::res_ip_strains(), quadhex::res_ip_strains(), q4plate::res_ip_strains(), planeelemrotlt::res_ip_strains(), planeelemrotlq::res_ip_strains(), planeelemlt::res_ip_strains(), planeelemlq::res_ip_strains(), lintetrot::res_ip_strains(), linhexrot::res_ip_strains(), linhex::res_ip_strains(), dstelem::res_ip_strains(), dktelem::res_ip_strains(), cctelem::res_ip_strains(), ArgyrisTriangle::res_ip_strains(), barelc::res_lower_internal_fluxes(), quadrilatc::res_mainip_strains(), barelc::res_mainip_strains(), soilplatetr::res_mainip_strains(), soilplateq::res_mainip_strains(), plquadcontact::res_mainip_strains(), planeelemrotlt::res_mainip_strains(), planeelemqt::res_mainip_strains(), beam2dspec::res_mainip_strains(), barelq3d::res_mainip_strains(), barelq2d::res_mainip_strains(), axisymlt::res_mainip_strains(), axisymlq::res_mainip_strains(), beam2dspec::res_mainip_stresses(), linbart::res_quantity_source_vector(), linbart::res_transmission_vector(), quadrilatc::res_upper_cond_coup_vector(), hexahedc::res_upper_cond_coup_vector(), barelc::res_upper_cond_coup_vector(), axiquadc::res_upper_cond_coup_vector(), barelc::res_volume_rhs_vector(), right_hand_side(), adaptivityt::run(), z2_smoothing::run(), adaptivity::run(), gtopology::searching_hanging_nodes(), solution_correction(), loadcaset::source_contrib(), soilplatetr::stiffness_matrix(), soilplateq::stiffness_matrix(), quadwedge::stiffness_matrix(), quadtet::stiffness_matrix(), quadhex::stiffness_matrix(), q4plate::stiffness_matrix(), planeelemsubqt::stiffness_matrix(), planeelemrotlt::stiffness_matrix(), planeelemrotlq::stiffness_matrix(), planeelemqt::stiffness_matrix(), planeelemqq::stiffness_matrix(), linwedge::stiffness_matrix(), lintetrot::stiffness_matrix(), linhex::stiffness_matrix(), dstelem::stiffness_matrix(), cctelem::stiffness_matrix(), barelq3d::stiffness_matrix(), barelq2d::stiffness_matrix(), axisymqq::stiffness_matrix(), axisymlt::stiffness_matrix(), axisymlq::stiffness_matrix(), ArgyrisTriangle::stiffness_matrix(), argyrisplate::stiffness_matrix(), axisymlt::stiffness_matrix_block(), axisymlq::stiffness_matrix_blocks(), mechtop::store_code_num_elem(), mechtop::strain_nodal_values(), soilplateq::strains(), quadtet::strains(), quadhex::strains(), q4plate::strains(), planeelemsubqt::strains(), planeelemrotlt::strains(), planeelemqt::strains(), planeelemlq::strains(), linhexrot::strains(), linhex::strains(), barelq2d::strains(), barel3d::strains(), barel2d::strains(), mechtop::stress_nodal_values(), shefplast::stress_return(), quadtet::stresses(), quadhex::stresses(), q4plate::stresses(), planeelemsubqt::stresses(), planeelemrotlt::stresses(), planeelemqt::stresses(), planeelemlq::stresses(), linhexrot::stresses(), linhex::stresses(), barelq2d::stresses(), barel3d::stresses(), barel2d::stresses(), loadel::surfaceload(), shefplast::tangentstiff(), mohrcoulomb::tangentstiff(), j2flow2::tangentstiff(), j2flow::tangentstiff(), drprag::tangentstiff(), chen::tangentstiff(), linhex::temp_forces(), axisymqq::temp_forces(), axisymlq::temp_forces(), linhex::temperaturestrains(), transfvalues_nod(), loadel::volumeload(), winpast::winpast(), write_gid_elem_type_scalar(), write_gid_elem_type_tensor(), write_gid_nodscalar(), write_gid_nodtensor(), write_nforces(), write_nforcest(), and zero_order_matrix().

void cmulv ( double  c,
double *  a,
double *  u,
long  n 
)

multiplies double array by constant

The function multiplies double array given by a with constant c, the result is stored in u.

Parameters:
c is the real number
a is the array, which is multiplied
u is the array, where the result is stored
n is number of members of arrays
Returns:
always zero

created by JK

Definition at line 1390 of file vector.cpp.

void cmulv ( double  c,
double *  a,
long  n 
)

multiplies double array by constant

The function multiplies double array given by a with constant c, the result is stored in a

Parameters:
c is the real number
a is the array, which is multiplied
n is number of members of arrays
Returns:
always zero

created by JK

Definition at line 1368 of file vector.cpp.

long cmulv ( long  c,
ivector a 
)

multiplies ivector by constant of type long

The function multiplies ivector given by a with integer constant c, the result is stored in a

Parameters:
c is the integer number
a is the structure of the ivector, which is multiplied
Return values:
0 always

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 1346 of file vector.cpp.

References ivector::a, and ivector::n.

long cmulv ( double  c,
vector a 
)

multiplies vector by constant

The function multiplies vector given by a with constant c, the result is stored in a

Parameters:
c is the real number
a is the structure of the vector, which is multiplied
Returns:
always zero

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 1324 of file vector.cpp.

References vector::a, and vector::n.

long cmulv ( long  c,
const ivector u,
ivector v 
)

multiplies ivector by constant of type long

The function multiplies ivector given by u by integer constant c, the result is stored in the vector v

Parameters:
c is the integer number type long
u is the structure of the ivector, which is multiplied
v is the structure of the result ivector

Requests : u and v should have same dimensions, u has to have allocated memory array for elements which is enough large to hold contents of the result.

Return values:
0 on succes
1 in case incompatibility sizes of u and v vector

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 1296 of file vector.cpp.

References ivector::a, ivector::n, and print_err().

long cmulv ( double  c,
const ivector u,
vector v 
)

multiplies ivector by constant of type double

The function multiplies ivector given by u by real constant c, the result is stored in the double ivector v

Parameters:
c is the real number type double
u is the structure of the ivector, which is multiplied
v is the structure of the result vector

Requests : u and v should have same dimensions, u has to have allocated memory array for elements which is enough large to hold contents of the result.

Return values:
0 on succes
1 in case incompatibility sizes of u and v vectors

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 1262 of file vector.cpp.

References ivector::a, vector::a, vector::n, ivector::n, and print_err().

long cmulv ( double  c,
const vector u,
vector v 
)

multiplies vector by constant

The function multiplies vector given by u by real constant c, the result is stored in the double vector v

Parameters:
c is the real number type double
u is the structure of the vector, which is multiplied
v is the structure of the result vector

Requests : u and v have to be same dimensions, u has to have allocated memory array for elements which is enough large to hold contents of the result.

Return values:
0 : on succes
1 : in case incompatibility sizes of u and v vectors

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 1228 of file vector.cpp.

References vector::a, vector::n, and print_err().

Referenced by axisymlq::allip_strains(), axisymlq::allip_stresses(), loadcase::assemble(), dloadcase::assemble(), assemble_gradients_contrib(), assemble_init(), assemble_init_coup_upper(), linhext::average_flux(), glasgmech::depseqdepsel(), difference_method(), lintetrot::eigstrain_forces(), lintet::eigstrain_forces(), linhex::eigstrain_forces(), soilplatetr::elem_integration(), soilplateq::elem_integration(), quadtet::elem_integration(), quadhex::elem_integration(), q4plate::elem_integration(), plquadcontact::elem_integration(), planeelemsubqt::elem_integration(), planeelemrotlt::elem_integration(), planeelemrotlq::elem_integration(), planeelemqt::elem_integration(), planeelemqq::elem_integration(), planeelemlt::elem_integration(), planeelemlq::elem_integration(), lintetrot::elem_integration(), lintet::elem_integration(), linhexrot::elem_integration(), linhex::elem_integration(), dstelem::elem_integration(), dktelem::elem_integration(), cctelem::elem_integration(), barelq3d::elem_integration(), barelq2d::elem_integration(), barel3d::elem_integration(), barel2d::elem_integration(), axisymqq::elem_integration(), axisymlt::elem_integration(), axisymlq::elem_integration(), ArgyrisTriangle::elem_integration(), lintet::elem_integration_quant(), linhex::gl_internal_forces(), planeelemlq::gl_ip_strains(), gnewton_raphson2(), linhexrot::gngeom_matrix(), linhex::gngeom_matrix(), planeelemlq::gnl_internal_forces(), linhexrot::gnl_internal_forces(), linhex::gnl_internal_forces(), HomogData::HerveZaoui(), trlineart::internal_fluxes(), trlinaxisym::internal_fluxes(), quadquadrilattax::internal_fluxes(), quadquadrilatt::internal_fluxes(), quadlineart::internal_fluxes(), quadlinaxisym::internal_fluxes(), quadhext::internal_fluxes(), quadbartax::internal_fluxes(), quadbart::internal_fluxes(), lintett::internal_fluxes(), linhext::internal_fluxes(), linbartax::internal_fluxes(), linbart::internal_fluxes(), linhex::internal_forces(), axisymqq::internal_forces(), axisymlq::internal_forces(), linhex::internal_forces2(), inverse_iteration(), gmatrix::inverse_iteration(), feti1::lagrmultdispl(), seqfeti::lagrmultdispl(), seqfeti::lagrmultnodunknowns(), quadtet::locglob_nodeval(), lintetrot::locglob_nodeval(), lintet::locglob_nodeval(), linhexrot::locglob_nodeval(), linhex::locglob_nodeval(), barelc::lower_internal_fluxes(), seqfeti::mpcg(), newmark_method(), newton_raphson_gparcoupl_nonlin(), glasgownew::nlstresses(), glasgowdam::nlstresses(), glasgmech::nlstresses(), drprag2::nlstresses(), quadtet::nod_eqother_ip(), lintetrot::nod_eqother_ip(), lintet::nod_eqother_ip(), quadtet::nod_strains_ip(), lintetrot::nod_strains_ip(), lintet::nod_strains_ip(), quadtet::nod_stresses_ip(), lintetrot::nod_stresses_ip(), lintet::nod_stresses_ip(), beamel2d::nodal_forces(), nonlin_newmark_method(), nonlinear_nonstat_solv_dform_dneska(), linhex::nonloc_internal_forces(), one_step_nonlinear_dform(), par_newton_raphson_gparcoupl_lin(), par_newton_raphson_gparcoupl_nonlin(), parallel_inverse_iteration(), parallel_subspace_iter_ortho(), least_square::polynom_coefficients_ae(), patch_averaging::polynom_coefficients_ae(), least_square::polynom_coefficients_inv_ae(), gmatrix::power_method(), trlineart::res_convection_vector(), trlinaxisym::res_convection_vector(), quadquadrilattax::res_convection_vector(), quadquadrilatt::res_convection_vector(), quadlineart::res_convection_vector(), quadlinaxisym::res_convection_vector(), quadhext::res_convection_vector(), quadbartax::res_convection_vector(), quadbart::res_convection_vector(), lintett::res_convection_vector(), linhext::res_convection_vector(), linbartax::res_convection_vector(), linbart::res_convection_vector(), residuum(), mechmat::scal_dam_sol(), solve_incremental_floating_subdomains(), solve_prob_constr_phases(), shefplast::stress_return(), subspace_iter_jac(), subspace_iter_ortho(), subspace_shift_iter_ortho(), shefplast::tangentstiff(), drprag2::tangentstiff(), linhex::temp_forces(), axisymqq::temp_forces(), axisymlq::temp_forces(), and barelc::upper_internal_forces().

long copymultv ( const double *  src,
double *  dest,
const double  c,
long  n 
)

copies contents of array multiplied by scalar

The function copies double array given by the src multiplied by scalar c to the dest.

Parameters:
src - double array to copy
dest - double array to which will be copied contents of src
c - scalar multiplier
n - length of arrays src and dest
Return values:
always zero

created 08.2011 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 513 of file vector.cpp.

long copymultv ( const ivector src,
ivector dest,
const long  c 
)

copies contents of ivector multiplied by scalar

The function copies ivector given by src multiplied by scalar c to dest.

Parameters:
src - structure with the source ivector to copy
dest - structure with the destination ivector to which will be copied the contents of the src
c - scalar multiplier

Requests : dest has to have dimensions and allocated memory array for vector components which is large enough to hold all contents of the ivector src.

Return values:
0 on succes
1 in case incompatibility sizes of the src and dest vectors

created 08.2011 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 485 of file vector.cpp.

References ivector::n, and print_err().

long copymultv ( const vector src,
vector dest,
const double  c 
)

copies contents of vector multiplied by scalar

The function copies vector given by src multiplied by c to dest.

Parameters:
src - structure with source vector to copy
dest - structure with destination vector to which will be copied contents of the src
c - scalar multiplier

Requests : dest has to have dimensions and allocated memory array for vector components which is large enough to hold all contents of the vector src.

Return values:
0 : on succes
1 : in case incompatibility sizes of the src and dest vectors

created 08.2011 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 453 of file vector.cpp.

References vector::n, and print_err().

Referenced by arclengthrv(), garclength(), and one_step_arcl().

long copyv ( const vector src,
double *  dest 
)

copies contents of vector to array

The function copies vector given by src to array dest.

Parameters:
src is the structure of source vector to copy
dest is the destination array which will be copied contents of src to

Requests : dest has to have allocated memory which is enough large to hold all contents of the vector src. Number of copied elements is given by the src dimension

Return values:
0 : on succes

created 4.10.2007 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 429 of file vector.cpp.

References vector::a, and vector::n.

long copyv ( const double *  src,
vector dest 
)

copies contents of array to vector

The function copies array given by src to vector dest.

Parameters:
src is source array to copy
dest is the structure of destination vector which will be copied contents of src to

Requests : dest has to be setuped dimensions and allocated memory array for required elements. Number of copied elements is given by the dest dimension

Return values:
0 : on succes

created 4.10.2007 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 407 of file vector.cpp.

References vector::a, and vector::n.

long copyv ( const double *  src,
double *  dest,
long  n 
)

copies contents of array

The function copies double array given by src to dest.

Parameters:
src is the double array to copy
dest is the double array to which will be copied contents of src
Return values:
always zero

created 3.11.2001 by JK

Definition at line 385 of file vector.cpp.

long copyv ( const long *  src,
long *  dest,
long  n 
)

The function copies long array given by src to dest.

Parameters:
src is the double array to copy
dest is the double array to which will be copied contents of src
Return values:
always zero

created 3.11.2001 by JK

Definition at line 367 of file vector.cpp.

long copyv ( const ivector src,
ivector dest 
)

copies contents of ivector

The function copies vector given by src to dest.

Parameters:
src is the structure of source ivector to copy
dest is the structure of destination ivector to which will be copied contents of src

Requests : dest has to be setuped dimensions and allocated memory array for elements which is enough large to hold all contents of the ivector src.

Return values:
0 on succes
1 in case incompatibility sizes of the src and dest vectors

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 343 of file vector.cpp.

References ivector::a, ivector::n, and print_err().

long copyv ( const vector src,
vector dest 
)

copies contents of vector

The function copies vector given by src to dest.

Parameters:
src is the structure of source vector to copy
dest is the structure of destination vector to which will be copied contents of src

Requests : dest has to be setuped dimensions and allocated memory array for elements which is enough large to hold all contents of the vector src.

Return values:
0 : on succes
1 : in case incompatibility sizes of the src and dest vectors

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 313 of file vector.cpp.

References vector::a, vector::n, and print_err().

Referenced by arclength(), arclengthadapt(), arclengthrv(), arclengthrv1(), seismtool::assemble(), loadcase::assemble(), dloadcase::assemble(), aggregator::assemble_smoothed_prol(), aggregator::boss(), loadcase::compute_reactions(), dloadcase::compute_reactions(), mohrcoulomb::cutting_plane(), eldispl(), elprdispl(), femplast_epressure(), findout_parentel_nod(), garclength(), mechcrsec::give_vectorlcs(), linhex::gl_internal_forces(), gnewton_raphson(), gnewton_raphson2(), stochdrivert::importvalues(), input_elem_lcs(), input_nod_lcs(), elemparticle::inter_forces_1d(), beamgen3d::internal_forces(), beamel3d::internal_forces(), beamgen3d::internal_forces1(), springel::intpointval(), inverse_iteration(), gmatrix::inverse_iteration(), lintet::ip_strains(), macrodispl(), planeelemsubqt::mainip_strains(), linhex::mainip_strains(), axisymqq::mainip_strains(), mohrcoulomb::mc_msurf_cp(), feti1::mpcg(), aggregator::mulA(), aggregator::mulS(), mechmat::mult_surf_cutting_plane(), newton_raphson_gparcoupl_nonlin(), newton_raphson_parcoupl_common_dt(), mechmat::newton_stress_return(), mechmat::newton_stress_return_2(), ortodamrot::nlstresses(), hissplas::nlstresses(), glasgowdam::nlstresses(), anisodam::nlstresses(), drprag2::nlstresses(), axisymqq::nod_strains(), axisymlq::nod_strains(), quadtet::nod_strains_comp(), quadhex::nod_strains_comp(), planeelemrotlq::nod_strains_comp(), planeelemlt::nod_strains_comp(), planeelemlq::nod_strains_comp(), linhexrot::nod_strains_comp(), linhex::nod_strains_comp(), barelq3d::nod_strains_comp(), barelq2d::nod_strains_comp(), axisymqq::nod_strains_comp(), axisymlt::nod_strains_comp(), axisymqq::nod_strains_old(), axisymqq::nod_stresses(), axisymqq::nod_stresses_comp(), beamgen3d::nodal_displ(), beamel3d::nodal_displ(), beamel2d::nodal_displ(), beamgen3d::nodal_forces(), beamel3d::nodal_forces(), beamel2d::nodal_forces(), nonlin_newmark_method(), nonlinear_nonstat_solv_dform(), nonstat_solv_dform_comp(), shefplast::numdiff_dfdsdsc(), shefplast::numdiff_dhdsc(), one_step(), one_step_arcl(), one_step_nonlinear_dform(), par_one_step(), par_one_step_mefel(), parallel_inverse_iteration(), parallel_subspace_iter_ortho(), gmatrix::power_method(), quadtet::res_eigstrain_forces(), quadhex::res_eigstrain_forces(), planeelemsubqt::res_eigstrain_forces(), planeelemrotlt::res_eigstrain_forces(), planeelemrotlq::res_eigstrain_forces(), planeelemqt::res_eigstrain_forces(), planeelemqq::res_eigstrain_forces(), planeelemlt::res_eigstrain_forces(), planeelemlq::res_eigstrain_forces(), lintetrot::res_eigstrain_forces(), lintet::res_eigstrain_forces(), linhexrot::res_eigstrain_forces(), linhex::res_eigstrain_forces(), cctelem::res_eigstrain_forces(), barelq3d::res_eigstrain_forces(), barelq2d::res_eigstrain_forces(), barel3d::res_eigstrain_forces(), barel2d::res_eigstrain_forces(), axisymqq::res_eigstrain_forces(), axisymlt::res_eigstrain_forces(), axisymlq::res_eigstrain_forces(), ArgyrisTriangle::res_eigstrain_forces(), soilplatetr::res_incr_internal_forces(), quadtet::res_incr_internal_forces(), quadhex::res_incr_internal_forces(), planeelemsubqt::res_incr_internal_forces(), planeelemrotlt::res_incr_internal_forces(), planeelemrotlq::res_incr_internal_forces(), planeelemqt::res_incr_internal_forces(), planeelemqq::res_incr_internal_forces(), planeelemlt::res_incr_internal_forces(), planeelemlq::res_incr_internal_forces(), lintetrot::res_incr_internal_forces(), lintet::res_incr_internal_forces(), linhexrot::res_incr_internal_forces(), linhex::res_incr_internal_forces(), dstelem::res_incr_internal_forces(), dktelem::res_incr_internal_forces(), cctelem::res_incr_internal_forces(), barelq3d::res_incr_internal_forces(), barelq2d::res_incr_internal_forces(), barel3d::res_incr_internal_forces(), barel2d::res_incr_internal_forces(), axisymqq::res_incr_internal_forces(), axisymlt::res_incr_internal_forces(), axisymlq::res_incr_internal_forces(), ArgyrisTriangle::res_incr_internal_forces(), soilplatetr::res_internal_forces(), shelltr::res_internal_forces(), quadtet::res_internal_forces(), quadhex::res_internal_forces(), plquadcontact::res_internal_forces(), planeelemsubqt::res_internal_forces(), planeelemrotlt::res_internal_forces(), planeelemrotlq::res_internal_forces(), planeelemqt::res_internal_forces(), planeelemqq::res_internal_forces(), planeelemlt::res_internal_forces(), planeelemlq::res_internal_forces(), lintetrot::res_internal_forces(), lintet::res_internal_forces(), linhexrot::res_internal_forces(), dstelem::res_internal_forces(), dktelem::res_internal_forces(), cctelem::res_internal_forces(), barelq3d::res_internal_forces(), barelq2d::res_internal_forces(), barel3d::res_internal_forces(), barel2d::res_internal_forces(), axisymqq::res_internal_forces(), axisymlt::res_internal_forces(), ArgyrisTriangle::res_internal_forces(), shelltr::res_ip_strains(), shellq::res_ip_strains(), quadtet::res_ip_strains(), quadhex::res_ip_strains(), q4plate::res_ip_strains(), planeelemrotlt::res_ip_strains(), planeelemrotlq::res_ip_strains(), planeelemqq::res_ip_strains(), planeelemlt::res_ip_strains(), planeelemlq::res_ip_strains(), lintetrot::res_ip_strains(), linhexrot::res_ip_strains(), linhex::res_ip_strains(), dstelem::res_ip_strains(), dktelem::res_ip_strains(), cctelem::res_ip_strains(), barel3d::res_ip_strains(), barel2d::res_ip_strains(), ArgyrisTriangle::res_ip_strains(), quadrilatc::res_mainip_strains(), barelc::res_mainip_strains(), soilplatetr::res_mainip_strains(), soilplateq::res_mainip_strains(), plquadcontact::res_mainip_strains(), planeelemrotlt::res_mainip_strains(), planeelemqt::res_mainip_strains(), beam2dspec::res_mainip_strains(), barelq3d::res_mainip_strains(), barelq2d::res_mainip_strains(), axisymlt::res_mainip_strains(), axisymlq::res_mainip_strains(), beam2dspec::res_mainip_stresses(), quadtet::res_nonloc_internal_forces(), quadhex::res_nonloc_internal_forces(), planeelemsubqt::res_nonloc_internal_forces(), planeelemrotlt::res_nonloc_internal_forces(), planeelemrotlq::res_nonloc_internal_forces(), planeelemqt::res_nonloc_internal_forces(), planeelemqq::res_nonloc_internal_forces(), planeelemlt::res_nonloc_internal_forces(), planeelemlq::res_nonloc_internal_forces(), lintetrot::res_nonloc_internal_forces(), lintet::res_nonloc_internal_forces(), linhexrot::res_nonloc_internal_forces(), linhex::res_nonloc_internal_forces(), cctelem::res_nonloc_internal_forces(), barelq3d::res_nonloc_internal_forces(), barelq2d::res_nonloc_internal_forces(), barel3d::res_nonloc_internal_forces(), barel2d::res_nonloc_internal_forces(), axisymqq::res_nonloc_internal_forces(), axisymlt::res_nonloc_internal_forces(), axisymlq::res_nonloc_internal_forces(), ArgyrisTriangle::res_nonloc_internal_forces(), solve_nonlinear_stationary_problem(), solve_nonlinear_stationary_problem_old(), solve_nonlinear_stationary_problem_pokus(), solve_prob_constr_phases(), schurcompl::solve_red_sys_iter(), parcongrad::solve_system(), boundparcongrad::solve_system(), gmatrix::solve_system(), soilbeam::strains(), beam2dspec::strains(), shefplast::stress_return(), subspace_iter_jac(), subspace_iter_ortho(), subspace_shift_iter_ortho(), trfel_right_hand_side(), visco_solver2(), write_gid_displ(), write_gid_elem_type_tensor(), write_gid_nforces(), write_gid_nodtensor(), and write_nforces().

long cosav ( const ivector a,
const ivector b,
double &  cos 
)

cosine angle of 2 ivectors

The function computes cosine of the angle between ivector given by a and b the result is stored in the cos

Parameters:
a is the structure of the first ivector
b is the structure of the second ivector
cos is real number, type double, where result is stored

Requests : vectors a nd b should have the same dimension

Return values:
0 on succes
1 in case

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 1518 of file vector.cpp.

References ivector::n, normv(), print_err(), and scprd().

long cosav ( const vector a,
const vector b,
double &  cos 
)

cosine angle of 2 vectors

The function computes cosine of the angle between vector given by a and b the result is stored in the cos

Parameters:
a is the structure of the first vector
b is the structure of the second vector
cos is real number, type double, where result is stored

Requests : vectors a nd b should have the same dimension

Return values:
0 on succes
1 in case

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 1481 of file vector.cpp.

References vector::n, normv(), print_err(), and scprd().

long crprd ( const ivector a,
const ivector b,
ivector c 
)

performs cross product of 2 ivectors

The function performs vector product, multiplies ivector given by a from right with ivector given by b, the result is stored in c

Parameters:
a is the structure of the ivector, from which is multiplied
b is the structure of the multiplicating ivector
c is the structure of the result ivector

Requests : a, b and c should have same dimension equal 3 c has to have allocated memory array for elements which is enough large to hold contents of the result.

Return values:
0 on succes
1 in case incompatibility sizes of a, b and c vectors
2 in case a and b vectors have dimension inequal 3

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 1076 of file vector.cpp.

References ivector::a, ivector::n, and print_err().

long crprd ( const vector a,
const vector b,
vector c 
)

performs cross product of 2 vectors

The function performs vector product, multiplies vector given by a from right with vector given by b, the result is stored in c

Parameters:
a is the structure of the vector, from which is multiplied
b is the structure of the multiplicating vector
c is the structure of the result vector

Requests : a, b and c have to be same dimension equal 3 c has to have allocated memory array for elements which is enough large to hold contents of the result.

Return values:
0 on succes
1 in case incompatibility sizes of a, b and c vectors
2 in case a and b vectors have dimension inequal 3

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 1032 of file vector.cpp.

References vector::a, vector::n, and print_err().

Referenced by microM4::initializeData(), and microfiber::initializeData().

long destrv ( ivector vec  ) 

deallocates ivector

The function deallocates memory occupied by ivector vec

Parameters:
vec is the structure for the deallocated ivector
Return values:
0 created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 658 of file vector.cpp.

References ivector::a, and ivector::n.

long destrv ( vector vec  ) 

deallocates vector

The function deallocates memory occupied by vector vec

Parameters:
vec is the structure for the deallocated vector

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 634 of file vector.cpp.

References vector::a, and vector::n.

Referenced by soilplateq::allip_strains(), planeelemsubqt::allip_strains(), planeelemrotlt::allip_strains(), planeelemqt::allip_strains(), linhex::allip_strains(), soilplatetr::allip_stresses(), soilplateq::allip_stresses(), planeelemsubqt::allip_stresses(), planeelemrotlt::allip_stresses(), planeelemqt::allip_stresses(), linhex::allip_stresses(), transtop::alloc_nodes(), soilplateq::appstrain(), planeelemsubqt::appstrain(), planeelemqt::appstrain(), axisymqq::appstrain(), axisymlq::appstrain(), planeelemsubqt::appstress(), planeelemqt::appstress(), axisymqq::appstress(), axisymlt::appstress(), axisymlq::appstress(), soilplateq::appval(), q4plate::appval(), planeelemsubqt::appval(), planeelemrotlt::appval(), planeelemqt::appval(), planeelemlt::appval(), dstelem::appval(), dktelem::appval(), axisymqq::appval(), axisymlt::appval(), axisymlq::appval(), assemble_coup(), loadcaset::assemble_flux(), assemble_gradients_contrib(), assemble_init(), assemble_init_coup_upper(), transmat::aux_values(), quadtet::aver_strains(), quadhex::aver_strains(), linhexrot::aver_strains(), linhex::aver_strains(), capacity_matrix(), stochdrivert::changevalues(), z2_smoothing::column_lengths_nn(), gtopology::comptop(), z2_smoothing::compute_ainv(), compute_cycles(), q4plate::compute_nlstress(), dstelem::compute_nlstress(), cctelem::compute_nlstress(), ArgyrisTriangle::compute_nlstress(), planeelemrotlt::compute_nonloc_nlstress(), z2_smoothing::compute_ntdbr(), z2_smoothing::compute_ntn_sky(), least_square::compute_patches_nod2sp(), least_square::compute_patches_sp2sp(), least_square::compute_patches_spr(), patch_averaging::compute_patches_spr(), conductivity_matrix(), creep_aeging_strains(), creep_givestressincr(), creep_incrtotstresses(), creep_initmaterialmodel(), creep_matstiffchange(), creep_nlstresses(), creep_nlstressesincr(), creep_updateval(), gtopology::dof_transfer_hangnod(), gtopology::edge_allelem(), gtopology::edge_elem(), mechmat::eigenstresses(), linhex::eigstrain_forces(), eldispl(), soilplatetr::elem_integration(), soilplateq::elem_integration(), quadtet::elem_integration(), quadhex::elem_integration(), q4plate::elem_integration(), planeelemsubqt::elem_integration(), planeelemrotlt::elem_integration(), planeelemrotlq::elem_integration(), planeelemqt::elem_integration(), planeelemqq::elem_integration(), planeelemlq::elem_integration(), linhexrot::elem_integration(), linhex::elem_integration(), dstelem::elem_integration(), dktelem::elem_integration(), cctelem::elem_integration(), barelq3d::elem_integration(), barelq2d::elem_integration(), axisymqq::elem_integration(), axisymlt::elem_integration(), axisymlq::elem_integration(), ArgyrisTriangle::elem_integration(), soilplateq::elem_strains(), planeelemsubqt::elem_strains(), planeelemrotlt::elem_strains(), planeelemqt::elem_strains(), linhex::elem_strains(), axisymqq::elem_strains(), axisymlq::elem_strains(), planeelemsubqt::elem_stresses(), planeelemrotlt::elem_stresses(), planeelemqt::elem_stresses(), linhex::elem_stresses(), axisymqq::elem_stresses(), axisymlq::elem_stresses(), elemnode::elemnodes(), elemvalues(), gtopology::enodes_allelem(), export_gid_gauss_pt(), export_gid_gauss_ptt(), femplast_epressure(), find_extreme_ipstresses(), first_order_matrix(), transmat::flux_contributions(), mechtop::give_edge_nodes(), gtopology::give_edge_nodes(), transtop::give_end_nodes(), gtopology::give_end_nodes(), loadelt::give_external_nodval(), gtopology::give_gcode_numbers(), loadelt::give_nodval(), gtopology::give_surf_nodes(), transtop::give_surface_nodes(), loadelt::give_trc(), loadelt::give_trr(), linhex::gl_internal_forces(), planeelemlq::gl_ip_strains(), linhexrot::gl_ip_strains(), linhex::gl_ip_strains(), linhex::gl_mainip_strains(), planeelemlq::gl_stiffness_matrix(), linhexrot::gl_stiffness_matrix(), linhex::gl_stiffness_matrix(), glvectortransfblock(), planeelemlq::gnl_internal_forces(), linhexrot::gnl_internal_forces(), linhex::gnl_internal_forces(), planeelemlq::gnl_ip_strains(), linhexrot::gnl_ip_strains(), linhex::gnl_ip_strains(), linhex::gnl_mainip_strains(), planeelemlq::gnl_stiffness_matrix(), linhexrot::gnl_stiffness_matrix(), linhex::gnl_stiffness_matrix(), HomogData::HerveZaoui(), stochdrivert::importvalues(), shelltr::inicipval(), shellq::inicipval(), quadtet::inicipval(), quadhex::inicipval(), q4plate::inicipval(), planeelemsubqt::inicipval(), planeelemrotlt::inicipval(), planeelemrotlq::inicipval(), planeelemqt::inicipval(), planeelemqq::inicipval(), planeelemlt::inicipval(), planeelemlq::inicipval(), mechbclc::inicipval(), lintetrot::inicipval(), lintet::inicipval(), linhexrot::inicipval(), linhex::inicipval(), dstelem::inicipval(), dktelem::inicipval(), cctelem::inicipval(), barelq3d::inicipval(), barelq2d::inicipval(), barel3d::inicipval(), barel2d::inicipval(), axisymqq::inicipval(), axisymlt::inicipval(), axisymlq::inicipval(), ArgyrisTriangle::inicipval(), q4plate::initstr_matrix(), internal_coup_fluxes(), internal_coup_forces(), internal_fluxes(), linhex::internal_forces(), axisymqq::internal_forces(), axisymlq::internal_forces(), linhex::internal_forces2(), interpolate(), linbart::intpointgrad(), quadrilatc::intpointgrad(), barelc::intpointgrad(), linbart::intpointval(), quadrilatc::intpointval(), barelc::intpointval(), quadtet::intpointval(), quadhex::intpointval(), planeelemqq::intpointval(), planeelemlq::intpointval(), linhexrot::intpointval(), linhex::intpointval(), barelq3d::intpointval(), barelq2d::intpointval(), barel3d::intpointval(), barel2d::intpointval(), axisymqq::intpointval(), axisymlq::intpointval(), quadtet::intpointval2(), quadhex::intpointval2(), planeelemqq::intpointval2(), barelq3d::intpointval2(), barelq2d::intpointval2(), axisymqq::intpointval2(), quadhex::ip_elast_stresses(), linhexrot::ip_elast_stresses(), linhex::ip_elast_stresses(), quadtet::ip_strains(), quadhex::ip_strains(), q4plate::ip_strains(), planeelemrotlt::ip_strains(), planeelemrotlq::ip_strains(), planeelemqq::ip_strains(), lintetrot::ip_strains(), lintet::ip_strains(), dstelem::ip_strains(), dktelem::ip_strains(), cctelem::ip_strains(), axisymlq::ip_strains(), ArgyrisTriangle::ip_strains(), planeelemsubqt::ipcoord(), barelq3d::ipcoord(), barelq2d::ipcoord(), barel3d::ipcoord(), axisymlt::ipcoord(), quadtet::ipvolume(), quadhex::ipvolume(), planeelemrotlt::ipvolume(), planeelemrotlq::ipvolume(), planeelemqt::ipvolume(), planeelemqq::ipvolume(), planeelemlq::ipvolume(), linhexrot::ipvolume(), linhex::ipvolume(), jac1d_2d(), jac2d_3d(), lgvectortransfblock(), local_global_displ_transf(), planeelemrotlt::local_values(), linhex::local_values(), quadrilatc::mainip_strains(), barelc::mainip_strains(), soilplatetr::mainip_strains(), soilplateq::mainip_strains(), planeelemsubqt::mainip_strains(), planeelemrotlt::mainip_strains(), planeelemqt::mainip_strains(), linhex::mainip_strains(), barelq3d::mainip_strains(), barelq2d::mainip_strains(), axisymqq::mainip_strains(), axisymlt::mainip_strains(), axisymlq::mainip_strains(), planeelemsubqt::mainip_stresses(), planeelemrotlt::mainip_stresses(), planeelemqt::mainip_stresses(), linhex::mainip_stresses(), barelq3d::mainip_stresses(), barelq2d::mainip_stresses(), axisymqq::mainip_stresses(), axisymlt::mainip_stresses(), axisymlq::mainip_stresses(), mohrcoulomb::mc_msurf_cp(), mechmat::mult_surf_cutting_plane(), quadtet::nod_eqother_ip(), quadhex::nod_eqother_ip(), planeelemqq::nod_eqother_ip(), lintetrot::nod_eqother_ip(), lintet::nod_eqother_ip(), linhexrot::nod_eqother_ip(), linhex::nod_eqother_ip(), barelq3d::nod_eqother_ip(), barelq2d::nod_eqother_ip(), barel3d::nod_eqother_ip(), barel2d::nod_eqother_ip(), axisymqq::nod_eqother_ip(), axisymlt::nod_eqother_ip(), axisymlq::nod_eqother_ip(), linbart::nod_others(), planeelemrotlt::nod_others(), planeelemlt::nod_others(), linhex::nod_others(), quadbart::nod_others_comp(), soilplateq::nod_strains(), planeelemsubqt::nod_strains(), planeelemrotlt::nod_strains(), planeelemqt::nod_strains(), linhex::nod_strains(), axisymqq::nod_strains(), axisymlq::nod_strains(), quadtet::nod_strains_comp(), quadhex::nod_strains_comp(), planeelemrotlq::nod_strains_comp(), planeelemlt::nod_strains_comp(), planeelemlq::nod_strains_comp(), linhexrot::nod_strains_comp(), linhex::nod_strains_comp(), barelq3d::nod_strains_comp(), axisymqq::nod_strains_comp(), axisymlt::nod_strains_comp(), shelltr::nod_strains_ip(), quadtet::nod_strains_ip(), axisymqq::nod_strains_old(), planeelemsubqt::nod_stresses(), planeelemrotlt::nod_stresses(), planeelemqt::nod_stresses(), linhex::nod_stresses(), axisymqq::nod_stresses(), axisymlq::nod_stresses(), axisymqq::nod_stresses_comp(), quadtet::nod_stresses_ip(), axisymqq::nod_stresses_old(), linhexrot::node_forces_surf(), linhex::node_forces_surf(), linhex::nonloc_internal_forces(), gtopology::normvectorient(), least_square::nsp_spcoord_maxcoord_assembling(), patch_averaging::nsp_spcoord_maxcoord_assembling(), shefplast::numdiff_dfdsdkc(), shefplast::numdiff_dhdkc(), shefplast::numdiff_dhdsc(), mechtop::other_nodal_values(), least_square::polynom_coefficients_inv_ae(), stochdriver::replace_values(), quadbart::res_boundary_flux(), linbart::res_boundary_flux(), linbart::res_convection_vector(), linbart::res_internal_fluxes(), shelltr::res_internal_forces(), shelltr::res_ip_strains(), shellq::res_ip_strains(), quadtet::res_ip_strains(), quadhex::res_ip_strains(), q4plate::res_ip_strains(), planeelemrotlt::res_ip_strains(), planeelemrotlq::res_ip_strains(), planeelemlt::res_ip_strains(), planeelemlq::res_ip_strains(), lintetrot::res_ip_strains(), linhexrot::res_ip_strains(), linhex::res_ip_strains(), dstelem::res_ip_strains(), dktelem::res_ip_strains(), cctelem::res_ip_strains(), ArgyrisTriangle::res_ip_strains(), barelc::res_lower_internal_fluxes(), quadrilatc::res_mainip_strains(), barelc::res_mainip_strains(), soilplatetr::res_mainip_strains(), soilplateq::res_mainip_strains(), plquadcontact::res_mainip_strains(), planeelemrotlt::res_mainip_strains(), planeelemqt::res_mainip_strains(), beam2dspec::res_mainip_strains(), barelq3d::res_mainip_strains(), barelq2d::res_mainip_strains(), axisymlt::res_mainip_strains(), axisymlq::res_mainip_strains(), beam2dspec::res_mainip_stresses(), linbart::res_quantity_source_vector(), linbart::res_transmission_vector(), quadrilatc::res_upper_cond_coup_vector(), hexahedc::res_upper_cond_coup_vector(), barelc::res_upper_cond_coup_vector(), axiquadc::res_upper_cond_coup_vector(), barelc::res_volume_rhs_vector(), right_hand_side(), gtopology::searching_hanging_nodes(), solution_correction(), loadcaset::source_contrib(), soilplatetr::stiffness_matrix(), soilplateq::stiffness_matrix(), quadwedge::stiffness_matrix(), quadtet::stiffness_matrix(), quadhex::stiffness_matrix(), q4plate::stiffness_matrix(), planeelemsubqt::stiffness_matrix(), planeelemrotlt::stiffness_matrix(), planeelemrotlq::stiffness_matrix(), planeelemqt::stiffness_matrix(), planeelemqq::stiffness_matrix(), linwedge::stiffness_matrix(), lintetrot::stiffness_matrix(), linhex::stiffness_matrix(), dstelem::stiffness_matrix(), cctelem::stiffness_matrix(), axisymqq::stiffness_matrix(), axisymlt::stiffness_matrix(), axisymlq::stiffness_matrix(), ArgyrisTriangle::stiffness_matrix(), argyrisplate::stiffness_matrix(), axisymlt::stiffness_matrix_block(), axisymlq::stiffness_matrix_blocks(), mechtop::strain_nodal_values(), soilplateq::strains(), quadtet::strains(), quadhex::strains(), q4plate::strains(), planeelemsubqt::strains(), planeelemrotlt::strains(), planeelemqt::strains(), planeelemlq::strains(), linhexrot::strains(), linhex::strains(), barelq2d::strains(), barel3d::strains(), barel2d::strains(), mechtop::stress_nodal_values(), shefplast::stress_return(), quadtet::stresses(), quadhex::stresses(), q4plate::stresses(), planeelemsubqt::stresses(), planeelemrotlt::stresses(), planeelemqt::stresses(), planeelemlq::stresses(), linhexrot::stresses(), linhex::stresses(), barelq2d::stresses(), barel3d::stresses(), barel2d::stresses(), shefplast::tangentstiff(), mohrcoulomb::tangentstiff(), j2flow2::tangentstiff(), j2flow::tangentstiff(), drprag::tangentstiff(), chen::tangentstiff(), linhex::temp_forces(), axisymqq::temp_forces(), axisymlq::temp_forces(), linhex::temperaturestrains(), write_gid_elem_type_tensor(), write_gid_nodtensor(), write_nforces(), write_nforcest(), zero_order_matrix(), and winpast::~winpast().

void extract ( vector a,
vector b,
long  fi,
long  ncomp 
)

function extracts ncomp components (from index fi) from vector b

function extracts ncomp components from vector b and put them into vector a

Parameters:
a - vector containing extracted components
b - vector from where components are extracted
fi - first index
ncomp - number of components

30.11.2002

Definition at line 1804 of file vector.cpp.

Referenced by linhex::temp_forces(), axisymqq::temp_forces(), and axisymlq::temp_forces().

long extractnegv ( vector a,
vector b 
)

extracts only negative components from vector a and stores them to vector b

Function extracts negative components from vector a and puts them into vector b in corresponding position as in the vector a. If component is positive the zero is stored.

Parameters:
a - vector containing compared components
b - vector where extracted components are stored

25.2.2004

Definition at line 1858 of file vector.cpp.

References vector::n, and print_err().

Referenced by glasgmech::compute_lits(), and scaldamcc::damfunction().

long extractposv ( vector a,
vector b 
)

extracts only positive components from vector a and stores them to vector b

Function extracts positive components from vector a and puts them into vector b in corresponding position as in the vector a. If component is negative the zero is stored.

Parameters:
a - vector containing compared components
b - vector where extracted components are stored

3.3.2003

Definition at line 1827 of file vector.cpp.

References vector::n, and print_err().

Referenced by scaldamcc::damfuncpar(), scaldam::damfuncpar(), glasgowdam::damfuncpar(), glasgmech::damfuncpar(), and scaldamcc::damfunction().

void fillv ( double  c,
double *  vec,
long  n 
)

fills contents of vector given by array with value c

The function fills vect's member array a with value c

Parameters:
c is value, which will be used for filling memory
vec is the structure ivector which should be filled
Return values:
always zero

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 593 of file vector.cpp.

void fillv ( long  c,
long *  vec,
long  n 
)

fills contents of integer vector given by array with value c

The function fills vect's member array a with value c

Parameters:
c is value, which will be used for filling memory
vec is the structure ivector which should be filled
Return values:
always zero

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 572 of file vector.cpp.

long fillv ( long  c,
ivector vec 
)

fills contents of ivector with value c

The function fills vect's member array a with value c

Parameters:
c is value, which will be used for filling memory
vec is the structure ivector which should be filled
Return values:
always zero

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 553 of file vector.cpp.

References ivector::n.

long fillv ( double  c,
vector vec 
)

fills contents of vector with value c

The function fills vect's member array a with value c

Parameters:
c is value, which will be used for filling memory
vec is the structure vector for the deallocated vector
Returns:
always zero

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 534 of file vector.cpp.

References vector::n.

Referenced by arclengthrv(), q4plate::areaforces(), loadcaset::assemble(), assemble_coup(), loadcaset::assemble_flux(), nonlocmicroM4::average(), aggregator::boss(), trlineart::boundary_flux(), trlinaxisym::boundary_flux(), quadquadrilattax::boundary_flux(), quadquadrilatt::boundary_flux(), quadlineart::boundary_flux(), quadlinaxisym::boundary_flux(), quadhext::boundary_flux(), lintett::boundary_flux(), linhext::boundary_flux(), planeelemlq::bvectors(), linhexrot::bvectors(), linhex::bvectors(), mechmat::compute_averstrains(), trlineart::compute_error(), planeelemlt::compute_error(), lintet::compute_error(), glasgmech::compute_lits(), trlineart::convection_vector(), trlinaxisym::convection_vector(), quadquadrilattax::convection_vector(), quadquadrilatt::convection_vector(), quadlineart::convection_vector(), quadlinaxisym::convection_vector(), quadhext::convection_vector(), lintett::convection_vector(), linhext::convection_vector(), creep_aeging_strains(), creep_givestressincr(), creep_incrtotstresses(), creep_initmaterialmodel(), creep_matstiffchange(), creep_nlstresses(), creep_nlstressesincr(), creep_updateval(), crsec3dbeam::crsec3dbeam(), anisodamrot::damdrvforce_dev(), anisodam::damdrvforce_dev(), scaldamcc::damfuncpar(), scaldam::damfuncpar(), glasgowdam::damfuncpar(), glasgmech::damfuncpar(), glasgmech::depseqdepsel(), chen::deryieldfdq(), hardsoft::dhdgamma(), axisymlt::edgeload(), axisymlq::edgeload(), trlineart::edgenodeval(), trlinaxisym::edgenodeval(), quadquadrilattax::edgenodeval(), quadquadrilatt::edgenodeval(), quadlineart::edgenodeval(), quadlinaxisym::edgenodeval(), planeelemlq::edgenodeval(), axisymlt::edgenodeval(), axisymlq::edgenodeval(), lintetrot::eigstrain_forces(), lintet::eigstrain_forces(), linhex::eigstrain_forces(), soilplatetr::elem_integration(), soilplateq::elem_integration(), quadtet::elem_integration(), quadhex::elem_integration(), q4plate::elem_integration(), plquadcontact::elem_integration(), planeelemsubqt::elem_integration(), planeelemrotlt::elem_integration(), planeelemrotlq::elem_integration(), planeelemqt::elem_integration(), planeelemqq::elem_integration(), planeelemlt::elem_integration(), planeelemlq::elem_integration(), lintetrot::elem_integration(), lintet::elem_integration(), linhexrot::elem_integration(), linhex::elem_integration(), dstelem::elem_integration(), dktelem::elem_integration(), cctelem::elem_integration(), barelq3d::elem_integration(), barelq2d::elem_integration(), axisymqq::elem_integration(), axisymlt::elem_integration(), axisymlq::elem_integration(), ArgyrisTriangle::elem_integration(), lintet::elem_integration_quant(), planeelemsubqt::elem_stresses(), planeelemrotlt::elem_stresses(), planeelemqt::elem_stresses(), linhex::elem_stresses(), axisymqq::elem_stresses(), axisymlq::elem_stresses(), planeelemlt::error(), find_extreme_ipstresses(), findout_parentel_nod(), garclength(), rspecmat::give_deps_free(), b3mat::give_deps_free(), rspecmat::give_deps_stressinduced(), b3mat::give_deps_stressinduced(), give_der_star(), loadelt::give_external_nodval(), mechtop::give_ipcoord_elem(), loadelt::give_nodval(), loadelt::give_trc(), loadelt::give_trr(), drprag2::giveIota(), mechmat::giveirrstrains(), mechmat::givestressincr(), linhex::gl_internal_forces(), gnewton_raphson(), gnewton_raphson_one_step(), planeelemlq::gnl_internal_forces(), linhexrot::gnl_internal_forces(), linhex::gnl_internal_forces(), hardsoft::hvalues(), elemparticle::inter_forces_1d(), elemparticle::inter_forces_2d(), elemparticle::inter_forces_3d(), internal_coup_fluxes(), internal_coup_forces(), internal_fluxes(), springel::internal_forces(), linhex::internal_forces(), beamel2d::internal_forces(), beam2dspec::internal_forces(), axisymqq::internal_forces(), axisymlq::internal_forces(), linhex::internal_forces2(), planeelemlt::intpointval(), barelc::lower_internal_fluxes(), planeelemsubqt::mainip_stresses(), planeelemrotlt::mainip_stresses(), planeelemqt::mainip_stresses(), linhex::mainip_stresses(), barelq3d::mainip_stresses(), barelq2d::mainip_stresses(), axisymqq::mainip_stresses(), axisymlq::mainip_stresses(), newton_raphson_gparcoupl_lin(), newton_raphson_gparcoupl_nonlin(), newton_raphson_parcoupl_lin(), newton_raphson_parcoupl_nonlin(), newton_raphsonrv1(), microSIM::nlstresses(), microM4::nlstresses(), microfiber::nlstresses(), drprag2::nlstresses(), planeelemsubqt::nod_stresses(), planeelemrotlt::nod_stresses(), planeelemqt::nod_stresses(), linhex::nod_stresses(), axisymlq::nod_stresses(), axisymqq::nod_stresses_old(), quadtet::node_forces_surf(), quadhex::node_forces_surf(), lintet::node_forces_surf(), linhex::node_forces_surf(), linhexrot::node_forces_surf_old(), linhex::node_forces_surf_old(), planeelemsubqt::nodeforces(), planeelemqt::nodeforces(), planeelemqq::nodeforces(), planeelemlt::nodeforces(), planeelemlq::nodeforces(), axisymqq::nodeforces(), axisymlq::nodeforces(), linhex::nonloc_internal_forces(), least_square::normal_coordinates_ae(), patch_averaging::normal_coordinates_ae(), planeelemqt::ntdbr_vector(), planeelemqq::ntdbr_vector(), planeelemlt::ntdbr_vector(), planeelemlq::ntdbr_vector(), lintet::ntdbr_vector(), planeelemlt::ntn_matrix(), one_step_arcl(), par_gnewton_raphson_one_step(), par_gnewton_raphson_one_step_mefel(), par_newton_raphson_gparcoupl_lin(), par_newton_raphson_gparcoupl_nonlin(), par_newton_raphson_parcoupl_lin(), par_newton_raphson_parcoupl_nonlin(), par_solve_prob_constr_phases(), par_solve_timemech_prob(), anisodamrot::pdam_dev(), anisodam::pdam_dev(), anisodam::pdaminc_dev(), least_square::polynom_coefficients_ae(), patch_averaging::polynom_coefficients_ae(), nodeoutm::print_stra(), nodeoutm::print_stre(), barelc::res_lower_internal_fluxes(), quadrilatc::res_upper_cond_coup_vector(), hexahedc::res_upper_cond_coup_vector(), barelc::res_upper_cond_coup_vector(), axiquadc::res_upper_cond_coup_vector(), barelc::res_upper_internal_forces(), right_hand_side(), mechmat::scal_dam_sol(), solve_incremental_floating_subdomains(), solve_prob_constr_phases(), loadcaset::source_contrib(), quadhext::surfnodeval(), lintett::surfnodeval(), linhext::surfnodeval(), linhexrot::surfnodeval(), linhex::surfnodeval(), drprag2::tangentstiff(), linhex::temp_forces(), axisymqq::temp_forces(), axisymlq::temp_forces(), linhex::tempstrains(), axisymqq::tempstrains(), axisymlq::tempstrains(), tensor_vector(), tensor_vector_full(), trlineart::transf_coeff(), trlinaxisym::transf_coeff(), quadquadrilattax::transf_coeff(), quadquadrilatt::transf_coeff(), quadlineart::transf_coeff(), quadlinaxisym::transf_coeff(), quadhext::transf_coeff(), lintett::transf_coeff(), linhext::transf_coeff(), trlineart::transf_flux(), trlinaxisym::transf_flux(), quadquadrilattax::transf_flux(), quadquadrilatt::transf_flux(), quadlineart::transf_flux(), quadlinaxisym::transf_flux(), quadhext::transf_flux(), lintett::transf_flux(), linhext::transf_flux(), trlineart::transf_val(), trlinaxisym::transf_val(), quadquadrilattax::transf_val(), quadquadrilatt::transf_val(), quadlineart::transf_val(), quadlinaxisym::transf_val(), quadhext::transf_val(), lintett::transf_val(), linhext::transf_val(), trlineart::transmission_vector(), trlinaxisym::transmission_vector(), quadquadrilattax::transmission_vector(), quadquadrilatt::transmission_vector(), quadlineart::transmission_vector(), quadlinaxisym::transmission_vector(), quadhext::transmission_vector(), lintett::transmission_vector(), linhext::transmission_vector(), trfel_right_hand_side(), barelc::upper_internal_forces(), visco_solver(), barelc::volume_rhs_vector(), and outdriverm::write_vtk_unkn().

double normv ( const ivector a  ) 

computes norm of ivector

The function computes norm of the ivector given by a, the result is stored in the parameter norm

Parameters:
a is the structure of the ivector, which size is requested
Returns:
Returns computed size of vector norm.

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 1452 of file vector.cpp.

References ivector::a, and ivector::n.

double normv ( const double *  a,
long  n 
)

computes norm of vector

Definition at line 1427 of file vector.cpp.

double normv ( const vector a  ) 
long nullv ( ivector a  ) 

Definition at line 618 of file vector.cpp.

References ivector::a, memset(), and ivector::n.

long nullv ( double *  a,
long  n 
)

fills array with zeros

The function fills double array a with zeros

Parameters:
a is array which should be filled
Return values:
always zero

Definition at line 610 of file vector.cpp.

References memset().

Referenced by np_glob_vec::alloc(), mt_glob_vec::alloc(), np_glob_vec::alloc_aux(), np_glob_vec::alloc_daux(), approximation_humid(), approximation_inittemper(), approximation_temper(), seismtool::assemble(), dloadcase::assemble(), assemble_coup(), loadcaset::assemble_flux(), lplate::cg(), seqfeti::coarse_local(), mechbclc::comp_sum(), mechbclc::comp_sum_pdreact(), mechbclc::comp_sum_react(), compute_average_fluxes(), dpfeti::compute_displ(), least_square::compute_patches_spr(), dpfeti::corner_displ(), difference_method(), soilplateq::elem_strains(), planeelemsubqt::elem_strains(), planeelemrotlt::elem_strains(), planeelemqt::elem_strains(), linhex::elem_strains(), axisymqq::elem_strains(), axisymlq::elem_strains(), planeelemsubqt::elem_stresses(), planeelemrotlt::elem_stresses(), planeelemqt::elem_stresses(), linhex::elem_stresses(), axisymqq::elem_stresses(), axisymlq::elem_stresses(), femplast_epressure(), findout_parentel_nod(), seqfeti::g_matrix(), gen_jacobi2(), general_epressure(), general_epressure_varsup(), loadelt::give_external_nodval(), loadelt::give_nodval(), loadelt::give_trc(), lplate::globloc_auxiliary(), feti1::hmatrix(), seqfeti::hmatrix(), incr_internal_forces(), incr_internal_gforces(), init_trfel_mefel(), internal_fluxes(), internal_gforces(), skyline::ker(), densemat::ker(), feti1::lagrmultdispl(), seqfeti::lagrmultdispl(), seqfeti::lagrmultnodunknowns(), skyline::ldl_a12block(), lin_nonstat_dform(), lin_nonstat_dform_resistance(), linear_nonstat_radiation_solv_dform(), linear_nonstat_solv_dform(), linear_nonstat_solv_dform_subcycl(), linear_nonstat_solv_vform(), loadincr(), loc_internal_forces(), seqfeti::local_coarse(), lplate::locglob_auxiliary(), skyline::ltv(), dpfeti::matxvect(), mefel_right_hand_side(), metr_right_hand_side(), feti1::mpcg(), seqfeti::mpcg(), seqfeti::mprcg(), comprow::mtxv_cr(), comprow::mxv_cr_pom(), elemmat::mxv_em(), newmark_method(), newton_raphson_coupl(), newton_raphson_coupl_new(), newton_raphson_gparcoupl_lin(), newton_raphson_gparcoupl_nonlin(), newton_raphson_parcoupl_common_dt(), newton_raphson_parcoupl_comp(), newton_raphson_parcoupl_lin(), newton_raphson_parcoupl_nonlin(), newton_raphson_parcoupl_nonlin_new(), newton_raphson_parcoupl_nonlin_old(), mechmat::newton_stress_return(), mechmat::newton_stress_return_2(), planeelemrotlt::nod_others(), planeelemlt::nod_others(), linhex::nod_others(), soilplateq::nod_strains(), planeelemsubqt::nod_strains(), planeelemrotlt::nod_strains(), planeelemqt::nod_strains(), linhex::nod_strains(), axisymlq::nod_strains(), axisymqq::nod_strains_old(), planeelemsubqt::nod_stresses(), planeelemrotlt::nod_stresses(), planeelemqt::nod_stresses(), linhex::nod_stresses(), axisymlq::nod_stresses(), axisymqq::nod_stresses_old(), lplate::nodaldisplacements(), nonlin_newmark_method(), nonlin_nonstat_dform(), nonlinear_nonstat_solv(), nonlinear_nonstat_solv_dform(), nonlinear_nonstat_solv_dform_dneska(), nonlinear_nonstat_solv_fnr_dform(), nonlinear_nonstat_solv_fnr_dform_old(), nonlinear_nonstat_solv_linesearch(), nonlinear_nonstat_solv_new(), nonlinear_nonstat_solv_nr_dform(), nonlinear_nonstat_solv_old(), nonlinear_nonstat_solv_oldd(), nonlinear_nonstat_solv_pokus(), nonlinear_nonstat_solv_vform(), nonloc_internal_forces(), nonstat_solv_vform_comp(), one_step_nonlinear(), one_step_nonlinear_dform(), par_homogenization(), par_linear_nonstat_solv_vform(), par_newton_raphson_gparcoupl_lin(), par_newton_raphson_gparcoupl_nonlin(), par_newton_raphson_parcoupl_comp(), par_newton_raphson_parcoupl_lin(), par_newton_raphson_parcoupl_lin_vform(), par_newton_raphson_parcoupl_nonlin(), par_nonstat_solv_vform_comp(), par_one_step_nonlinear(), par_one_step_trfel_nonlinear(), par_solve_nonlinear_nonstationary_problem(), par_solve_nonlinear_nonstationary_problem_dform(), par_solve_prob_constr_phases(), par_solve_timemech_prob(), par_solve_timemech_prob_old(), paral_transport_homogenization(), lplate::pcg(), least_square::polynom_coefficients_inv_ae(), tloadcase::read(), seismtool::read(), trlineart::res_transmission_vector(), quadlineart::res_transmission_vector(), lintett::res_transmission_vector(), linhext::res_transmission_vector(), response_spectrum_method(), mechtop::restore_nodforce(), mechtop::restore_nodval(), dpfeti::rhs_dpfeti(), right_hand_side(), schurcompl::scatter_bound_vect(), schurcompl::selected_norm_calculation(), solve_epressure(), boundparcongrad::solve_fact_mat_petsc(), solve_linear_statics(), solve_nonlinear_stationary_problem_pokus(), solve_nonstationary_growing_problem(), solve_nonstationary_growing_problem_nonlin(), solve_nonstationary_growing_vform(), solve_prob_constr_phases(), solve_radiation_stationary_problem(), schurcompl::solve_red_sys_fin(), seqschur::solve_red_sys_fin(), schurcompl::solve_red_sys_iter(), parcongrad::solve_system(), lplate::solve_system(), boundparcongrad::solve_system(), dloadcase::tempercontrib(), transport_homogenization(), trfel_bound_flux(), trfel_mefel(), trfel_right_hand_side(), schurcompl::unbalanced_values(), skyline::utv(), dpfeti::vectors_br_bm(), and visco_solver().

long printv ( const long *  u,
long  n,
FILE *  out,
int  width 
)

prints contents of integer vector given by array

The function prints out the contents of the vector u (integer values are assumed) given by array. Optionally, the file and field width can be specified.

Parameters:
u - pointer to array of integer values which will be printed
n - size of array u

Optionally :

Parameters:
out is the structure with opened file for ivector output (default is stdout)
width is desired width of the ivector elements on the output (default is 11)
Return values:
0 on succes
1 in case NULL pointer of the out parameter

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 1711 of file vector.cpp.

References print_err().

long printv ( const ivector u,
FILE *  out,
int  width 
)

prints contents of ivector

The function prints out the contents of the ivector u to the file out. Optionally, the file and field width can be specified.

Parameters:
u is the structure of the ivector which is printed

Optionally :

Parameters:
out is the structure with opened file for ivector output (default is stdout)
width is desired width of the ivector elements on the output (default is 11)
Return values:
0 on succes
1 in case NULL pointer of the out parameter

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 1679 of file vector.cpp.

References ivector::a, ivector::n, and print_err().

long printv ( FILE *  out,
vector u 
)

prints vector u to the file out

The function prints contents of the vector u into the file out,

Parameters:
out - pointer to the structure with opened output file
u - vector which contents will be printed

Requirements : Vector u have to be allocated memory. Number of read values is given by the vector n member.

Return values:
0 : on succes
1 : in case NULL pointer of the in parameter
2 : in case error reading number from the file

TKr, 11/02/2013 accroding to readv(XFILE *in, vector u)

Definition at line 1652 of file vector.cpp.

References vector::n.

long printv ( const double *  u,
long  n,
FILE *  out,
int  prec,
int  width 
)

prints contents of vector given by array to the file out with given precision and field width

The function prints out the contents of the vector u given by array to the out file. Optionally, file, precision and field width can be specified

Parameters:
u - pointer to array of double values which will be printed
n - size of array u

Optionally :

Parameters:
out is the structure with opened file for vector output (default is stdout)
prec is desired precision of the vector elements on the output (default is 3)
width is desired width of the vector elements on the output (default is 11)
Return values:
0 : on succes
1 : in case NULL pointer of the out parameter

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 1621 of file vector.cpp.

References print_err().

long printv ( const vector u,
FILE *  out,
int  prec,
int  width 
)

prints contents of vector to the file out with given precision and field width

The function prints out the contents of the vector u to the out file, Optionally, the file, precision and field width can be specified file.

Parameters:
u is the structure of the vector which is printed

Optionally :

Parameters:
out is the structure with opened file for vector output (default is stdout)
prec is desired precision of the vector elements on the output (default is 3)
width is desired width of the vector elements on the output (default is 11)
Return values:
0 : on succes
1 : in case NULL pointer of the out parameter

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 1588 of file vector.cpp.

References vector::a, vector::n, and print_err().

Referenced by crsec3dbeam::print().

long readv ( char *  in,
vector u 
)

reads contents of vector from string

The function reads contents of the vector u from the string in,

Parameters:
in pointer to the input string
u vector which contents will be read

Requirements : Vector u have to be allocated memory. Number of read values is given by the vector n member.

Return values:
0 : on succes
1 : in case NULL pointer of the in parameter
2 : in case error reading number from the file

created 6.9.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 1775 of file vector.cpp.

References vector::a, vector::n, and print_err().

long readv ( XFILE in,
vector u 
)

reads contents of vector from file

The function reads contents of the vector u from the file in,

Parameters:
in pointer to the structure with opened input file
u vector which contents will be read

Requirements : Vector u have to be allocated memory. Number of read values is given by the vector n member.

Return values:
0 : on succes
1 : in case NULL pointer of the in parameter
2 : in case error reading number from the file

created 3.12.2006 by Jaroslav Kruis, jk@cml.fsv.cvut.cz

Definition at line 1742 of file vector.cpp.

References vector::a, vector::n, print_err(), and xfscanf().

Referenced by input_elem_lcs(), input_nod_lcs(), and crsec3dbeam::read().

long reallocv ( long  n,
ivector vec 
)

reallocates ivector

The function reallocates memory for the ivector's member array a. If the new ivector size is greater than previously allocated one, array a is deleted and new memory is allocted from the heap. If the new ivector size is less or equal, then the memory allocated for the array a is left and the number of ivector components is changed. Components of the array a are set to zero.

Parameters:
n is the new number of the ivector components
vec is the structure for reallocated ivector
Return values:
0 - on success
1 - if fails allocating memory

created 12.2012 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 272 of file vector.cpp.

References ivector::a, memset(), ivector::n, and print_err().

long reallocv ( long  n,
vector vec 
)

reallocates vector

The function reallocates memory for the vector's member array a. If the new vector size is greater than previously allocated one, array a is deleted and new memory is allocted from the heap. If the new vector size is less or equal, then the memory allocated for the array a is left and the number of vector components is changed. Components of the array a are set to zero.

Parameters:
n is the new number of the ivector components
vec is the structure for reallocated vector
Return values:
0 - on success
1 - if fails allocating memory

created 12.2012 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 200 of file vector.cpp.

References vector::a, memset(), vector::n, and print_err().

Referenced by gtopology::adjacelem(), gtopology::adjacnodes(), mechtop::alloc_nodes_arrays(), loadcaset::assemble(), loadcase::assemble(), dloadcase::assemble(), linhext::average_flux(), gtopology::code_num_mod(), loadcase::compute_reactions(), dloadcase::compute_reactions(), mechtop::comreacelem(), lintett::conductivity_matrix(), eldispl(), mechtop::elemprescdisp(), elprdispl(), give_transq_nodval(), gtopology::hang_nodes_check(), incr_internal_forces(), mechtop::initial_displ(), initial_stiffness_matrix(), quadquadrilattax::internal_fluxes(), quadquadrilatt::internal_fluxes(), quadlineart::internal_fluxes(), quadlinaxisym::internal_fluxes(), quadhext::internal_fluxes(), linhext::internal_fluxes(), trlineart::intpointgrad(), trlinaxisym::intpointgrad(), quadquadrilattax::intpointgrad(), quadquadrilatt::intpointgrad(), quadlineart::intpointgrad(), quadlinaxisym::intpointgrad(), quadhext::intpointgrad(), quadbartax::intpointgrad(), quadbart::intpointgrad(), lintett::intpointgrad(), linhext::intpointgrad(), linbartax::intpointgrad(), trlineart::intpointother(), trlinaxisym::intpointother(), quadquadrilattax::intpointother(), quadquadrilatt::intpointother(), quadlineart::intpointother(), quadlinaxisym::intpointother(), quadhext::intpointother(), quadbartax::intpointother(), quadbart::intpointother(), lintett::intpointother(), linhext::intpointother(), linbartax::intpointother(), linbart::intpointother(), trlineart::intpointval(), trlinaxisym::intpointval(), quadquadrilattax::intpointval(), quadquadrilatt::intpointval(), quadlineart::intpointval(), quadlinaxisym::intpointval(), quadhext::intpointval(), quadbartax::intpointval(), quadbart::intpointval(), lintett::intpointval(), linhext::intpointval(), linbartax::intpointval(), linbart::intpointval(), intpointval(), intpointval2(), trlineart::intpointval_puc(), quadlineart::intpointval_puc(), lintett::intpointval_puc(), linhext::intpointval_puc(), intpointvalt(), lintett::l_matrix(), lintett::l_t_matrix(), lnso_leso_setting(), loc_internal_forces(), mass_matrix(), mefel_trfel(), mefel_trfel_by_nodes(), quadlineart::nod_eqother_ip(), planeelemlq::nod_eqother_ip(), trlinaxisym::nod_others(), quadquadrilattax::nod_others(), quadquadrilatt::nod_others(), quadlinaxisym::nod_others(), quadhext::nod_others(), quadbartax::nod_others(), lintett::nod_others(), linbartax::nod_others(), trlineart::nod_others_comp(), quadquadrilatt::nod_others_comp(), quadlineart::nod_others_comp(), linhext::nod_others_comp(), linbart::nod_others_comp(), nodal_eigstrain_forces(), nodal_pore_press_forces(), nodforce(), nonloc_internal_forces(), elemoutm::print_stra(), nodeoutm::print_stra(), elemoutm::print_stre(), nodeoutm::print_stre(), trlineart::res_boundary_flux(), trlinaxisym::res_boundary_flux(), quadquadrilattax::res_boundary_flux(), quadquadrilatt::res_boundary_flux(), quadlineart::res_boundary_flux(), quadlinaxisym::res_boundary_flux(), quadhext::res_boundary_flux(), quadbartax::res_boundary_flux(), lintett::res_boundary_flux(), linhext::res_boundary_flux(), linbartax::res_boundary_flux(), trlineart::res_convection_vector(), trlinaxisym::res_convection_vector(), quadquadrilattax::res_convection_vector(), quadquadrilatt::res_convection_vector(), quadlineart::res_convection_vector(), quadlinaxisym::res_convection_vector(), quadhext::res_convection_vector(), quadbartax::res_convection_vector(), quadbart::res_convection_vector(), lintett::res_convection_vector(), linhext::res_convection_vector(), linbartax::res_convection_vector(), trlineart::res_internal_fluxes(), trlinaxisym::res_internal_fluxes(), quadquadrilattax::res_internal_fluxes(), quadquadrilatt::res_internal_fluxes(), quadlineart::res_internal_fluxes(), quadlinaxisym::res_internal_fluxes(), quadhext::res_internal_fluxes(), quadbartax::res_internal_fluxes(), quadbart::res_internal_fluxes(), lintett::res_internal_fluxes(), linhext::res_internal_fluxes(), linbartax::res_internal_fluxes(), trlineart::res_quantity_source_vector(), trlinaxisym::res_quantity_source_vector(), quadquadrilattax::res_quantity_source_vector(), quadquadrilatt::res_quantity_source_vector(), quadlineart::res_quantity_source_vector(), quadlinaxisym::res_quantity_source_vector(), quadhext::res_quantity_source_vector(), quadbartax::res_quantity_source_vector(), quadbart::res_quantity_source_vector(), lintett::res_quantity_source_vector(), linhext::res_quantity_source_vector(), linbartax::res_quantity_source_vector(), trlineart::res_transmission_vector(), trlinaxisym::res_transmission_vector(), quadquadrilattax::res_transmission_vector(), quadquadrilatt::res_transmission_vector(), quadlineart::res_transmission_vector(), quadlinaxisym::res_transmission_vector(), quadhext::res_transmission_vector(), quadbartax::res_transmission_vector(), quadbart::res_transmission_vector(), lintett::res_transmission_vector(), linhext::res_transmission_vector(), linbartax::res_transmission_vector(), quadlineart::res_volume_rhs_vector(), quadlinaxisym::res_volume_rhs_vector(), quadbart::res_volume_rhs_vector(), linhext::res_volume_rhs_vector(), linbart::res_volume_rhs_vector(), mechtop::restore_nodforce(), mechtop::restore_nodval(), mechtop::save_elem_inidispl(), mechtop::save_node_inidispl(), gtopology::search_iface_nodes(), mechtop::searching_hanging_nodes(), gtopology::shell_sort_x(), gtopology::shell_sort_y(), gtopology::shell_sort_z(), stiffness_matrix(), stress_initdispl(), total_integral(), trfel_mefel_by_nodes(), trfel_right_hand_side(), gtopology::update_nodes(), write_gid_displ(), and write_gid_nforces().

double scprd ( const double *  a,
const double *  b,
long  n 
)

performs scalar product of 2 arrays

The function computes the scalar product of the vector given by a and vector given by b.

Parameters:
a - onedimensional array of the first multiplied vector
b - onedimensional array of the second multiplied vector
n - number of components in arrays a and b.

Requests : a and b must have the same dimension

Returns:
The function returns the scalar product of vectors a and b.

created 12.2011 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 1146 of file vector.cpp.

long scprd ( const ivector a,
const ivector b,
long &  scalar 
)

performs scalar product of 2 ivectors

The function performs scalar product of the ivector given by a and ivector given by b, the result is stored in the c

Parameters:
a is the structure of the scalar multiplied ivector
b is the structure of the scalar multiplied ivector
scalar is the integer number type of long by which the result is passed

Requests : a and b should have same dimension

Return values:
0 on succes
1 in case incompatibility sizes of a and b

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 1173 of file vector.cpp.

References ivector::a, ivector::n, and print_err().

long scprd ( const vector a,
const vector b,
double &  scalar 
)

performs scalar product of 2 vectors

The function performs scalar product of the vector given by a and vector given by b, the result is stored in the c.

Parameters:
a is the structure of the scalar multiplied vector
b is the structure of the scalar multiplied vector
scalar is the real number type of double by which the result is passed

Requests : a and b have to be same dimension

Return values:
0 : on succes
1 : in case incompatibility sizes of a and b

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 1116 of file vector.cpp.

References vector::a, vector::n, and print_err().

Referenced by trlineart::approx(), trlinaxisym::approx(), quadquadrilattax::approx(), quadquadrilatt::approx(), quadlineart::approx(), quadlinaxisym::approx(), quadhext::approx(), quadbartax::approx(), quadbart::approx(), lintett::approx(), linhext::approx(), linbartax::approx(), linbart::approx(), soilplateq::approx(), quadwedge::approx(), quadtet::approx(), quadhex::approx(), q4plate::approx(), plquadcontact::approx(), planeelemsubqt::approx(), planeelemrotlt::approx(), planeelemrotlq::approx(), planeelemqt::approx(), planeelemqq::approx(), planeelemlt::approx(), planeelemlq::approx(), linwedge::approx(), lintetrot::approx(), lintet::approx(), linhexrot::approx(), linhex::approx(), dstelem::approx(), dktelem::approx(), creepbs::approx(), creepbbeam::approx(), creepb::approx(), cctelem::approx(), barelq3d::approx(), barelq2d::approx(), barel3d::approx(), barel2d::approx(), axisymqq::approx(), axisymlt::approx(), axisymlq::approx(), ArgyrisTriangle::approx(), trlineart::approx_nat(), trlinaxisym::approx_nat(), soilplatetr::approx_nat(), planeelemrotlt::approx_nat(), planeelemlt::approx_nat(), lintetrot::approx_nat(), lintet::approx_nat(), cctelem::approx_nat(), axisymlt::approx_nat(), ArgyrisTriangle::approx_nat(), least_square::apvalue_assembling(), planeelemlt::compute_error(), lintet::compute_error(), cosav(), mohrcoulomb::cutting_plane(), mechmat::cutting_plane(), mechmat::cutting_plane2(), scaldamcc::damfuncpar(), scaldam::damfuncpar(), glasgowdam::damfuncpar(), glasgmech::damfuncpar(), scaldamcc::damfunction(), displincr(), drprag2::getImportantValues(), give_valuesinpoints(), linhexrot::gngeom_matrix(), linhex::gngeom_matrix(), planeelemlq::gnl_ip_strains(), linhexrot::gnl_ip_strains(), linhex::gnl_ip_strains(), linhex::gnl_mainip_strains(), gtopology::hang_nodes_check(), quadtet::locglob_nodeval(), lintetrot::locglob_nodeval(), lintet::locglob_nodeval(), linhexrot::locglob_nodeval(), linhex::locglob_nodeval(), splas1d::matstiff(), camclay::matstiff(), glasgmech::nlstresses(), least_square::nsp_spcoord_maxcoord_assembling(), patch_averaging::nsp_spcoord_maxcoord_assembling(), splas1d::plasmodscalar(), j2flow2::plasmodscalar(), j2flow::plasmodscalar(), drprag::plasmodscalar(), camclaycoup::plasmodscalar(), camclay::plasmodscalar(), radius(), least_square::sigma(), patch_averaging::sigma(), least_square::spvalue_assembling_patch_ae(), shefplast::stress_return(), shefplast::tangentstiff(), mohrcoulomb::tangentstiff(), j2flow2::tangentstiff(), j2flow::tangentstiff(), drprag::tangentstiff(), and chen::tangentstiff().

void shell_sort ( long *  v,
long  n 
)

Shell sort for long integer array.

The function sorts array of integer numbers v by Shell sort algorithm in ascending order.

Parameters:
v - array of sorted numbers
n - length of array v
Returns:
The function does not return anything but changes order of v elements.

Created by Tomas Koudelka, 3.7.2013

Definition at line 1922 of file vector.cpp.

void shell_sort ( ivector v  ) 

Shell sort of ivector.

The function sorts ivector v by Shell sort algorithm in ascending order.

Parameters:
v - vector of sorted numbers
Returns:
The function does not return anything but changes order of v elements.

Created by Tomas Koudelka, 2.7.2013

Definition at line 1888 of file vector.cpp.

References ivector::n.

double ss ( double *  a,
double *  b,
long  n 
)

performs scalar product of 2 arrays

The function performs scalar product of the double array given by a and double array given by b, the result is stored in the c

Parameters:
a is the first array
b is the second array
n is number of members of arrays

created by JK

Definition at line 1199 of file vector.cpp.

Referenced by arclength(), arclength15(), arclengthadapt(), arclengthrv1(), dskyline::bicg(), comprow::bicg(), comprow::bicg_new(), lplate::cg(), dpfeti::cg(), symcomprow::cg(), elemmat::cg(), densemat::cg(), comprow::cg(), symcomprow::cg_prec(), densemat::cg_prec(), comprow::cg_prec(), densemat::cg_prec_new(), gedge::check_normal(), aggregator::coarse_matrix(), transtop::compute_resistance_factor(), creep_incrtotstresses(), creep_nlstressesincr(), creep_updateval(), displ_control(), displincr(), seqfeti::evector(), gen_jacobi2(), general_epressure(), general_epressure_varsup(), rspecmat::give_deps_free(), b3mat::give_deps_free(), rspecmat::give_deps_stressinduced(), b3mat::give_deps_stressinduced(), inverse_iteration(), gmatrix::inverse_iteration(), loadincr(), feti1::mpcg(), seqfeti::mpcg(), seqfeti::mprcg(), newton_raphson(), newton_raphson_coupl(), newton_raphson_coupl_new(), newton_raphson_gparcoupl_lin(), newton_raphson_gparcoupl_nonlin(), newton_raphson_parcoupl_lin(), newton_raphson_parcoupl_nonlin(), newton_raphson_parcoupl_nonlin_new(), newton_raphson_parcoupl_nonlin_old(), newton_raphson_restart(), newton_raphsonep(), nonlin_newmark_method(), nonlinear_nonstat_solv(), nonlinear_nonstat_solv_linesearch(), nonlinear_nonstat_solv_new(), nonlinear_nonstat_solv_old(), nonlinear_nonstat_solv_oldd(), nonlinear_nonstat_solv_pokus(), one_step_nonlinear(), par_newton_raphson_parcoupl_lin(), par_solve_nonlinear_statics(), lplate::pcg(), gmatrix::power_method(), quadeqcoeff(), feti1::qvector(), seqfeti::qvector(), cemhydmat::rand3d(), response_spectrum_method(), solve_nonstationary_growing_problem_nonlin(), solve_prob_constr_phases(), schurcompl::solve_red_sys_iter(), parcongrad::solve_system(), boundparcongrad::solve_system(), subspace_iter_jac(), subspace_iter_ortho(), subspace_shift_iter_ortho(), and visco_solver().

void subv ( double *  a,
double *  b,
double *  c,
long  n 
)

subtracts 2 arrays, result is stored to the another array

The function subtracts double array given by b from double array by a, the result is stored in the array c.

Parameters:
a - double array of minuend
b - double array of subtrahent
c - double array of resulting difference
n - length of arrays a, b and c
Returns:
The result is returned in the parameter c.

Created by JK

Definition at line 1001 of file vector.cpp.

void subv ( double *  a,
double *  b,
long  n 
)

subtracts 2 arrays

The function subtracts double array given by b from double array given by a, the result is stored in the a

Parameters:
a is the array, from which is subtracted
b is the subtracted array
n is number of members of arrays
Return values:
always zero

created by JK

Definition at line 980 of file vector.cpp.

long subv ( const ivector a,
const ivector b,
ivector c 
)

subtracts 2 ivectors

The function subtracts ivector given by b from ivector given by a, the result is stored in the c

Parameters:
a is the structure of the ivector, from which is subtracted
b is the structure of subtracted ivector
c is the structure of the result ivector

Requests : a, b and c should have same dimensions, c has to have allocated memory array for elements which is enough large to hold contents of the result.

Return values:
0 on succes
1 in case incompatibility sizes of a, b and c ivectors

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 953 of file vector.cpp.

References ivector::a, ivector::n, and print_err().

long subv ( const vector a,
const vector b 
)

subtracts 2 vectors

The function subtracts vector given by b from vector given by a, the result is stored in the a

Parameters:
a is the structure of the vector, from which is subtracted
b is the structure of subtracted vector

Requests : a and b have to have same dimensions

Return values:
0 on succes
1 in case incompatibility sizes of a and b vectors

created 08.2011 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 920 of file vector.cpp.

References vector::a, vector::n, and print_err().

long subv ( const vector a,
const vector b,
vector c 
)

subtracts 2 vectors

The function subtracts vector given by b from vector given by a, the result is stored in the c

Parameters:
a is the structure of the vector, from which is subtracted
b is the structure of subtracted vector
c is the structure of the result vector

Requests : a, b and c have to be same dimensions, c has to have allocated memory array for elements which is enough large to hold contents of the result.

Return values:
0 on succes
1 in case incompatibility sizes of a, b and c vectors

created 29.5.2000 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz modified 9.5.2001 by Tomas Koudelka, koudelka@cml.fsv.cvut.cz

Definition at line 890 of file vector.cpp.

References vector::a, vector::n, and print_err().

Referenced by arclength(), arclengthadapt(), arclengthrv(), arclengthrv1(), nonlocplast::average(), aggregator::boss(), trlineart::compute_error(), quadlineart::compute_error(), planeelemqt::compute_error(), planeelemqq::compute_error(), planeelemlt::compute_error(), planeelemlq::compute_error(), lintet::compute_error(), mohrcoulomb::cutting_plane(), mechmat::cutting_plane(), mechmat::cutting_plane2(), scaldamcc::damfunction(), garclength(), Ctlinterface::get_residual(), drprag2::getImportantValues(), gnewton_raphson(), gnewton_raphson_one_step(), feti1::lagrmultdispl(), seqfeti::lagrmultdispl(), seqfeti::lagrmultnodunknowns(), mohrcoulomb::mc_msurf_cp(), feti1::mpcg(), seqfeti::mpcg(), seqfeti::mprcg(), mechmat::mult_surf_cutting_plane(), newton_raphson_gparcoupl_nonlin(), mechmat::newton_stress_return(), mechmat::newton_stress_return_2(), visplast::nlstresses(), ortodamrot::nlstresses(), ortodam::nlstresses(), hissplas::nlstresses(), glasgownew::nlstresses(), glasgmech::nlstresses(), creep_effym::nlstresses(), drprag2::nlstresses(), one_step(), one_step_arcl(), one_step_nonlinear_dform(), par_gnewton_raphson_one_step(), par_gnewton_raphson_one_step_mefel(), par_newton_raphson_gparcoupl_lin(), par_newton_raphson_gparcoupl_nonlin(), par_one_step(), par_one_step_mefel(), par_solve_prob_constr_phases(), trlineart::res_internal_fluxes(), trlinaxisym::res_internal_fluxes(), quadquadrilattax::res_internal_fluxes(), quadquadrilatt::res_internal_fluxes(), quadlineart::res_internal_fluxes(), quadlinaxisym::res_internal_fluxes(), quadhext::res_internal_fluxes(), quadbartax::res_internal_fluxes(), quadbart::res_internal_fluxes(), lintett::res_internal_fluxes(), linhext::res_internal_fluxes(), linbartax::res_internal_fluxes(), linbart::res_internal_fluxes(), residuum(), solve_prob_constr_phases(), parcongrad::solve_system(), boundparcongrad::solve_system(), and shefplast::stress_return().


Generated by  doxygen 1.6.2