Lemina
A molecular dynamics package for network, granular material and point particles with a range of interaction potential.
 
Loading...
Searching...
No Matches
global.h File Reference
#include <stdio.h>
+ Include dependency graph for global.h:
+ This graph shows which files directly or indirectly include this file:

Go to the source code of this file.

Macros

#define EXTERN   extern
 
#define NDIM   2
 
#define Sqr(x)
 
#define SignR(x, y)
 

Typedefs

typedef double real
 

Variables

double * rx
 
double * ry
 
double * vx
 
double * vy
 
double * ax
 
double * ay
 
double * fx
 
double * fy
 
double * speed
 
double region [2+1]
 
double regionH [2+1]
 
double deltaT
 
double timeNow
 
double potEnergy
 
double kinEnergy
 
double totEnergy
 
double density
 
double pressure
 
double rCut
 
double kappa
 
double uSum
 
double virSum
 
double svirSum
 
double vSum
 
double vSumX
 
double vSumY
 
double vvSum
 
double sPotEnergy
 
double sKinEnergy
 
double sTotEnergy
 
double sPressure
 
double ssPotEnergy
 
double ssKinEnergy
 
double ssTotEnergy
 
double ssPressure
 
int initUcell [2+1]
 
int moreCycles
 
int nAtom
 
int stepAvg
 
int stepCount
 
int stepEquil
 
int stepLimit
 
int stepTraj
 
int stepDump
 
double RadiusIJ
 
double SqrRadiusIJ
 
double RadiusIJInv
 
int nAtomType
 
int * atomType
 
int * atomID
 
double * atomRadius
 
double * atomMass
 
double TotalMass
 
double mass
 
int nBond
 
int nBondType
 
int * atom1
 
int * atom2
 
int * BondID
 
int * BondType
 
double * kb
 
double * ro
 
double * BondEnergy
 
double * BondLength
 
double TotalBondEnergy
 
double BondEnergyPerAtom
 
double gamman
 
double * discDragx
 
double * discDragy
 
double * nodeDragx
 
double * nodeDragy
 
double strain
 
double strainRate
 
double shearDisplacement
 
double shearVelocity
 
double VSqr
 
double VMeanSqr
 
double VRootMeanSqr
 
double ComX
 
double ComY
 
double ComX0
 
double ComY0
 
double ComXRatio
 
double ComYRatio
 
double HaltCondition
 
double DeltaY
 
double DeltaX
 
int * ImageX
 
int * ImageY
 
double * rxUnwrap
 
double * ryUnwrap
 
double Kn
 
double fxExtern
 
double fyExtern
 
double FyBylx
 
double fxByfy
 
double forceSumxExtern
 
double forceSumyExtern
 
int DampFlag
 
double strech
 
char mode [64]
 
char inputConfig [128]
 
int dumpPairFlag
 
int nPairTotal
 
int nPairActive
 
int * PairID
 
int * Pairatom1
 
int * Pairatom2
 
double * PairXij
 
double * PairYij
 
char solver [128]
 
char xBoundary [10]
 
char yBoundary [10]
 
int * molID
 
int ** isBonded
 
double InterfaceWidth
 
double bigDiameter
 
int nAtomInterface
 
int nDiscInterface
 
int nAtomBlock
 
int * atomIDInterface
 
int BondPairFlag
 
int nAtomInterfaceTotal
 
int * cellList
 
int cells [2+1]
 
int rank
 
int size
 
int master
 
double * fax
 
double * fay
 
double fuSum
 
double fvirSum
 
double frfAtom
 
double uSumPair
 
double uSumPairPerAtom
 
double virSumPair
 
double virSumPairxx
 
double virSumPairyy
 
double virSumPairxy
 
double virSumBond
 
double virSumBondxx
 
double virSumBondyy
 
double virSumBondxy
 
double virSumxx
 
double virSumyy
 
double virSumxy
 
int freezeAtomType
 
double ** cfOrg
 
double ** spacetimeCorr
 
double * cfVal
 
double * spacetimeCorrAv
 
int * indexCorr
 
int countCorrAv
 
int limitCorrAv
 
int nBuffCorr
 
int nFunCorr
 
int nValCorr
 
int stepCorr
 
double rfAtom
 
double * indexAcf
 
double ** viscAcf
 
double * viscAcfOrg
 
double * viscAcfAv
 
double viscAcfInt
 
int nValAcf
 
int nBuffAcf
 
int stepAcf
 
int countAcfAv
 
int limitAcfAv
 
double * histRdf
 
double rangeRdf
 
int countRdf
 
int limitRdf
 
int sizeHistRdf
 
int stepRdf
 
char * prefix
 
char result [250]
 
FILE * fpresult
 
char xyz [256]
 
FILE * fpxyz
 
char bond [256]
 
FILE * fpbond
 
char dump [256]
 
FILE * fpdump
 
char dnsty [256]
 
FILE * fpdnsty
 
char visc [256]
 
FILE * fpvisc
 
char rdf [256]
 
FILE * fprdf
 
char vrms [256]
 
FILE * fpvrms
 
char stress [256]
 
FILE * fpstress
 
char momentum [256]
 
FILE * fpmomentum
 
char force [256]
 
FILE * fpforce
 
char com [256]
 
FILE * fpcom
 
char pair [256]
 
FILE * fppair
 

Macro Definition Documentation

◆ EXTERN

#define EXTERN   extern

Definition at line 8 of file global.h.

◆ NDIM

#define NDIM   2

◆ SignR

#define SignR ( x,
y )
Value:
(((y) >= 0) ? (x) : (- (x)))

Definition at line 15 of file global.h.

Referenced by EvalRdf(), and LeapfrogStep().

◆ Sqr

#define Sqr ( x)

Typedef Documentation

◆ real

typedef double real

Definition at line 11 of file global.h.

Variable Documentation

◆ atom1

◆ atom2

int * atom2

◆ atomID

◆ atomIDInterface

int* atomIDInterface
extern

◆ atomMass

◆ atomRadius

◆ atomType

◆ ax

◆ ay

◆ bigDiameter

double bigDiameter

Definition at line 75 of file global.h.

Referenced by Init(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ bond

char bond[256]
extern

Referenced by main().

◆ BondEnergy

double* BondEnergy
extern

◆ BondEnergyPerAtom

double BondEnergyPerAtom

Definition at line 40 of file global.h.

Referenced by EvalProps(), HaltConditionCheck(), and PrintSummary().

◆ BondID

◆ BondLength

double * BondLength

Definition at line 39 of file global.h.

Referenced by ComputeBondForce(), DumpBonds(), Init(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ BondPairFlag

int BondPairFlag
extern

◆ BondType

int * BondType

Definition at line 37 of file global.h.

Referenced by Close(), DumpBonds(), DumpRestart(), Init(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ cellList

int* cellList
extern

◆ cells

int cells[2+1]

Definition at line 83 of file global.h.

Referenced by ComputeForcesCells(), Init(), and ReadBinaryRestart().

◆ cfOrg

double** cfOrg
extern

◆ cfVal

double * cfVal

Definition at line 94 of file global.h.

Referenced by AllocArrays(), Close(), and EvalSpacetimeCorr().

◆ com

char com[256]
extern

Referenced by main().

◆ ComX

double ComX
extern

Referenced by EvalCom(), and PrintCom().

◆ ComX0

double ComX0

Definition at line 47 of file global.h.

Referenced by EvalCom().

◆ ComXRatio

double ComXRatio

Definition at line 47 of file global.h.

Referenced by EvalCom().

◆ ComY

double ComY

Definition at line 47 of file global.h.

Referenced by EvalCom(), and PrintCom().

◆ ComY0

double ComY0

Definition at line 47 of file global.h.

Referenced by EvalCom().

◆ ComYRatio

double ComYRatio

Definition at line 47 of file global.h.

Referenced by EvalCom().

◆ countAcfAv

int countAcfAv

Definition at line 100 of file global.h.

Referenced by AccumVacf(), and ZeroVacf().

◆ countCorrAv

int countCorrAv

Definition at line 95 of file global.h.

Referenced by EvalSpacetimeCorr(), and SetupJob().

◆ countRdf

int countRdf
extern

Referenced by EvalRdf(), and SetupJob().

◆ DampFlag

int DampFlag
extern

◆ deltaT

◆ DeltaX

double DeltaX

Definition at line 49 of file global.h.

Referenced by DisplaceAtoms(), Init(), and ReadBinaryRestart().

◆ DeltaY

double DeltaY
extern

◆ density

double density

Definition at line 20 of file global.h.

Referenced by EvalProps(), Init(), and ReadBinaryRestart().

◆ discDragx

◆ discDragy

double * discDragy

◆ dnsty

char dnsty[256]
extern

◆ dump

char dump[256]
extern

◆ dumpPairFlag

int dumpPairFlag
extern

◆ fax

double* fax
extern

Referenced by Close(), and Init().

◆ fay

double * fay

Definition at line 85 of file global.h.

Referenced by Close(), and Init().

◆ force

char force[256]
extern

Referenced by main().

◆ forceSumxExtern

double forceSumxExtern

Definition at line 53 of file global.h.

Referenced by ApplyForce(), PrintForceSum(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ forceSumyExtern

double forceSumyExtern

Definition at line 53 of file global.h.

Referenced by ApplyForce(), PrintForceSum(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ fpbond

FILE* fpbond
extern

Referenced by DumpBonds(), and main().

◆ fpcom

FILE* fpcom
extern

◆ fpdnsty

FILE* fpdnsty
extern

Referenced by EvalSpacetimeCorr().

◆ fpdump

FILE* fpdump
extern

◆ fpforce

FILE* fpforce
extern

◆ fpmomentum

FILE* fpmomentum
extern

Referenced by PrintMomentum().

◆ fppair

FILE* fppair
extern

Referenced by DumpPairs(), and main().

◆ fprdf

FILE* fprdf
extern

Referenced by EvalRdf().

◆ fpresult

◆ fpstress

FILE* fpstress
extern

Referenced by PrintStress().

◆ fpvisc

FILE* fpvisc
extern

Referenced by PrintVacf().

◆ fpvrms

FILE* fpvrms
extern

◆ fpxyz

FILE* fpxyz
extern

Referenced by main(), and Trajectory().

◆ freezeAtomType

int freezeAtomType
extern

Referenced by Init(), and VelocityVerletStep().

◆ frfAtom

double frfAtom

Definition at line 85 of file global.h.

◆ fuSum

double fuSum

Definition at line 85 of file global.h.

◆ fvirSum

double fvirSum

Definition at line 85 of file global.h.

◆ fx

◆ fxByfy

double fxByfy

Definition at line 53 of file global.h.

Referenced by ApplyForce(), Init(), and ReadBinaryRestart().

◆ fxExtern

double fxExtern
extern

Referenced by ApplyForce().

◆ fy

◆ FyBylx

double FyBylx

Definition at line 53 of file global.h.

Referenced by ApplyForce(), Init(), and ReadBinaryRestart().

◆ fyExtern

double fyExtern

Definition at line 53 of file global.h.

Referenced by ApplyForce().

◆ gamman

◆ HaltCondition

double HaltCondition
extern

◆ histRdf

double* histRdf
extern

Referenced by AllocArrays(), and EvalRdf().

◆ ImageX

◆ ImageY

int * ImageY

◆ indexAcf

double* indexAcf
extern

◆ indexCorr

int* indexCorr
extern

◆ initUcell

int initUcell[2+1]
extern

◆ inputConfig

char inputConfig[128]

Definition at line 58 of file global.h.

Referenced by Init().

◆ InterfaceWidth

double InterfaceWidth
extern

◆ isBonded

int** isBonded
extern

◆ kappa

double kappa

Definition at line 21 of file global.h.

Referenced by Init(), LeapfrogStep(), and ReadBinaryRestart().

◆ kb

◆ kinEnergy

double kinEnergy

Definition at line 20 of file global.h.

Referenced by AccumProps(), AccumVacf(), EvalProps(), HaltConditionCheck(), and PrintSummary().

◆ Kn

double Kn
extern

Referenced by ComputePairForce(), and Init().

◆ limitAcfAv

int limitAcfAv

Definition at line 100 of file global.h.

Referenced by AccumVacf(), and Init().

◆ limitCorrAv

int limitCorrAv

Definition at line 95 of file global.h.

Referenced by EvalSpacetimeCorr(), and Init().

◆ limitRdf

int limitRdf

Definition at line 104 of file global.h.

Referenced by EvalRdf(), and Init().

◆ mass

double mass
extern

Referenced by Init(), and ReadBinaryRestart().

◆ master

int master

Definition at line 84 of file global.h.

◆ mode

char mode[64]
extern

Referenced by Init().

◆ molID

◆ momentum

char momentum[256]
extern

◆ moreCycles

int moreCycles

Definition at line 24 of file global.h.

Referenced by main().

◆ nAtom

◆ nAtomBlock

int nAtomBlock

Definition at line 76 of file global.h.

Referenced by ApplyForce(), Init(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ nAtomInterface

int nAtomInterface
extern

◆ nAtomInterfaceTotal

int nAtomInterfaceTotal
extern

◆ nAtomType

int nAtomType
extern

◆ nBond

◆ nBondType

int nBondType

Definition at line 35 of file global.h.

Referenced by DumpRestart(), Init(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ nBuffAcf

int nBuffAcf

Definition at line 100 of file global.h.

Referenced by AccumVacf(), AllocArrays(), Close(), EvalVacf(), Init(), and InitVacf().

◆ nBuffCorr

int nBuffCorr

Definition at line 95 of file global.h.

Referenced by AllocArrays(), Close(), EvalSpacetimeCorr(), Init(), and SetupJob().

◆ nDiscInterface

int nDiscInterface

Definition at line 76 of file global.h.

Referenced by Init(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ nFunCorr

int nFunCorr

Definition at line 95 of file global.h.

Referenced by AllocArrays(), EvalSpacetimeCorr(), Init(), and SetupJob().

◆ nodeDragx

double * nodeDragx

Definition at line 42 of file global.h.

Referenced by ComputeBondForce(), DumpBonds(), Init(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ nodeDragy

double * nodeDragy

Definition at line 42 of file global.h.

Referenced by ComputeBondForce(), DumpBonds(), Init(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ nPairActive

int nPairActive

Definition at line 62 of file global.h.

Referenced by ComputePairForce(), DumpPairs(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ nPairTotal

int nPairTotal
extern

◆ nValAcf

int nValAcf
extern

◆ nValCorr

int nValCorr

Definition at line 95 of file global.h.

Referenced by AllocArrays(), EvalSpacetimeCorr(), Init(), and SetupJob().

◆ pair

char pair[256]
extern

Referenced by main().

◆ Pairatom1

int * Pairatom1

Definition at line 63 of file global.h.

Referenced by Close(), ComputePairForce(), DumpPairs(), Init(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ Pairatom2

int * Pairatom2

Definition at line 63 of file global.h.

Referenced by Close(), ComputePairForce(), DumpPairs(), Init(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ PairID

◆ PairXij

double* PairXij
extern

◆ PairYij

double * PairYij

Definition at line 64 of file global.h.

Referenced by Close(), ComputePairForce(), DumpPairs(), Init(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ potEnergy

double potEnergy

Definition at line 20 of file global.h.

Referenced by AccumProps(), EvalProps(), HaltConditionCheck(), and PrintSummary().

◆ prefix

char* prefix
extern

Definition at line 13 of file main.c.

Referenced by DumpRestart(), DumpState(), main(), and WriteBinaryRestart().

◆ pressure

double pressure

Definition at line 21 of file global.h.

Referenced by AccumProps(), EvalProps(), HaltConditionCheck(), PrintStress(), and PrintSummary().

◆ RadiusIJ

double RadiusIJ
extern

◆ RadiusIJInv

double RadiusIJInv

Definition at line 27 of file global.h.

Referenced by ComputeForcesCells(), and ComputePairForce().

◆ rangeRdf

double rangeRdf

Definition at line 103 of file global.h.

Referenced by EvalRdf(), and Init().

◆ rank

int rank
extern

Referenced by ComputeForcesCells().

◆ rCut

double rCut

Definition at line 21 of file global.h.

Referenced by Init(), LeapfrogStep(), and ReadBinaryRestart().

◆ rdf

char rdf[256]
extern

◆ region

◆ regionH

◆ result

char result[250]
extern

Referenced by main().

◆ rfAtom

double rfAtom
extern

Referenced by ComputeForcesCells(), and EvalVacf().

◆ ro

double * ro

◆ rx

◆ rxUnwrap

double* rxUnwrap
extern

◆ ry

◆ ryUnwrap

double * ryUnwrap

Definition at line 51 of file global.h.

Referenced by Close(), EvalCom(), EvalUnwrap(), Init(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ shearDisplacement

double shearDisplacement
extern

◆ shearVelocity

double shearVelocity

Definition at line 45 of file global.h.

Referenced by Init().

◆ size

int size

Definition at line 84 of file global.h.

Referenced by ComputeForcesCells().

◆ sizeHistRdf

int sizeHistRdf

Definition at line 104 of file global.h.

Referenced by AllocArrays(), EvalRdf(), and Init().

◆ sKinEnergy

double sKinEnergy

Definition at line 21 of file global.h.

Referenced by AccumProps().

◆ solver

char solver[128]
extern

Referenced by EvalProps(), Init(), and ReadBinaryRestart().

◆ spacetimeCorr

double ** spacetimeCorr

Definition at line 94 of file global.h.

Referenced by AllocArrays(), Close(), and EvalSpacetimeCorr().

◆ spacetimeCorrAv

double * spacetimeCorrAv

Definition at line 94 of file global.h.

Referenced by AllocArrays(), Close(), EvalSpacetimeCorr(), and SetupJob().

◆ speed

double* speed
extern

Referenced by Close(), and Init().

◆ sPotEnergy

double sPotEnergy

Definition at line 21 of file global.h.

Referenced by AccumProps().

◆ sPressure

double sPressure

Definition at line 22 of file global.h.

Referenced by AccumProps().

◆ SqrRadiusIJ

double SqrRadiusIJ

Definition at line 27 of file global.h.

Referenced by ComputeForcesCells(), and ComputePairForce().

◆ ssKinEnergy

double ssKinEnergy

Definition at line 22 of file global.h.

Referenced by AccumProps().

◆ ssPotEnergy

double ssPotEnergy

Definition at line 22 of file global.h.

Referenced by AccumProps().

◆ ssPressure

double ssPressure

Definition at line 22 of file global.h.

Referenced by AccumProps().

◆ ssTotEnergy

double ssTotEnergy

Definition at line 22 of file global.h.

Referenced by AccumProps().

◆ stepAcf

int stepAcf

Definition at line 100 of file global.h.

Referenced by AccumVacf(), Init(), and PrintVacf().

◆ stepAvg

int stepAvg

Definition at line 24 of file global.h.

Referenced by AccumProps(), Init(), and main().

◆ stepCorr

int stepCorr

Definition at line 95 of file global.h.

Referenced by EvalSpacetimeCorr(), and Init().

◆ stepCount

int stepCount

◆ stepDump

int stepDump

Definition at line 24 of file global.h.

Referenced by Init(), and main().

◆ stepEquil

int stepEquil

Definition at line 24 of file global.h.

Referenced by BrownianStep(), Init(), LeapfrogStep(), and ReadBinaryRestart().

◆ stepLimit

int stepLimit

Definition at line 24 of file global.h.

Referenced by Init(), main(), and ReadBinaryRestart().

◆ stepRdf

int stepRdf

Definition at line 104 of file global.h.

Referenced by Init().

◆ stepTraj

int stepTraj

Definition at line 24 of file global.h.

Referenced by Init(), and main().

◆ sTotEnergy

double sTotEnergy

Definition at line 22 of file global.h.

Referenced by AccumProps().

◆ strain

double strain
extern

Referenced by ApplyShear(), Init(), and ReadBinaryRestart().

◆ strainRate

double strainRate

Definition at line 44 of file global.h.

Referenced by Init(), and ReadBinaryRestart().

◆ strech

double strech
extern

◆ stress

char stress[256]
extern

◆ svirSum

double svirSum

Definition at line 21 of file global.h.

Referenced by AccumProps().

◆ timeNow

◆ TotalBondEnergy

double TotalBondEnergy
extern

◆ TotalMass

double TotalMass

Definition at line 32 of file global.h.

Referenced by EvalCom().

◆ totEnergy

double totEnergy

Definition at line 20 of file global.h.

Referenced by AccumProps(), EvalProps(), HaltConditionCheck(), and PrintSummary().

◆ uSum

double uSum

Definition at line 21 of file global.h.

Referenced by ComputeForcesCells().

◆ uSumPair

double uSumPair
extern

◆ uSumPairPerAtom

double uSumPairPerAtom

Definition at line 88 of file global.h.

Referenced by EvalProps(), HaltConditionCheck(), and PrintSummary().

◆ virSum

double virSum

Definition at line 21 of file global.h.

Referenced by AccumProps(), ComputeForcesCells(), EvalProps(), HaltConditionCheck(), and PrintSummary().

◆ virSumBond

double virSumBond
extern

◆ virSumBondxx

double virSumBondxx

Definition at line 89 of file global.h.

Referenced by ComputeBondForce(), EvalProps(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ virSumBondxy

double virSumBondxy

Definition at line 89 of file global.h.

Referenced by ComputeBondForce(), EvalProps(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ virSumBondyy

double virSumBondyy

Definition at line 89 of file global.h.

Referenced by ComputeBondForce(), EvalProps(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ virSumPair

double virSumPair

Definition at line 88 of file global.h.

Referenced by ComputePairForce(), EvalProps(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ virSumPairxx

double virSumPairxx

Definition at line 88 of file global.h.

Referenced by ComputePairForce(), EvalProps(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ virSumPairxy

double virSumPairxy

Definition at line 88 of file global.h.

Referenced by ComputePairForce(), EvalProps(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ virSumPairyy

double virSumPairyy

Definition at line 88 of file global.h.

Referenced by ComputePairForce(), EvalProps(), ReadBinaryRestart(), and WriteBinaryRestart().

◆ virSumxx

double virSumxx
extern

Referenced by EvalProps(), and PrintStress().

◆ virSumxy

double virSumxy

Definition at line 90 of file global.h.

Referenced by EvalProps(), and PrintStress().

◆ virSumyy

double virSumyy

Definition at line 90 of file global.h.

Referenced by EvalProps(), and PrintStress().

◆ visc

char visc[256]
extern

◆ viscAcf

double ** viscAcf

Definition at line 99 of file global.h.

Referenced by AccumVacf(), AllocArrays(), Close(), and EvalVacf().

◆ viscAcfAv

double * viscAcfAv

Definition at line 99 of file global.h.

Referenced by AccumVacf(), AllocArrays(), Close(), PrintVacf(), and ZeroVacf().

◆ viscAcfInt

double viscAcfInt

Definition at line 99 of file global.h.

Referenced by AccumVacf(), and PrintVacf().

◆ viscAcfOrg

double * viscAcfOrg

Definition at line 99 of file global.h.

Referenced by AllocArrays(), Close(), and EvalVacf().

◆ VMeanSqr

double VMeanSqr

Definition at line 46 of file global.h.

Referenced by EvalVrms().

◆ vrms

char vrms[256]
extern

Referenced by main().

◆ VRootMeanSqr

double VRootMeanSqr

Definition at line 46 of file global.h.

Referenced by EvalVrms(), main(), and PrintVrms().

◆ VSqr

double VSqr
extern

Referenced by EvalVrms().

◆ vSum

double vSum

Definition at line 21 of file global.h.

Referenced by EvalProps(), HaltConditionCheck(), and PrintSummary().

◆ vSumX

double vSumX

Definition at line 21 of file global.h.

Referenced by EvalProps(), and PrintMomentum().

◆ vSumY

double vSumY

Definition at line 21 of file global.h.

Referenced by EvalProps(), and PrintMomentum().

◆ vvSum

double vvSum

Definition at line 21 of file global.h.

Referenced by EvalProps(), and LeapfrogStep().

◆ vx

◆ vy

◆ xBoundary

char xBoundary[10]
extern

◆ xyz

char xyz[256]
extern

Referenced by main().

◆ yBoundary

char yBoundary[10]

Definition at line 68 of file global.h.

Referenced by ApplyBoundaryCond(), Init(), and ReadBinaryRestart().