diff --git a/docs/source/dev/index.rst b/docs/source/dev/index.rst index dd833c8ef6..96ef271719 100644 --- a/docs/source/dev/index.rst +++ b/docs/source/dev/index.rst @@ -61,7 +61,7 @@ with the NREL OpenFAST team to define the scope of the work and coordinate development efforts. This is particularly important since many groups work on OpenFAST simultaneously. By engaging early, all developers can stay up to date and minimize conflicts during the code merge. -The prefered method of communication is `GitHub Issues `_. +The preferred method of communication is `GitHub Issues `_. An initial post should contain all relevant information about the planned development work, the areas of the software that will be impacted, and any model validation materials. See :ref:`development_plan` diff --git a/docs/source/install/index.rst b/docs/source/install/index.rst index 643fa0fc38..932a15d2be 100644 --- a/docs/source/install/index.rst +++ b/docs/source/install/index.rst @@ -478,7 +478,7 @@ The CMake options specific to OpenFAST and their default settings are: ORCA_DLL_LOAD - Enable OrcaFlex library load (Default: ON) USE_DLL_INTERFACE - Enable runtime loading of dynamic libraries (Default: ON) USE_LOCAL_STATIC_LAPACK - Enable downloading and building static LAPACK and BLAS libs (Default: OFF) - VARIABLE_TRACKING - Enables variable tracking for better runtime debugging output. May increase compile time. Valid only for GNU. (Defualt: ON) + VARIABLE_TRACKING - Enables variable tracking for better runtime debugging output. May increase compile time. Valid only for GNU. (Default: ON) Additional system-specific options may exist for a given system, but those diff --git a/docs/source/user/aerodyn-olaf/OLAFTheory.rst b/docs/source/user/aerodyn-olaf/OLAFTheory.rst index 7bde8f6587..ac21622da4 100644 --- a/docs/source/user/aerodyn-olaf/OLAFTheory.rst +++ b/docs/source/user/aerodyn-olaf/OLAFTheory.rst @@ -94,7 +94,7 @@ a line of varying circulation. The line follows the motion of the blade and is referred to as “bound” circulation. The bound circulation does not follow the same dynamic equation as the free vorticity of the wake. Instead, the intensity is linked to airfoil lift via the Kutta-Joukowski theorem. Spanwise variation of -the bound circulation results in vorticity being emitted into the the wake. This +the bound circulation results in vorticity being emitted into the wake. This is referred to as “trailed vorticity”. Time changes of the bound circulation are also emitted in the wake, referred to as “shed” vorticity. The subsequent paragraphs describe the representation of the bound vorticity. diff --git a/docs/source/user/aerodyn/input.rst b/docs/source/user/aerodyn/input.rst index 000fc089fe..5013abbad5 100644 --- a/docs/source/user/aerodyn/input.rst +++ b/docs/source/user/aerodyn/input.rst @@ -187,7 +187,7 @@ Determines the kind of BEM algorithm to use. .. warning:: - ``BEM_Mod`` currently governs the coordinate system used for "ill-defined" outputs (outputs that don't have a specified coordinate system) such as the ones that ends with "x" and "y". Other ill-defined outputs are the typical BEM quantities such as "AxInd", "TnInd", "Phi", etc. These are defined in a different coordinate system depending on `BEM_Mod`. For consistency accross differents `Wake_Mod` (even when `Wake_Mod/=1`), we use `BEM_Mod` to determine the coordinate system of the ill-defined outputs. + ``BEM_Mod`` currently governs the coordinate system used for "ill-defined" outputs (outputs that don't have a specified coordinate system) such as the ones that ends with "x" and "y". Other ill-defined outputs are the typical BEM quantities such as "AxInd", "TnInd", "Phi", etc. These are defined in a different coordinate system depending on `BEM_Mod`. For consistency across differents `Wake_Mod` (even when `Wake_Mod/=1`), we use `BEM_Mod` to determine the coordinate system of the ill-defined outputs. The following inputs in this section are only used when ``Wake_Mod = 1``. diff --git a/docs/source/user/aerodyn/theory.rst b/docs/source/user/aerodyn/theory.rst index 8043c51cfe..edd4aa2f1f 100644 --- a/docs/source/user/aerodyn/theory.rst +++ b/docs/source/user/aerodyn/theory.rst @@ -4,7 +4,7 @@ AeroDyn Theory ============== -This theory manual is work in progress, please refer to the AeroDyn 14 manual for more details :cite:`ad-AeroDyn:manual`. Many changes have occured since AeroDyn 14 (e.g. BEM formulation, coordinate system used in the BEM equations, dynamic stall, dynamic BEM), but these changes are not yet documented here. +This theory manual is work in progress, please refer to the AeroDyn 14 manual for more details :cite:`ad-AeroDyn:manual`. Many changes have occurred since AeroDyn 14 (e.g. BEM formulation, coordinate system used in the BEM equations, dynamic stall, dynamic BEM), but these changes are not yet documented here. diff --git a/docs/source/user/beamdyn/theory.rst b/docs/source/user/beamdyn/theory.rst index f8a80e1e1f..78d14e6936 100644 --- a/docs/source/user/beamdyn/theory.rst +++ b/docs/source/user/beamdyn/theory.rst @@ -82,7 +82,7 @@ Local blade coordinate system The local blade coordinate system is used for some input and output quantities, for example, the cross-sectional mass and stiffness matrices -and the the sectional force and moment resultants. This coordinate +and the sectional force and moment resultants. This coordinate system is different from the blade reference coordinate system in that its :math:`Z_l` axis is always tangent to the blade axis as the blade deflects. Note that a subscript :math:`l` denotes the local blade diff --git a/docs/source/user/cppapi/files/cDriver.i b/docs/source/user/cppapi/files/cDriver.i index 917208c312..f62e9725eb 100644 --- a/docs/source/user/cppapi/files/cDriver.i +++ b/docs/source/user/cppapi/files/cDriver.i @@ -27,7 +27,7 @@ n_substeps: 1 # Number of substeps per timestep of the glue-code n_checkpoint: 160 # Restart files will be written every so many time steps -set_exp_law_wind: false # Set velocity at the the turbine using an exponential law profile. +set_exp_law_wind: false # Set velocity at the turbine using an exponential law profile. Turbine0: diff --git a/docs/source/user/elastodyn/theory.rst b/docs/source/user/elastodyn/theory.rst index d4756dd0cd..09f2eec1e6 100644 --- a/docs/source/user/elastodyn/theory.rst +++ b/docs/source/user/elastodyn/theory.rst @@ -5,7 +5,7 @@ ElastoDyn Theory ================ Note this document is work in progress and is greatly incomplete. -This documentation was started to document some code changes to the the tail furl and rotor furl part of ElastoDyn. +This documentation was started to document some code changes to the tail furl and rotor furl part of ElastoDyn. Please refer to the different ressources provided in :numref:`ed_intro` for additional documents. diff --git a/docs/source/user/fast.farm/FFarmTheory.rst b/docs/source/user/fast.farm/FFarmTheory.rst index 6d0fd4b42a..3f58c3a53e 100644 --- a/docs/source/user/fast.farm/FFarmTheory.rst +++ b/docs/source/user/fast.farm/FFarmTheory.rst @@ -1278,7 +1278,7 @@ where :math:`D` is a reference diameter, and :math:`\bar{U}` is the mean velocity taken as the filtered velocity at the turbine location normal to the rotor disk. The coordinates :math:`x,y,z` and :math:`r,\theta` are taken in the meandering frame of reference. The parameters :math:`k_\text{def}^\text{WAT}` -and :math:`k_\text{grad}^\text{WAT}` are tuning paramters of the model +and :math:`k_\text{grad}^\text{WAT}` are tuning parameters of the model respectively multiplying the quasi-steady wake deficit and the gradient of the wake deficit. These are based on an eddy-viscosity filter with five calibrated parameters to give a more realistic dependence on downstream position. The diff --git a/docs/source/user/fast.farm/OutputFiles.rst b/docs/source/user/fast.farm/OutputFiles.rst index 683820605f..4e65e3accf 100644 --- a/docs/source/user/fast.farm/OutputFiles.rst +++ b/docs/source/user/fast.farm/OutputFiles.rst @@ -138,5 +138,5 @@ module levels, as specified within the OpenFAST input files) are described in the OpenFAST documentation and include summary (*.sum*) files, time-series results (ASCI *.out* or binary *.outb*) files, visualization (*.vtk*) files, etc. FAST.Farm simulations will generate -these same files, but with the the path/rootname changed to *.T*. diff --git a/docs/source/user/subdyn/theory.rst b/docs/source/user/subdyn/theory.rst index 06bdea0790..8fb686c6f3 100755 --- a/docs/source/user/subdyn/theory.rst +++ b/docs/source/user/subdyn/theory.rst @@ -1879,7 +1879,7 @@ This applies e.g.: to :math:`F_{R,e}, F_{L,e}, F_{R,g}, F_{L,g}`, where the foll The dependency of the load vectors on :math:`U_{TP}` introduces some complications for the state space representation, where for instance the :math:`B` and :math:`F_X` matrices should be modified to account for the dependency in :math:`U_{TP}` in Eq. :eq:`ABFx`. -The equation remains valid even if :math:`F_{L,e}` and :math:`F_{L,g}` contains a dependency in :math:`U_{TP}`, but the matrix :math:`B` shouldn't be used for the linearization (numerical differentiation is then prefered for simplicity). +The equation remains valid even if :math:`F_{L,e}` and :math:`F_{L,g}` contains a dependency in :math:`U_{TP}`, but the matrix :math:`B` shouldn't be used for the linearization (numerical differentiation is then preferred for simplicity). Similar considerations apply for Eq. :eq:`bigY2`. diff --git a/glue-codes/fast-farm/src/FAST_Farm.f90 b/glue-codes/fast-farm/src/FAST_Farm.f90 index bbc9ad94bd..6d2a8c141b 100644 --- a/glue-codes/fast-farm/src/FAST_Farm.f90 +++ b/glue-codes/fast-farm/src/FAST_Farm.f90 @@ -49,8 +49,8 @@ PROGRAM FAST_Farm REAL(ReKi) :: PrevClockTime !< Previous clock time in seconds past midnight INTEGER :: SimStrtTime (8) !< An array containing the elements of the start time (after initialization). INTEGER :: ProgStrtTime (8) !< An array containing the elements of the program start time (before initialization). -REAL(ReKi) :: SimStrtCPU !< User CPU time for simulation (without intialization) -REAL(ReKi) :: ProgStrtCPU !< User CPU time for program (with intialization) +REAL(ReKi) :: SimStrtCPU !< User CPU time for simulation (without initialization) +REAL(ReKi) :: ProgStrtCPU !< User CPU time for program (with initialization) ! these should probably go in the FAST.Farm registry: type(All_FastFarm_Data) :: farm diff --git a/glue-codes/fast-farm/src/FAST_Farm_Subs.f90 b/glue-codes/fast-farm/src/FAST_Farm_Subs.f90 index 851ca26de0..74de9eebc6 100644 --- a/glue-codes/fast-farm/src/FAST_Farm_Subs.f90 +++ b/glue-codes/fast-farm/src/FAST_Farm_Subs.f90 @@ -341,7 +341,7 @@ SUBROUTINE WAT_init( p, WAT_IfW, AWAE_InitInput, ErrStat, ErrMsg ) HAWC_InitInput%WindFileName(3) = trim(BoxFileRoot)//trim(FileEnding(3)) ! HAWC spatial grid - if (p%WAT == Mod_WAT_PreDef) then ! from libary of WAT files, set the NxNyNz and DxDyDz terms + if (p%WAT == Mod_WAT_PreDef) then ! from library of WAT files, set the NxNyNz and DxDyDz terms call MannLibDims(BoxFileRoot, p%RotorDiamRef, p%WAT_NxNyNz, p%WAT_DxDyDz, ErrStat2, ErrMsg2); if (Failed()) return write(sDummy, '(3(I8,1X))') p%WAT_NxNyNz call WrScr(' WAT: NxNyNz set to: '//trim(sDummy)//' (inferred from filename)') diff --git a/glue-codes/openfast-cpp/src/OpenFAST.H b/glue-codes/openfast-cpp/src/OpenFAST.H index ab656344da..8b28d086bf 100644 --- a/glue-codes/openfast-cpp/src/OpenFAST.H +++ b/glue-codes/openfast-cpp/src/OpenFAST.H @@ -81,7 +81,7 @@ struct turbineDataType { int nBRfsiPtsTwr; //! The mean azimuth at which the loads are blended between AeroDyn and CFD double azBlendMean; - //! The delta azimuth over which the the loads are blended between AeroDyn and CFD + //! The delta azimuth over which the loads are blended between AeroDyn and CFD double azBlendDelta; //! Mean velocity at reference height double velMean; @@ -708,7 +708,7 @@ private: //! Allocate memory for data structures for all turbines on this processor void allocateMemory_preInit(); - //! Allocate more memory for each turbine after intialization/restart + //! Allocate more memory for each turbine after initialization/restart void allocateMemory_postInit(int iTurbLoc); //! Get the nacelle drag coefficient of local turbine number 'iTurbLoc' diff --git a/modules/aerodyn/src/AeroDyn_Driver.f90 b/modules/aerodyn/src/AeroDyn_Driver.f90 index 076f0a4bcc..63b9eaef79 100644 --- a/modules/aerodyn/src/AeroDyn_Driver.f90 +++ b/modules/aerodyn/src/AeroDyn_Driver.f90 @@ -26,8 +26,8 @@ program AeroDyn_Driver ! Program variables REAL(ReKi) :: PrevClockTime ! Clock time at start of simulation in seconds [(s)] REAL(ReKi) :: UsrTime1 ! User CPU time for simulation initialization [(s)] - REAL(ReKi) :: UsrTime2 ! User CPU time for simulation (without intialization) [(s)] - INTEGER(IntKi) , DIMENSION(1:8) :: StrtTime ! Start time of simulation (including intialization) [-] + REAL(ReKi) :: UsrTime2 ! User CPU time for simulation (without initialization) [(s)] + INTEGER(IntKi) , DIMENSION(1:8) :: StrtTime ! Start time of simulation (including initialization) [-] INTEGER(IntKi) , DIMENSION(1:8) :: SimStrtTime ! Start time of simulation (after initialization) [-] REAL(DbKi) :: t_global ! global-loop time marker REAL(DbKi) :: t_final ! global-loop time marker diff --git a/modules/aerodyn/src/AeroDyn_Inflow_C_Binding.f90 b/modules/aerodyn/src/AeroDyn_Inflow_C_Binding.f90 index 9cda0d19c6..afaa85efba 100644 --- a/modules/aerodyn/src/AeroDyn_Inflow_C_Binding.f90 +++ b/modules/aerodyn/src/AeroDyn_Inflow_C_Binding.f90 @@ -422,10 +422,10 @@ SUBROUTINE ADI_C_Init( ADinputFilePassed, ADinputFileString_C, ADinputFileString ! Input file info integer(c_int), intent(in ) :: ADinputFilePassed !< Write VTK outputs [0: none, 1: init only, 2: animation] type(c_ptr), intent(in ) :: ADinputFileString_C !< Input file as a single string with lines deliniated by C_NULL_CHAR - integer(c_int), intent(in ) :: ADinputFileStringLength_C !< lenght of the input file string + integer(c_int), intent(in ) :: ADinputFileStringLength_C !< length of the input file string integer(c_int), intent(in ) :: IfWinputFilePassed !< Write VTK outputs [0: none, 1: init only, 2: animation] type(c_ptr), intent(in ) :: IfWinputFileString_C !< Input file as a single string with lines deliniated by C_NULL_CHAR - integer(c_int), intent(in ) :: IfWinputFileStringLength_C !< lenght of the input file string + integer(c_int), intent(in ) :: IfWinputFileStringLength_C !< length of the input file string character(kind=c_char), intent(in ) :: OutRootName_C(IntfStrLen) !< Root name to use for echo files and other character(kind=c_char), intent(in ) :: OutVTKDir_C(IntfStrLen) !< Directory to put all vtk output ! Environmental @@ -2110,7 +2110,7 @@ end subroutine ADI_C_GetDiskAvgVel !=================================================================================================================================== !> This routine is operating on module level data. Error handling here in case checks added -!! NOTE: the OriginInit is not included in the data passed in and must be added to the the position info here +!! NOTE: the OriginInit is not included in the data passed in and must be added to the position info here subroutine Set_MotionMesh(iWT, ErrStat3, ErrMsg3) integer(IntKi), intent(in ) :: iWT !< current rotor/turbine integer(IntKi), intent( out) :: ErrStat3 @@ -2138,7 +2138,7 @@ end subroutine Set_MotionMesh !> Map the motion of the intermediate input mesh over to the input meshes !! This routine is operating on module level data, hence few inputs -!! NOTE: the OriginInit is not included in the data passed in and must be added to the the position info here +!! NOTE: the OriginInit is not included in the data passed in and must be added to the position info here subroutine AD_SetInputMotion( iWT, u_local, & HubPos_C, HubOri_C, HubVel_C, HubAcc_C, & NacPos_C, NacOri_C, NacVel_C, NacAcc_C, & diff --git a/modules/aerodyn/src/AirfoilInfo.f90 b/modules/aerodyn/src/AirfoilInfo.f90 index 55f0d5d2a4..b00886b7da 100644 --- a/modules/aerodyn/src/AirfoilInfo.f90 +++ b/modules/aerodyn/src/AirfoilInfo.f90 @@ -1391,8 +1391,8 @@ SUBROUTINE ComputeUA360_AttachedFlow(p, ColUAf, cn_cl, iLower, iUpper) !------------------------------------------------ call Compute_iLoweriUpper(p, iLower, iUpper) - p%UA_BL%alphaLower = p%alpha(iLower) ! note we are overwritting values here to make them consistent in the linear equation - p%UA_BL%alphaUpper = p%alpha(iUpper) ! note we are overwritting values here to make them consistent in the linear equation + p%UA_BL%alphaLower = p%alpha(iLower) ! note we are overwriting values here to make them consistent in the linear equation + p%UA_BL%alphaUpper = p%alpha(iUpper) ! note we are overwriting values here to make them consistent in the linear equation p%UA_BL%c_alphaLower = cn_cl(iLower) ! for vortex calculations (x5, HGMV model) p%UA_BL%c_alphaUpper = cn_cl(iUpper) ! for vortex calculations (x5, HGMV model) diff --git a/modules/aerodyn/src/DBEMT.f90 b/modules/aerodyn/src/DBEMT.f90 index 4f5a2d6bd8..add09cedc5 100644 --- a/modules/aerodyn/src/DBEMT.f90 +++ b/modules/aerodyn/src/DBEMT.f90 @@ -844,7 +844,7 @@ SUBROUTINE DBEMT_ABM4( i, j, t, n, u, utimes, p, x, OtherState, m, ErrStat, ErrM x_in = x%element(i,j) - ! predict: (note that we are overwritting x%element(i,j)%vind and x%element(i,j)%vind_1 here): + ! predict: (note that we are overwriting x%element(i,j)%vind and x%element(i,j)%vind_1 here): CALL DBEMT_AB4( i, j, t, n, u, utimes, p, x, OtherState, m, ErrStat2, ErrMsg2 ) CALL SetErrStat(ErrStat2,ErrMsg2,ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) RETURN diff --git a/modules/aerodyn/src/FVW.f90 b/modules/aerodyn/src/FVW.f90 index 2c55f4dc27..92b43acfbb 100644 --- a/modules/aerodyn/src/FVW.f90 +++ b/modules/aerodyn/src/FVW.f90 @@ -480,7 +480,7 @@ subroutine FVW_FinalWrite(u, p, x, z, m, ErrStat, ErrMsg) ErrMsg = "" ! Place any last minute operations or calculations here: if (p%WrVTK>0 .and. m%VTKstep= AbortErrLev ) RETURN diff --git a/modules/beamdyn/src/BeamDyn.f90 b/modules/beamdyn/src/BeamDyn.f90 index 6568785970..c56d481021 100644 --- a/modules/beamdyn/src/BeamDyn.f90 +++ b/modules/beamdyn/src/BeamDyn.f90 @@ -2282,7 +2282,7 @@ SUBROUTINE BD_QuadraturePointDataAt0( p ) DO nelem = 1,p%elem_total DO idx_qp = 1,p%nqp - !> ### Calculate the the initial displacement fields in an element + !> ### Calculate the initial displacement fields in an element !! Initial displacement field \n !! \f$ \underline{u_0}\left( \xi \right) = !! \sum_{k=1}^{p+1} h^k\left( \xi \right) \underline{\hat{u}_0}^k @@ -2370,7 +2370,7 @@ SUBROUTINE BD_DisplacementQP( nelem, p, x, m ) INTEGER(IntKi) :: idx_qp !< index to the current quadrature point INTEGER(IntKi) :: elem_start !< Node point of first node in current element - !> ### Calculate the the displacement fields in an element + !> ### Calculate the displacement fields in an element !! Using equations (27) and (28) \n !! \f$ \underline{u}\left( \xi \right) = !! \sum_{i=1}^{p+1} h^i\left( \xi \right) \underline{\hat{u}}^i diff --git a/modules/beamdyn/src/BeamDyn_Subs.f90 b/modules/beamdyn/src/BeamDyn_Subs.f90 index c1b9796a07..823fa9d0e2 100644 --- a/modules/beamdyn/src/BeamDyn_Subs.f90 +++ b/modules/beamdyn/src/BeamDyn_Subs.f90 @@ -146,7 +146,7 @@ SUBROUTINE BD_CrvMatrixR(cc,Rr) c2 = cc(2)/4.0_BDKi c3 = cc(3)/4.0_BDKi ! \f$ c_0 \f$ is equivalent to \f$ 0.5 - (||\vec{c}||)^2 / 32 \f$ - c0 = 0.5_BDKi * (1.0_BDKi-c1*c1-c2*c2-c3*c3) ! 1/4 the value of the the AIAA paper (after plugging in c1, c2, c3 conversions) + c0 = 0.5_BDKi * (1.0_BDKi-c1*c1-c2*c2-c3*c3) ! 1/4 the value of the AIAA paper (after plugging in c1, c2, c3 conversions) tr0 = 1.0_BDKi - c0 ! This is 1/4 the value of the AIAA paper, after converting c0. @@ -316,7 +316,7 @@ END SUBROUTINE BD_CrvCompose SUBROUTINE BD_CrvExtractCrv(R, cc, ErrStat, ErrMsg) REAL(BDKi), INTENT(IN ) :: R(3,3) !< Rotation Matrix - REAL(BDKi), INTENT( OUT) :: cc(3) !< Crv paramters + REAL(BDKi), INTENT( OUT) :: cc(3) !< Crv parameters INTEGER(IntKi), INTENT( OUT) :: ErrStat !< Error status of the operation CHARACTER(*), INTENT( OUT) :: ErrMsg !< Error message if ErrStat /= ErrID_None @@ -525,13 +525,13 @@ SUBROUTINE BD_GaussPointWeight(n, x, w, ErrStat, ErrMsg) ! loop through each of the "half" n points do i = 1, n_half - ! Intial guess for ith root; based on ith root of Chebyshev polynomial + ! Initial guess for ith root; based on ith root of Chebyshev polynomial x(i) = - cos( REAL( 2*i - 1, BDKi) * pi_D / (2.0_BDKi * n_real) ) ! initialize newton iteration counter newton = 0 - p3 = 1. ! some intial big number; logic will always take at least one newton iteration + p3 = 1. ! some initial big number; logic will always take at least one newton iteration do while (abs(p3) .gt. eps .and. newton .le. newton_max) newton = newton + 1 ! keep track of number of newton iterations diff --git a/modules/beamdyn/src/Driver_Beam.f90 b/modules/beamdyn/src/Driver_Beam.f90 index 8b1d51d194..0141190d7e 100644 --- a/modules/beamdyn/src/Driver_Beam.f90 +++ b/modules/beamdyn/src/Driver_Beam.f90 @@ -63,8 +63,8 @@ PROGRAM BeamDyn_Driver_Program REAL(DbKi) :: TiLstPrn ! The simulation time of the last print (to file) [(s)] REAL(ReKi) :: PrevClockTime ! Clock time at start of simulation in seconds [(s)] REAL(ReKi) :: UsrTime1 ! User CPU time for simulation initialization [(s)] - REAL(ReKi) :: UsrTime2 ! User CPU time for simulation (without intialization) [(s)] - INTEGER(IntKi) , DIMENSION(1:8) :: StrtTime ! Start time of simulation (including intialization) [-] + REAL(ReKi) :: UsrTime2 ! User CPU time for simulation (without initialization) [(s)] + INTEGER(IntKi) , DIMENSION(1:8) :: StrtTime ! Start time of simulation (including initialization) [-] INTEGER(IntKi) , DIMENSION(1:8) :: SimStrtTime ! Start time of simulation (after initialization) [-] CHARACTER(200) :: git_commit ! String containing the current git commit hash diff --git a/modules/elastodyn/src/ElastoDyn.f90 b/modules/elastodyn/src/ElastoDyn.f90 index 05ad19300c..486dfc3c18 100644 --- a/modules/elastodyn/src/ElastoDyn.f90 +++ b/modules/elastodyn/src/ElastoDyn.f90 @@ -5211,7 +5211,7 @@ SUBROUTINE Coeff(p,InputFileData, ErrStat, ErrMsg) END SUBROUTINE Coeff !---------------------------------------------------------------------------------------------------------------------------------- !> This routine calculates the initial blade deflections. -!! Base the intial values of the blade DOFs, INITQF1, INITQF2, and +!! Base the initial values of the blade DOFs, INITQF1, INITQF2, and !! INITQE1, on OoPDefl and IPDefl. !! Write messages to the screen if the specified initial tip displacements !! are incompatible with the enabled DOFs. diff --git a/modules/feamooring/src/FEAM.f90 b/modules/feamooring/src/FEAM.f90 index a97aeee76b..76ac6fccbd 100644 --- a/modules/feamooring/src/FEAM.f90 +++ b/modules/feamooring/src/FEAM.f90 @@ -1444,7 +1444,7 @@ SUBROUTINE FEAM_CalcOutput ( t, u, p, x, xd, z, OtherState, y, misc, ErrStat, CHARACTER(*), INTENT( OUT) :: ErrMsg ! Error message if ErrStat /= ErrID_None ! Local variables - REAL(ReKi) :: AllOuts(MaxOutPts) ! All the the available output channels + REAL(ReKi) :: AllOuts(MaxOutPts) ! All the available output channels INTEGER(IntKi) :: I,J ! Generic loop index ! INTEGER(IntKi) :: K ! Blade index ! INTEGER(IntKi) :: ErrStat2 @@ -2208,7 +2208,7 @@ SUBROUTINE SetPrimaryParameters( p, InputFileData, ErrStat, ErrMsg ) p%NEQ(:) = (p%NumElems+1)*p%NHBD-1 ! number of equations DO I = 1, p%NumLines - p%GSL (I,:,:) = InputFileData%GSL (I,:,:) !bjj: todo: Inspector flags this as unintialized + p%GSL (I,:,:) = InputFileData%GSL (I,:,:) !bjj: todo: Inspector flags this as uninitialized p%LineCI (I) = InputFileData%LineCI (I) p%LineCD (I) = InputFileData%LineCD (I) p%Elength (I) = InputFileData%LUnstrLen(I)/p%NumElems diff --git a/modules/hydrodyn/src/Conv_Radiation.f90 b/modules/hydrodyn/src/Conv_Radiation.f90 index 59842ddd2c..0584f2a8ef 100644 --- a/modules/hydrodyn/src/Conv_Radiation.f90 +++ b/modules/hydrodyn/src/Conv_Radiation.f90 @@ -178,7 +178,7 @@ SUBROUTINE Conv_Rdtn_Init( InitInp, u, p, x, xd, z, OtherState, y, m, InitOut, E RETURN END IF - ! Initialize all elements of the xd%XDHistory array with the intial values of u%Velocity + ! Initialize all elements of the xd%XDHistory array with the initial values of u%Velocity DO K = 0,p%NStepRdtn-1 DO J = 1,6*p%NBody ! Loop through all DOFs xd%XDHistory(K,J) = u%Velocity(J) diff --git a/modules/hydrodyn/src/HydroDyn_DriverCode.f90 b/modules/hydrodyn/src/HydroDyn_DriverCode.f90 index 4c2ccf61bb..a0cc08d04e 100644 --- a/modules/hydrodyn/src/HydroDyn_DriverCode.f90 +++ b/modules/hydrodyn/src/HydroDyn_DriverCode.f90 @@ -73,11 +73,11 @@ PROGRAM HydroDynDriver TYPE(HD_Drvr_Data) :: drvrData ! Data for the driver program (from an input file) TYPE(HD_Drvr_MappingData) :: mappingData ! data for mesh mappings in the driver - integer :: StrtTime (8) ! Start time of simulation (including intialization) + integer :: StrtTime (8) ! Start time of simulation (including initialization) integer :: SimStrtTime (8) ! Start time of simulation (after initialization) real(ReKi) :: PrevClockTime ! Clock time at start of simulation in seconds real(ReKi) :: UsrTime1 ! User CPU time for simulation initialization - real(ReKi) :: UsrTime2 ! User CPU time for simulation (without intialization) + real(ReKi) :: UsrTime2 ! User CPU time for simulation (without initialization) real(DbKi) :: TiLstPrn ! The simulation time of the last print integer :: n_SttsTime ! Number of time steps between screen status messages (-) diff --git a/modules/hydrodyn/src/Morison.f90 b/modules/hydrodyn/src/Morison.f90 index 32ccbe48ae..2c225611dd 100644 --- a/modules/hydrodyn/src/Morison.f90 +++ b/modules/hydrodyn/src/Morison.f90 @@ -225,7 +225,7 @@ END SUBROUTINE FindInterpFactor FUNCTION InterpWrappedStpInt( XValIn, XAry, YAry, Ind, AryLen ) - ! This funtion returns a y-value that corresponds to an input x-value which is wrapped back + ! This function returns a y-value that corresponds to an input x-value which is wrapped back ! into the range [1-XAry(AryLen). It finds a x-value which corresponds to a value in the XAry where XAry(Ind-1) < MOD(XValIn, XAry(AryLen)) <= XAry(Ind) ! It is assumed that XAry is sorted in ascending order. ! It uses the passed index as the starting point and does a stepwise interpolation from there. This is @@ -306,7 +306,7 @@ END FUNCTION InterpWrappedStpInt ! ( XVal, XAry, YAry, Ind, AryLen ) FUNCTION InterpWrappedStpLogical( XValIn, XAry, YAry, Ind, AryLen ) - ! This funtion returns a y-value that corresponds to an input x-value which is wrapped back + ! This function returns a y-value that corresponds to an input x-value which is wrapped back ! into the range [0-XAry(AryLen) by interpolating into the arrays. ! It is assumed that XAry is sorted in ascending order. ! It uses the passed index as the starting point and does a stepwise interpolation from there. This is @@ -437,7 +437,7 @@ SUBROUTINE CylTaperCalc(R1, R2, H, taperV, h_c) if ( EqualRealNos(R1, R2) ) then ! if just a cylinder taperV = abs(pi*R1*R1*H) h_c = H/2.0 - elseif ( EqualRealNos(R1,0.0_ReKi) ) then ! seperate this case out because it gives a divide by zero in general formula + elseif ( EqualRealNos(R1,0.0_ReKi) ) then ! separate this case out because it gives a divide by zero in general formula taperV = abs(1.0/3.0*pi*R2*R2*H) ! cone volume h_c = 3.0/4.0*H ! from base else @@ -490,7 +490,7 @@ SUBROUTINE CylInertia(R1, R2, H, rho, Il, Ir) if ( EqualRealNos(R1, R2) ) then ! if just a cylinder Ir = abs(1.0/12.0* rho*pi*R1*R1*H *(3.0*R1*R1 + 4.0*H*H)) ! radial inertia about node 1 Il = abs(0.5* rho*pi*R1*R1*H *R1*R1) - ELSEIF ( EqualRealNos(R1,0.0_ReKi) ) then ! seperate this case out because it gives a divide by zero in general formula + ELSEIF ( EqualRealNos(R1,0.0_ReKi) ) then ! separate this case out because it gives a divide by zero in general formula Ir = abs(rho*pi*(1.0/20.0/m + 1.0/5.0/m**3) * R2**5) Il = abs(1.0/10.0*rho*pi/m*R2**5) ELSE @@ -1870,7 +1870,7 @@ subroutine FlipMemberNodeData( member, nodes, doSwap) doSwap = .TRUE. ! Z1 > Z2 END IF - ! If we swap the the nodes, we need know this later when calculating the normal vector to the ends + ! If we swap the nodes, we need know this later when calculating the normal vector to the ends member%Flipped = doSwap IF ( doSwap ) THEN member%NodeIndx(1) = j2 @@ -2225,7 +2225,7 @@ subroutine SetMemberProperties_Cyl( gravity, member, MCoefMod, MmbrCoefIDIndx, M member%Vballast = member%Vballast + Vballast_l + Vballast_u else if ((member%memfloodstatus > 0) .and. (member%FillFSLoc > Za) .AND. (member%FillFSLoc < Zb)) then ! Partially flooded element - + member%floodstatus(i) = 2 member%elem_fill = i member%h_fill = member%l_fill - (i-1)*dl diff --git a/modules/hydrodyn/src/Morison_Output.f90 b/modules/hydrodyn/src/Morison_Output.f90 index 16ccff3178..4aa0d64dd6 100644 --- a/modules/hydrodyn/src/Morison_Output.f90 +++ b/modules/hydrodyn/src/Morison_Output.f90 @@ -7980,7 +7980,7 @@ SUBROUTINE MrsnOut_Init( InitInp, y, p, InitOut, ErrStat, ErrMsg ) TYPE(Morison_InitInputType ), INTENT( IN ) :: InitInp ! data needed to initialize the output module TYPE(Morison_OutputType), INTENT( INOUT ) :: y ! Morison module's output data - TYPE(Morison_ParameterType), INTENT( INOUT ) :: p ! Morison module paramters + TYPE(Morison_ParameterType), INTENT( INOUT ) :: p ! Morison module parameters TYPE(Morison_InitOutputType ), INTENT( INOUT ) :: InitOut ! Morison module initialization output data INTEGER, INTENT( OUT ) :: ErrStat ! a non-zero value indicates an error occurred CHARACTER(*), INTENT( OUT ) :: ErrMsg ! Error message if ErrStat /= ErrID_None diff --git a/modules/hydrodyn/src/WAMIT.f90 b/modules/hydrodyn/src/WAMIT.f90 index d04c5a823b..bf1260f4ca 100644 --- a/modules/hydrodyn/src/WAMIT.f90 +++ b/modules/hydrodyn/src/WAMIT.f90 @@ -126,12 +126,12 @@ SUBROUTINE WAMIT_Init( InitInp, u, p, x, xd, z, OtherState, y, m, Interval, ErrS ! These are dummy variables to satisfy the framework, but are not used - TYPE(Conv_Rdtn_InitInputType) :: Conv_Rdtn_InitInp ! Local version of the intialization data for the radiation module + TYPE(Conv_Rdtn_InitInputType) :: Conv_Rdtn_InitInp ! Local version of the initialization data for the radiation module TYPE(Conv_Rdtn_InitOutputType) :: Conv_Rdtn_InitOut ! Initialization Outputs from the Conv_Rdtn module initialization !TYPE(Conv_Rdtn_InitOutputType) :: Conv_RdtnInitOutData - TYPE(SS_Rad_InitInputType) :: SS_Rdtn_InitInp ! Local version of the intialization data for the radiation module + TYPE(SS_Rad_InitInputType) :: SS_Rdtn_InitInp ! Local version of the initialization data for the radiation module TYPE(SS_Rad_InitOutputType) :: SS_Rdtn_InitOut ! Initialization Outputs from the SS_Rdtn module initialization - TYPE(SS_Exc_InitInputType) :: SS_Exctn_InitInp ! Local version of the intialization data for the SS wave excitation module + TYPE(SS_Exc_InitInputType) :: SS_Exctn_InitInp ! Local version of the initialization data for the SS wave excitation module TYPE(SS_Exc_InitOutputType) :: SS_Exctn_InitOut ! Initialization Outputs from the SS wave excitation module initialization @@ -1163,7 +1163,7 @@ SUBROUTINE WAMIT_Init( InitInp, u, p, x, xd, z, OtherState, y, m, Interval, ErrS DO iHdg = 1,p%NExctnHdg+1 DO J = 1,6*p%NBody ! Loop through all wave excitation forces and moments CALL ApplyFFT_cx ( p%WaveExctnGrid(0:p%WaveField%NStepWave-1,1_IntKi,1_IntKi,iHdg,J), WaveExctnC(:,iHdg,J), FFT_Data, ErrStat2 ) - CALL SetErrStat( ErrStat2, ' An error occured while applying an FFT to WaveExctnC.', ErrStat, ErrMsg, RoutineName) + CALL SetErrStat( ErrStat2, ' An error occurred while applying an FFT to WaveExctnC.', ErrStat, ErrMsg, RoutineName) IF ( ErrStat >= AbortErrLev) THEN CALL Cleanup() RETURN @@ -1249,7 +1249,7 @@ SUBROUTINE WAMIT_Init( InitInp, u, p, x, xd, z, OtherState, y, m, Interval, ErrS iY = (iGrid-1) / p%ExctnGridParams%n(2) + 1 DO J = 1,6*p%NBody ! Loop through all wave excitation forces and moments CALL ApplyFFT_cx ( p%WaveExctnGrid(0:p%WaveField%NStepWave-1,iX,iY,iHdg,J), WaveExctnCGrid(:,iGrid,iHdg,J), FFT_Data, ErrStat2 ) - CALL SetErrStat( ErrStat2, ' An error occured while applying an FFT to WaveExctnC.', ErrStat, ErrMsg, RoutineName) + CALL SetErrStat( ErrStat2, ' An error occurred while applying an FFT to WaveExctnC.', ErrStat, ErrMsg, RoutineName) IF ( ErrStat >= AbortErrLev) THEN CALL Cleanup() RETURN @@ -1332,7 +1332,7 @@ SUBROUTINE WAMIT_Init( InitInp, u, p, x, xd, z, OtherState, y, m, Interval, ErrS ! representations of the wave kinematics without stretching: CALL InitFFT ( p%WaveField%NStepWave, FFT_Data, .TRUE., ErrStat2 ) - CALL SetErrStat(ErrStat2,'Error occured while initializing the FFT.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStat2,'Error occurred while initializing the FFT.',ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN CALL CleanUp() RETURN @@ -1341,7 +1341,7 @@ SUBROUTINE WAMIT_Init( InitInp, u, p, x, xd, z, OtherState, y, m, Interval, ErrS ! We'll need the following for wave stretching once we implement it. ! NOTE THIS IS OVERWRITING THE WAVEFIELD WaveElev0 PARAMETER DATA CALL ApplyFFT_cx ( SS_Exctn_InitInp%WaveField%WaveElev0(0:p%WaveField%NStepWave-1), tmpComplexArr(: ), FFT_Data, ErrStat2 ) - CALL SetErrStat(ErrStat2,'Error occured while applying the FFT to WaveElev0.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStat2,'Error occurred while applying the FFT to WaveElev0.',ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN CALL CleanUp() RETURN diff --git a/modules/hydrodyn/src/WAMIT2.f90 b/modules/hydrodyn/src/WAMIT2.f90 index f62043b92f..3c38462510 100644 --- a/modules/hydrodyn/src/WAMIT2.f90 +++ b/modules/hydrodyn/src/WAMIT2.f90 @@ -1339,7 +1339,7 @@ SUBROUTINE NewmanApp_InitCalc( InitInp, p, NewmanAppData, NewmanAppForce, ErrMsg ! Initialize the FFT library CALL InitCFFT ( InitInp%WaveField%NStepWave, FFT_Data, .FALSE., ErrStatTmp ) ! Complex result FFT initialize - CALL SetErrStat(ErrStatTmp,'Error occured while initializing the FFT.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while initializing the FFT.',ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN IF (ALLOCATED(TmpData3D)) DEALLOCATE(TmpData3D,STAT=ErrStatTmp) IF (ALLOCATED(TmpData4D)) DEALLOCATE(TmpData4D,STAT=ErrStatTmp) @@ -1620,7 +1620,7 @@ SUBROUTINE NewmanApp_InitCalc( InitInp, p, NewmanAppData, NewmanAppForce, ErrMsg ! Done with the FFT library routines, so end them. CALL ExitCFFT(FFT_Data, ErrStatTmp) - CALL SetErrStat(ErrStatTmp,'Error occured while cleaning up after the FFTs.', ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while cleaning up after the FFTs.', ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN IF (ALLOCATED(TmpData3D)) DEALLOCATE(TmpData3D,STAT=ErrStatTmp) IF (ALLOCATED(TmpData4D)) DEALLOCATE(TmpData4D,STAT=ErrStatTmp) @@ -1803,7 +1803,7 @@ SUBROUTINE DiffQTF_InitCalc( InitInp, p, DiffQTFData, DiffQTFForce, ErrMsg, ErrS ! Initialize the FFT library. Do not apply normalization. CALL InitFFT ( InitInp%WaveField%NStepWave, FFT_Data, .FALSE., ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while initializing the FFT.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while initializing the FFT.',ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN call cleanup() RETURN @@ -1990,7 +1990,7 @@ SUBROUTINE DiffQTF_InitCalc( InitInp, p, DiffQTFData, DiffQTFForce, ErrMsg, ErrS ! Now we apply the FFT to the result of the sum CALL ApplyFFT_cx( TmpDiffQTFForce(:), TmpComplexArr(:,ThisDim), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT to the second term of the difference QTF.', & + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT to the second term of the difference QTF.', & ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN call cleanup() @@ -2015,7 +2015,7 @@ SUBROUTINE DiffQTF_InitCalc( InitInp, p, DiffQTFData, DiffQTFForce, ErrMsg, ErrS ! Done with the FFT library routines, so end them. CALL ExitFFT(FFT_Data, ErrStatTmp) - CALL SetErrStat(ErrStatTmp,'Error occured while cleaning up after the FFTs.', ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while cleaning up after the FFTs.', ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN call cleanup() RETURN @@ -2234,7 +2234,7 @@ SUBROUTINE SumQTF_InitCalc( InitInp, p, SumQTFData, SumQTFForce, ErrMsg, ErrStat ! Initialize the FFT library. Normalization not required in this formulation. CALL InitFFT ( InitInp%WaveField%NStepWave, FFT_Data, .FALSE., ErrStatTmp ) ! FIXME: - CALL SetErrStat(ErrStatTmp,'Error occured while initializing the FFT.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while initializing the FFT.',ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN IF (ALLOCATED(TmpData4D)) DEALLOCATE(TmpData4D,STAT=ErrStatTmp) IF (ALLOCATED(SumQTFForce)) DEALLOCATE(SumQTFForce,STAT=ErrStatTmp) @@ -2516,7 +2516,7 @@ SUBROUTINE SumQTF_InitCalc( InitInp, p, SumQTFData, SumQTFForce, ErrMsg, ErrStat ! Now we apply the FFT to the result of the sum. CALL ApplyFFT_cx( Term1Array(:), Term1ArrayC(:,ThisDim), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT to the first term of the Sum QTF.', & + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT to the first term of the Sum QTF.', & ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN IF (ALLOCATED(TmpData4D)) DEALLOCATE(TmpData4D,STAT=ErrStatTmp) @@ -2525,7 +2525,7 @@ SUBROUTINE SumQTF_InitCalc( InitInp, p, SumQTFData, SumQTFForce, ErrMsg, ErrStat ! Now we apply the FFT to the result of the sum. CALL ApplyFFT_cx( Term2Array(:), Term2ArrayC(:,ThisDim), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT to the second term of the Sum QTF.', & + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT to the second term of the Sum QTF.', & ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN IF (ALLOCATED(TmpData4D)) DEALLOCATE(TmpData4D,STAT=ErrStatTmp) @@ -2548,7 +2548,7 @@ SUBROUTINE SumQTF_InitCalc( InitInp, p, SumQTFData, SumQTFForce, ErrMsg, ErrStat ! Done with the FFT library routines, so end them. CALL ExitFFT(FFT_Data, ErrStatTmp) - CALL SetErrStat(ErrStatTmp,'Error occured while cleaning up after the FFTs.', ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while cleaning up after the FFTs.', ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN IF (ALLOCATED(TmpData4D)) DEALLOCATE(TmpData4D,STAT=ErrStatTmp) RETURN diff --git a/modules/icedyn/src/IceDyn.f90 b/modules/icedyn/src/IceDyn.f90 index 9abd548d9f..87440da45c 100644 --- a/modules/icedyn/src/IceDyn.f90 +++ b/modules/icedyn/src/IceDyn.f90 @@ -2516,7 +2516,7 @@ END FUNCTION SolveLambda FUNCTION BrkLdPar (alpha, lambda, mu) Result (A) - !BRKLDPAR Calculates Ralston's horizontal force paramters A1, A2, A3, A4 and B1, B2. + !BRKLDPAR Calculates Ralston's horizontal force parameters A1, A2, A3, A4 and B1, B2. ! Detailed explanation in Ralston's paper: Ice Force Desgin Consideration ! for Conical Offshore Structure and Ice Module Manual diff --git a/modules/icefloe/src/icefloe/IceFlexISO.f90 b/modules/icefloe/src/icefloe/IceFlexISO.f90 index aeb4e9f25d..4e292c8bc5 100644 --- a/modules/icefloe/src/icefloe/IceFlexISO.f90 +++ b/modules/icefloe/src/icefloe/IceFlexISO.f90 @@ -126,9 +126,9 @@ subroutine initFlexISO (iceInput, myIceParams, iceLog) call getIceInput(iceInput, 'includeLc', inParams%includeLc, iceLog) if (inParams%includeLc) then - call logMessage(iceLog, ' Including crack lenght modification term, Lc') + call logMessage(iceLog, ' Including crack length modification term, Lc') else - call logMessage(iceLog, ' NOT including crack lenght modification term, Lc') + call logMessage(iceLog, ' NOT including crack length modification term, Lc') endif ! The Croasdale method precalculates a time series of loads based @@ -275,7 +275,7 @@ subroutine randomFlexLoadTimeSeries (myIceParams, iceLog, maxLoad) ! Loop on all legs do nL = 1, myIceParams%numLegs - ! Number of whole periods required not known (since period lenght is random) + ! Number of whole periods required not known (since period length is random) ! So iterate until we have enough points in the time series n = 1 seriesLoop: do while (n < nSteps+1) diff --git a/modules/icefloe/src/interfaces/FAST/IceFloe.f90 b/modules/icefloe/src/interfaces/FAST/IceFloe.f90 index f257ddeb6e..90b2b4490e 100644 --- a/modules/icefloe/src/interfaces/FAST/IceFloe.f90 +++ b/modules/icefloe/src/interfaces/FAST/IceFloe.f90 @@ -190,7 +190,7 @@ SUBROUTINE IceFloe_Init( InitInp, u, p, x, xd, z, OtherState, y, m, Interval, In endif ! get the simulation length from FAST - ! if the the length from FAST is zero read from iceFloe input file + ! if the length from FAST is zero read from iceFloe input file if (InitInp%simLength <= 0) then duration = InitInp%simLength else diff --git a/modules/icefloe/test/GLA_proto_flex_ISO.log b/modules/icefloe/test/GLA_proto_flex_ISO.log index 88efb643e8..d46f6f5115 100644 --- a/modules/icefloe/test/GLA_proto_flex_ISO.log +++ b/modules/icefloe/test/GLA_proto_flex_ISO.log @@ -44,7 +44,7 @@ Including pile up term, Hp Including rubble lifting term, Hl Including block rotation term, Ht - Including crack lenght modification term, Lc + Including crack length modification term, Lc ** Pile up term, Hp = 2242 Newtons ** Rubble lifting term, Hl = 2.09678E+05 Newtons ** Block rotation term, Ht = 42609 Newtons diff --git a/modules/inflowwind/src/IfW_C_Binding.f90 b/modules/inflowwind/src/IfW_C_Binding.f90 index 8299d6010f..1050b1cec4 100644 --- a/modules/inflowwind/src/IfW_C_Binding.f90 +++ b/modules/inflowwind/src/IfW_C_Binding.f90 @@ -101,7 +101,7 @@ SUBROUTINE IfW_C_Init(IfWinputFilePassed, IfWinputFileString_C, IfWinputFileStri #endif integer(c_int), intent(in ) :: IfWinputFilePassed !< Write VTK outputs [0: none, 1: init only, 2: animation] type(c_ptr), intent(in ) :: IfWinputFileString_C !< Input file as a single string with lines deliniated by C_NULL_CHAR - integer(c_int), intent(in ) :: IfWinputFileStringLength_C !< lenght of the input file string + integer(c_int), intent(in ) :: IfWinputFileStringLength_C !< length of the input file string character(kind=c_char), intent(in ) :: OutRootName_C(IntfStrLen) !< Root name to use for echo files and other integer(c_int), intent(in ) :: NumWindPts_C real(c_double), intent(in ) :: DT_C diff --git a/modules/inflowwind/src/InflowWind.f90 b/modules/inflowwind/src/InflowWind.f90 index 58f9d1d4a6..22796ed0dc 100644 --- a/modules/inflowwind/src/InflowWind.f90 +++ b/modules/inflowwind/src/InflowWind.f90 @@ -535,7 +535,7 @@ END SUBROUTINE InflowWind_Init !! these PositionXYZPrime coordinates. !! !! After the calculation by the submodule, the PositionXYZPrime coordinate array is deallocated. The returned VelocityUVW -!! array is then rotated by p%PropagationDir so that it now corresponds the the global coordinate UVW values for wind +!! array is then rotated by p%PropagationDir so that it now corresponds to the global coordinate UVW values for wind !! with that direction. !---------------------------------------------------------------------------------------------------- SUBROUTINE InflowWind_CalcOutput( Time, InputData, p, & diff --git a/modules/inflowwind/src/InflowWind_Driver.f90 b/modules/inflowwind/src/InflowWind_Driver.f90 index 42b29d1d11..f1d7dcfb12 100644 --- a/modules/inflowwind/src/InflowWind_Driver.f90 +++ b/modules/inflowwind/src/InflowWind_Driver.f90 @@ -733,7 +733,7 @@ PROGRAM InflowWind_Driver InflowWind_x, InflowWind_xd, InflowWind_z, InflowWind_OtherState, & InflowWind_y1, InflowWind_MiscVars, ErrStat, ErrMsg) - ! Make sure no errors occured that give us reason to terminate now. + ! Make sure no errors occurred that give us reason to terminate now. IF ( ErrStat >= AbortErrLev ) THEN CALL DriverCleanup() CALL ProgAbort( ErrMsg ) @@ -860,7 +860,7 @@ PROGRAM InflowWind_Driver InflowWind_x, InflowWind_xd, InflowWind_z, InflowWind_OtherState, & InflowWind_y1, InflowWind_MiscVars, ErrStat, ErrMsg ) - ! Make sure no errors occured that give us reason to terminate now. + ! Make sure no errors occurred that give us reason to terminate now. IF ( ErrStat >= AbortErrLev ) THEN CALL DriverCleanup() CALL ProgAbort( ErrMsg ) @@ -879,7 +879,7 @@ PROGRAM InflowWind_Driver InflowWind_x, InflowWind_xd, InflowWind_z, InflowWind_OtherState, & InflowWind_y2, InflowWind_MiscVars, ErrStat, ErrMsg ) - ! Make sure no errors occured that give us reason to terminate now. + ! Make sure no errors occurred that give us reason to terminate now. IF ( ErrStat >= AbortErrLev ) THEN CALL DriverCleanup() CALL ProgAbort( ErrMsg ) @@ -898,7 +898,7 @@ PROGRAM InflowWind_Driver InflowWind_x, InflowWind_xd, InflowWind_z, InflowWind_OtherState, & InflowWind_y3, InflowWind_MiscVars, ErrStat, ErrMsg ) - ! Make sure no errors occured that give us reason to terminate now. + ! Make sure no errors occurred that give us reason to terminate now. IF ( ErrStat >= AbortErrLev ) THEN CALL DriverCleanup() CALL ProgAbort( ErrMsg ) diff --git a/modules/inflowwind/src/InflowWind_Subs.f90 b/modules/inflowwind/src/InflowWind_Subs.f90 index 0824d2ff08..232c89ca97 100644 --- a/modules/inflowwind/src/InflowWind_Subs.f90 +++ b/modules/inflowwind/src/InflowWind_Subs.f90 @@ -462,7 +462,7 @@ SUBROUTINE InflowWind_ParseInputFileInfo( InputFileData, InFileInfo, PriPath, In ! if (Failed()) return !---------------------------------------------------------------------------------------------- - !> Read the _Mean wind profile paramters (added to HAWC-format files) [used only for WindType = 5]_ subsection + !> Read the _Mean wind profile parameters (added to HAWC-format files) [used only for WindType = 5]_ subsection !---------------------------------------------------------------------------------------------- CurLine = CurLine + 1 ! Skip section break diff --git a/modules/lindyn/src/LinDyn.f90 b/modules/lindyn/src/LinDyn.f90 index 3bb9f0f292..799c0d2fd3 100644 --- a/modules/lindyn/src/LinDyn.f90 +++ b/modules/lindyn/src/LinDyn.f90 @@ -179,10 +179,10 @@ subroutine LD_SetInitialConditions(x, x0, xd0, p, OtherState, m, errStat, errMsg nx = int(size(x%q)/2) errStat = ErrID_Fatal if (size(x0)/=size(xd0)) then - errMsg ='Shape of x0 and xd0 should match when setting intial conditions'; return + errMsg ='Shape of x0 and xd0 should match when setting initial conditions'; return endif if (size(x0)/=nx) then - errMsg ='Shape of x0 should match nx when setting intial conditions'; return + errMsg ='Shape of x0 should match nx when setting initial conditions'; return endif errMsg = '' errStat = ErrID_None diff --git a/modules/map/src/bstring/bstrlib.h b/modules/map/src/bstring/bstrlib.h index 1292a38cb9..0887977a90 100644 --- a/modules/map/src/bstring/bstrlib.h +++ b/modules/map/src/bstring/bstrlib.h @@ -1506,7 +1506,7 @@ bseof(const struct bStream *s); /* Static constant block parameter pair */ /** - * The bsStaticBlkParms macro emits a pair of comma seperated parameters + * The bsStaticBlkParms macro emits a pair of comma separated parameters * corresponding to the block parameters for the block functions in Bstrlib * (i.e., blk2bstr, bcatblk, blk2tbstr, bisstemeqblk, bisstemeqcaselessblk). * @@ -1521,7 +1521,7 @@ bseof(const struct bStream *s); * * These are faster than using bfromcstr() and bcatcstr() respectively * because the length of the inline string is known as a compile time - * constant. Also note that seperate struct tagbstring declarations for + * constant. Also note that separate struct tagbstring declarations for */ #define bsStaticBlkParms(q) \ ((void *)("" q "")), ((int)sizeof(q) -1) diff --git a/modules/map/src/freedata.c b/modules/map/src/freedata.c index f875db98d0..062564d132 100644 --- a/modules/map/src/freedata.c +++ b/modules/map/src/freedata.c @@ -56,8 +56,8 @@ MAP_ERROR_CODE free_outlist(Domain* domain, char* map_msg, MAP_ERROR_CODE* ierr) list_iterator_stop(&domain->y_list->out_list_ptr); // @rm y_list->out_list no longer exists/is useful ? - list_destroy(&domain->y_list->out_list); /* destroy output lists for writting information to output file */ - list_destroy(&domain->y_list->out_list_ptr); /* destroy output lists for writting information to output file */ + list_destroy(&domain->y_list->out_list); /* destroy output lists for writing information to output file */ + list_destroy(&domain->y_list->out_list_ptr); /* destroy output lists for writing information to output file */ }; MAPFREE(domain->y_list); return MAP_SAFE; diff --git a/modules/map/src/lineroutines.c b/modules/map/src/lineroutines.c index ba89c7b5bd..de5f61939f 100644 --- a/modules/map/src/lineroutines.c +++ b/modules/map/src/lineroutines.c @@ -350,7 +350,7 @@ MAP_ERROR_CODE line_solve_sequence(Domain* domain, MAP_ParameterType_t* p_type, success = set_line_variables_pre_solve(domain, map_msg, ierr); success = reset_node_force_to_zero(domain, map_msg, ierr); success = solve_line(domain, t, map_msg, ierr); CHECKERRQ(MAP_FATAL_88); - // /* prematurely terminating the the line solve routine to return back to the + // /* prematurely terminating the line solve routine to return back to the // caller function. Do a back tracking on the solution and attempt recovery */ // if (success==MAP_FATAL) { // return MAP_FATAL_59; diff --git a/modules/map/src/mapapi.c b/modules/map/src/mapapi.c index ec86d8402a..69d47714b1 100644 --- a/modules/map/src/mapapi.c +++ b/modules/map/src/mapapi.c @@ -151,7 +151,7 @@ MAP_EXTERNCALL void map_init(MAP_InitInputType_t* init_type, MAP_END_ERROR_LOG; - /* the next functions are called in a seperate do-loop to log information to the + /* the next functions are called in a separate do-loop to log information to the * summary file even if a fatal error is encountered. This guarantees the summary * file is written even if garbage is recorded. */ @@ -159,7 +159,7 @@ MAP_EXTERNCALL void map_init(MAP_InitInputType_t* init_type, free_init_data(init_data, map_msg, ierr); MAP_InitInput_Delete(init_data); - if (*ierr!=MAP_SAFE) printf("Intialization: %s\n", map_msg); + if (*ierr!=MAP_SAFE) printf("Initialization: %s\n", map_msg); // checkpoint(); // printf("In initialization: %p\n",z_type); diff --git a/modules/map/src/mapapi.h b/modules/map/src/mapapi.h index 5d7134b1bf..4111f818e1 100644 --- a/modules/map/src/mapapi.h +++ b/modules/map/src/mapapi.h @@ -98,7 +98,7 @@ MAP_EXTERNCALL int free_init_data (MAP_InitializationData_t init, char* map_msg, /** * @brief Set the water depth. Should be called before {@link map_init()} - * @param p_type paramter type, native C struct {@link MAP_ParameterType_t} + * @param p_type parameter type, native C struct {@link MAP_ParameterType_t} * @param depth water depth [m] * * Example Fortran usage: @@ -123,7 +123,7 @@ MAP_EXTERNCALL void map_set_sea_depth(MAP_Parameter_t p_type, const double depth /** * @brief Set the water density. Should be called before {@link map_init()} - * @param p_type paramter type, native C struct {@link MAP_ParameterType_t} + * @param p_type parameter type, native C struct {@link MAP_ParameterType_t} * @param rho water density [kg/m^3] * * Example Fortran usage: @@ -148,7 +148,7 @@ MAP_EXTERNCALL void map_set_sea_density(MAP_Parameter_t p_type, const double rho /** * @brief Set the gravitational constant. Should be called before {@link map_init()} - * @param p_type paramter type, native C struct {@link MAP_ParameterType_t} + * @param p_type parameter type, native C struct {@link MAP_ParameterType_t} * @param grtavity gravitational acceleration [m/s^2] * * Example Fortran usage: diff --git a/modules/map/src/mapinit.h b/modules/map/src/mapinit.h index 2693c26171..bd3063827d 100644 --- a/modules/map/src/mapinit.h +++ b/modules/map/src/mapinit.h @@ -210,7 +210,7 @@ MAP_ERROR_CODE check_help_flag(bstring list); * inner_ftol * * @param list, a character array structure - * @param ftol, pointer to the FTOL paramter for minpack + * @param ftol, pointer to the FTOL parameter for minpack * @see set_model_options_list(), map_init() * @return MAP error code */ @@ -230,7 +230,7 @@ MAP_ERROR_CODE check_inner_f_tol_flag(struct bstrList* list, double* ftol); * inner_gtol * * @param list, a character array structure - * @param gtol, pointer to the GTOL paramter for minpack + * @param gtol, pointer to the GTOL parameter for minpack * @see set_model_options_list(), map_init() * @return MAP error code */ @@ -249,7 +249,7 @@ MAP_ERROR_CODE check_inner_g_tol_flag(struct bstrList* list, double* gtol); * inner_xtol * * @param list, a character array structure - * @param xtol, pointer to the XTOL paramter for minpack + * @param xtol, pointer to the XTOL parameter for minpack * @see set_model_options_list(), map_init() * @return MAP error code */ @@ -302,7 +302,7 @@ MAP_ERROR_CODE check_outer_max_its_flag(struct bstrList* list, int* max_its); * outer_tol * * @param list, a character array structure - * @param outer_tol, pointer to the tolerance paramter + * @param outer_tol, pointer to the tolerance parameter * @see set_model_options_list(), map_init() * @return MAP error code */ diff --git a/modules/map/src/simclist/simclist.h b/modules/map/src/simclist/simclist.h index c6463a8719..32b2a13d99 100644 --- a/modules/map/src/simclist/simclist.h +++ b/modules/map/src/simclist/simclist.h @@ -97,7 +97,7 @@ typedef int (*element_comparator)(const void *a, const void *b); typedef int (*element_seeker)(const void *el, const void *indicator); /** - * an element lenght meter. + * an element length meter. * * An element meter is a function that: * -# receives the reference to an element el diff --git a/modules/moordyn/src/MoorDyn.f90 b/modules/moordyn/src/MoorDyn.f90 index e4850c9020..d45ccc9be1 100644 --- a/modules/moordyn/src/MoorDyn.f90 +++ b/modules/moordyn/src/MoorDyn.f90 @@ -2376,7 +2376,7 @@ SUBROUTINE MD_Init(InitInp, u, p, x, xd, z, other, y, m, DTcoupling, InitOut, Er ! rRef and OrMatRef or the position and orientation matrix of the ! coupled object relative to the platform, based on the input file. ! They are used to set the "reference" pose of each coupled mesh - ! entry before the intial offsets from PtfmInit are applied. + ! entry before the initial offsets from PtfmInit are applied. J = 0 ! this is the counter through the mesh points for each turbine @@ -2483,7 +2483,7 @@ SUBROUTINE MD_Init(InitInp, u, p, x, xd, z, other, y, m, DTcoupling, InitOut, Er end do ! iTurb - ! >>>>>> ensure the output mesh includes all elements from u%(Farm)CoupledKinematics, OR make a seperate array of output meshes for each turbine <<<<<<<<< + ! >>>>>> ensure the output mesh includes all elements from u%(Farm)CoupledKinematics, OR make a separate array of output meshes for each turbine <<<<<<<<< CALL CheckError( ErrStat2, ErrMsg2 ) @@ -2652,7 +2652,7 @@ SUBROUTINE MD_Init(InitInp, u, p, x, xd, z, other, y, m, DTcoupling, InitOut, Er ! if log file, compute and write some object properties ! ------------------------------------------------------------------- if (p%writeLog > 1) then - write(p%UnLog, '(A)' ) "Values after intialization before dynamic relaxation" + write(p%UnLog, '(A)' ) "Values after initialization before dynamic relaxation" write(p%UnLog, '(A)' ) " Bodies:" DO l = 1,p%nBodies write(p%UnLog, '(A)' ) " Body"//trim(num2lstr(l))//":" @@ -3946,7 +3946,7 @@ END SUBROUTINE MD_Step !-------------------------------------------------------------- SUBROUTINE MD_RK2 ( t, dtM, u_interp, u, t_array, p, x, xd, z, other, m, ErrStat, ErrMsg ) - REAL(DbKi) , INTENT(INOUT) :: t ! intial time (s) for this integration step + REAL(DbKi) , INTENT(INOUT) :: t ! initial time (s) for this integration step REAL(DbKi) , INTENT(IN ) :: dtM ! single time step size (s) for this integration step TYPE( MD_InputType ) , INTENT(INOUT) :: u_interp ! interpolated instantaneous input values to be calculated for each mooring time step TYPE( MD_InputType ) , INTENT(INOUT) :: u(:) ! INTENT(IN ) @@ -4311,7 +4311,7 @@ SUBROUTINE MD_JacobianPInput( t, u, p, x, xd, z, OtherState, y, m, ErrStat, ErrM ! get central difference: ! we may have had an error allocating memory, so we'll check if(Failed()) return - ! get central difference (state entries are mapped the the dXdu column in routine): + ! get central difference (state entries are mapped to the dXdu column in routine): call MD_Compute_dX( p, x_p, x_m, delta_p, dXdu(:,i) ) end do END IF ! dXdu diff --git a/modules/moordyn/src/MoorDyn_Driver.f90 b/modules/moordyn/src/MoorDyn_Driver.f90 index 1e7e5950f7..9a2d97b528 100644 --- a/modules/moordyn/src/MoorDyn_Driver.f90 +++ b/modules/moordyn/src/MoorDyn_Driver.f90 @@ -108,8 +108,8 @@ PROGRAM MoorDyn_Driver REAL(ReKi) :: PrevClockTime !< Previous clock time in seconds past midnight INTEGER :: SimStrtTime (8) !< An array containing the elements of the start time (after initialization). INTEGER :: ProgStrtTime (8) !< An array containing the elements of the program start time (before initialization). - REAL(ReKi) :: SimStrtCPU !< User CPU time for simulation (without intialization) - REAL(ReKi) :: ProgStrtCPU !< User CPU time for program (with intialization) + REAL(ReKi) :: SimStrtCPU !< User CPU time for simulation (without initialization) + REAL(ReKi) :: ProgStrtCPU !< User CPU time for program (with initialization) CHARACTER(20) :: FlagArg ! flag argument from command line diff --git a/modules/moordyn/src/MoorDyn_Misc.f90 b/modules/moordyn/src/MoorDyn_Misc.f90 index bf26a7ab1b..39da747167 100644 --- a/modules/moordyn/src/MoorDyn_Misc.f90 +++ b/modules/moordyn/src/MoorDyn_Misc.f90 @@ -189,7 +189,7 @@ SUBROUTINE TransformKinematics(rRelBody, r_in, TransMat, rd_in, r_out, rd_out) ! rd_in should be in global orientation frame ! note: it's okay if r_out and rd_out are 6-size. Only the first 3 will be written, and 4-6 will - ! already be correct or can be assigned seperately from r_in and rd_in (assuming orientation frames are identical) + ! already be correct or can be assigned separately from r_in and rd_in (assuming orientation frames are identical) ! locations (unrotated reference frame) about platform reference point (2021-01-05: just transposed TransMat, it was incorrect before) @@ -246,7 +246,7 @@ SUBROUTINE TransformKinematicsA(rRelBody, r_in, TransMat, v_in, a_in, r_out, v_o ! rd_in should be in global orientation frame ! note: it's okay if r_out and rd_out are 6-size. Only the first 3 will be written, and 4-6 will - ! already be correct or can be assigned seperately from r_in and rd_in (assuming orientation frames are identical) + ! already be correct or can be assigned separately from r_in and rd_in (assuming orientation frames are identical) ! locations about ref point in *unrotated* reference frame @@ -1306,7 +1306,7 @@ SUBROUTINE setupWaterKin(WaterKinString, p, Tmax, ErrStat, ErrMsg) INTEGER(IntKi) :: NStepWave ! INTEGER(IntKi) :: NStepWave2 ! - REAL(SiKi) :: WaveTMax ! max wave elevation time series duration after optimizing lenght for FFT + REAL(SiKi) :: WaveTMax ! max wave elevation time series duration after optimizing length for FFT REAL(SiKi) :: WaveDOmega REAL(SiKi) :: SinWaveDir ! SIN( WaveDirArr(I) ) -- Each wave frequency has a unique wave direction. REAL(SiKi) :: CosWaveDir ! COS( WaveDirArr(I) ) -- Each wave frequency has a unique wave direction. @@ -1589,11 +1589,11 @@ SUBROUTINE setupWaterKin(WaterKinString, p, Tmax, ErrStat, ErrMsg) ! Initialize the FFT CALL InitFFT ( NStepWave, FFT_Data, .FALSE., ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while initializing the FFT.',ErrStat,ErrMsg,RoutineName); if(Failed()) return + CALL SetErrStat(ErrStatTmp,'Error occurred while initializing the FFT.',ErrStat,ErrMsg,RoutineName); if(Failed()) return ! Apply the forward FFT to get the real and imaginary parts of the frequency information. CALL ApplyFFT_f ( TmpFFTWaveElev(:), FFT_Data, ErrStatTmp ) ! Note that the TmpFFTWaveElev now contains the real and imaginary bits. - CALL SetErrStat(ErrStatTmp,'Error occured while applying the forwards FFT to TmpFFTWaveElev array.',ErrStat,ErrMsg,RoutineName); if(Failed()) return + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the forwards FFT to TmpFFTWaveElev array.',ErrStat,ErrMsg,RoutineName); if(Failed()) return ! Copy the resulting TmpFFTWaveElev(:) data over to the WaveElevC0 array DO I=1,NStepWave2-1 @@ -1603,7 +1603,7 @@ SUBROUTINE setupWaterKin(WaterKinString, p, Tmax, ErrStat, ErrMsg) WaveElevC0(:,NStepWave2) = 0.0_SiKi CALL ExitFFT(FFT_Data, ErrStatTmp) - CALL SetErrStat(ErrStatTmp,'Error occured while cleaning up after the FFTs.', ErrStat,ErrMsg,RoutineName); if(Failed()) return + CALL SetErrStat(ErrStatTmp,'Error occurred while cleaning up after the FFTs.', ErrStat,ErrMsg,RoutineName); if(Failed()) return IF (ALLOCATED( WaveElev0 )) DEALLOCATE( WaveElev0 , STAT=ErrStatTmp) @@ -1641,7 +1641,7 @@ SUBROUTINE setupWaterKin(WaterKinString, p, Tmax, ErrStat, ErrMsg) ! set up FFTer for doing IFFTs CALL InitFFT ( NStepWave, FFT_Data, .TRUE., ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while initializing the FFT.', ErrStat, ErrMsg, routineName); if(Failed()) return + CALL SetErrStat(ErrStatTmp,'Error occurred while initializing the FFT.', ErrStat, ErrMsg, routineName); if(Failed()) return ! Loop through all points where the incident wave kinematics will be computed do ix = 1,p%nxWave @@ -1683,7 +1683,7 @@ SUBROUTINE setupWaterKin(WaterKinString, p, Tmax, ErrStat, ErrMsg) ! could also reproduce the wave elevation at 0,0,0 on a separate channel for verification... CALL ExitFFT(FFT_Data, ErrStatTmp) - CALL SetErrStat(ErrStatTmp,'Error occured while cleaning up after the IFFTs.', ErrStat,ErrMsg,RoutineName); if(Failed()) return + CALL SetErrStat(ErrStatTmp,'Error occurred while cleaning up after the IFFTs.', ErrStat,ErrMsg,RoutineName); if(Failed()) return end if ! p%WaveKin == 3 diff --git a/modules/moordyn/src/MoorDyn_Registry.txt b/modules/moordyn/src/MoorDyn_Registry.txt index 60a4ad7c8e..38e69d21b3 100644 --- a/modules/moordyn/src/MoorDyn_Registry.txt +++ b/modules/moordyn/src/MoorDyn_Registry.txt @@ -99,7 +99,7 @@ typedef ^ ^ IntKi nAttachedC - typedef ^ ^ IntKi nAttachedR - - - "number of attached rods" typedef ^ ^ DbKi rPointRel {3}{30} - - "relative position of point on body" typedef ^ ^ DbKi r6RodRel {6}{30} - - "relative position and orientation of rod on body" -typedef ^ ^ DbKi bodyM - - - "body mass (seperate from attached objects)" "[kg]" +typedef ^ ^ DbKi bodyM - - - "body mass (separate from attached objects)" "[kg]" typedef ^ ^ DbKi bodyV - - - "body volume (for buoyancy calculation)" "[m^3]" typedef ^ ^ DbKi bodyI {3} - - "body 3x3 inertia matrix diagonals" "[kg-m^2]" typedef ^ ^ DbKi bodyCdA {6} - - "product of drag force and frontal area of body" "[m^2]" diff --git a/modules/moordyn/src/MoorDyn_Types.f90 b/modules/moordyn/src/MoorDyn_Types.f90 index cd85475cf6..bb59e91f41 100644 --- a/modules/moordyn/src/MoorDyn_Types.f90 +++ b/modules/moordyn/src/MoorDyn_Types.f90 @@ -116,7 +116,7 @@ MODULE MoorDyn_Types INTEGER(IntKi) :: nAttachedR = 0_IntKi !< number of attached rods [-] REAL(DbKi) , DIMENSION(1:3,1:30) :: rPointRel = 0.0_R8Ki !< relative position of point on body [-] REAL(DbKi) , DIMENSION(1:6,1:30) :: r6RodRel = 0.0_R8Ki !< relative position and orientation of rod on body [-] - REAL(DbKi) :: bodyM = 0.0_R8Ki !< body mass (seperate from attached objects) [[kg]] + REAL(DbKi) :: bodyM = 0.0_R8Ki !< body mass (separate from attached objects) [[kg]] REAL(DbKi) :: bodyV = 0.0_R8Ki !< body volume (for buoyancy calculation) [[m^3]] REAL(DbKi) , DIMENSION(1:3) :: bodyI = 0.0_R8Ki !< body 3x3 inertia matrix diagonals [[kg-m^2]] REAL(DbKi) , DIMENSION(1:6) :: bodyCdA = 0.0_R8Ki !< product of drag force and frontal area of body [[m^2]] diff --git a/modules/nwtc-library/src/NWTC_IO.f90 b/modules/nwtc-library/src/NWTC_IO.f90 index 241a7bc672..204db312bf 100644 --- a/modules/nwtc-library/src/NWTC_IO.f90 +++ b/modules/nwtc-library/src/NWTC_IO.f90 @@ -7456,7 +7456,7 @@ SUBROUTINE WrMatrix2R8( A, Un, ReFmt, MatName ) END SUBROUTINE WrMatrix2R8 !======================================================================= !> Based on nwtc_io::wrmatrix, this routine writes a matrix to an already-open text file. It allows -!! the user to omit rows and columns of A in the the file. +!! the user to omit rows and columns of A in the file. !! Use WrPartialMatrix (nwtc_io::wrpartialmatrix) instead of directly calling a specific routine in the generic interface. SUBROUTINE WrPartialMatrix1R8( A, Un, ReFmt, MatName, UseCol, UseAllCols, ExtCol ) diff --git a/modules/nwtc-library/src/NWTC_Num.f90 b/modules/nwtc-library/src/NWTC_Num.f90 index 97284cde29..928321affb 100644 --- a/modules/nwtc-library/src/NWTC_Num.f90 +++ b/modules/nwtc-library/src/NWTC_Num.f90 @@ -1490,7 +1490,7 @@ END SUBROUTINE DCM_logMapR !! Use DCM_SetLogMapForInterp (nwtc_num::dcm_setlogmapforinterp) instead of directly calling a specific routine in the generic interface. SUBROUTINE DCM_SetLogMapForInterpD( tensor ) - REAL(DbKi), INTENT(INOUT) :: tensor(:,:) !< a 3xn matrix, whose columns represent individual skew-symmmetric matrices. On exit, + REAL(DbKi), INTENT(INOUT) :: tensor(:,:) !< a 3xn matrix, whose columns represent individual skew-symmetric matrices. On exit, !! each column will be within \f$2\pi\f$ of the previous column, allowing for interpolation !! of the quantities. @@ -2814,7 +2814,7 @@ FUNCTION GetSmllRotAngsR ( DCMat, ErrStat, ErrMsg ) END FUNCTION GetSmllRotAngsR !======================================================================= -!> This funtion returns the non-dimensional (-1:+1) location of the given Gauss-Legendre Quadrature point and its weight. +!> This function returns the non-dimensional (-1:+1) location of the given Gauss-Legendre Quadrature point and its weight. !! It works for NPts \f$\in \left[{1,6\right]\f$. !! The values came from Carnahan, Brice; Luther, H.A.; Wilkes, James O. (1969) "Applied Numerical Methods." SUBROUTINE GL_Pts ( IPt, NPts, Loc, Wt, ErrStat, ErrMsg ) @@ -2937,7 +2937,7 @@ SUBROUTINE GL_Pts ( IPt, NPts, Loc, Wt, ErrStat, ErrMsg ) RETURN END SUBROUTINE GL_Pts ! ( IPt, NPts, Loc, Wt [, ErrStat] ) !======================================================================= -!> This funtion returns an integer index such that CAry(IndexCharAry) = CVal. If +!> This function returns an integer index such that CAry(IndexCharAry) = CVal. If !! no element in the array matches CVal, the value -1 is returned. The routine !! performs a binary search on the input array to determine if CVal is an !! element of the array; thus, CAry must be sorted and stored in increasing @@ -3002,7 +3002,7 @@ FUNCTION IndexCharAry( CVal, CAry ) END FUNCTION IndexCharAry !======================================================================= -!> This funtion returns a y-value that corresponds to an input x-value by interpolating into the arrays. +!> This function returns a y-value that corresponds to an input x-value by interpolating into the arrays. !! It uses a binary interpolation scheme that takes about log(AryLen) / log(2) steps to converge. !! It returns the first or last YAry() value if XVal is outside the limits of XAry(). !! @@ -3131,7 +3131,7 @@ FUNCTION InterpBinReal( XVal, XAry, YAry, ILo, AryLen ) RETURN END FUNCTION InterpBinReal ! ( XVal, XAry, YAry, ILo, AryLen ) !======================================================================= -!> This funtion returns a y-value that corresponds to an input x-value by interpolating into the arrays. +!> This function returns a y-value that corresponds to an input x-value by interpolating into the arrays. !! It uses the passed index as the starting point and does a stepwise interpolation from there. This is !! especially useful when the calling routines save the value from the last time this routine was called !! for a given case where XVal does not change much from call to call. When there is no correlation @@ -3505,7 +3505,7 @@ FUNCTION InterpStpReal8( XVal, XAry, YAry, Ind, AryLen ) END FUNCTION InterpStpReal8 !======================================================================= -!> This funtion returns a y-value array that corresponds to an input x-value by interpolating into the arrays. +!> This function returns a y-value array that corresponds to an input x-value by interpolating into the arrays. !! It uses the passed index as the starting point and does a stepwise interpolation from there. This is !! especially useful when the calling routines save the value from the last time this routine was called !! for a given case where XVal does not change much from call to call. @@ -3568,7 +3568,7 @@ SUBROUTINE InterpStpMat4( XVal, XAry, Y, Ind, AryLen, yInterp ) RETURN END SUBROUTINE InterpStpMat4 !======================================================================= -!> This funtion returns a y-value array that corresponds to an input x-value by interpolating into the arrays. +!> This function returns a y-value array that corresponds to an input x-value by interpolating into the arrays. !! It uses the passed index as the starting point and does a stepwise interpolation from there. This is !! especially useful when the calling routines save the value from the last time this routine was called !! for a given case where XVal does not change much from call to call. @@ -3869,7 +3869,7 @@ SUBROUTINE InterpStpReal3D( InCoord, Dataset, x, y, z, LastIndex, InterpData ) END SUBROUTINE InterpStpReal3D !======================================================================= -!> This funtion returns a y-value that corresponds to an input x-value which is wrapped back +!> This function returns a y-value that corresponds to an input x-value which is wrapped back !! into the range [0-XAry(AryLen)] by interpolating into the arrays. !! It is assumed that XAry is sorted in ascending order. !! It uses the passed index as the starting point and does a stepwise interpolation from there. This is @@ -4674,7 +4674,7 @@ FUNCTION PSF ( Npsf, NumPrimes, subtract ) ELSE - NPr = NPrime(IPR) ! The small prime number we will try to find the the factorization of NTR + NPr = NPrime(IPR) ! The small prime number we will try to find the factorization of NTR DO NT = NTR/NPr ! Doing some modular arithmetic to see if @@ -5420,7 +5420,7 @@ SUBROUTINE RunTimes( StrtTime, UsrTime1, SimStrtTime, UsrTime2, ZTime, UnSum, Us INTEGER , INTENT(IN) :: StrtTime (8) !< Start time of simulation (including initialization) INTEGER , INTENT(IN) :: SimStrtTime (8) !< Start time of simulation (after initialization) REAL(ReKi), INTENT(IN) :: UsrTime1 !< User CPU time for simulation initialization. - REAL(ReKi), INTENT(IN) :: UsrTime2 !< User CPU time for simulation (without intialization) + REAL(ReKi), INTENT(IN) :: UsrTime2 !< User CPU time for simulation (without initialization) REAL(DbKi), INTENT(IN) :: ZTime !< The final simulation time (not necessarially TMax) INTEGER(IntKi), INTENT(IN), OPTIONAL:: UnSum !< optional unit number of file. If present and > 0, REAL(ReKi), INTENT(OUT),OPTIONAL:: UsrTime_out !< User CPU time for entire run - optional value returned to calling routine @@ -5634,7 +5634,7 @@ SUBROUTINE SimStatus_FirstTime( PrevSimTime, PrevClockTime, SimStrtTime, UsrTime REAL(DbKi), INTENT( OUT) :: PrevSimTime !< Previous time message was written to screen (s > 0) REAL(ReKi), INTENT( OUT) :: PrevClockTime !< Previous clock time in seconds past midnight INTEGER, INTENT( OUT) :: SimStrtTime (8) !< An array containing the elements of the start time. - REAL(ReKi), INTENT( OUT) :: UsrTimeSim !< User CPU time for simulation (without intialization) + REAL(ReKi), INTENT( OUT) :: UsrTimeSim !< User CPU time for simulation (without initialization) CHARACTER(*), INTENT(IN), OPTIONAL :: DescStrIn !< optional additional string to print for SimStatus diff --git a/modules/nwtc-library/src/NetLib/scalapack/dlasrt2.f b/modules/nwtc-library/src/NetLib/scalapack/dlasrt2.f index b134da5c36..c063a923b7 100644 --- a/modules/nwtc-library/src/NetLib/scalapack/dlasrt2.f +++ b/modules/nwtc-library/src/NetLib/scalapack/dlasrt2.f @@ -75,7 +75,7 @@ SUBROUTINE DLASRT2( ID, N, D, KEY, INFO ) * .. * .. Executable Statements .. * -* Test the input paramters. +* Test the input parameters. * * INFO = 0 diff --git a/modules/nwtc-library/src/NetLib/scalapack/slasrt2.f b/modules/nwtc-library/src/NetLib/scalapack/slasrt2.f index 7c4b9ce2d2..fa725eb506 100644 --- a/modules/nwtc-library/src/NetLib/scalapack/slasrt2.f +++ b/modules/nwtc-library/src/NetLib/scalapack/slasrt2.f @@ -75,7 +75,7 @@ SUBROUTINE SLASRT2( ID, N, D, KEY, INFO ) * .. * .. Executable Statements .. * -* Test the input paramters. +* Test the input parameters. * * INFO = 0 diff --git a/modules/openfast-library/src/FAST_Registry.txt b/modules/openfast-library/src/FAST_Registry.txt index ddec6be1fb..3c1c797b1f 100644 --- a/modules/openfast-library/src/FAST_Registry.txt +++ b/modules/openfast-library/src/FAST_Registry.txt @@ -810,8 +810,8 @@ typedef ^ FAST_MiscVarType DbKi t_global - - - "Current simulation time (for glo typedef ^ FAST_MiscVarType DbKi NextJacCalcTime - - - "Time between calculating Jacobians in the HD-ED and SD-ED simulations" (s) typedef ^ FAST_MiscVarType ReKi PrevClockTime - - - "Clock time at start of simulation in seconds" (s) typedef ^ FAST_MiscVarType ReKi UsrTime1 - - - "User CPU time for simulation initialization" (s) -typedef ^ FAST_MiscVarType ReKi UsrTime2 - - - "User CPU time for simulation (without intialization)" (s) -typedef ^ FAST_MiscVarType INTEGER StrtTime {8} - - "Start time of simulation (including intialization)" +typedef ^ FAST_MiscVarType ReKi UsrTime2 - - - "User CPU time for simulation (without initialization)" (s) +typedef ^ FAST_MiscVarType INTEGER StrtTime {8} - - "Start time of simulation (including initialization)" typedef ^ FAST_MiscVarType INTEGER SimStrtTime {8} - - "Start time of simulation (after initialization)" #typedef ^ FAST_MiscVarType IntKi n_t_global - - - "simulation time step, loop counter for global (FAST) simulation" (s) typedef ^ FAST_MiscVarType Logical calcJacobian - - - "Should we calculate Jacobians in Option 1?" (flag) diff --git a/modules/openfast-library/src/FAST_Solver.f90 b/modules/openfast-library/src/FAST_Solver.f90 index 618d53ee01..4d0ee9910f 100644 --- a/modules/openfast-library/src/FAST_Solver.f90 +++ b/modules/openfast-library/src/FAST_Solver.f90 @@ -4602,7 +4602,7 @@ SUBROUTINE InitModuleMappings(p_FAST, ED, SED, BD, AD, ADsk, ExtLd, HD, SD, ExtP RETURN END IF - ! Create the the mesh mapping for mapping between ED and ExtLoad blade root meshes + ! Create the mesh mapping for mapping between ED and ExtLoad blade root meshes DO K=1,NumBl CALL MeshMapCreate( ED%y%BladeRootMotion(K), ExtLd%u%BladeRootMotion(K), MeshMapData%ED_P_2_ExtLd_P_R(K), ErrStat2, ErrMsg2 ) CALL SetErrStat( ErrStat2, ErrMsg2, ErrStat, ErrMsg, RoutineName//':ED_P_2_ExtLd_P_R('//TRIM(Num2LStr(K))//')' ) diff --git a/modules/openfast-library/src/FAST_Subs.f90 b/modules/openfast-library/src/FAST_Subs.f90 index c15e2ff892..8e3f970ca2 100644 --- a/modules/openfast-library/src/FAST_Subs.f90 +++ b/modules/openfast-library/src/FAST_Subs.f90 @@ -196,7 +196,7 @@ SUBROUTINE FAST_InitializeAll( t_initial, p_FAST, y_FAST, m_FAST, ED, SED, BD, S END IF ! ... Open and read input files ... - ! also, set applicable farm paramters and turbine reference position also for graphics output + ! also, set applicable farm parameters and turbine reference position also for graphics output if (PRESENT(ExternInitData)) then p_FAST%FarmIntegration = ExternInitData%FarmIntegration p_FAST%TurbinePos = ExternInitData%TurbinePos @@ -2404,7 +2404,7 @@ SUBROUTINE FAST_InitOutput( p_FAST, y_FAST, Init, ErrStat, ErrMsg ) !...................................................... ! Set the number of output columns from each module !...................................................... - y_FAST%numOuts = 0 ! Inintialize entire array + y_FAST%numOuts = 0 ! Initialize entire array IF ( ALLOCATED( Init%OutData_IfW%WriteOutputHdr ) ) y_FAST%numOuts(Module_IfW) = SIZE(Init%OutData_IfW%WriteOutputHdr) IF ( ALLOCATED( Init%OutData_ExtInfw%WriteOutputHdr ) ) y_FAST%numOuts(Module_ExtInfw) = SIZE(Init%OutData_ExtInfw%WriteOutputHdr) diff --git a/modules/openfast-library/src/FAST_Types.f90 b/modules/openfast-library/src/FAST_Types.f90 index 06061ca975..4b37025174 100644 --- a/modules/openfast-library/src/FAST_Types.f90 +++ b/modules/openfast-library/src/FAST_Types.f90 @@ -818,8 +818,8 @@ MODULE FAST_Types REAL(DbKi) :: NextJacCalcTime = 0.0_R8Ki !< Time between calculating Jacobians in the HD-ED and SD-ED simulations [(s)] REAL(ReKi) :: PrevClockTime = 0.0_ReKi !< Clock time at start of simulation in seconds [(s)] REAL(ReKi) :: UsrTime1 = 0.0_ReKi !< User CPU time for simulation initialization [(s)] - REAL(ReKi) :: UsrTime2 = 0.0_ReKi !< User CPU time for simulation (without intialization) [(s)] - INTEGER(IntKi) , DIMENSION(1:8) :: StrtTime = 0_IntKi !< Start time of simulation (including intialization) [-] + REAL(ReKi) :: UsrTime2 = 0.0_ReKi !< User CPU time for simulation (without initialization) [(s)] + INTEGER(IntKi) , DIMENSION(1:8) :: StrtTime = 0_IntKi !< Start time of simulation (including initialization) [-] INTEGER(IntKi) , DIMENSION(1:8) :: SimStrtTime = 0_IntKi !< Start time of simulation (after initialization) [-] LOGICAL :: calcJacobian = .false. !< Should we calculate Jacobians in Option 1? [(flag)] TYPE(FAST_ExternInputType) :: ExternInput !< external input values [-] diff --git a/modules/orcaflex-interface/src/OrcaDriver.f90 b/modules/orcaflex-interface/src/OrcaDriver.f90 index 667e588cd4..5addc01640 100644 --- a/modules/orcaflex-interface/src/OrcaDriver.f90 +++ b/modules/orcaflex-interface/src/OrcaDriver.f90 @@ -355,7 +355,7 @@ PROGRAM OrcaDriver Orca_y, Orca_m, Settings%DT, Orca_InitOut, ErrStat, ErrMsg ) - ! Make sure no errors occured that give us reason to terminate now. + ! Make sure no errors occurred that give us reason to terminate now. IF ( ErrStat >= AbortErrLev ) THEN CALL DriverCleanup() CALL ProgAbort( ErrMsg ) @@ -447,7 +447,7 @@ PROGRAM OrcaDriver - ! Make sure no errors occured that give us reason to terminate now. + ! Make sure no errors occurred that give us reason to terminate now. IF ( ErrStat >= AbortErrLev ) THEN CALL DriverCleanup() CALL ProgAbort( ErrMsg ) @@ -505,7 +505,7 @@ PROGRAM OrcaDriver Orca_y, Orca_m, ErrStat, ErrMsg) - ! Make sure no errors occured that give us reason to terminate now. + ! Make sure no errors occurred that give us reason to terminate now. IF ( ErrStat >= AbortErrLev ) THEN CALL DriverCleanup() CALL ProgAbort( ErrMsg ) @@ -535,7 +535,7 @@ PROGRAM OrcaDriver TimeNow, Orca_InitOut, Orca_p, Orca_u, Orca_y, ErrStat, ErrMsg ) CLOSE(TmpUnit) - ! Make sure no errors occured that give us reason to terminate now. + ! Make sure no errors occurred that give us reason to terminate now. IF ( ErrStat >= AbortErrLev ) THEN CALL DriverCleanup() CALL ProgAbort( ErrMsg ) @@ -583,7 +583,7 @@ PROGRAM OrcaDriver IF ( SettingsFlags%AddedMassFile ) THEN CALL AddedMass_OutputWrite( Settings, SettingsFlags%AddedMassOutputInit, & Orca_m%PtfmAM, ErrStat, ErrMsg ) - ! Make sure no errors occured that give us reason to terminate now. + ! Make sure no errors occurred that give us reason to terminate now. IF ( ErrStat >= AbortErrLev ) THEN CALL DriverCleanup() CALL ProgAbort( ErrMsg ) @@ -611,7 +611,7 @@ PROGRAM OrcaDriver Orca_x, Orca_xd, Orca_z, Orca_OtherState, & Orca_y, Orca_m, ErrStat, ErrMsg ) - ! Make sure no errors occured that give us reason to terminate now. + ! Make sure no errors occurred that give us reason to terminate now. IF ( ErrStat >= AbortErrLev ) THEN CALL DriverCleanup() CALL ProgAbort( ErrMsg ) diff --git a/modules/seastate/src/SeaState_DriverCode.f90 b/modules/seastate/src/SeaState_DriverCode.f90 index 885a1f50e7..53e33165f3 100644 --- a/modules/seastate/src/SeaState_DriverCode.f90 +++ b/modules/seastate/src/SeaState_DriverCode.f90 @@ -89,11 +89,11 @@ program SeaStateDriver character(1024) :: drvrFilename ! Filename and path for the driver input file. This is passed in as a command line argument when running the Driver exe. type(SeaSt_Drvr_InitInput) :: drvrInitInp ! Initialization data for the driver program - integer :: StrtTime (8) ! Start time of simulation (including intialization) + integer :: StrtTime (8) ! Start time of simulation (including initialization) integer :: SimStrtTime (8) ! Start time of simulation (after initialization) real(ReKi) :: PrevClockTime ! Clock time at start of simulation in seconds real(ReKi) :: UsrTime1 ! User CPU time for simulation initialization - real(ReKi) :: UsrTime2 ! User CPU time for simulation (without intialization) + real(ReKi) :: UsrTime2 ! User CPU time for simulation (without initialization) real(DbKi) :: TiLstPrn ! The simulation time of the last print real(DbKi) :: t_global ! Current simulation time (for global/FAST simulation) real(DbKi) :: SttsTime ! Amount of time between screen status messages (sec) diff --git a/modules/seastate/src/UserWaves.f90 b/modules/seastate/src/UserWaves.f90 index 1ff95fef81..454ad5ca7c 100644 --- a/modules/seastate/src/UserWaves.f90 +++ b/modules/seastate/src/UserWaves.f90 @@ -367,7 +367,7 @@ SUBROUTINE UserWaveElevations_Init ( InitInp, InitOut, WaveField, ErrStat, ErrMs ! Initialize the FFT CALL InitFFT ( WaveField%NStepWave, FFT_Data, .FALSE., ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while initializing the FFT.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while initializing the FFT.',ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN CALL CleanUp() RETURN @@ -375,7 +375,7 @@ SUBROUTINE UserWaveElevations_Init ( InitInp, InitOut, WaveField, ErrStat, ErrMs ! Apply the forward FFT to get the real and imaginary parts of the frequency information. CALL ApplyFFT_f ( TmpFFTWaveElev(:), FFT_Data, ErrStatTmp ) ! Note that the TmpFFTWaveElev now contains the real and imaginary bits. - CALL SetErrStat(ErrStatTmp,'Error occured while applying the forwards FFT to TmpFFTWaveElev array.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the forwards FFT to TmpFFTWaveElev array.',ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN CALL CleanUp() RETURN @@ -389,7 +389,7 @@ SUBROUTINE UserWaveElevations_Init ( InitInp, InitOut, WaveField, ErrStat, ErrMs WaveField%WaveElevC0(:,WaveField%NStepWave2) = 0.0_SiKi CALL ExitFFT(FFT_Data, ErrStatTmp) - CALL SetErrStat(ErrStatTmp,'Error occured while cleaning up after the FFTs.', ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while cleaning up after the FFTs.', ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN CALL CleanUp() RETURN diff --git a/modules/seastate/src/Waves.f90 b/modules/seastate/src/Waves.f90 index 405b35e2ab..f4580fa0f7 100644 --- a/modules/seastate/src/Waves.f90 +++ b/modules/seastate/src/Waves.f90 @@ -900,7 +900,7 @@ SUBROUTINE VariousWaves_Init ( InitInp, InitOut, WaveField, ErrStat, ErrMsg ) ! make sure this is called before calling ConstrainedNewWaves CALL InitFFT ( WaveField%NStepWave, FFT_Data, .TRUE., ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while initializing the FFT.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while initializing the FFT.',ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN CALL CleanUp() RETURN @@ -1106,7 +1106,7 @@ SUBROUTINE VariousWaves_Init ( InitInp, InitOut, WaveField, ErrStat, ErrMsg ) END IF CALL ExitFFT(FFT_Data, ErrStatTmp) - CALL SetErrStat(ErrStatTmp,'Error occured while cleaning up after the FFTs.', ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while cleaning up after the FFTs.', ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN CALL CleanUp() RETURN @@ -1319,7 +1319,7 @@ logical function Failed0(TmpName) end function logical function FailedFFT(TmpName) character(*), intent(in) :: TmpName - CALL SetErrStat( ErrStatTmp, 'Error occured while applying the FFT to '//trim(TmpName), ErrStat, ErrMsg, RoutineName ) + CALL SetErrStat( ErrStatTmp, 'Error occurred while applying the FFT to '//trim(TmpName), ErrStat, ErrMsg, RoutineName ) FailedFFT = ErrStat >= AbortErrLev if (FailedFFT) CALL Cleanup() end function @@ -1355,7 +1355,7 @@ SUBROUTINE WaveElevTimeSeriesAtXY(Xcoord,Ycoord, WaveElevAtXY, WaveElevCAtXY, tm ENDDO CALL ApplyFFT_cx ( WaveElevAtXY(0:WaveField%NStepWave-1), tmpComplexArr, FFT_Data, ErrStatLcl2 ) - CALL SetErrStat(ErrStatLcl2,'Error occured while applying the FFT.',ErrStatLcl,ErrMsgLcl,'WaveElevTimeSeriesAtXY') + CALL SetErrStat(ErrStatLcl2,'Error occurred while applying the FFT.',ErrStatLcl,ErrMsgLcl,'WaveElevTimeSeriesAtXY') WaveElevCAtXY( 1,: ) = REAL(tmpComplexArr(:)) WaveElevCAtXY( 2,: ) = AIMAG(tmpComplexArr(:)) @@ -2239,7 +2239,7 @@ SUBROUTINE ConstrainedNewWaves(InitInp, InitOut, WaveField, OmegaArr, WaveS1SddA tmpComplexArr = CMPLX( WaveField%WaveElevC0(1,:) + Crest * tmpArr, & WaveField%WaveElevC0(2,:)) CALL ApplyFFT_cx ( WaveField%WaveElev0 (0:WaveField%NStepWave-1), tmpComplexArr (: ), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT to WaveElev0.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT to WaveElev0.',ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) RETURN ! Find the preceding or following trough, whichever is lower @@ -2254,7 +2254,7 @@ SUBROUTINE ConstrainedNewWaves(InitInp, InitOut, WaveField, OmegaArr, WaveS1SddA tmpComplexArr = CMPLX( WaveField%WaveElevC0(1,:) + (Crest+CrestHeightTol) * tmpArr, & WaveField%WaveElevC0(2,:)) CALL ApplyFFT_cx ( WaveField%WaveElev0 (0:WaveField%NStepWave-1), tmpComplexArr (: ), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT to WaveElev0.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT to WaveElev0.',ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) RETURN diff --git a/modules/seastate/src/Waves2.f90 b/modules/seastate/src/Waves2.f90 index f7edb77883..b8c985dafb 100644 --- a/modules/seastate/src/Waves2.f90 +++ b/modules/seastate/src/Waves2.f90 @@ -395,7 +395,7 @@ SUBROUTINE Waves2_Init( InitInp, InitOut, WaveField, ErrStat, ErrMsg ) !-------------------------------------------------------------------------------- CALL InitFFT ( WaveField%NStepWave, FFT_Data, .FALSE., ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while initializing the FFT.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while initializing the FFT.',ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN CALL CleanUp() RETURN @@ -495,7 +495,7 @@ SUBROUTINE Waves2_Init( InitInp, InitOut, WaveField, ErrStat, ErrMsg ) i = mod(k-1, InitInp%NGrid(1)) + 1 j = (k-1) / InitInp%NGrid(1) + 1 CALL WaveElevTimeSeriesAtXY_Diff(InitInp%WaveKinGridxi(k), InitInp%WaveKinGridyi(k), TmpTimeSeries, ErrStatTmp, ErrMsgTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT to WaveField%WaveElev2.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT to WaveField%WaveElev2.',ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN CALL CleanUp() RETURN @@ -639,21 +639,21 @@ SUBROUTINE Waves2_Init( InitInp, InitOut, WaveField, ErrStat, ErrMsg ) !> ### Apply the inverse FFT to each of the components to get the time domain result ### !> * \f$ V(t) = 2 \operatorname{IFFT}\left[H^-\right] \f$ CALL ApplyFFT_cx( WaveVel2xDiff(:), WaveVel2xCDiff(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on V_x.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on V_x.',ErrStat,ErrMsg,RoutineName) CALL ApplyFFT_cx( WaveVel2yDiff(:), WaveVel2yCDiff(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on V_y.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on V_y.',ErrStat,ErrMsg,RoutineName) CALL ApplyFFT_cx( WaveVel2zDiff(:), WaveVel2zCDiff(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on V_z.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on V_z.',ErrStat,ErrMsg,RoutineName) CALL ApplyFFT_cx( WaveAcc2xDiff(:), WaveAcc2xCDiff(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on Acc_x.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on Acc_x.',ErrStat,ErrMsg,RoutineName) CALL ApplyFFT_cx( WaveAcc2yDiff(:), WaveAcc2yCDiff(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on Acc_y.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on Acc_y.',ErrStat,ErrMsg,RoutineName) CALL ApplyFFT_cx( WaveAcc2zDiff(:), WaveAcc2zCDiff(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on Acc_z.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on Acc_z.',ErrStat,ErrMsg,RoutineName) CALL ApplyFFT_cx( WaveDynP2Diff(:), WaveDynP2CDiff(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on DynP2.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on DynP2.',ErrStat,ErrMsg,RoutineName) @@ -858,7 +858,7 @@ SUBROUTINE Waves2_Init( InitInp, InitOut, WaveField, ErrStat, ErrMsg ) i = mod(k-1, InitInp%NGrid(1)) + 1 j = (k-1) / InitInp%NGrid(1) + 1 CALL WaveElevTimeSeriesAtXY_Sum(InitInp%WaveKinGridxi(k), InitInp%WaveKinGridyi(k), TmpTimeSeries, ErrStatTmp, ErrMsgTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT to WaveField%WaveElev2.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT to WaveField%WaveElev2.',ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN CALL CleanUp() RETURN @@ -1124,38 +1124,38 @@ SUBROUTINE Waves2_Init( InitInp, InitOut, WaveField, ErrStat, ErrMsg ) !> * \f$ V^{(2)+}(t) = \operatorname{IFFT}\left[K^+\right] !! + 2\operatorname{IFFT}\left[H^+\right] \f$ CALL ApplyFFT_cx( WaveVel2xSumT1(:), WaveVel2xCSumT1(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on V_x.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on V_x.',ErrStat,ErrMsg,RoutineName) CALL ApplyFFT_cx( WaveVel2ySumT1(:), WaveVel2yCSumT1(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on V_y.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on V_y.',ErrStat,ErrMsg,RoutineName) CALL ApplyFFT_cx( WaveVel2zSumT1(:), WaveVel2zCSumT1(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on V_z.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on V_z.',ErrStat,ErrMsg,RoutineName) CALL ApplyFFT_cx( WaveAcc2xSumT1(:), WaveAcc2xCSumT1(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on Acc_x.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on Acc_x.',ErrStat,ErrMsg,RoutineName) CALL ApplyFFT_cx( WaveAcc2ySumT1(:), WaveAcc2yCSumT1(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on Acc_y.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on Acc_y.',ErrStat,ErrMsg,RoutineName) CALL ApplyFFT_cx( WaveAcc2zSumT1(:), WaveAcc2zCSumT1(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on Acc_z.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on Acc_z.',ErrStat,ErrMsg,RoutineName) CALL ApplyFFT_cx( WaveDynP2SumT1(:), WaveDynP2CSumT1(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on DynP2.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on DynP2.',ErrStat,ErrMsg,RoutineName) CALL ApplyFFT_cx( WaveVel2xSumT2(:), WaveVel2xCSumT2(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on V_x.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on V_x.',ErrStat,ErrMsg,RoutineName) CALL ApplyFFT_cx( WaveVel2ySumT2(:), WaveVel2yCSumT2(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on V_y.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on V_y.',ErrStat,ErrMsg,RoutineName) CALL ApplyFFT_cx( WaveVel2zSumT2(:), WaveVel2zCSumT2(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on V_z.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on V_z.',ErrStat,ErrMsg,RoutineName) CALL ApplyFFT_cx( WaveAcc2xSumT2(:), WaveAcc2xCSumT2(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on Acc_x.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on Acc_x.',ErrStat,ErrMsg,RoutineName) CALL ApplyFFT_cx( WaveAcc2ySumT2(:), WaveAcc2yCSumT2(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on Acc_y.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on Acc_y.',ErrStat,ErrMsg,RoutineName) CALL ApplyFFT_cx( WaveAcc2zSumT2(:), WaveAcc2zCSumT2(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on Acc_z.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on Acc_z.',ErrStat,ErrMsg,RoutineName) CALL ApplyFFT_cx( WaveDynP2SumT2(:), WaveDynP2CSumT2(:), FFT_Data, ErrStatTmp ) - CALL SetErrStat(ErrStatTmp,'Error occured while applying the FFT on DynP2.',ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while applying the FFT on DynP2.',ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN CALL CleanUp() @@ -1236,7 +1236,7 @@ SUBROUTINE Waves2_Init( InitInp, InitOut, WaveField, ErrStat, ErrMsg ) CALL ExitFFT(FFT_Data, ErrStatTmp) - CALL SetErrStat(ErrStatTmp,'Error occured while cleaning up after the FFTs.', ErrStat,ErrMsg,RoutineName) + CALL SetErrStat(ErrStatTmp,'Error occurred while cleaning up after the FFTs.', ErrStat,ErrMsg,RoutineName) IF ( ErrStat >= AbortErrLev ) THEN CALL CleanUp() RETURN @@ -1376,7 +1376,7 @@ SUBROUTINE WaveElevTimeSeriesAtXY_Diff(Xcoord,Ycoord, WaveElevSeriesAtXY, ErrSta !> ### Apply the inverse FFT to each of the components to get the time domain result ### !> * \f$ \eta(t) = \operatorname{IFFT}\left[2 H^-\right] \f$ CALL ApplyFFT_cx( WaveElevSeriesAtXY(:), TmpFreqSeries(:), FFT_Data, ErrStatLcl2 ) - CALL SetErrStat(ErrStatLcl2,'Error occured while applying the FFT on WaveElevSeriesAtXY.',ErrStatLcl,ErrMsgLcl,'WaveElevSeriesAtXY_Diff') + CALL SetErrStat(ErrStatLcl2,'Error occurred while applying the FFT on WaveElevSeriesAtXY.',ErrStatLcl,ErrMsgLcl,'WaveElevSeriesAtXY_Diff') ! Append first datapoint as the last as aid for repeated wave data WaveElevSeriesAtXY(WaveField%NStepWave) = WaveElevSeriesAtXY(0) @@ -1563,9 +1563,9 @@ SUBROUTINE WaveElevTimeSeriesAtXY_Sum(Xcoord,Ycoord, WaveElevSeriesAtXY, ErrStat !> * \f$ \eta^{(2)+}(t) = \operatorname{IFFT}\left[K^+\right] !! + 2\operatorname{IFFT}\left[H^+\right] \f$ CALL ApplyFFT_cx( WaveElevSeriesAtXY(:), TmpFreqSeries(:), FFT_Data, ErrStatLcl2 ) - CALL SetErrStat(ErrStatLcl2,'Error occured while applying the FFT on WaveElevSeriesAtXY.',ErrStatLcl,ErrMsgLcl,'WaveElevSeriesAtXY_Sum') + CALL SetErrStat(ErrStatLcl2,'Error occurred while applying the FFT on WaveElevSeriesAtXY.',ErrStatLcl,ErrMsgLcl,'WaveElevSeriesAtXY_Sum') CALL ApplyFFT_cx( TmpTimeSeries2(:), TmpFreqSeries2(:), FFT_Data, ErrStatLcl2 ) - CALL SetErrStat(ErrStatLcl2,'Error occured while applying the FFT on WaveElevSeriesAtXY.',ErrStatLcl,ErrMsgLcl,'WaveElevSeriesAtXY_Sum') + CALL SetErrStat(ErrStatLcl2,'Error occurred while applying the FFT on WaveElevSeriesAtXY.',ErrStatLcl,ErrMsgLcl,'WaveElevSeriesAtXY_Sum') ! Add the two terms together DO Ctr=0,WaveField%NStepWave diff --git a/modules/servodyn/src/BladedInterface_EX.f90 b/modules/servodyn/src/BladedInterface_EX.f90 index 45fde31595..b2f08be893 100644 --- a/modules/servodyn/src/BladedInterface_EX.f90 +++ b/modules/servodyn/src/BladedInterface_EX.f90 @@ -642,10 +642,10 @@ subroutine Retrieve_EXavrSWAP_StControls () ! Retrieve StC control channels here do I=1,p%NumStC_Control J=StCCtrl_StartIdx + ((I-1)*StCCtrl_ChanPerSet-1) ! Index into the full avrSWAP (minus 1 so counting is simpler) - dll_data%StCCmdStiff(1:3,I) = dll_data%avrswap(J+ 7:J+ 9) ! StC commmanded stiffness -- StC_Stiff_X, StC_Stiff_Y, StC_Stiff_Z (N/m) - dll_data%StCCmdDamp( 1:3,I) = dll_data%avrswap(J+10:J+12) ! StC commmanded damping -- StC_Damp_X, StC_Damp_Y, StC_Damp_Z (N/(m/s)) - dll_data%StCCmdBrake(1:3,I) = dll_data%avrswap(J+13:J+15) ! StC commmanded brake -- StC_Brake_X, StC_Brake_Y, StC_Brake_Z (N) - dll_data%StCCmdForce(1:3,I) = dll_data%avrswap(J+16:J+18) ! StC commmanded brake -- StC_Force_X, StC_Force_Y, StC_Force_Z (N) + dll_data%StCCmdStiff(1:3,I) = dll_data%avrswap(J+ 7:J+ 9) ! StC commanded stiffness -- StC_Stiff_X, StC_Stiff_Y, StC_Stiff_Z (N/m) + dll_data%StCCmdDamp( 1:3,I) = dll_data%avrswap(J+10:J+12) ! StC commanded damping -- StC_Damp_X, StC_Damp_Y, StC_Damp_Z (N/(m/s)) + dll_data%StCCmdBrake(1:3,I) = dll_data%avrswap(J+13:J+15) ! StC commanded brake -- StC_Brake_X, StC_Brake_Y, StC_Brake_Z (N) + dll_data%StCCmdForce(1:3,I) = dll_data%avrswap(J+16:J+18) ! StC commanded brake -- StC_Force_X, StC_Force_Y, StC_Force_Z (N) enddo end subroutine Retrieve_EXavrSWAP_StControls diff --git a/modules/servodyn/src/ServoDyn.f90 b/modules/servodyn/src/ServoDyn.f90 index c03b489997..a48212bad6 100644 --- a/modules/servodyn/src/ServoDyn.f90 +++ b/modules/servodyn/src/ServoDyn.f90 @@ -1629,7 +1629,7 @@ subroutine StC_CtrlChan_Setup(m,p,CtrlChanInitInfo,UnSum,ErrStat,ErrMsg) ErrMsg = "" ! NOTE: For now we only have the option of the StC requesting the bladed interface - ! at the the ServoDyn level. If we later add a Simulink interface, the logic + ! at the ServoDyn level. If we later add a Simulink interface, the logic ! below for checking if the DLL interface was requested will need updating. ! At that point it might be necessary to set an array for the p%StCCMode so ! it is possible to tell which channel is from Simulink and which is from @@ -2148,7 +2148,7 @@ SUBROUTINE SrvD_CalcOutput( t, u, p, x, xd, z, OtherState, y, m, ErrStat, ErrMsg CHARACTER(*), INTENT( OUT) :: ErrMsg !< Error message if ErrStat /= ErrID_None ! Local variables - REAL(ReKi) :: AllOuts(0:MaxOutPts) ! All the the available output channels + REAL(ReKi) :: AllOuts(0:MaxOutPts) ! All the available output channels INTEGER(IntKi) :: I ! Generic loop index INTEGER(IntKi) :: K ! Blade index INTEGER(IntKi) :: J ! Structural control instance at location @@ -2818,7 +2818,7 @@ subroutine Jac_BStC_dYdu( n, sgn, u_perturb, delta, y_perturb, ErrStat3, ErrMsg3 integer(IntKi) :: i,j,k ! Generic indices type(StC_InputType) :: u_StC ! copy of the StC inputs for StC_CalcOutput call type(StC_OutputType) :: y_StC ! copy of the StC outputs for StC_CalcOutput call - real(ReKi) :: AllOuts(0:MaxOutPts) ! All the the available output channels - perturbed (ReKi since WriteOutput is ReKi) + real(ReKi) :: AllOuts(0:MaxOutPts) ! All the available output channels - perturbed (ReKi since WriteOutput is ReKi) ! Since this is acting on only a single blade within a single StC instance, we can look up exactly which one ! from the Jac_u_indx array. This allows us to simplify the number of calls dramatically k = p%Jac_u_indx(n,4) ! this blade @@ -2862,7 +2862,7 @@ subroutine Jac_NStC_dYdu( n, sgn, u_perturb, delta, y_perturb, ErrStat3, ErrMsg3 integer(IntKi) :: i,j,k ! Generic indices type(StC_InputType) :: u_StC ! copy of the StC inputs for StC_CalcOutput call type(StC_OutputType) :: y_StC ! copy of the StC outputs for StC_CalcOutput call - real(ReKi) :: AllOuts(0:MaxOutPts) ! All the the available output channels - perturbed (ReKi since WriteOutput is ReKi) + real(ReKi) :: AllOuts(0:MaxOutPts) ! All the available output channels - perturbed (ReKi since WriteOutput is ReKi) ! Since this is acting on only a single blade within a single StC instance, we can look up exactly which one ! from the Jac_u_indx array. This allows us to simplify the number of calls dramatically j = p%Jac_u_indx(n,3) ! this instance @@ -2906,7 +2906,7 @@ subroutine Jac_TStC_dYdu( n, sgn, u_perturb, delta, y_perturb, ErrStat3, ErrMsg3 integer(IntKi) :: i,j,k ! Generic indices type(StC_InputType) :: u_StC ! copy of the StC inputs for StC_CalcOutput call type(StC_OutputType) :: y_StC ! copy of the StC outputs for StC_CalcOutput call - real(ReKi) :: AllOuts(0:MaxOutPts) ! All the the available output channels - perturbed (ReKi since WriteOutput is ReKi) + real(ReKi) :: AllOuts(0:MaxOutPts) ! All the available output channels - perturbed (ReKi since WriteOutput is ReKi) ! Since this is acting on only a single blade within a single StC instance, we can look up exactly which one ! from the Jac_u_indx array. This allows us to simplify the number of calls dramatically j = p%Jac_u_indx(n,3) ! this instance @@ -2950,7 +2950,7 @@ subroutine Jac_SStC_dYdu( n, sgn, u_perturb, delta, y_perturb, ErrStat3, ErrMsg3 integer(IntKi) :: i,j,k ! Generic indices type(StC_InputType) :: u_StC ! copy of the StC inputs for StC_CalcOutput call type(StC_OutputType) :: y_StC ! copy of the StC outputs for StC_CalcOutput call - real(ReKi) :: AllOuts(0:MaxOutPts) ! All the the available output channels - perturbed (ReKi since WriteOutput is ReKi) + real(ReKi) :: AllOuts(0:MaxOutPts) ! All the available output channels - perturbed (ReKi since WriteOutput is ReKi) ! Since this is acting on only a single blade within a single StC instance, we can look up exactly which one ! from the Jac_u_indx array. This allows us to simplify the number of calls dramatically j = p%Jac_u_indx(n,3) ! this instance @@ -3732,7 +3732,7 @@ subroutine Jac_BStC_dYdx( n, sgn, x_perturb, delta, y_perturb, ErrStat3, ErrMsg3 character(ErrMsgLen), intent( out) :: ErrMsg3 integer(IntKi) :: i,j,k ! Generic indices type(StC_OutputType) :: y_StC ! copy of the StC outputs for StC_CalcOutput call - real(ReKi) :: AllOuts(0:MaxOutPts) ! All the the available output channels - perturbed (ReKi since WriteOutput is ReKi) + real(ReKi) :: AllOuts(0:MaxOutPts) ! All the available output channels - perturbed (ReKi since WriteOutput is ReKi) ! Since this is acting on only a single blade within a single StC instance, we can look up exactly which one ! from the Jac_x_indx array. This allows us to simplify the number of calls dramatically k = p%Jac_x_indx(n,4) ! this blade @@ -3769,7 +3769,7 @@ subroutine Jac_NStC_dYdx( n, sgn, x_perturb, delta, y_perturb, ErrStat3, ErrMsg3 character(ErrMsgLen), intent( out) :: ErrMsg3 integer(IntKi) :: i,j ! Generic indices type(StC_OutputType) :: y_StC ! copy of the StC outputs for StC_CalcOutput call - real(ReKi) :: AllOuts(0:MaxOutPts) ! All the the available output channels - perturbed (ReKi since WriteOutput is ReKi) + real(ReKi) :: AllOuts(0:MaxOutPts) ! All the available output channels - perturbed (ReKi since WriteOutput is ReKi) ! Since this is acting on only a single blade within a single StC instance, we can look up exactly which one ! from the Jac_x_indx array. This allows us to simplify the number of calls dramatically j = p%Jac_x_indx(n,3) ! this instance @@ -3805,7 +3805,7 @@ subroutine Jac_TStC_dYdx( n, sgn, x_perturb, delta, y_perturb, ErrStat3, ErrMsg3 character(ErrMsgLen), intent( out) :: ErrMsg3 integer(IntKi) :: i,j ! Generic indices type(StC_OutputType) :: y_StC ! copy of the StC outputs for StC_CalcOutput call - real(ReKi) :: AllOuts(0:MaxOutPts) ! All the the available output channels - perturbed (ReKi since WriteOutput is ReKi) + real(ReKi) :: AllOuts(0:MaxOutPts) ! All the available output channels - perturbed (ReKi since WriteOutput is ReKi) ! Since this is acting on only a single blade within a single StC instance, we can look up exactly which one ! from the Jac_x_indx array. This allows us to simplify the number of calls dramatically j = p%Jac_x_indx(n,3) ! this instance @@ -3841,7 +3841,7 @@ subroutine Jac_SStC_dYdx( n, sgn, x_perturb, delta, y_perturb, ErrStat3, ErrMsg3 character(ErrMsgLen), intent( out) :: ErrMsg3 integer(IntKi) :: i,j ! Generic indices type(StC_OutputType) :: y_StC ! copy of the StC outputs for StC_CalcOutput call - real(ReKi) :: AllOuts(0:MaxOutPts) ! All the the available output channels - perturbed (ReKi since WriteOutput is ReKi) + real(ReKi) :: AllOuts(0:MaxOutPts) ! All the available output channels - perturbed (ReKi since WriteOutput is ReKi) ! Since this is acting on only a single blade within a single StC instance, we can look up exactly which one ! from the Jac_x_indx array. This allows us to simplify the number of calls dramatically j = p%Jac_x_indx(n,3) ! this instance diff --git a/modules/servodyn/src/ServoDyn_IO.f90 b/modules/servodyn/src/ServoDyn_IO.f90 index a98b3dc14d..2a618589b4 100644 --- a/modules/servodyn/src/ServoDyn_IO.f90 +++ b/modules/servodyn/src/ServoDyn_IO.f90 @@ -769,7 +769,7 @@ subroutine Set_SrvD_Outs( p, y, m, AllOuts ) type(SrvD_ParameterType), intent(in ) :: p !< Parameters type(SrvD_OutputType), intent(in ) :: y !< Outputs computed at Time type(SrvD_MiscVarType), intent(inout) :: m !< Misc (optimization) variables - real(ReKi), intent(inout) :: AllOuts(0:MaxOutPts) ! All the the available output channels + real(ReKi), intent(inout) :: AllOuts(0:MaxOutPts) ! All the available output channels integer :: K !............................................................................................................................... @@ -803,7 +803,7 @@ subroutine Set_NStC_Outs( p_SrvD, x, m, y, AllOuts ) ! Nacelle type(StC_ContinuousStateType), allocatable,intent(in ) :: x(:) !< Continuous states at t type(StC_MiscVarType), allocatable,intent(in ) :: m(:) !< Misc (optimization) variables type(StC_OutputType), allocatable,intent(in ) :: y(:) !< Outputs computed at Time - real(ReKi), intent(inout) :: AllOuts(0:MaxOutPts) ! All the the available output channels + real(ReKi), intent(inout) :: AllOuts(0:MaxOutPts) ! All the available output channels integer :: i if (allocated(x) .and. allocated(m) .and. allocated(y)) then do i=1,min(p_SrvD%NumNStC,MaxStC) ! in case we have more Nacelle StCs than the outputs are set for @@ -817,7 +817,7 @@ subroutine Set_NStC_Outs_Instance( i, x, m, y, AllOuts ) ! Nacelle single St type(StC_ContinuousStateType), intent(in ) :: x !< Continuous states at t type(StC_MiscVarType), intent(in ) :: m !< Misc (optimization) variables type(StC_OutputType), intent(in ) :: y !< Outputs computed at Time - real(ReKi), intent(inout) :: AllOuts(0:MaxOutPts) ! All the the available output channels + real(ReKi), intent(inout) :: AllOuts(0:MaxOutPts) ! All the available output channels integer :: j j=1 if (i < MaxStC) then @@ -847,7 +847,7 @@ subroutine Set_TStC_Outs( p_SrvD, x, m, y, AllOuts ) ! Tower type(StC_ContinuousStateType), allocatable,intent(in ) :: x(:) !< Continuous states at t type(StC_MiscVarType), allocatable,intent(in ) :: m(:) !< Misc (optimization) variables type(StC_OutputType), allocatable,intent(in ) :: y(:) !< Outputs computed at Time - real(ReKi), intent(inout) :: AllOuts(0:MaxOutPts) ! All the the available output channels + real(ReKi), intent(inout) :: AllOuts(0:MaxOutPts) ! All the available output channels integer :: i if (allocated(x) .and. allocated(m) .and. allocated(y)) then do i=1,min(p_SrvD%NumTStC,MaxStC) ! in case we have more Nacelle StCs than the outputs are set for @@ -861,7 +861,7 @@ subroutine Set_TStC_Outs_Instance( i, x, m, y, AllOuts ) ! Tower single StC type(StC_ContinuousStateType), intent(in ) :: x !< Continuous states at t type(StC_MiscVarType), intent(in ) :: m !< Misc (optimization) variables type(StC_OutputType), intent(in ) :: y !< Outputs computed at Time - real(ReKi), intent(inout) :: AllOuts(0:MaxOutPts) ! All the the available output channels + real(ReKi), intent(inout) :: AllOuts(0:MaxOutPts) ! All the available output channels integer :: j j=1 if (i < MaxStC) then @@ -891,7 +891,7 @@ subroutine Set_BStC_Outs( p_SrvD, x, m, y, AllOuts ) ! Blades type(StC_ContinuousStateType), allocatable,intent(in ) :: x(:) !< Continuous states at t type(StC_MiscVarType), allocatable,intent(in ) :: m(:) !< Misc (optimization) variables type(StC_OutputType), allocatable,intent(in ) :: y(:) !< Outputs computed at Time - real(ReKi), intent(inout) :: AllOuts(0:MaxOutPts) ! All the the available output channels + real(ReKi), intent(inout) :: AllOuts(0:MaxOutPts) ! All the available output channels integer :: i if (allocated(x) .and. allocated(m) .and. allocated(y)) then do i=1,min(p_SrvD%NumBStC,MaxStC) ! in case we have more Blade StCs than the outputs are set for @@ -906,7 +906,7 @@ subroutine Set_BStC_Outs_Instance( i, numBl, x, m, y, AllOuts ) ! Single type(StC_ContinuousStateType), intent(in ) :: x !< Continuous states at t type(StC_MiscVarType), intent(in ) :: m !< Misc (optimization) variables type(StC_OutputType), intent(in ) :: y !< Outputs computed at Time - real(ReKi), intent(inout) :: AllOuts(0:MaxOutPts) ! All the the available output channels + real(ReKi), intent(inout) :: AllOuts(0:MaxOutPts) ! All the available output channels integer :: j if (i < MaxStC) then do j=1,min(NumBl,MaxBlOuts) @@ -937,7 +937,7 @@ subroutine Set_SStC_Outs( p_SrvD, x, m, y, AllOuts ) ! Platform type(StC_ContinuousStateType), allocatable,intent(in ) :: x(:) !< Continuous states at t type(StC_MiscVarType), allocatable,intent(in ) :: m(:) !< Misc (optimization) variables type(StC_OutputType), allocatable,intent(in ) :: y(:) !< Outputs computed at Time - real(ReKi), intent(inout) :: AllOuts(0:MaxOutPts) ! All the the available output channels + real(ReKi), intent(inout) :: AllOuts(0:MaxOutPts) ! All the available output channels integer :: i if (allocated(x) .and. allocated(m) .and. allocated(y)) then do i=1,min(p_SrvD%NumSStC,MaxStC) ! in case we have more Nacelle StCs than the outputs are set for @@ -951,7 +951,7 @@ subroutine Set_SStC_Outs_Instance( i, x, m, y, AllOuts ) ! Platform type(StC_ContinuousStateType), intent(in ) :: x !< Continuous states at t type(StC_MiscVarType), intent(in ) :: m !< Misc (optimization) variables type(StC_OutputType), intent(in ) :: y !< Outputs computed at Time - real(ReKi), intent(inout) :: AllOuts(0:MaxOutPts) ! All the the available output channels + real(ReKi), intent(inout) :: AllOuts(0:MaxOutPts) ! All the available output channels integer :: j j=1 if (i < MaxStC) then diff --git a/modules/subdyn/src/SubDyn_Output.f90 b/modules/subdyn/src/SubDyn_Output.f90 index 76d470711c..37b1bac1b2 100644 --- a/modules/subdyn/src/SubDyn_Output.f90 +++ b/modules/subdyn/src/SubDyn_Output.f90 @@ -54,7 +54,7 @@ MODULE SubDyn_Output SUBROUTINE SDOut_Init( Init, y, p, misc, InitOut, WtrDpth, ErrStat, ErrMsg ) TYPE(SD_InitType), INTENT( INOUT ) :: Init ! data needed to initialize the output module TYPE(SD_OutputType), INTENT( INOUT ) :: y ! SubDyn module's output data - TYPE(SD_ParameterType), target, INTENT( INOUT ) :: p ! SubDyn module paramters + TYPE(SD_ParameterType), target, INTENT( INOUT ) :: p ! SubDyn module parameters TYPE(SD_MiscVarType), INTENT( INOUT ) :: misc ! SubDyn misc/optimization variables TYPE(SD_InitOutputType ), INTENT( INOUT ) :: InitOut ! SubDyn module initialization output data REAL(ReKi), INTENT( IN ) :: WtrDpth ! water depth from initialization routine diff --git a/openfast_io/openfast_io/FAST_reader.py b/openfast_io/openfast_io/FAST_reader.py index fdacc85c61..a8f1441cfd 100644 --- a/openfast_io/openfast_io/FAST_reader.py +++ b/openfast_io/openfast_io/FAST_reader.py @@ -736,7 +736,7 @@ def read_ElastoDynTower(self, tower_file): f.readline() f.readline() - # General Tower Paramters + # General Tower Parameters f.readline() self.fst_vt['ElastoDynTower']['NTwInpSt'] = int(f.readline().split()[0]) self.fst_vt['ElastoDynTower']['TwrFADmp1'] = float_read(f.readline().split()[0]) diff --git a/openfast_io/openfast_io/FAST_writer.py b/openfast_io/openfast_io/FAST_writer.py index c1cd955de7..69510e16c7 100644 --- a/openfast_io/openfast_io/FAST_writer.py +++ b/openfast_io/openfast_io/FAST_writer.py @@ -253,7 +253,7 @@ def execute(self): if 'option_names' in self.fst_vt['MoorDyn'] and 'WATERKIN' in self.fst_vt['MoorDyn']['option_names']: self.write_WaterKin(os.path.join(self.FAST_runDirectory,self.fst_vt['MoorDyn']['WaterKin_file'])) - # # look at if the the self.fst_vt['BeamDyn'] is an array, if so, loop through the array + # # look at if the self.fst_vt['BeamDyn'] is an array, if so, loop through the array # # if its a dictionary, just write the same BeamDyn file if isinstance(self.fst_vt['BeamDyn'], list): diff --git a/openfast_io/openfast_io/turbsim_file.py b/openfast_io/openfast_io/turbsim_file.py index 02b8887cff..3434ac7e51 100644 --- a/openfast_io/openfast_io/turbsim_file.py +++ b/openfast_io/openfast_io/turbsim_file.py @@ -367,7 +367,7 @@ def normalPlane(ts, t=None, it0=None, removeMean=False): def vertProfile(self, y_span='full'): """ Vertical profile of the box INPUTS: - - y_span: if 'full', average the vertical profile accross all y-values + - y_span: if 'full', average the vertical profile across all y-values if 'mid', average the vertical profile at the middle y value """ if y_span=='full': @@ -1053,7 +1053,7 @@ def fitPowerLaw(ts, z_ref=None, y_span='full', U_guess=10, alpha_guess=0.1): Fit power law to vertical profile INPUTS: - z_ref: reference height used to define the "U_ref" - - y_span: if 'full', average the vertical profile accross all y-values + - y_span: if 'full', average the vertical profile across all y-values if 'mid', average the vertical profile at the middle y value """ if z_ref is None: diff --git a/reg_tests/executeUnsteadyAeroRegressionCase.py b/reg_tests/executeUnsteadyAeroRegressionCase.py index 2e441c4abc..53c8bf567e 100644 --- a/reg_tests/executeUnsteadyAeroRegressionCase.py +++ b/reg_tests/executeUnsteadyAeroRegressionCase.py @@ -158,7 +158,7 @@ def Error(msg): sys.exit(0) else: print('---------- UNSTEADY AERODYNAMICS DRIVER TEST: {} --------'.format(caseName)) - print('The following errors occured:') + print('The following errors occurred:') for e in errors: print(e) sys.exit(1) diff --git a/reg_tests/lib/rtestlib.py b/reg_tests/lib/rtestlib.py index e90ca95820..ed952f25ec 100644 --- a/reg_tests/lib/rtestlib.py +++ b/reg_tests/lib/rtestlib.py @@ -64,7 +64,7 @@ def validateExeOrExit(path): def copyTree(src, dst, excludeExt=None, renameDict=None, renameExtDict=None, includeExt=None): """ - Copy a directory to another one, overwritting files if necessary. + Copy a directory to another one, overwriting files if necessary. copy_tree from distutils and copytree from shutil fail on Windows (in particular on git files) INPUTS: - src: source directory diff --git a/share/discon/DISCON.F90 b/share/discon/DISCON.F90 index c37070c7ea..b2f8c728d9 100644 --- a/share/discon/DISCON.F90 +++ b/share/discon/DISCON.F90 @@ -69,7 +69,7 @@ SUBROUTINE DISCON ( avrSWAP, aviFAIL, accINFILE, avcOUTNAME, avcMSG ) BIND (C, N REAL(4), PARAMETER :: OnePlusEps = 1.0 + EPSILON(OnePlusEps) ! The number slighty greater than unity in single precision. REAL(4), PARAMETER :: PC_DT = 0.000125 !JASON:THIS CHANGED FOR ITI BARGE: 0.0001 ! Communication interval for pitch controller, sec. REAL(4), PARAMETER :: PC_KI = 0.008068634 ! Integral gain for pitch controller at rated pitch (zero), (-). -REAL(4), PARAMETER :: PC_KK = 0.1099965 ! Pitch angle where the the derivative of the aerodynamic power w.r.t. pitch has increased by a factor of two relative to the derivative at rated pitch (zero), rad. +REAL(4), PARAMETER :: PC_KK = 0.1099965 ! Pitch angle where the derivative of the aerodynamic power w.r.t. pitch has increased by a factor of two relative to the derivative at rated pitch (zero), rad. REAL(4), PARAMETER :: PC_KP = 0.01882681 ! Proportional gain for pitch controller at rated pitch (zero), sec. REAL(4), PARAMETER :: PC_MaxPit = 1.570796 ! Maximum pitch setting in pitch controller, rad. REAL(4), PARAMETER :: PC_MaxRat = 0.1396263 ! Maximum pitch rate (in absolute value) in pitch controller, rad/s. @@ -316,7 +316,7 @@ SUBROUTINE DISCON ( avrSWAP, aviFAIL, accINFILE, avcOUTNAME, avcMSG ) BIND (C, N ! Main control calculations: -IF ( ( iStatus >= 0 ) .AND. ( aviFAIL >= 0 ) ) THEN ! Only compute control calculations if no error has occured and we are not on the last time step +IF ( ( iStatus >= 0 ) .AND. ( aviFAIL >= 0 ) ) THEN ! Only compute control calculations if no error has occurred and we are not on the last time step