diff --git a/Solver/Makefile.in b/Solver/Makefile.in index 7e3bdc65f..9fcafb010 100755 --- a/Solver/Makefile.in +++ b/Solver/Makefile.in @@ -370,7 +370,7 @@ addons: done ########################################## -## Extra auxiliar rules ## +## Extra auxiliary rules ## ########################################## clean: FORCE horseslibclean problemfileclean horsesclean addonsclean $(info Removing object *.o files from $(NSLITE3D_PATH)/build) diff --git a/Solver/src/CahnHilliardSolver/Makefile b/Solver/src/CahnHilliardSolver/Makefile index 4962846ff..df1d0ea9f 100644 --- a/Solver/src/CahnHilliardSolver/Makefile +++ b/Solver/src/CahnHilliardSolver/Makefile @@ -69,7 +69,7 @@ install: $(PROG) @echo ########################################## -## Extra auxiliar rules ## +## Extra auxiliary rules ## ########################################## clean: FORCE rm -f ./include/*.mod ./lib/*.a ./build/*.o diff --git a/Solver/src/IncompressibleNSSolver/Makefile b/Solver/src/IncompressibleNSSolver/Makefile index 41c8a467f..2c66f5224 100644 --- a/Solver/src/IncompressibleNSSolver/Makefile +++ b/Solver/src/IncompressibleNSSolver/Makefile @@ -69,7 +69,7 @@ install: $(PROG) @echo ########################################## -## Extra auxiliar rules ## +## Extra auxiliary rules ## ########################################## clean: FORCE rm -f ./include/*.mod ./lib/*.a ./build/*.o diff --git a/Solver/src/IncompressibleNSSolver/SpatialDiscretization.f90 b/Solver/src/IncompressibleNSSolver/SpatialDiscretization.f90 index 59e8d0be9..9b8ef25b5 100644 --- a/Solver/src/IncompressibleNSSolver/SpatialDiscretization.f90 +++ b/Solver/src/IncompressibleNSSolver/SpatialDiscretization.f90 @@ -186,7 +186,7 @@ SUBROUTINE ComputeTimeDerivative( mesh, particles, time, mode) INTEGER :: k, eID ! ! ******************************************************************* -! Construct the auxiliar state for the fluxes with density positivity +! Construct the auxiliary state for the fluxes with density positivity ! ******************************************************************* ! !$omp do schedule(runtime) diff --git a/Solver/src/MultiphaseSolver/Makefile b/Solver/src/MultiphaseSolver/Makefile index afcdcb2ae..384675072 100644 --- a/Solver/src/MultiphaseSolver/Makefile +++ b/Solver/src/MultiphaseSolver/Makefile @@ -69,7 +69,7 @@ install: $(PROG) @echo ########################################## -## Extra auxiliar rules ## +## Extra auxiliary rules ## ########################################## clean: FORCE rm -f ./include/*.mod ./lib/*.a ./build/*.o diff --git a/Solver/src/NavierStokesSolver/Makefile b/Solver/src/NavierStokesSolver/Makefile index 27488ebe0..66bcfc2f6 100644 --- a/Solver/src/NavierStokesSolver/Makefile +++ b/Solver/src/NavierStokesSolver/Makefile @@ -68,7 +68,7 @@ install: $(PROG) @echo ########################################## -## Extra auxiliar rules ## +## Extra auxiliary rules ## ########################################## clean: FORCE diff --git a/Solver/src/NavierStokesSolverRANS/Makefile b/Solver/src/NavierStokesSolverRANS/Makefile index 3ef31881d..5dff21a20 100644 --- a/Solver/src/NavierStokesSolverRANS/Makefile +++ b/Solver/src/NavierStokesSolverRANS/Makefile @@ -68,7 +68,7 @@ install: $(PROG) @echo ########################################## -## Extra auxiliar rules ## +## Extra auxiliary rules ## ########################################## clean: FORCE diff --git a/Solver/src/addons/extractgeometry/GeometryClass.f90 b/Solver/src/addons/extractgeometry/GeometryClass.f90 index e1c941b13..4d25aced2 100644 --- a/Solver/src/addons/extractgeometry/GeometryClass.f90 +++ b/Solver/src/addons/extractgeometry/GeometryClass.f90 @@ -231,9 +231,9 @@ subroutine Cube_Compute(self, mesh, spA) logical :: success character(len=LINE_LENGTH) :: solutionFile ! -! *********************** -! Construct auxiliar mesh -! *********************** +! ************************ +! Construct auxiliary mesh +! ************************ ! allocate(elems(0:self % Npoints,0:self % Npoints,0:self % Npoints)) allocate(xi(NDIM,0:self % Npoints,0:self % Npoints,0:self % Npoints)) diff --git a/Solver/src/addons/extractgeometry/Makefile b/Solver/src/addons/extractgeometry/Makefile index 831cef048..dce322e15 100644 --- a/Solver/src/addons/extractgeometry/Makefile +++ b/Solver/src/addons/extractgeometry/Makefile @@ -65,7 +65,7 @@ install: $(PROG) @echo ########################################## -## Extra auxiliar rules ## +## Extra auxiliary rules ## ########################################## clean: FORCE rm -f ./include/*.mod ./lib/*.a ./build/*.o diff --git a/Solver/src/addons/horses2tecplot/Makefile b/Solver/src/addons/horses2tecplot/Makefile index 157221f5d..5662a6934 100644 --- a/Solver/src/addons/horses2tecplot/Makefile +++ b/Solver/src/addons/horses2tecplot/Makefile @@ -71,7 +71,7 @@ install: $(PROG) @echo ########################################## -## Extra auxiliar rules ## +## Extra auxiliary rules ## ########################################## clean: FORCE rm -f ./include/*.mod ./lib/*.a ./build/*.o diff --git a/Solver/src/addons/horses2tecplot/ProlongMeshAndSolution.f90 b/Solver/src/addons/horses2tecplot/ProlongMeshAndSolution.f90 index a75983b33..d51371998 100644 --- a/Solver/src/addons/horses2tecplot/ProlongMeshAndSolution.f90 +++ b/Solver/src/addons/horses2tecplot/ProlongMeshAndSolution.f90 @@ -190,7 +190,7 @@ end subroutine ProlongSolutionToGaussPoints ! !///////////////////////////////////////////////////////////////////////////////////////// ! -! Auxiliar subroutines +! Auxiliary subroutines ! -------------------- ! !///////////////////////////////////////////////////////////////////////////////////////// diff --git a/Solver/src/addons/mergeStatistics/Makefile b/Solver/src/addons/mergeStatistics/Makefile index 4d6887562..ee2e30b0d 100644 --- a/Solver/src/addons/mergeStatistics/Makefile +++ b/Solver/src/addons/mergeStatistics/Makefile @@ -65,7 +65,7 @@ install: $(PROG) @echo ########################################## -## Extra auxiliar rules ## +## Extra auxiliary rules ## ########################################## clean: FORCE rm -f ./include/*.mod ./lib/*.a ./build/*.o diff --git a/Solver/src/addons/tools/Makefile b/Solver/src/addons/tools/Makefile index ab696ccff..7683e1e71 100644 --- a/Solver/src/addons/tools/Makefile +++ b/Solver/src/addons/tools/Makefile @@ -72,7 +72,7 @@ install: $(PROG) @echo ########################################## -## Extra auxiliar rules ## +## Extra auxiliary rules ## ########################################## clean: FORCE rm -f ./include/*.mod ./lib/*.a ./build/*.o diff --git a/Solver/src/addons/tools/readHDF5.f90 b/Solver/src/addons/tools/readHDF5.f90 index a6d112a65..50f21ce50 100644 --- a/Solver/src/addons/tools/readHDF5.f90 +++ b/Solver/src/addons/tools/readHDF5.f90 @@ -97,7 +97,7 @@ subroutine ConstructSimpleMesh_FromHDF5File_( self, fileName, locR) integer :: nDims CHARACTER(LEN=255), ALLOCATABLE :: BCNames(:) - ! Auxiliar variables + ! Auxiliary variables integer :: i,j,k,l ! Counters integer :: HOPRNodeID ! Node ID in HOPR integer :: HCornerMap(8) ! Map from the corner node index of an element to the local high-order node index used in HOPR diff --git a/Solver/src/libs/discretization/SVV.f90 b/Solver/src/libs/discretization/SVV.f90 index 316b8db48..d1a1baf03 100644 --- a/Solver/src/libs/discretization/SVV.f90 +++ b/Solver/src/libs/discretization/SVV.f90 @@ -868,7 +868,7 @@ end subroutine SVV_GuermondPopov_ENTROPY ! !////////////////////////////////////////////////////////////////////////////////////////////////// ! -! Auxiliar subroutines +! Auxiliary subroutines ! -------------------- ! !////////////////////////////////////////////////////////////////////////////////////////////////// diff --git a/Solver/src/libs/discretization/WallFunctionConnectivity.f90 b/Solver/src/libs/discretization/WallFunctionConnectivity.f90 index 4659cb61e..93c5df526 100644 --- a/Solver/src/libs/discretization/WallFunctionConnectivity.f90 +++ b/Solver/src/libs/discretization/WallFunctionConnectivity.f90 @@ -139,7 +139,7 @@ Subroutine Initialize_WallConnection(controlVariables, mesh) oppositeIndex = maxloc(merge(1.0, 0.0, normalAxis == oppositeIndex),dim=1) linkedElementID = e % Connection(oppositeIndex) % globID end associate - linkedElementID = getElemntID(mesh, linkedElementID) + linkedElementID = getElementID(mesh, linkedElementID) wallFaceID(k) = fID wallElemIds(k) = linkedElementID !get the normalIndex of the linked element instead of actual element, needed for rotated meshes @@ -407,7 +407,7 @@ Subroutine WallStartMeanV(mesh) End Subroutine WallStartMeanV - integer Function getElemntID(mesh, globeID) + integer Function getElementID(mesh, globeID) ! ******************************************************************* ! This subroutine get the element ID based on the global element ID @@ -427,7 +427,7 @@ integer Function getElemntID(mesh, globeID) do eID = 1, mesh % no_of_elements if (mesh % elements(eID) % globID .eq. globeID) then - getElemntID = eID + getElementID = eID return end if end do @@ -437,7 +437,7 @@ integer Function getElemntID(mesh, globeID) errorMessage(STD_OUT) stop - End Function getElemntID + End Function getElementID End Module WallFunctionConnectivity #endif diff --git a/Solver/src/libs/foundation/Stopwatch.f90 b/Solver/src/libs/foundation/Stopwatch.f90 index 7df58a260..ec94bd14a 100644 --- a/Solver/src/libs/foundation/Stopwatch.f90 +++ b/Solver/src/libs/foundation/Stopwatch.f90 @@ -618,7 +618,7 @@ end subroutine Event_Destruct ! !///////////////////////////////////////////////////////////////////// ! -! AUXILIAR PROCEDURES +! AUXILIARY PROCEDURES ! ------------------- !//////////////////////////////////////////////////////////////////// ! diff --git a/Solver/src/libs/io/FileReading.f90 b/Solver/src/libs/io/FileReading.f90 index a2c4ab392..721ef6df7 100644 --- a/Solver/src/libs/io/FileReading.f90 +++ b/Solver/src/libs/io/FileReading.f90 @@ -239,8 +239,8 @@ character(len=LINE_LENGTH) function getPath( inputLine ) ! integer :: pos ! -! Get the last forward slash ocurrence -! ------------------------------------ +! Get the last forward slash occurrence +! ------------------------------------- pos = index(inputLine,'/',BACK=.true.) if ( pos .eq. 0 ) then diff --git a/Solver/src/libs/jacobian/NumericalJacobian.f90 b/Solver/src/libs/jacobian/NumericalJacobian.f90 index 9b0150d67..067df4978 100644 --- a/Solver/src/libs/jacobian/NumericalJacobian.f90 +++ b/Solver/src/libs/jacobian/NumericalJacobian.f90 @@ -536,7 +536,7 @@ subroutine NumJacobian_Compute(this, sem, nEqn, time, Matrix, TimeDerivative, Ti do thiselmidx = ielm, felm-1 thiselm = ecolors%elmnts(thiselmidx) IF (this % ndofelm(thiselm) auxMesh % storage % elements(eID) end do -! Read the solution in the auxiliar mesh and interpolate to current mesh +! Read the solution in the auxiliary mesh and interpolate to current mesh ! ---------------------------------------------------------------------- call auxMesh % LoadSolution ( fileName, initial_iteration, initial_time , with_gradients, loadFromNSSA=loadFromNSSA) @@ -3347,7 +3347,7 @@ subroutine GetDiscretizationError(mesh,controlVariables) fileName = controlVariables % stringValueForKey("get discretization error of",LINE_LENGTH) -! Construct an auxiliar mesh to read the solution +! Construct an auxiliary mesh to read the solution ! ----------------------------------------------- refMesh % nodeType = mesh % nodeType @@ -3367,7 +3367,7 @@ subroutine GetDiscretizationError(mesh,controlVariables) call refMesh % PrepareForIO call refMesh % AllocateStorage (NDOF, controlVariables,.FALSE.) -! Read the solution in the auxiliar mesh and interpolate to current mesh +! Read the solution in the auxiliary mesh and interpolate to current mesh ! ---------------------------------------------------------------------- call refMesh % LoadSolution ( fileName, initial_iteration, initial_time ) @@ -3392,7 +3392,7 @@ end subroutine GetDiscretizationError ! !//////////////////////////////////////////////////////////////////////// ! -! AUXILIAR SUBROUTINES +! AUXILIARY SUBROUTINES ! -------------------- ! !//////////////////////////////////////////////////////////////////////// diff --git a/Solver/src/libs/mesh/IBMClass.f90 b/Solver/src/libs/mesh/IBMClass.f90 index eadabf7cb..5d11a2eb5 100644 --- a/Solver/src/libs/mesh/IBMClass.f90 +++ b/Solver/src/libs/mesh/IBMClass.f90 @@ -251,7 +251,7 @@ subroutine IBM_construct( this, controlVariables ) this% STLfilename(STLNum) = controlVariables% stringValueForKey(trim(filename), requestedLength = LINE_LENGTH) call STLfile_GetMotionInfo( this% stl(STLNum), this% STLfilename(STLNum), this% NumOfSTL ) this% stl(STLNum)% body = STLNum - call this% stl(STLNum)% ReadTesselation( this% STLfilename(STLNum) ) + call this% stl(STLNum)% ReadTessellation( this% STLfilename(STLNum) ) call OBB(STLNum)% construct( this% stl(STLNum), this% plotOBB ) this% root(STLNum)% STLNum = STLNum call OBB(STLNum)% ChangeObjsRefFrame( this% stl(STLNum)% ObjectsList ) diff --git a/Solver/src/libs/mesh/Read_HDF5Mesh_HOPR.f90 b/Solver/src/libs/mesh/Read_HDF5Mesh_HOPR.f90 index 05ce3f13f..b20137f0a 100644 --- a/Solver/src/libs/mesh/Read_HDF5Mesh_HOPR.f90 +++ b/Solver/src/libs/mesh/Read_HDF5Mesh_HOPR.f90 @@ -134,7 +134,7 @@ subroutine ConstructMesh_FromHDF5File_( self, fileName, nodes, Nx, Ny, Nz, MeshI integer :: nDims CHARACTER(LEN=255), ALLOCATABLE :: BCNames(:) - ! Auxiliar variables + ! Auxiliary variables integer :: i,j,k,l ! Counters integer :: HOPRNodeID ! Node ID in HOPR integer :: HCornerMap(8) ! Map from the corner node index of an element to the local high-order node index used in HOPR @@ -501,7 +501,7 @@ subroutine ConstructMeshPartition_FromHDF5File_( self, fileName, nodes, Nx, Ny, integer :: nDims CHARACTER(LEN=255), ALLOCATABLE :: BCNames(:) - ! Auxiliar variables + ! Auxiliary variables integer, allocatable :: gHOPR2pHORSESNodeMap(:) ! Map from the global HOPR node index to the local partition index in HORSES3D integer, allocatable :: globalToLocalElementID(:) integer :: i,j,k,l, eID, GlobeID ! Counters diff --git a/Solver/src/libs/mesh/StorageClass.f90 b/Solver/src/libs/mesh/StorageClass.f90 index a4b730e02..13c407fe8 100644 --- a/Solver/src/libs/mesh/StorageClass.f90 +++ b/Solver/src/libs/mesh/StorageClass.f90 @@ -72,7 +72,7 @@ module StorageClass real(kind=RP), private, allocatable :: U_xNS(:,:,:,:) ! NSE x-gradients real(kind=RP), private, allocatable :: U_yNS(:,:,:,:) ! NSE y-gradients real(kind=RP), private, allocatable :: U_zNS(:,:,:,:) ! NSE z-gradients - real(kind=RP), allocatable :: G_NS(:,:,:,:) ! NSE auxiliar storage + real(kind=RP), allocatable :: G_NS(:,:,:,:) ! NSE auxiliary storage real(kind=RP), allocatable :: S_NS(:,:,:,:) ! NSE source term real(kind=RP), allocatable :: S_NSP(:,:,:,:) ! NSE Particles source term real(kind=RP), allocatable :: mu_NS(:,:,:,:) ! (mu, beta, kappa) artificial @@ -95,7 +95,7 @@ module StorageClass real(kind=RP), dimension(:,:,:,:), allocatable :: mu_y ! CHE chemical potential y-gradient real(kind=RP), dimension(:,:,:,:), allocatable :: mu_z ! CHE chemical potential z-gradient real(kind=RP), dimension(:,:,:,:), allocatable :: v ! CHE flow field velocity - real(kind=RP), dimension(:,:,:,:), allocatable :: G_CH ! CHE auxiliar storage + real(kind=RP), dimension(:,:,:,:), allocatable :: G_CH ! CHE auxiliary storage #endif contains procedure :: Assign => ElementStorage_Assign diff --git a/Solver/src/libs/mesh/SurfaceMesh.f90 b/Solver/src/libs/mesh/SurfaceMesh.f90 index 06844beeb..dae4d5f3b 100644 --- a/Solver/src/libs/mesh/SurfaceMesh.f90 +++ b/Solver/src/libs/mesh/SurfaceMesh.f90 @@ -1436,7 +1436,7 @@ Subroutine getFaceWallDistance(mesh,f,dWall) nodeEnd = N - 1 end select - ! get x of 1 (or 2) and N (or N-1) node of elemnt + ! get x of 1 (or 2) and N (or N-1) node of element xf = f % geom % x(:,0,0) associate ( e => mesh % elements(eID) ) select case (normalDirection) diff --git a/Solver/src/libs/mesh/TessellationTypes.f90 b/Solver/src/libs/mesh/TessellationTypes.f90 index 1f174037e..2d3d2d0c1 100644 --- a/Solver/src/libs/mesh/TessellationTypes.f90 +++ b/Solver/src/libs/mesh/TessellationTypes.f90 @@ -98,7 +98,7 @@ module TessellationTypes character(len=LINE_LENGTH) :: filename, motionType contains - procedure :: ReadTesselation + procedure :: ReadTessellation procedure :: getRotationaMatrix => STLfile_getRotationaMatrix procedure :: getDisplacement => STLfile_getDisplacement procedure :: destroy => STLfile_destroy @@ -576,7 +576,7 @@ end subroutine DescribePartitions_STLfile ! ------------------------------------------------- ! This subroutine reads the .stl file ! ----------------------------------------------- - subroutine ReadTesselation( this, filename ) + subroutine ReadTessellation( this, filename ) use PhysicsStorage implicit none !-arguments-------------------------------- @@ -596,7 +596,7 @@ subroutine ReadTesselation( this, filename ) open(unit=funit,file='MESH/'//trim(filename)//'.stl',status='old',access='stream',form='unformatted', iostat=fileStat) if( fileStat .ne. 0 ) then - print *, "Read Tesselation: file '",trim(filename),"' not found" + print *, "Read Tessellation: file '",trim(filename),"' not found" error stop end if @@ -631,7 +631,7 @@ subroutine ReadTesselation( this, filename ) call this% describe( filename ) - end subroutine ReadTesselation + end subroutine ReadTessellation subroutine STLfile_GetMotionInfo( this, STLfilename, NumOfSTL ) use FileReadingUtilities diff --git a/Solver/src/libs/monitors/FWHObseverClass.f90 b/Solver/src/libs/monitors/FWHObseverClass.f90 index eb381a6f3..cf65df916 100644 --- a/Solver/src/libs/monitors/FWHObseverClass.f90 +++ b/Solver/src/libs/monitors/FWHObseverClass.f90 @@ -893,7 +893,7 @@ Subroutine SourceProlongSolution(source_zone, mesh, eSides) End Subroutine SourceProlongSolution ! !///////////////////////////////////////////////////////////////////////// -! AUXILIAR PROCEDURES -------------------------- +! AUXILIARY PROCEDURES -------------------------- !///////////////////////////////////////////////////////////////////////// ! get the interpolated value of an array diff --git a/Solver/src/libs/physics/common/BoundaryConditions.f90 b/Solver/src/libs/physics/common/BoundaryConditions.f90 index 6e33199e2..d385476c1 100644 --- a/Solver/src/libs/physics/common/BoundaryConditions.f90 +++ b/Solver/src/libs/physics/common/BoundaryConditions.f90 @@ -165,7 +165,7 @@ end subroutine DestructBoundaryConditions ! !//////////////////////////////////////////////////////////////////////////// ! -! Auxiliar subroutines +! Auxiliary subroutines ! -------------------- ! !//////////////////////////////////////////////////////////////////////////// diff --git a/Solver/src/libs/physics/common/WallFunctionBC.f90 b/Solver/src/libs/physics/common/WallFunctionBC.f90 index af146c27e..f72b4d1bf 100644 --- a/Solver/src/libs/physics/common/WallFunctionBC.f90 +++ b/Solver/src/libs/physics/common/WallFunctionBC.f90 @@ -55,7 +55,7 @@ SUBROUTINE WallViscousFlux (U_inst, dWall, nHat, rho, mu, U_avg, visc_flux, u_ta REAL(kind=RP), DIMENSION(NDIM) :: x_II ! Unitary vector parallel to wall REAL(kind=RP), DIMENSION(NDIM) :: U_ref ! Reference Velocity REAL(kind=RP), DIMENSION(NDIM) :: u_parallel ! Velocity parallel to wall - REAL(kind=RP), DIMENSION(NDIM) :: u_parallel_aux ! Velocity parallel to wall auxiliar, is the instantaneous when the average is used + REAL(kind=RP), DIMENSION(NDIM) :: u_parallel_aux ! Velocity parallel to wall auxiliary, is the instantaneous when the average is used REAL(kind=RP) :: u_II ! Velocity magnitude parallel to wall, used in Wall Function REAL(kind=RP) :: tau_w ! Wall shear stress REAL(kind=RP) :: beta ! damping factor from Thomas et. al @@ -159,10 +159,10 @@ FUNCTION u_tau_f (u_II,y,nu, u_tau0) DO i = 1, newtonMaxIter - ! Evaluate auxiliar function at u_tau + ! Evaluate auxiliary function at u_tau Aux_x0 = Aux_f ( u_tau , u_II, y, nu ) - ! Compute numerical derivative of auxiliar function at u_tau + ! Compute numerical derivative of auxiliary function at u_tau eps = ABS(u_tau) * 1.0E-8_RP JAC = ( Aux_f ( u_tau + eps, u_II, y, nu ) - Aux_x0 ) / eps @@ -209,7 +209,7 @@ FUNCTION Aux_f (u_tau, u_II, y, nu) REAL(kind=RP) :: Aux_f ! (OUT) - ! Auxiliar function is evaluated at x0 + ! Auxiliary function is evaluated at x0 ! When Aux_f = 0 The definition of the ! dimensionless mean streamwise velocity ! parallel to the wall is recovered and diff --git a/Solver/src/libs/physics/navierstokes/Physics_NS.f90 b/Solver/src/libs/physics/navierstokes/Physics_NS.f90 index c560bfeaf..654a50614 100644 --- a/Solver/src/libs/physics/navierstokes/Physics_NS.f90 +++ b/Solver/src/libs/physics/navierstokes/Physics_NS.f90 @@ -722,7 +722,7 @@ pure subroutine ViscousJacobian(q, Q_x, Q_y, Q_z, df_dgradq, df_dq) ! Derivative with respect to q ! **************************** ! -! Auxiliar variables +! Auxiliary variables ! ------------------ rho_DivV = Q(IRHO) * ( U_x(IX) + U_y(IY) + U_z(IZ) ) ! rho ∇ · v diff --git a/Solver/src/libs/timeintegrator/AnalyticalJacobian.f90 b/Solver/src/libs/timeintegrator/AnalyticalJacobian.f90 index 9d908328f..b82ad2d1f 100644 --- a/Solver/src/libs/timeintegrator/AnalyticalJacobian.f90 +++ b/Solver/src/libs/timeintegrator/AnalyticalJacobian.f90 @@ -1120,7 +1120,7 @@ subroutine Local_SetDiagonalBlock(e, fF, fB, fO, fR, fT, fL, Matrix, IBM) do k12 = 0, e % Nxyz(3) ; do j12 = 0, e % Nxyz(2) ; do i2 = 0, e % Nxyz(1) ; do i1 = 0, e % Nxyz(1) MatEntries = 0._RP -! Get Xi auxiliar terms +! Get Xi auxiliary terms ! --------------------- xiAux = 0._RP @@ -1166,7 +1166,7 @@ subroutine Local_SetDiagonalBlock(e, fF, fB, fO, fR, fT, fL, Matrix, IBM) do k12 = 0, e % Nxyz(3) ; do j2 = 0, e % Nxyz(2) ; do j1 = 0, e % Nxyz(2) ; do i12 = 0, e % Nxyz(1) MatEntries = 0._RP -! Get Eta auxiliar terms +! Get Eta auxiliary terms ! ---------------------- etaAux = 0._RP @@ -1211,7 +1211,7 @@ subroutine Local_SetDiagonalBlock(e, fF, fB, fO, fR, fT, fL, Matrix, IBM) do k2 = 0, e % Nxyz(3) ; do k1 = 0, e % Nxyz(3) ; do j12 = 0, e % Nxyz(2) ; do i12 = 0, e % Nxyz(1) MatEntries = 0._RP -! Get Zeta auxiliar terms +! Get Zeta auxiliary terms ! ----------------------- zetaAux = 0._RP @@ -1531,9 +1531,9 @@ subroutine Local_GetOffDiagonalBlock(f,e_plus,e_minus,side,Matrix) real(kind=RP) :: dtan1_minus, dtan2_minus ! Kronecker deltas in the tangent directions in the reference frame of e⁻ (only needed for viscous fluxes) real(kind=RP) :: a_minus real(kind=RP) :: normAux(NCONS,NCONS) - real(kind=RP), pointer :: Gvec_norm(:,:,:) ! Auxiliar vector containing values of dFv_dgradQ in the direction normal to the face - real(kind=RP), pointer :: Gvec_tan1(:,:,:) ! Auxiliar vector containing values of dFv_dgradQ in the first tangent direction to the face - real(kind=RP), pointer :: Gvec_tan2(:,:,:) ! Auxiliar vector containing values of dFv_dgradQ in the second tangent direction to the face + real(kind=RP), pointer :: Gvec_norm(:,:,:) ! Auxiliary vector containing values of dFv_dgradQ in the direction normal to the face + real(kind=RP), pointer :: Gvec_tan1(:,:,:) ! Auxiliary vector containing values of dFv_dgradQ in the first tangent direction to the face + real(kind=RP), pointer :: Gvec_tan2(:,:,:) ! Auxiliary vector containing values of dFv_dgradQ in the second tangent direction to the face real(kind=RP), allocatable :: nHat(:,:,:) !-------------------------------------------------------------------------------- ! @@ -1717,7 +1717,7 @@ subroutine Local_GetOffDiagonalBlock(f,e_plus,e_minus,side,Matrix) ! Computation of the matrix entry ! ------------------------------- -! Get NORMAL auxiliar term +! Get NORMAL auxiliary term ! ------------------------ normAux = 0._RP if (dtan1*dtan2 > 0.5_RP) then diff --git a/Solver/src/libs/timeintegrator/LinearSolvers/StaticCondensationSolverClass.f90 b/Solver/src/libs/timeintegrator/LinearSolvers/StaticCondensationSolverClass.f90 index 49bba3f85..87f6866b4 100644 --- a/Solver/src/libs/timeintegrator/LinearSolvers/StaticCondensationSolverClass.f90 +++ b/Solver/src/libs/timeintegrator/LinearSolvers/StaticCondensationSolverClass.f90 @@ -204,7 +204,7 @@ subroutine SCS_construct(this,DimPrb, globalDimPrb, nEqn,controlVariables,sem,Ma allocate ( this % matSolver % Jacobian % ndofelm_l(nelem) ) this % matSolver % Jacobian % ndofelm_l = this % A % BlockSizes - this % A % inner_blockSizes - ! Construct auxiliar matrix (nor really needed now since the matrix is constructed in this % A % getSchurComplement()) + ! Construct auxiliary matrix (nor really needed now since the matrix is constructed in this % A % getSchurComplement()) !~ call this % Mii_inv % construct (num_of_Rows = this % A % size_i) case(SSOLVER_MATF_GMRES) @@ -212,7 +212,7 @@ subroutine SCS_construct(this,DimPrb, globalDimPrb, nEqn,controlVariables,sem,Ma ! Matrix-free solver ! ****************** - ! Construct auxiliar CSR matrices + ! Construct auxiliary CSR matrices call this % Mii_LU % construct (num_of_Blocks = this % A % num_of_Blocks) call this % Mii_LU % PreAllocate(nnzs = this % A % inner_blockSizes) @@ -253,7 +253,7 @@ subroutine SCS_destruct(this) ! ************** case(SSOLVER_PARDISO, SSOLVER_PETSC) ! -! Destroy auxiliar matrix (must be done prior to destroying solver) +! Destroy auxiliary matrix (must be done prior to destroying solver) ! ----------------------------------------------------------------- call this % Mii_inv % destruct deallocate (this % Mii_inv) @@ -544,7 +544,7 @@ subroutine SCS_getCondensedSystem(this) case (SSOLVER_PARDISO, SSOLVER_PETSC) call Stopwatch % Start("System condensation") - ! Construct auxiliar matrix for Mii⁻¹ + ! Construct auxiliary matrix for Mii⁻¹ call Mii_inv % construct (num_of_Blocks = this % A % num_of_Blocks) call Mii_inv % PreAllocate(nnzs = this % A % inner_blockSizes) @@ -654,7 +654,7 @@ function SCS_MatrixAction(this,x) result(v) real(kind=RP) , intent(in) :: x(this % A % size_b) real(kind=RP) :: v(this % A % size_b) !-local-variables----------------------------------------------------- - real(kind=RP) :: Mbi_xb (this % A % size_i) ! Auxiliar vector with size of Mii + real(kind=RP) :: Mbi_xb (this % A % size_i) ! Auxiliary vector with size of Mii real(kind=RP) :: vi (this % A % size_i) real(kind=RP) :: vb (this % A % size_b) !--------------------------------------------------------------------- @@ -682,7 +682,7 @@ end function SCS_MatrixAction ! !/////////////////////////////////////////////////////////////////////////////////////////////////////////////////////////////////// ! -! Auxiliar subroutines +! Auxiliary subroutines ! !/////////////////////////////////////////////////////////////////////////////////////////////////////////////////////////////////// ! diff --git a/Solver/src/libs/timeintegrator/MultiTauEstimationClass.f90 b/Solver/src/libs/timeintegrator/MultiTauEstimationClass.f90 index 0a0b3112f..917d36a0f 100644 --- a/Solver/src/libs/timeintegrator/MultiTauEstimationClass.f90 +++ b/Solver/src/libs/timeintegrator/MultiTauEstimationClass.f90 @@ -2,7 +2,7 @@ !////////////////////////////////////////////////////// ! ! Module that provides routines to estimate the truncation error every n number of -! iteractions and store it in files. +! interactions and store it in files. ! !////////////////////////////////////////////////////// ! @@ -314,7 +314,7 @@ end subroutine MultiTau_GetTEmap ! !/////////////////////////////////////////////////////////////////////////////////////////////////////////////////////////////////// ! -! Auxiliar routines +! Auxiliary routines ! !/////////////////////////////////////////////////////////////////////////////////////////////////////////////////////////////////// ! diff --git a/Solver/test/Components/Gradients/src/navierstokes/Physics_NS.f90 b/Solver/test/Components/Gradients/src/navierstokes/Physics_NS.f90 index 089ebd3a0..0ba4509b7 100644 --- a/Solver/test/Components/Gradients/src/navierstokes/Physics_NS.f90 +++ b/Solver/test/Components/Gradients/src/navierstokes/Physics_NS.f90 @@ -505,7 +505,7 @@ pure subroutine ViscousJacobian(q, U_x, U_y, U_z, gradRho, df_dgradq, df_dq) ! Derivative with respect to q ! **************************** ! -! Auxiliar variables +! Auxiliary variables ! ------------------ rho_DivV = Q(IRHO) * ( U_x(IGU) + U_y(IGV) + U_z(IGW) ) ! rho ∇ · v diff --git a/Solver/test/Components/Makefile.gradients b/Solver/test/Components/Makefile.gradients index 28e882201..a59f6008c 100644 --- a/Solver/test/Components/Makefile.gradients +++ b/Solver/test/Components/Makefile.gradients @@ -319,7 +319,7 @@ $(OBJS_CASE): %: ./src/%.f90 ########################################## -## Extra auxiliar rules ## +## Extra auxiliary rules ## ########################################## clean: FORCE horseslibclean $(info Removing object *.o files from $(NSLITE3D_PATH)/build) diff --git a/doc/UserManual.tex b/doc/UserManual.tex index 3110244dc..13f4726f1 100644 --- a/doc/UserManual.tex +++ b/doc/UserManual.tex @@ -591,8 +591,8 @@ \subsection{Tripping} trip center 2 & \textit{REAL}: Position of the origin of the second trip, if used, in the streamwise direction. & -- \\ \hline trip amplitude & \textit{REAL}: Maximum time varying amplitude of the trip. & 1.0 \\ \hline trip amplitude steady & \textit{REAL}: Maximum steady amplitude of the trip. & 0.0 \\ \hline -random seed 1 & \textit{INTEGER}: Number used to initilialize the random number generator of the trip. It can vary in different simulations but must remain constant for a restart. & 930187532 \\ \hline -random seed 2 & \textit{INTEGER}: Number used to initilialize the random number generator of the trip. It can vary in different simulations but must remain constant for a restart. & 597734650 \\ \hline +random seed 1 & \textit{INTEGER}: Number used to initialilize the random number generator of the trip. It can vary in different simulations but must remain constant for a restart. & 930187532 \\ \hline +random seed 2 & \textit{INTEGER}: Number used to initialilize the random number generator of the trip. It can vary in different simulations but must remain constant for a restart. & 597734650 \\ \hline \end{tabular} \label{tab:trip} \end{table} @@ -1020,7 +1020,7 @@ \chapter{Immersed boundary method} plot band points & \textit{LOGICAL}: The band region's points are plotted. & .FALSE. \\ \hline -target y plus & \textit{REAL}: Target distance at which the image poitns are located. It is not used unless wall function is active & 100.0 \\ \hline +target y plus & \textit{REAL}: Target distance at which the image points are located. It is not used unless wall function is active & 100.0 \\ \hline \end{longtable}