From c1aa5d9f8f435d3b03ea9a4b37373f8d799c197e Mon Sep 17 00:00:00 2001
From: GitHub Action
Date: Tue, 2 Mar 2021 16:02:12 +0000
Subject: [PATCH] Changing version number to 7.1.1
---
Common/doc/docmain.hpp | 4 +-
Common/include/CConfig.hpp | 2 +-
Common/include/adt/CADTBaseClass.hpp | 2 +-
Common/include/adt/CADTComparePointClass.hpp | 2 +-
Common/include/adt/CADTElemClass.hpp | 4 +-
Common/include/adt/CADTNodeClass.hpp | 2 +-
Common/include/adt/CADTPointsOnlyClass.hpp | 2 +-
Common/include/adt/CBBoxTargetClass.hpp | 4 +-
Common/include/basic_types/ad_structure.hpp | 2 +-
.../basic_types/datatype_structure.hpp | 2 +-
Common/include/containers/C2DContainer.hpp | 2 +-
.../containers/CFastFindAndEraseQueue.hpp | 2 +-
Common/include/containers/CVertexMap.hpp | 2 +-
.../containers/container_decorators.hpp | 2 +-
Common/include/fem/fem_cgns_elements.hpp | 4 +-
.../fem/fem_gauss_jacobi_quadrature.hpp | 4 +-
Common/include/fem/fem_geometry_structure.hpp | 24 +-
Common/include/fem/fem_standard_element.hpp | 10 +-
.../fem/geometry_structure_fem_part.hpp | 2 +-
Common/include/geometry/CDummyGeometry.hpp | 2 +-
Common/include/geometry/CGeometry.hpp | 2 +-
.../include/geometry/CMultiGridGeometry.hpp | 2 +-
Common/include/geometry/CMultiGridQueue.hpp | 2 +-
Common/include/geometry/CPhysicalGeometry.hpp | 2 +-
.../include/geometry/dual_grid/CDualGrid.hpp | 2 +-
Common/include/geometry/dual_grid/CEdge.hpp | 2 +-
Common/include/geometry/dual_grid/CPoint.hpp | 2 +-
.../geometry/dual_grid/CTurboVertex.hpp | 2 +-
Common/include/geometry/dual_grid/CVertex.hpp | 2 +-
Common/include/geometry/elements/CElement.hpp | 4 +-
.../geometry/elements/CElementProperty.hpp | 6 +-
.../geometry/elements/CGaussVariable.hpp | 4 +-
.../geometry/meshreader/CBoxMeshReaderFVM.hpp | 2 +-
.../meshreader/CCGNSMeshReaderFVM.hpp | 2 +-
.../geometry/meshreader/CMeshReaderFVM.hpp | 2 +-
.../meshreader/CRectangularMeshReaderFVM.hpp | 2 +-
.../meshreader/CSU2ASCIIMeshReaderFVM.hpp | 2 +-
.../geometry/primal_grid/CHexahedron.hpp | 2 +-
Common/include/geometry/primal_grid/CLine.hpp | 2 +-
.../geometry/primal_grid/CPrimalGrid.hpp | 2 +-
.../primal_grid/CPrimalGridBoundFEM.hpp | 4 +-
.../geometry/primal_grid/CPrimalGridFEM.hpp | 4 +-
.../include/geometry/primal_grid/CPrism.hpp | 2 +-
.../include/geometry/primal_grid/CPyramid.hpp | 2 +-
.../geometry/primal_grid/CQuadrilateral.hpp | 2 +-
.../geometry/primal_grid/CTetrahedron.hpp | 2 +-
.../geometry/primal_grid/CTriangle.hpp | 2 +-
.../geometry/primal_grid/CVertexMPI.hpp | 2 +-
Common/include/graph_coloring_structure.hpp | 4 +-
.../grid_movement/CBSplineBlending.hpp | 2 +-
.../include/grid_movement/CBezierBlending.hpp | 2 +-
.../grid_movement/CFreeFormBlending.hpp | 2 +-
.../include/grid_movement/CFreeFormDefBox.hpp | 2 +-
.../include/grid_movement/CGridMovement.hpp | 2 +-
.../grid_movement/CSurfaceMovement.hpp | 2 +-
.../grid_movement/CVolumetricMovement.hpp | 2 +-
.../interface_interpolation/CInterpolator.hpp | 2 +-
.../CInterpolatorFactory.hpp | 2 +-
.../CIsoparametric.hpp | 2 +-
.../interface_interpolation/CMirror.hpp | 2 +-
.../CNearestNeighbor.hpp | 2 +-
.../CRadialBasisFunction.hpp | 2 +-
.../interface_interpolation/CSlidingMesh.hpp | 2 +-
.../linear_algebra/CMatrixVectorProduct.hpp | 2 +-
.../include/linear_algebra/CPastixWrapper.hpp | 2 +-
.../linear_algebra/CPreconditioner.hpp | 2 +-
Common/include/linear_algebra/CSysMatrix.hpp | 2 +-
Common/include/linear_algebra/CSysMatrix.inl | 2 +-
Common/include/linear_algebra/CSysSolve.hpp | 2 +-
Common/include/linear_algebra/CSysSolve_b.hpp | 2 +-
Common/include/linear_algebra/CSysVector.hpp | 2 +-
.../include/linear_algebra/blas_structure.hpp | 4 +-
.../linear_algebra/vector_expressions.hpp | 2 +-
Common/include/option_structure.hpp | 2 +-
Common/include/option_structure.inl | 2 +-
.../include/parallelization/mpi_structure.cpp | 2 +-
.../include/parallelization/mpi_structure.hpp | 2 +-
.../include/parallelization/omp_structure.hpp | 2 +-
.../parallelization/special_vectorization.hpp | 2 +-
.../include/parallelization/vectorization.hpp | 2 +-
Common/include/toolboxes/C1DInterpolation.hpp | 2 +-
.../include/toolboxes/CLinearPartitioner.hpp | 2 +-
.../toolboxes/CQuasiNewtonInvLeastSquares.hpp | 2 +-
Common/include/toolboxes/CSquareMatrixCM.hpp | 2 +-
Common/include/toolboxes/CSymmetricMatrix.hpp | 2 +-
.../include/toolboxes/MMS/CIncTGVSolution.hpp | 2 +-
.../toolboxes/MMS/CInviscidVortexSolution.hpp | 2 +-
.../toolboxes/MMS/CMMSIncEulerSolution.hpp | 2 +-
.../toolboxes/MMS/CMMSIncNSSolution.hpp | 2 +-
.../MMS/CMMSNSTwoHalfCirclesSolution.hpp | 2 +-
.../MMS/CMMSNSTwoHalfSpheresSolution.hpp | 2 +-
.../toolboxes/MMS/CMMSNSUnitQuadSolution.hpp | 2 +-
.../MMS/CMMSNSUnitQuadSolutionWallBC.hpp | 2 +-
.../toolboxes/MMS/CNSUnitQuadSolution.hpp | 2 +-
.../toolboxes/MMS/CRinglebSolution.hpp | 2 +-
Common/include/toolboxes/MMS/CTGVSolution.hpp | 2 +-
.../toolboxes/MMS/CUserDefinedSolution.hpp | 2 +-
.../toolboxes/MMS/CVerificationSolution.hpp | 2 +-
.../include/toolboxes/allocation_toolbox.hpp | 2 +-
Common/include/toolboxes/geometry_toolbox.hpp | 2 +-
Common/include/toolboxes/graph_toolbox.hpp | 2 +-
Common/include/toolboxes/printing_toolbox.hpp | 2 +-
Common/include/wall_model.hpp | 4 +-
Common/lib/Makefile.am | 2 +-
Common/src/CConfig.cpp | 4 +-
Common/src/adt/CADTBaseClass.cpp | 2 +-
Common/src/adt/CADTElemClass.cpp | 2 +-
Common/src/adt/CADTPointsOnlyClass.cpp | 2 +-
Common/src/basic_types/ad_structure.cpp | 2 +-
Common/src/fem/fem_cgns_elements.cpp | 2 +-
.../src/fem/fem_gauss_jacobi_quadrature.cpp | 2 +-
Common/src/fem/fem_geometry_structure.cpp | 2 +-
Common/src/fem/fem_integration_rules.cpp | 2 +-
Common/src/fem/fem_standard_element.cpp | 2 +-
Common/src/fem/fem_wall_distance.cpp | 2 +-
Common/src/fem/fem_work_estimate_metis.cpp | 2 +-
.../src/fem/geometry_structure_fem_part.cpp | 2 +-
Common/src/geometry/CDummyGeometry.cpp | 2 +-
Common/src/geometry/CGeometry.cpp | 2 +-
Common/src/geometry/CMultiGridGeometry.cpp | 2 +-
Common/src/geometry/CMultiGridQueue.cpp | 2 +-
Common/src/geometry/CPhysicalGeometry.cpp | 2 +-
Common/src/geometry/dual_grid/CDualGrid.cpp | 2 +-
Common/src/geometry/dual_grid/CEdge.cpp | 2 +-
Common/src/geometry/dual_grid/CPoint.cpp | 2 +-
.../src/geometry/dual_grid/CTurboVertex.cpp | 2 +-
Common/src/geometry/dual_grid/CVertex.cpp | 2 +-
Common/src/geometry/elements/CElement.cpp | 2 +-
Common/src/geometry/elements/CHEXA8.cpp | 2 +-
Common/src/geometry/elements/CPRISM6.cpp | 2 +-
Common/src/geometry/elements/CPYRAM5.cpp | 2 +-
Common/src/geometry/elements/CQUAD4.cpp | 2 +-
Common/src/geometry/elements/CTETRA1.cpp | 2 +-
Common/src/geometry/elements/CTRIA1.cpp | 2 +-
.../geometry/meshreader/CBoxMeshReaderFVM.cpp | 2 +-
.../meshreader/CCGNSMeshReaderFVM.cpp | 2 +-
.../geometry/meshreader/CMeshReaderFVM.cpp | 2 +-
.../meshreader/CRectangularMeshReaderFVM.cpp | 2 +-
.../meshreader/CSU2ASCIIMeshReaderFVM.cpp | 2 +-
.../src/geometry/primal_grid/CHexahedron.cpp | 2 +-
Common/src/geometry/primal_grid/CLine.cpp | 2 +-
.../src/geometry/primal_grid/CPrimalGrid.cpp | 2 +-
.../primal_grid/CPrimalGridBoundFEM.cpp | 2 +-
.../geometry/primal_grid/CPrimalGridFEM.cpp | 2 +-
Common/src/geometry/primal_grid/CPrism.cpp | 2 +-
Common/src/geometry/primal_grid/CPyramid.cpp | 2 +-
.../geometry/primal_grid/CQuadrilateral.cpp | 2 +-
.../src/geometry/primal_grid/CTetrahedron.cpp | 2 +-
Common/src/geometry/primal_grid/CTriangle.cpp | 2 +-
.../src/geometry/primal_grid/CVertexMPI.cpp | 2 +-
Common/src/graph_coloring_structure.cpp | 2 +-
Common/src/grid_movement/CBSplineBlending.cpp | 2 +-
Common/src/grid_movement/CBezierBlending.cpp | 2 +-
.../src/grid_movement/CFreeFormBlending.cpp | 2 +-
Common/src/grid_movement/CFreeFormDefBox.cpp | 2 +-
Common/src/grid_movement/CGridMovement.cpp | 2 +-
Common/src/grid_movement/CSurfaceMovement.cpp | 2 +-
.../src/grid_movement/CVolumetricMovement.cpp | 2 +-
.../interface_interpolation/CInterpolator.cpp | 2 +-
.../CInterpolatorFactory.cpp | 2 +-
.../CIsoparametric.cpp | 2 +-
.../src/interface_interpolation/CMirror.cpp | 2 +-
.../CNearestNeighbor.cpp | 2 +-
.../CRadialBasisFunction.cpp | 2 +-
.../interface_interpolation/CSlidingMesh.cpp | 2 +-
Common/src/linear_algebra/CPastixWrapper.cpp | 2 +-
Common/src/linear_algebra/CSysMatrix.cpp | 2 +-
Common/src/linear_algebra/CSysSolve.cpp | 2 +-
Common/src/linear_algebra/CSysSolve_b.cpp | 2 +-
Common/src/linear_algebra/CSysVector.cpp | 2 +-
Common/src/toolboxes/C1DInterpolation.cpp | 2 +-
Common/src/toolboxes/CLinearPartitioner.cpp | 2 +-
Common/src/toolboxes/CSquareMatrixCM.cpp | 2 +-
Common/src/toolboxes/CSymmetricMatrix.cpp | 2 +-
Common/src/toolboxes/MMS/CIncTGVSolution.cpp | 2 +-
.../toolboxes/MMS/CInviscidVortexSolution.cpp | 2 +-
.../toolboxes/MMS/CMMSIncEulerSolution.cpp | 2 +-
.../src/toolboxes/MMS/CMMSIncNSSolution.cpp | 2 +-
.../MMS/CMMSNSTwoHalfCirclesSolution.cpp | 2 +-
.../MMS/CMMSNSTwoHalfSpheresSolution.cpp | 2 +-
.../toolboxes/MMS/CMMSNSUnitQuadSolution.cpp | 2 +-
.../MMS/CMMSNSUnitQuadSolutionWallBC.cpp | 2 +-
.../src/toolboxes/MMS/CNSUnitQuadSolution.cpp | 2 +-
Common/src/toolboxes/MMS/CRinglebSolution.cpp | 2 +-
Common/src/toolboxes/MMS/CTGVSolution.cpp | 2 +-
.../toolboxes/MMS/CUserDefinedSolution.cpp | 2 +-
.../toolboxes/MMS/CVerificationSolution.cpp | 2 +-
.../CMMSIncEulerSolution.py | 2 +-
.../CreateMMSSourceTerms/CMMSIncNSSolution.py | 2 +-
Common/src/toolboxes/printing_toolbox.cpp | 2 +-
Common/src/wall_model.cpp | 2 +-
Makefile.am | 2 +-
QuickStart/inv_NACA0012.cfg | 2 +-
README.md | 2 +-
SU2_CFD/include/CMarkerProfileReaderFVM.hpp | 2 +-
SU2_CFD/include/SU2_CFD.hpp | 2 +-
SU2_CFD/include/definition_structure.hpp | 2 +-
.../drivers/CDiscAdjMultizoneDriver.hpp | 2 +-
.../drivers/CDiscAdjSinglezoneDriver.hpp | 4 +-
SU2_CFD/include/drivers/CDriver.hpp | 2 +-
SU2_CFD/include/drivers/CDummyDriver.hpp | 2 +-
SU2_CFD/include/drivers/CMultizoneDriver.hpp | 4 +-
SU2_CFD/include/drivers/CSinglezoneDriver.hpp | 4 +-
SU2_CFD/include/fluid/CConductivityModel.hpp | 2 +-
.../include/fluid/CConstantConductivity.hpp | 2 +-
.../fluid/CConstantConductivityRANS.hpp | 2 +-
SU2_CFD/include/fluid/CConstantDensity.hpp | 2 +-
SU2_CFD/include/fluid/CConstantPrandtl.hpp | 2 +-
.../include/fluid/CConstantPrandtlRANS.hpp | 2 +-
SU2_CFD/include/fluid/CConstantViscosity.hpp | 2 +-
SU2_CFD/include/fluid/CFluidModel.hpp | 2 +-
SU2_CFD/include/fluid/CIdealGas.hpp | 2 +-
SU2_CFD/include/fluid/CIncIdealGas.hpp | 2 +-
.../include/fluid/CIncIdealGasPolynomial.hpp | 2 +-
SU2_CFD/include/fluid/CMutationTCLib.hpp | 2 +-
SU2_CFD/include/fluid/CNEMOGas.hpp | 2 +-
SU2_CFD/include/fluid/CPengRobinson.hpp | 2 +-
.../include/fluid/CPolynomialConductivity.hpp | 2 +-
.../fluid/CPolynomialConductivityRANS.hpp | 2 +-
.../include/fluid/CPolynomialViscosity.hpp | 2 +-
SU2_CFD/include/fluid/CSU2TCLib.hpp | 2 +-
SU2_CFD/include/fluid/CSutherland.hpp | 2 +-
SU2_CFD/include/fluid/CVanDerWaalsGas.hpp | 2 +-
SU2_CFD/include/fluid/CViscosityModel.hpp | 2 +-
.../gradients/computeGradientsGreenGauss.hpp | 2 +-
.../computeGradientsLeastSquares.hpp | 2 +-
.../integration/CFEM_DG_Integration.hpp | 4 +-
SU2_CFD/include/integration/CIntegration.hpp | 2 +-
.../integration/CMultiGridIntegration.hpp | 2 +-
.../integration/CNewtonIntegration.hpp | 2 +-
.../integration/CSingleGridIntegration.hpp | 2 +-
.../integration/CStructuralIntegration.hpp | 2 +-
SU2_CFD/include/interfaces/CInterface.hpp | 4 +-
.../cfd/CConservativeVarsInterface.hpp | 2 +-
.../interfaces/cfd/CMixingPlaneInterface.hpp | 2 +-
.../interfaces/cfd/CSlidingInterface.hpp | 2 +-
.../cht/CConjugateHeatInterface.hpp | 2 +-
.../fsi/CDiscAdjFlowTractionInterface.hpp | 2 +-
.../fsi/CDisplacementsInterface.hpp | 2 +-
.../interfaces/fsi/CFlowTractionInterface.hpp | 2 +-
.../include/iteration/CAdjFluidIteration.hpp | 2 +-
.../iteration/CDiscAdjFEAIteration.hpp | 2 +-
.../iteration/CDiscAdjFluidIteration.hpp | 2 +-
.../iteration/CDiscAdjHeatIteration.hpp | 2 +-
SU2_CFD/include/iteration/CFEAIteration.hpp | 4 +-
.../include/iteration/CFEMFluidIteration.hpp | 4 +-
SU2_CFD/include/iteration/CFluidIteration.hpp | 2 +-
SU2_CFD/include/iteration/CHeatIteration.hpp | 2 +-
SU2_CFD/include/iteration/CIteration.hpp | 2 +-
.../include/iteration/CIterationFactory.hpp | 2 +-
SU2_CFD/include/iteration/CTurboIteration.hpp | 2 +-
SU2_CFD/include/limiters/CLimiterDetails.hpp | 2 +-
SU2_CFD/include/limiters/computeLimiters.hpp | 2 +-
.../include/limiters/computeLimiters_impl.hpp | 2 +-
SU2_CFD/include/numerics/CNumerics.hpp | 2 +-
.../include/numerics/NEMO/CNEMONumerics.hpp | 2 +-
.../include/numerics/NEMO/NEMO_diffusion.hpp | 6 +-
.../include/numerics/NEMO/NEMO_sources.hpp | 4 +-
.../include/numerics/NEMO/convection/ausm.hpp | 2 +-
.../numerics/NEMO/convection/ausmplusup2.hpp | 2 +-
.../numerics/NEMO/convection/ausmpwplus.hpp | 2 +-
.../include/numerics/NEMO/convection/lax.hpp | 2 +-
.../include/numerics/NEMO/convection/msw.hpp | 4 +-
.../include/numerics/NEMO/convection/roe.hpp | 4 +-
.../continuous_adjoint/adj_convection.hpp | 2 +-
.../continuous_adjoint/adj_diffusion.hpp | 2 +-
.../continuous_adjoint/adj_sources.hpp | 2 +-
.../numerics/elasticity/CFEAElasticity.hpp | 4 +-
.../elasticity/CFEALinearElasticity.hpp | 6 +-
.../elasticity/CFEANonlinearElasticity.hpp | 4 +-
.../numerics/elasticity/nonlinear_models.hpp | 10 +-
.../numerics/flow/convection/ausm_slau.hpp | 2 +-
.../numerics/flow/convection/centered.hpp | 2 +-
.../include/numerics/flow/convection/cusp.hpp | 2 +-
.../include/numerics/flow/convection/fds.hpp | 2 +-
.../include/numerics/flow/convection/fvs.hpp | 2 +-
.../include/numerics/flow/convection/hllc.hpp | 6 +-
.../include/numerics/flow/convection/roe.hpp | 6 +-
.../include/numerics/flow/flow_diffusion.hpp | 2 +-
.../include/numerics/flow/flow_sources.hpp | 6 +-
SU2_CFD/include/numerics/heat.hpp | 10 +-
SU2_CFD/include/numerics/radiation.hpp | 2 +-
SU2_CFD/include/numerics/template.hpp | 2 +-
SU2_CFD/include/numerics/transition.hpp | 2 +-
.../numerics/turbulent/turb_convection.hpp | 2 +-
.../numerics/turbulent/turb_diffusion.hpp | 2 +-
.../numerics/turbulent/turb_sources.hpp | 8 +-
.../include/numerics_simd/CNumericsSIMD.cpp | 2 +-
.../include/numerics_simd/CNumericsSIMD.hpp | 2 +-
.../flow/convection/centered.hpp | 2 +-
.../numerics_simd/flow/convection/common.hpp | 2 +-
.../numerics_simd/flow/convection/roe.hpp | 2 +-
.../numerics_simd/flow/diffusion/common.hpp | 2 +-
.../flow/diffusion/viscous_fluxes.hpp | 2 +-
.../include/numerics_simd/flow/variables.hpp | 2 +-
SU2_CFD/include/numerics_simd/util.hpp | 2 +-
.../include/output/CAdjElasticityOutput.hpp | 2 +-
SU2_CFD/include/output/CAdjFlowIncOutput.hpp | 2 +-
SU2_CFD/include/output/CAdjFlowOutput.hpp | 2 +-
SU2_CFD/include/output/CAdjHeatOutput.hpp | 2 +-
SU2_CFD/include/output/CBaselineOutput.hpp | 2 +-
SU2_CFD/include/output/CElasticityOutput.hpp | 2 +-
SU2_CFD/include/output/CFlowCompFEMOutput.hpp | 2 +-
SU2_CFD/include/output/CFlowCompOutput.hpp | 2 +-
SU2_CFD/include/output/CFlowIncOutput.hpp | 2 +-
SU2_CFD/include/output/CFlowOutput.hpp | 2 +-
SU2_CFD/include/output/CHeatOutput.hpp | 2 +-
SU2_CFD/include/output/CMeshOutput.hpp | 2 +-
SU2_CFD/include/output/CMultizoneOutput.hpp | 2 +-
SU2_CFD/include/output/CNEMOCompOutput.hpp | 2 +-
SU2_CFD/include/output/COutput.hpp | 2 +-
SU2_CFD/include/output/COutputFactory.hpp | 2 +-
SU2_CFD/include/output/COutputLegacy.hpp | 2 +-
.../output/filewriter/CCSVFileWriter.hpp | 2 +-
.../output/filewriter/CFEMDataSorter.hpp | 2 +-
.../output/filewriter/CFVMDataSorter.hpp | 2 +-
.../include/output/filewriter/CFileWriter.hpp | 2 +-
.../output/filewriter/CParallelDataSorter.hpp | 2 +-
.../filewriter/CParaviewBinaryFileWriter.hpp | 2 +-
.../output/filewriter/CParaviewFileWriter.hpp | 2 +-
.../filewriter/CParaviewVTMFileWriter.hpp | 2 +-
.../filewriter/CParaviewXMLFileWriter.hpp | 2 +-
.../output/filewriter/CSTLFileWriter.hpp | 4 +-
.../filewriter/CSU2BinaryFileWriter.hpp | 2 +-
.../output/filewriter/CSU2FileWriter.hpp | 2 +-
.../output/filewriter/CSU2MeshFileWriter.hpp | 2 +-
.../filewriter/CSurfaceFEMDataSorter.hpp | 2 +-
.../filewriter/CSurfaceFVMDataSorter.hpp | 2 +-
.../filewriter/CTecplotBinaryFileWriter.hpp | 2 +-
.../output/filewriter/CTecplotFileWriter.hpp | 2 +-
.../include/output/tools/CWindowingTools.hpp | 2 +-
SU2_CFD/include/sgs_model.hpp | 10 +-
SU2_CFD/include/sgs_model.inl | 2 +-
SU2_CFD/include/solvers/CAdjEulerSolver.hpp | 2 +-
SU2_CFD/include/solvers/CAdjNSSolver.hpp | 2 +-
SU2_CFD/include/solvers/CAdjTurbSolver.hpp | 2 +-
SU2_CFD/include/solvers/CBaselineSolver.hpp | 2 +-
.../include/solvers/CBaselineSolver_FEM.hpp | 4 +-
SU2_CFD/include/solvers/CDiscAdjFEASolver.hpp | 2 +-
.../include/solvers/CDiscAdjMeshSolver.hpp | 2 +-
SU2_CFD/include/solvers/CDiscAdjSolver.hpp | 2 +-
SU2_CFD/include/solvers/CEulerSolver.hpp | 2 +-
SU2_CFD/include/solvers/CFEASolver.hpp | 2 +-
.../include/solvers/CFEM_DG_EulerSolver.hpp | 4 +-
SU2_CFD/include/solvers/CFEM_DG_NSSolver.hpp | 4 +-
.../include/solvers/CFVMFlowSolverBase.hpp | 2 +-
.../include/solvers/CFVMFlowSolverBase.inl | 2 +-
SU2_CFD/include/solvers/CHeatSolver.hpp | 4 +-
SU2_CFD/include/solvers/CIncEulerSolver.hpp | 2 +-
SU2_CFD/include/solvers/CIncNSSolver.hpp | 2 +-
SU2_CFD/include/solvers/CMeshSolver.hpp | 2 +-
SU2_CFD/include/solvers/CNEMOEulerSolver.hpp | 4 +-
SU2_CFD/include/solvers/CNEMONSSolver.hpp | 2 +-
SU2_CFD/include/solvers/CNSSolver.hpp | 2 +-
SU2_CFD/include/solvers/CRadP1Solver.hpp | 2 +-
SU2_CFD/include/solvers/CRadSolver.hpp | 2 +-
SU2_CFD/include/solvers/CSolver.hpp | 2 +-
SU2_CFD/include/solvers/CTemplateSolver.hpp | 2 +-
SU2_CFD/include/solvers/CTransLMSolver.hpp | 2 +-
SU2_CFD/include/solvers/CTurbSASolver.hpp | 2 +-
SU2_CFD/include/solvers/CTurbSSTSolver.hpp | 2 +-
SU2_CFD/include/solvers/CTurbSolver.hpp | 2 +-
SU2_CFD/include/task_definition.hpp | 4 +-
SU2_CFD/include/task_definition.inl | 2 +-
.../include/variables/CAdjEulerVariable.hpp | 2 +-
SU2_CFD/include/variables/CAdjNSVariable.hpp | 2 +-
.../include/variables/CAdjTurbVariable.hpp | 2 +-
.../include/variables/CBaselineVariable.hpp | 2 +-
.../variables/CDiscAdjFEABoundVariable.hpp | 4 +-
.../include/variables/CDiscAdjFEAVariable.hpp | 4 +-
.../variables/CDiscAdjMeshBoundVariable.hpp | 2 +-
.../include/variables/CDiscAdjVariable.hpp | 2 +-
SU2_CFD/include/variables/CEulerVariable.hpp | 2 +-
.../include/variables/CFEABoundVariable.hpp | 4 +-
SU2_CFD/include/variables/CFEAVariable.hpp | 4 +-
SU2_CFD/include/variables/CHeatVariable.hpp | 4 +-
.../include/variables/CIncEulerVariable.hpp | 2 +-
SU2_CFD/include/variables/CIncNSVariable.hpp | 2 +-
.../include/variables/CMeshBoundVariable.hpp | 2 +-
SU2_CFD/include/variables/CMeshElement.hpp | 2 +-
SU2_CFD/include/variables/CMeshVariable.hpp | 2 +-
.../include/variables/CNEMOEulerVariable.hpp | 1176 ++++++++---------
SU2_CFD/include/variables/CNEMONSVariable.hpp | 334 ++---
SU2_CFD/include/variables/CNSVariable.hpp | 2 +-
SU2_CFD/include/variables/CRadP1Variable.hpp | 2 +-
SU2_CFD/include/variables/CRadVariable.hpp | 2 +-
.../include/variables/CTransLMVariable.hpp | 2 +-
SU2_CFD/include/variables/CTurbSAVariable.hpp | 2 +-
.../include/variables/CTurbSSTVariable.hpp | 2 +-
SU2_CFD/include/variables/CTurbVariable.hpp | 2 +-
SU2_CFD/include/variables/CVariable.hpp | 2 +-
SU2_CFD/obj/Makefile.am | 2 +-
SU2_CFD/src/CMarkerProfileReaderFVM.cpp | 2 +-
SU2_CFD/src/SU2_CFD.cpp | 4 +-
SU2_CFD/src/definition_structure.cpp | 2 +-
.../src/drivers/CDiscAdjMultizoneDriver.cpp | 2 +-
.../src/drivers/CDiscAdjSinglezoneDriver.cpp | 2 +-
SU2_CFD/src/drivers/CDriver.cpp | 2 +-
SU2_CFD/src/drivers/CDummyDriver.cpp | 2 +-
SU2_CFD/src/drivers/CMultizoneDriver.cpp | 2 +-
SU2_CFD/src/drivers/CSinglezoneDriver.cpp | 2 +-
SU2_CFD/src/fluid/CFluidModel.cpp | 2 +-
SU2_CFD/src/fluid/CIdealGas.cpp | 2 +-
SU2_CFD/src/fluid/CMutationTCLib.cpp | 2 +-
SU2_CFD/src/fluid/CNEMOGas.cpp | 2 +-
SU2_CFD/src/fluid/CPengRobinson.cpp | 2 +-
SU2_CFD/src/fluid/CSU2TCLib.cpp | 2 +-
SU2_CFD/src/fluid/CVanDerWaalsGas.cpp | 2 +-
.../src/integration/CFEM_DG_Integration.cpp | 2 +-
SU2_CFD/src/integration/CIntegration.cpp | 2 +-
.../src/integration/CIntegrationFactory.cpp | 2 +-
.../src/integration/CMultiGridIntegration.cpp | 2 +-
.../src/integration/CNewtonIntegration.cpp | 2 +-
.../integration/CSingleGridIntegration.cpp | 2 +-
.../integration/CStructuralIntegration.cpp | 2 +-
SU2_CFD/src/interfaces/CInterface.cpp | 2 +-
.../cfd/CConservativeVarsInterface.cpp | 2 +-
.../interfaces/cfd/CMixingPlaneInterface.cpp | 2 +-
.../src/interfaces/cfd/CSlidingInterface.cpp | 2 +-
.../cht/CConjugateHeatInterface.cpp | 2 +-
.../fsi/CDiscAdjFlowTractionInterface.cpp | 2 +-
.../fsi/CDisplacementsInterface.cpp | 2 +-
.../interfaces/fsi/CFlowTractionInterface.cpp | 2 +-
SU2_CFD/src/iteration/CAdjFluidIteration.cpp | 2 +-
.../src/iteration/CDiscAdjFEAIteration.cpp | 2 +-
.../src/iteration/CDiscAdjFluidIteration.cpp | 2 +-
.../src/iteration/CDiscAdjHeatIteration.cpp | 2 +-
SU2_CFD/src/iteration/CFEAIteration.cpp | 2 +-
SU2_CFD/src/iteration/CFEMFluidIteration.cpp | 2 +-
SU2_CFD/src/iteration/CFluidIteration.cpp | 2 +-
SU2_CFD/src/iteration/CHeatIteration.cpp | 2 +-
SU2_CFD/src/iteration/CIteration.cpp | 2 +-
SU2_CFD/src/iteration/CIterationFactory.cpp | 2 +-
SU2_CFD/src/iteration/CTurboIteration.cpp | 2 +-
SU2_CFD/src/limiters/CLimiterDetails.cpp | 2 +-
SU2_CFD/src/numerics/CNumerics.cpp | 2 +-
SU2_CFD/src/numerics/NEMO/CNEMONumerics.cpp | 2 +-
SU2_CFD/src/numerics/NEMO/NEMO_diffusion.cpp | 2 +-
SU2_CFD/src/numerics/NEMO/NEMO_sources.cpp | 2 +-
SU2_CFD/src/numerics/NEMO/convection/ausm.cpp | 2 +-
.../numerics/NEMO/convection/ausmplusup2.cpp | 2 +-
.../numerics/NEMO/convection/ausmpwplus.cpp | 2 +-
SU2_CFD/src/numerics/NEMO/convection/lax.cpp | 2 +-
SU2_CFD/src/numerics/NEMO/convection/msw.cpp | 2 +-
SU2_CFD/src/numerics/NEMO/convection/roe.cpp | 2 +-
.../continuous_adjoint/adj_convection.cpp | 2 +-
.../continuous_adjoint/adj_diffusion.cpp | 2 +-
.../continuous_adjoint/adj_sources.cpp | 2 +-
.../numerics/elasticity/CFEAElasticity.cpp | 2 +-
.../elasticity/CFEALinearElasticity.cpp | 2 +-
.../elasticity/CFEANonlinearElasticity.cpp | 2 +-
.../numerics/elasticity/nonlinear_models.cpp | 2 +-
.../numerics/flow/convection/ausm_slau.cpp | 2 +-
.../src/numerics/flow/convection/centered.cpp | 2 +-
SU2_CFD/src/numerics/flow/convection/cusp.cpp | 2 +-
SU2_CFD/src/numerics/flow/convection/fds.cpp | 2 +-
SU2_CFD/src/numerics/flow/convection/fvs.cpp | 2 +-
SU2_CFD/src/numerics/flow/convection/hllc.cpp | 2 +-
SU2_CFD/src/numerics/flow/convection/roe.cpp | 2 +-
SU2_CFD/src/numerics/flow/flow_diffusion.cpp | 2 +-
SU2_CFD/src/numerics/flow/flow_sources.cpp | 2 +-
SU2_CFD/src/numerics/heat.cpp | 2 +-
SU2_CFD/src/numerics/radiation.cpp | 2 +-
SU2_CFD/src/numerics/template.cpp | 2 +-
SU2_CFD/src/numerics/transition.cpp | 2 +-
.../numerics/turbulent/turb_convection.cpp | 2 +-
.../src/numerics/turbulent/turb_diffusion.cpp | 2 +-
.../src/numerics/turbulent/turb_sources.cpp | 2 +-
SU2_CFD/src/output/CAdjElasticityOutput.cpp | 2 +-
SU2_CFD/src/output/CAdjFlowCompOutput.cpp | 2 +-
SU2_CFD/src/output/CAdjFlowIncOutput.cpp | 2 +-
SU2_CFD/src/output/CAdjHeatOutput.cpp | 2 +-
SU2_CFD/src/output/CBaselineOutput.cpp | 2 +-
SU2_CFD/src/output/CElasticityOutput.cpp | 2 +-
SU2_CFD/src/output/CFlowCompFEMOutput.cpp | 2 +-
SU2_CFD/src/output/CFlowCompOutput.cpp | 2 +-
SU2_CFD/src/output/CFlowIncOutput.cpp | 2 +-
SU2_CFD/src/output/CFlowOutput.cpp | 4 +-
SU2_CFD/src/output/CHeatOutput.cpp | 2 +-
SU2_CFD/src/output/CMeshOutput.cpp | 2 +-
SU2_CFD/src/output/CMultizoneOutput.cpp | 2 +-
SU2_CFD/src/output/COutput.cpp | 2 +-
SU2_CFD/src/output/COutputFactory.cpp | 2 +-
.../src/output/filewriter/CCSVFileWriter.cpp | 2 +-
.../src/output/filewriter/CFEMDataSorter.cpp | 2 +-
.../src/output/filewriter/CFVMDataSorter.cpp | 2 +-
.../output/filewriter/CParallelDataSorter.cpp | 2 +-
.../output/filewriter/CParallelFileWriter.cpp | 2 +-
.../filewriter/CParaviewBinaryFileWriter.cpp | 2 +-
.../output/filewriter/CParaviewFileWriter.cpp | 2 +-
.../filewriter/CParaviewVTMFileWriter.cpp | 2 +-
.../filewriter/CParaviewXMLFileWriter.cpp | 2 +-
.../src/output/filewriter/CSTLFileWriter.cpp | 2 +-
.../filewriter/CSU2BinaryFileWriter.cpp | 2 +-
.../src/output/filewriter/CSU2FileWriter.cpp | 2 +-
.../output/filewriter/CSU2MeshFileWriter.cpp | 2 +-
.../filewriter/CSurfaceFEMDataSorter.cpp | 2 +-
.../filewriter/CSurfaceFVMDataSorter.cpp | 2 +-
.../filewriter/CTecplotBinaryFileWriter.cpp | 2 +-
.../output/filewriter/CTecplotFileWriter.cpp | 2 +-
SU2_CFD/src/output/output_physics.cpp | 2 +-
.../src/output/output_structure_legacy.cpp | 2 +-
SU2_CFD/src/output/tools/CWindowingTools.cpp | 2 +-
SU2_CFD/src/python_wrapper_structure.cpp | 2 +-
SU2_CFD/src/solvers/CAdjEulerSolver.cpp | 2 +-
SU2_CFD/src/solvers/CAdjNSSolver.cpp | 2 +-
SU2_CFD/src/solvers/CAdjTurbSolver.cpp | 2 +-
SU2_CFD/src/solvers/CBaselineSolver.cpp | 2 +-
SU2_CFD/src/solvers/CBaselineSolver_FEM.cpp | 2 +-
SU2_CFD/src/solvers/CDiscAdjFEASolver.cpp | 2 +-
SU2_CFD/src/solvers/CDiscAdjMeshSolver.cpp | 2 +-
SU2_CFD/src/solvers/CDiscAdjSolver.cpp | 2 +-
SU2_CFD/src/solvers/CEulerSolver.cpp | 2 +-
SU2_CFD/src/solvers/CFEASolver.cpp | 2 +-
SU2_CFD/src/solvers/CFEM_DG_EulerSolver.cpp | 2 +-
SU2_CFD/src/solvers/CFEM_DG_NSSolver.cpp | 2 +-
SU2_CFD/src/solvers/CHeatSolver.cpp | 2 +-
SU2_CFD/src/solvers/CIncEulerSolver.cpp | 2 +-
SU2_CFD/src/solvers/CIncNSSolver.cpp | 2 +-
SU2_CFD/src/solvers/CMeshSolver.cpp | 2 +-
SU2_CFD/src/solvers/CNEMOEulerSolver.cpp | 2 +-
SU2_CFD/src/solvers/CNEMONSSolver.cpp | 2 +-
SU2_CFD/src/solvers/CNSSolver.cpp | 2 +-
SU2_CFD/src/solvers/CRadP1Solver.cpp | 2 +-
SU2_CFD/src/solvers/CRadSolver.cpp | 2 +-
SU2_CFD/src/solvers/CSolver.cpp | 2 +-
SU2_CFD/src/solvers/CSolverFactory.cpp | 2 +-
SU2_CFD/src/solvers/CTemplateSolver.cpp | 2 +-
SU2_CFD/src/solvers/CTransLMSolver.cpp | 2 +-
SU2_CFD/src/solvers/CTurbSASolver.cpp | 2 +-
SU2_CFD/src/solvers/CTurbSSTSolver.cpp | 2 +-
SU2_CFD/src/solvers/CTurbSolver.cpp | 2 +-
SU2_CFD/src/variables/CAdjEulerVariable.cpp | 2 +-
SU2_CFD/src/variables/CAdjNSVariable.cpp | 2 +-
SU2_CFD/src/variables/CAdjTurbVariable.cpp | 2 +-
SU2_CFD/src/variables/CBaselineVariable.cpp | 2 +-
.../variables/CDiscAdjFEABoundVariable.cpp | 2 +-
SU2_CFD/src/variables/CDiscAdjFEAVariable.cpp | 2 +-
.../variables/CDiscAdjMeshBoundVariable.cpp | 2 +-
SU2_CFD/src/variables/CDiscAdjVariable.cpp | 2 +-
SU2_CFD/src/variables/CEulerVariable.cpp | 2 +-
SU2_CFD/src/variables/CFEABoundVariable.cpp | 2 +-
SU2_CFD/src/variables/CFEAVariable.cpp | 2 +-
SU2_CFD/src/variables/CHeatVariable.cpp | 2 +-
SU2_CFD/src/variables/CIncEulerVariable.cpp | 2 +-
SU2_CFD/src/variables/CIncNSVariable.cpp | 2 +-
SU2_CFD/src/variables/CMeshBoundVariable.cpp | 2 +-
SU2_CFD/src/variables/CMeshElement.cpp | 2 +-
SU2_CFD/src/variables/CMeshVariable.cpp | 2 +-
SU2_CFD/src/variables/CNEMOEulerVariable.cpp | 702 +++++-----
SU2_CFD/src/variables/CNEMONSVariable.cpp | 284 ++--
SU2_CFD/src/variables/CNSVariable.cpp | 2 +-
SU2_CFD/src/variables/CRadP1Variable.cpp | 2 +-
SU2_CFD/src/variables/CRadVariable.cpp | 2 +-
SU2_CFD/src/variables/CTransLMVariable.cpp | 2 +-
SU2_CFD/src/variables/CTurbSAVariable.cpp | 2 +-
SU2_CFD/src/variables/CTurbSSTVariable.cpp | 2 +-
SU2_CFD/src/variables/CTurbVariable.cpp | 2 +-
SU2_CFD/src/variables/CVariable.cpp | 2 +-
SU2_DEF/include/SU2_DEF.hpp | 2 +-
SU2_DEF/obj/Makefile.am | 2 +-
SU2_DEF/src/SU2_DEF.cpp | 2 +-
SU2_DOT/include/SU2_DOT.hpp | 2 +-
SU2_DOT/obj/Makefile.am | 2 +-
SU2_DOT/src/SU2_DOT.cpp | 2 +-
SU2_GEO/include/SU2_GEO.hpp | 2 +-
SU2_GEO/obj/Makefile.am | 2 +-
SU2_GEO/src/SU2_GEO.cpp | 2 +-
SU2_PY/FSI_tools/FSIInterface.py | 2 +-
SU2_PY/FSI_tools/FSI_config.py | 2 +-
SU2_PY/Makefile.am | 2 +-
SU2_PY/OptimalPropeller.py | 2 +-
SU2_PY/SU2/eval/design.py | 2 +-
SU2_PY/SU2/eval/functions.py | 2 +-
SU2_PY/SU2/eval/gradients.py | 2 +-
SU2_PY/SU2/io/config.py | 2 +-
SU2_PY/SU2/io/config_options.py | 2 +-
SU2_PY/SU2/io/data.py | 2 +-
SU2_PY/SU2/io/filelock.py | 2 +-
SU2_PY/SU2/io/redirect.py | 2 +-
SU2_PY/SU2/io/state.py | 2 +-
SU2_PY/SU2/io/tools.py | 2 +-
SU2_PY/SU2/opt/project.py | 2 +-
SU2_PY/SU2/opt/scipy_tools.py | 2 +-
SU2_PY/SU2/run/adjoint.py | 2 +-
SU2_PY/SU2/run/deform.py | 2 +-
SU2_PY/SU2/run/direct.py | 2 +-
SU2_PY/SU2/run/geometry.py | 2 +-
SU2_PY/SU2/run/interface.py | 2 +-
SU2_PY/SU2/run/merge.py | 2 +-
SU2_PY/SU2/run/projection.py | 2 +-
SU2_PY/SU2/util/filter_adjoint.py | 2 +-
SU2_PY/SU2/util/plot.py | 2 +-
SU2_PY/SU2/util/polarSweepLib.py | 2 +-
SU2_PY/SU2/util/which.py | 2 +-
SU2_PY/SU2_CFD.py | 2 +-
SU2_PY/SU2_Nastran/pysu2_nastran.py | 2 +-
SU2_PY/change_version_number.py | 6 +-
SU2_PY/compute_multipoint.py | 2 +-
SU2_PY/compute_polar.py | 2 +-
SU2_PY/compute_stability.py | 2 +-
SU2_PY/compute_uncertainty.py | 2 +-
SU2_PY/config_gui.py | 2 +-
SU2_PY/continuous_adjoint.py | 2 +-
SU2_PY/direct_differentiation.py | 2 +-
SU2_PY/discrete_adjoint.py | 2 +-
SU2_PY/finite_differences.py | 2 +-
SU2_PY/fsi_computation.py | 2 +-
SU2_PY/merge_solution.py | 2 +-
SU2_PY/mesh_deformation.py | 2 +-
SU2_PY/package_tests.py | 2 +-
SU2_PY/parallel_computation.py | 2 +-
SU2_PY/parallel_computation_fsi.py | 2 +-
SU2_PY/parse_config.py | 2 +-
SU2_PY/profiling.py | 2 +-
SU2_PY/pySU2/Makefile.am | 2 +-
SU2_PY/pySU2/pySU2.i | 2 +-
SU2_PY/set_ffd_design_var.py | 2 +-
SU2_PY/shape_optimization.py | 4 +-
SU2_PY/topology_optimization.py | 2 +-
SU2_SOL/include/SU2_SOL.hpp | 2 +-
SU2_SOL/obj/Makefile.am | 2 +-
SU2_SOL/src/SU2_SOL.cpp | 2 +-
TestCases/TestCase.py | 2 +-
.../aeroelastic/aeroelastic_NACA64A010.cfg | 2 +-
.../cont_adj_euler/naca0012/inv_NACA0012.cfg | 2 +-
.../naca0012/inv_NACA0012_FD.cfg | 2 +-
.../naca0012/inv_NACA0012_discadj.cfg | 2 +-
.../cont_adj_euler/oneram6/inv_ONERAM6.cfg | 2 +-
.../cont_adj_euler/wedge/inv_wedge_ROE.cfg | 2 +-
.../wedge/inv_wedge_ROE_multiobj.cfg | 2 +-
.../cylinder/lam_cylinder.cfg | 2 +-
.../naca0012_sub/lam_NACA0012.cfg | 2 +-
.../naca0012_trans/lam_NACA0012.cfg | 2 +-
.../cont_adj_rans/naca0012/turb_nasa.cfg | 2 +-
.../naca0012/turb_nasa_binary.cfg | 2 +-
.../cont_adj_rans/oneram6/turb_ONERAM6.cfg | 2 +-
.../cont_adj_rans/rae2822/turb_SA_RAE2822.cfg | 2 +-
.../control_surface/inv_ONERAM6_moving.cfg | 2 +-
.../control_surface/inv_ONERAM6_setting.cfg | 2 +-
TestCases/ddes/flatplate/ddes_flatplate.cfg | 2 +-
.../cylindrical_ffd/def_cylindrical.cfg | 2 +-
.../deformation/naca0012/def_NACA0012.cfg | 2 +-
.../naca0012/surface_file_NACA0012.cfg | 2 +-
.../deformation/naca4412/def_NACA4412.cfg | 2 +-
TestCases/deformation/rae2822/def_RAE2822.cfg | 2 +-
.../spherical_ffd/def_spherical.cfg | 2 +-
.../spherical_ffd/def_spherical_bspline.cfg | 2 +-
.../cylinder3D/inv_cylinder3D.cfg | 2 +-
.../disc_adj_euler/oneram6/inv_ONERAM6.cfg | 2 +-
TestCases/disc_adj_fea/configAD_fem.cfg | 2 +-
TestCases/disc_adj_fsi/configFEA.cfg | 2 +-
TestCases/disc_adj_fsi/configFlow.cfg | 2 +-
TestCases/disc_adj_heat/disc_adj_heat.cfg | 2 +-
.../naca0012/incomp_NACA0012_disc.cfg | 2 +-
.../cylinder/heated_cylinder.cfg | 2 +-
.../naca0012/turb_naca0012_sa.cfg | 2 +-
.../naca0012/turb_naca0012_sst.cfg | 2 +-
TestCases/disc_adj_rans/naca0012/naca0012.cfg | 2 +-
TestCases/euler/CRM/inv_CRM_JST.cfg | 2 +-
TestCases/euler/biparabolic/BIPARABOLIC.cfg | 2 +-
TestCases/euler/channel/inv_channel.cfg | 2 +-
TestCases/euler/channel/inv_channel_RK.cfg | 2 +-
TestCases/euler/naca0012/inv_NACA0012.cfg | 2 +-
TestCases/euler/naca0012/inv_NACA0012_Roe.cfg | 2 +-
TestCases/euler/oneram6/inv_ONERAM6.cfg | 2 +-
TestCases/euler/wedge/inv_wedge_HLLC.cfg | 2 +-
TestCases/fea_fsi/Airfoil_RBF/configFEA.cfg | 2 +-
TestCases/fea_fsi/Airfoil_RBF/configFlow.cfg | 2 +-
.../fea_fsi/DynBeam_2d/configBeam_2d.cfg | 2 +-
TestCases/fea_fsi/MixElemsKnowles/config.cfg | 2 +-
.../fea_fsi/StatBeam_3d/configBeam_3d.cfg | 2 +-
TestCases/fea_topology/config.cfg | 2 +-
TestCases/gust/inv_gust_NACA0012.cfg | 2 +-
TestCases/harmonic_balance/HB.cfg | 2 +-
.../hb_rans_preconditioning/davis.cfg | 2 +-
.../fem_NACA0012.cfg | 2 +-
.../NACA0012_5thOrder/fem_NACA0012.cfg | 2 +-
.../NACA0012_5thOrder/fem_NACA0012_reg.cfg | 2 +-
.../Sphere_4thOrder_Hexa/fem_Sphere.cfg | 2 +-
.../Sphere_4thOrder_Tet/fem_Sphere.cfg | 2 +-
.../nPoly1/fem_SubsonicChannel.cfg | 2 +-
.../nPoly1/fem_SubsonicChannel_Farfield.cfg | 2 +-
.../nPoly2/fem_SubsonicChannel.cfg | 2 +-
.../nPoly2/fem_SubsonicChannel_Farfield.cfg | 2 +-
.../nPoly4/fem_SubsonicChannel.cfg | 2 +-
.../nPoly4/fem_SubsonicChannel_Farfield.cfg | 2 +-
.../nPoly3/fem_Cylinder_reg.cfg | 2 +-
.../FlatPlate/nPoly4/lam_flatplate_reg.cfg | 2 +-
.../nPoly3_QuadDominant/fem_Sphere_reg.cfg | 2 +-
.../fem_Sphere_reg_ADER.cfg | 2 +-
.../nPoly4/fem_unst_cylinder.cfg | 2 +-
.../nPoly4/fem_unst_cylinder_ADER.cfg | 2 +-
TestCases/hybrid_regression.py | 2 +-
.../incomp_euler/naca0012/incomp_NACA0012.cfg | 2 +-
TestCases/incomp_euler/nozzle/inv_nozzle.cfg | 2 +-
.../buoyancy_cavity/lam_buoyancy_cavity.cfg | 2 +-
.../cylinder/incomp_cylinder.cfg | 2 +-
.../cylinder/poly_cylinder.cfg | 2 +-
.../chtPinArray_2d/DA_configMaster.cfg | 2 +-
.../chtPinArray_2d/FD_configMaster.cfg | 2 +-
.../chtPinArray_2d/configMaster.cfg | 2 +-
.../chtPinArray_2d/configSolid.cfg | 2 +-
.../chtPinArray_3d/configFluid.cfg | 2 +-
.../chtPinArray_3d/configMaster.cfg | 2 +-
.../chtPinArray_3d/configSolid.cfg | 2 +-
.../pipeSlice_3d/sp_pipeSlice_3d_dp_hf_tp.cfg | 2 +-
TestCases/incomp_rans/naca0012/naca0012.cfg | 2 +-
.../naca0012/naca0012_SST_SUST.cfg | 2 +-
.../mms/fvm_incomp_euler/inv_mms_jst.cfg | 2 +-
.../fvm_incomp_navierstokes/lam_mms_fds.cfg | 2 +-
.../mms/fvm_navierstokes/lam_mms_roe.cfg | 2 +-
TestCases/moving_wall/cavity/lam_cavity.cfg | 2 +-
.../spinning_cylinder/spinning_cylinder.cfg | 2 +-
.../naca0012/inv_NACA0012_ffd.cfg | 2 +-
.../cylinder/cylinder_lowmach.cfg | 2 +-
.../navierstokes/cylinder/lam_cylinder.cfg | 2 +-
.../navierstokes/flatplate/lam_flatplate.cfg | 2 +-
.../navierstokes/naca0012/lam_NACA0012.cfg | 2 +-
.../poiseuille/lam_poiseuille.cfg | 2 +-
TestCases/nicf/edge/edge_PPR.cfg | 2 +-
TestCases/nicf/edge/edge_VW.cfg | 2 +-
.../nonequilibrium/invwedge/invwedge.cfg | 2 +-
.../nonequilibrium/viscwedge/viscwedge.cfg | 2 +-
.../viscwedge_mpp/viscwedge_mpp.cfg | 2 +-
.../inv_wedge_ROE_2surf_1obj.cfg | 2 +-
.../inv_wedge_ROE_multiobj.cfg | 2 +-
.../inv_wedge_ROE_multiobj_1surf.cfg | 2 +-
.../inv_wedge_ROE_multiobj_combo.cfg | 2 +-
.../inv_NACA0012_multipoint.cfg | 2 +-
.../pitching_NACA64A010.cfg | 2 +-
.../pitching_oneram6/pitching_ONERAM6.cfg | 2 +-
.../rotating_naca0012/rotating_NACA0012.cfg | 2 +-
.../steady_naca0012/inv_NACA0012_adv.cfg | 2 +-
.../steady_naca0012/inv_NACA0012_basic.cfg | 2 +-
.../steady_oneram6/inv_ONERAM6_adv.cfg | 2 +-
.../steady_oneram6/inv_ONERAM6_basic.cfg | 2 +-
.../optimization_rans/naca0012/naca0012.cfg | 2 +-
.../pitching_naca64a010/turb_NACA64A010.cfg | 2 +-
.../pitching_oneram6/turb_ONERAM6.cfg | 2 +-
.../steady_oneram6/turb_ONERAM6.cfg | 2 +-
.../steady_rae2822/turb_SA_RAE2822.cfg | 2 +-
TestCases/parallel_regression.py | 2 +-
TestCases/parallel_regression_AD.py | 2 +-
TestCases/pastix_support/config.cfg | 2 +-
TestCases/pastix_support/readme.txt | 2 +-
TestCases/polar/naca0012/inv_NACA0012.cfg | 2 +-
.../flow_load_sens/run_adjoint.py | 2 +-
.../mesh_disp_sens/run_adjoint.py | 2 +-
.../flatPlate_rigidMotion_Conf.cfg | 2 +-
.../launch_flatPlate_rigidMotion.py | 2 +-
.../launch_unsteady_CHT_FlatPlate.py | 2 +-
.../unsteady_CHT_FlatPlate_Conf.cfg | 2 +-
.../radiation/p1adjoint/configp1adjoint.cfg | 2 +-
TestCases/radiation/p1model/configp1.cfg | 2 +-
.../propeller_variable_load.cfg | 474 +++----
.../rans/flatplate/turb_SA_flatplate.cfg | 2 +-
.../rans/flatplate/turb_SST_flatplate.cfg | 2 +-
.../turb_NACA0012_sst_multigrid_restart.cfg | 2 +-
TestCases/rans/oneram6/turb_ONERAM6.cfg | 2 +-
TestCases/rans/oneram6/turb_ONERAM6_nk.cfg | 2 +-
TestCases/rans/propeller/propeller.cfg | 2 +-
TestCases/rans/rae2822/turb_SA_RAE2822.cfg | 2 +-
TestCases/rans/rae2822/turb_SST_RAE2822.cfg | 2 +-
.../rans/rae2822/turb_SST_SUST_RAE2822.cfg | 2 +-
.../rans/restart_directdiff_naca/naca0012.cfg | 2 +-
TestCases/rans/s809/trans_s809.cfg | 2 +-
TestCases/rans/s809/turb_S809.cfg | 2 +-
TestCases/rans/vki_turbine/turb_vki.cfg | 2 +-
.../caradonna_tung/rot_caradonna_tung.cfg | 2 +-
TestCases/rotating/naca0012/rot_NACA0012.cfg | 2 +-
TestCases/serial_regression.py | 2 +-
TestCases/serial_regression_AD.py | 2 +-
.../sliding_interface/bars_SST_2D/bars.cfg | 2 +-
.../sliding_interface/bars_SST_2D/zone_1.cfg | 2 +-
.../sliding_interface/bars_SST_2D/zone_2.cfg | 2 +-
.../sliding_interface/bars_SST_2D/zone_3.cfg | 2 +-
.../sliding_interface/channel_2D/zone_2.cfg | 2 +-
.../sliding_interface/channel_2D/zone_3.cfg | 2 +-
.../transitional_BC_model_ConfigFile.cfg | 2 +-
.../transitional_BC_model_ConfigFile.cfg | 2 +-
.../transitional_BC_model_ConfigFile.cfg | 2 +-
TestCases/tutorials.py | 2 +-
.../pitching_NACA64A010.cfg | 2 +-
.../turb_NACA64A010.cfg | 2 +-
.../plunging_naca0012/plunging_NACA0012.cfg | 2 +-
.../unsteady/square_cylinder/turb_square.cfg | 2 +-
UnitTests/Common/geometry/CGeometry_test.cpp | 2 +-
.../geometry/dual_grid/CDualGrid_tests.cpp | 2 +-
.../primal_grid/CPrimalGrid_tests.cpp | 2 +-
UnitTests/Common/simple_ad_test.cpp | 2 +-
UnitTests/Common/simple_directdiff_test.cpp | 2 +-
.../CQuasiNewtonInvLeastSquares_tests.cpp | 2 +-
UnitTests/Common/vectorization.cpp | 2 +-
UnitTests/SU2_CFD/gradients.cpp | 2 +-
.../SU2_CFD/numerics/CNumerics_tests.cpp | 2 +-
UnitTests/UnitQuadTestCase.hpp | 2 +-
config_template.cfg | 2 +-
configure.ac | 2 +-
externals/Makefile.am | 2 +-
meson.build | 4 +-
meson.py | 2 +-
meson_scripts/init.py | 2 +-
preconfigure.py | 2 +-
804 files changed, 2369 insertions(+), 2369 deletions(-)
diff --git a/Common/doc/docmain.hpp b/Common/doc/docmain.hpp
index 4a915ae58e0..885bafeba5b 100644
--- a/Common/doc/docmain.hpp
+++ b/Common/doc/docmain.hpp
@@ -2,7 +2,7 @@
* \file docmain.hpp
* \brief This file contains documentation for Doxygen and does not have any significance with respect to C++.
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* The current SU2 release has been coordinated by the
* SU2 International Developers Society
@@ -33,7 +33,7 @@
*/
/*!
- * \mainpage SU2 version 7.1.0 "Blackbird"
+ * \mainpage SU2 version 7.1.1 "Blackbird"
* SU2 suite is an open-source collection of C++ based software tools
* to perform PDE analysis and PDE constrained optimization problems. The toolset is designed with
* computational fluid dynamics and aerodynamic shape optimization in mind, but is extensible to
diff --git a/Common/include/CConfig.hpp b/Common/include/CConfig.hpp
index b5a5556bf41..d46efb24547 100644
--- a/Common/include/CConfig.hpp
+++ b/Common/include/CConfig.hpp
@@ -3,7 +3,7 @@
* \brief All the information about the definition of the physical problem.
* The subroutines and functions are in the CConfig.cpp file.
* \author F. Palacios, T. Economon, B. Tracey
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/adt/CADTBaseClass.hpp b/Common/include/adt/CADTBaseClass.hpp
index d2f88d38c9e..9cf77835492 100644
--- a/Common/include/adt/CADTBaseClass.hpp
+++ b/Common/include/adt/CADTBaseClass.hpp
@@ -2,7 +2,7 @@
* \file CADTBaseClass.hpp
* \brief Base class for storing an ADT in an arbitrary number of dimensions.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/adt/CADTComparePointClass.hpp b/Common/include/adt/CADTComparePointClass.hpp
index a8b8572eef3..2b7663e2086 100644
--- a/Common/include/adt/CADTComparePointClass.hpp
+++ b/Common/include/adt/CADTComparePointClass.hpp
@@ -2,7 +2,7 @@
* \file CADTComparePointClass.hpp
* \brief subroutines for comparing two points in an alternating digital tree (ADT).
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/adt/CADTElemClass.hpp b/Common/include/adt/CADTElemClass.hpp
index 1cdfce581fe..07a61555c9c 100644
--- a/Common/include/adt/CADTElemClass.hpp
+++ b/Common/include/adt/CADTElemClass.hpp
@@ -2,7 +2,7 @@
* \file CADTElemClass.hpp
* \brief Class for storing an ADT of (linear) elements in an arbitrary number of dimensions.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -35,7 +35,7 @@
* \class CADTElemClass
* \brief Class for storing an ADT of (linear) elements in an arbitrary number of dimensions.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CADTElemClass : public CADTBaseClass {
private:
diff --git a/Common/include/adt/CADTNodeClass.hpp b/Common/include/adt/CADTNodeClass.hpp
index 1bb848ae247..f572cb36fc9 100644
--- a/Common/include/adt/CADTNodeClass.hpp
+++ b/Common/include/adt/CADTNodeClass.hpp
@@ -2,7 +2,7 @@
* \file CADTNodeClass.hpp
* \brief Class for storing the information needed in a node of an ADT.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/adt/CADTPointsOnlyClass.hpp b/Common/include/adt/CADTPointsOnlyClass.hpp
index f3131588a94..5370054f512 100644
--- a/Common/include/adt/CADTPointsOnlyClass.hpp
+++ b/Common/include/adt/CADTPointsOnlyClass.hpp
@@ -2,7 +2,7 @@
* \file CADTPointsOnlyClass.hpp
* \brief Class for storing an ADT of only points in an arbitrary number of dimensions.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/adt/CBBoxTargetClass.hpp b/Common/include/adt/CBBoxTargetClass.hpp
index 0bd62b861d7..4c6be23da99 100644
--- a/Common/include/adt/CBBoxTargetClass.hpp
+++ b/Common/include/adt/CBBoxTargetClass.hpp
@@ -3,7 +3,7 @@
* \brief Class for storing the information of a possible bounding box candidate
during a minimum distance search.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -34,7 +34,7 @@
* \brief Class for storing the information of a possible bounding box candidate
during a minimum distance search.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
struct CBBoxTargetClass {
diff --git a/Common/include/basic_types/ad_structure.hpp b/Common/include/basic_types/ad_structure.hpp
index 6353ec3046c..6875896bad4 100644
--- a/Common/include/basic_types/ad_structure.hpp
+++ b/Common/include/basic_types/ad_structure.hpp
@@ -2,7 +2,7 @@
* \file ad_structure.hpp
* \brief Main routines for the algorithmic differentiation (AD) structure.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/basic_types/datatype_structure.hpp b/Common/include/basic_types/datatype_structure.hpp
index 58bc9920c3b..f806c5f6cc4 100644
--- a/Common/include/basic_types/datatype_structure.hpp
+++ b/Common/include/basic_types/datatype_structure.hpp
@@ -2,7 +2,7 @@
* \file datatype_structure.hpp
* \brief Headers for generalized datatypes, defines an interface for AD types.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/containers/C2DContainer.hpp b/Common/include/containers/C2DContainer.hpp
index bd7efbf75cc..4ef2bf1b4ae 100644
--- a/Common/include/containers/C2DContainer.hpp
+++ b/Common/include/containers/C2DContainer.hpp
@@ -2,7 +2,7 @@
* \file C2DContainer.hpp
* \brief A templated vector/matrix object.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/containers/CFastFindAndEraseQueue.hpp b/Common/include/containers/CFastFindAndEraseQueue.hpp
index 90965f39ecb..d6ffc0db6ef 100644
--- a/Common/include/containers/CFastFindAndEraseQueue.hpp
+++ b/Common/include/containers/CFastFindAndEraseQueue.hpp
@@ -3,7 +3,7 @@
* \brief A queue-type container (push back, pop front), but with
* fast deletion of arbitrary items (possibly in the middle).
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/containers/CVertexMap.hpp b/Common/include/containers/CVertexMap.hpp
index 80afd30d724..166a3ae2251 100644
--- a/Common/include/containers/CVertexMap.hpp
+++ b/Common/include/containers/CVertexMap.hpp
@@ -2,7 +2,7 @@
* \file CVertexMap.hpp
* \brief An index to index lookup vector.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/containers/container_decorators.hpp b/Common/include/containers/container_decorators.hpp
index 14910d94168..a129ff51e8a 100644
--- a/Common/include/containers/container_decorators.hpp
+++ b/Common/include/containers/container_decorators.hpp
@@ -3,7 +3,7 @@
* \brief Collection of small classes that decorate C2DContainer to
* augment its functionality, e.g. give it extra dimensions.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/fem/fem_cgns_elements.hpp b/Common/include/fem/fem_cgns_elements.hpp
index 511580eb043..9bd1bde737a 100644
--- a/Common/include/fem/fem_cgns_elements.hpp
+++ b/Common/include/fem/fem_cgns_elements.hpp
@@ -4,7 +4,7 @@
* with high order elements.
* The functions are in the cgns_elements.cpp file.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -47,7 +47,7 @@ class CBoundaryFace;
* \class CCGNSElementType
* \brief Class which stores the CGNS element type info for a connectivity
section.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CCGNSElementType {
diff --git a/Common/include/fem/fem_gauss_jacobi_quadrature.hpp b/Common/include/fem/fem_gauss_jacobi_quadrature.hpp
index 2b3413a1105..c8dfeb55f85 100644
--- a/Common/include/fem/fem_gauss_jacobi_quadrature.hpp
+++ b/Common/include/fem/fem_gauss_jacobi_quadrature.hpp
@@ -6,7 +6,7 @@
All the functions in this class are based on the program JACOBI_RULE
of John Burkardt.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -95,7 +95,7 @@ using namespace std;
* \brief Class used to determine the quadrature points of the Gauss Jacobi
integration rules.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CGaussJacobiQuadrature {
public:
diff --git a/Common/include/fem/fem_geometry_structure.hpp b/Common/include/fem/fem_geometry_structure.hpp
index a719e813419..a2c9b13a65a 100644
--- a/Common/include/fem/fem_geometry_structure.hpp
+++ b/Common/include/fem/fem_geometry_structure.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for creating the geometrical structure for the FEM solver.
* The subroutines and functions are in the fem_geometry_structure.cpp file.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -41,7 +41,7 @@ using namespace std;
/*!
* \class CLong3T
* \brief Help class used to store three longs as one entity.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
struct CLong3T {
long long0 = 0; /*!< \brief First long to store in this class. */
@@ -59,7 +59,7 @@ struct CLong3T {
* \class CReorderElements
* \brief Class, used to reorder the owned elements after the partitioning.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CReorderElements {
private:
@@ -131,7 +131,7 @@ class CReorderElements {
* \brief Functor, used for a different sorting of the faces than the < operator
* of CFaceOfElement.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CVolumeElementFEM; // Forward declaration to avoid problems.
class CSortFaces {
@@ -172,7 +172,7 @@ class CSortFaces {
* \brief Functor, used for a different sorting of the faces than the < operator
* of CSurfaceElementFEM.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
struct CSurfaceElementFEM; // Forward declaration to avoid problems.
struct CSortBoundaryFaces {
@@ -189,7 +189,7 @@ struct CSortBoundaryFaces {
* \class CVolumeElementFEM
* \brief Class to store a volume element for the FEM solver.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CVolumeElementFEM {
public:
@@ -283,7 +283,7 @@ class CVolumeElementFEM {
* \class CPointFEM
* \brief Class to a point for the FEM solver.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
struct CPointFEM {
unsigned long globalID; /*!< \brief The global ID of this point in the grid. */
@@ -308,7 +308,7 @@ struct CPointFEM {
* \class CInternalFaceElementFEM
* \brief Class to store an internal face for the FEM solver.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
struct CInternalFaceElementFEM {
unsigned short VTK_Type; /*!< \brief Element type using the VTK convention. */
@@ -353,7 +353,7 @@ struct CInternalFaceElementFEM {
* \class CSurfaceElementFEM
* \brief Class to store a surface element for the FEM solver.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
struct CSurfaceElementFEM {
unsigned short VTK_Type; /*!< \brief Element type using the VTK convention. */
@@ -415,7 +415,7 @@ struct CSurfaceElementFEM {
* \class CBoundaryFEM
* \brief Class to store a boundary for the FEM solver.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
struct CBoundaryFEM {
string markerTag; /*!< \brief Marker tag of this boundary. */
@@ -438,7 +438,7 @@ struct CBoundaryFEM {
* \class CMeshFEM
* \brief Base class for the FEM solver.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CMeshFEM: public CGeometry {
protected:
@@ -712,7 +712,7 @@ class CMeshFEM: public CGeometry {
* \class CMeshFEM_DG
* \brief Class which contains all the variables for the DG FEM solver.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CMeshFEM_DG: public CMeshFEM {
protected:
diff --git a/Common/include/fem/fem_standard_element.hpp b/Common/include/fem/fem_standard_element.hpp
index 549d2b7b8bc..28622a6b9c6 100644
--- a/Common/include/fem/fem_standard_element.hpp
+++ b/Common/include/fem/fem_standard_element.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main functions for the FEM standard elements.
* The functions are in the fem_standard_element.cpp file.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -40,7 +40,7 @@ using namespace std;
* \class CFEMStandardElementBase
* \brief Base class for a FEM standard element.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CFEMStandardElementBase {
protected:
@@ -781,7 +781,7 @@ class CFEMStandardElementBase {
* \class CFEMStandardElement
* \brief Class to define a FEM standard element.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CFEMStandardElement : public CFEMStandardElementBase {
private:
@@ -1220,7 +1220,7 @@ class CFEMStandardElement : public CFEMStandardElementBase {
* \class CFEMStandardInternalFace
* \brief Class to define a FEM standard internal face.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CFEMStandardInternalFace : public CFEMStandardElementBase {
private:
@@ -1546,7 +1546,7 @@ class CFEMStandardInternalFace : public CFEMStandardElementBase {
* \class CFEMStandardBoundaryFace
* \brief Class to define a FEM standard boundary face.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CFEMStandardBoundaryFace : public CFEMStandardElementBase {
private:
diff --git a/Common/include/fem/geometry_structure_fem_part.hpp b/Common/include/fem/geometry_structure_fem_part.hpp
index c0aef498529..72d2e76c130 100644
--- a/Common/include/fem/geometry_structure_fem_part.hpp
+++ b/Common/include/fem/geometry_structure_fem_part.hpp
@@ -2,7 +2,7 @@
* \file geometry_structure_fem_part.hpp
* \brief Helper classes for the Fluid FEM solver.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/CDummyGeometry.hpp b/Common/include/geometry/CDummyGeometry.hpp
index 4a6b29dfe0d..a179257ead3 100644
--- a/Common/include/geometry/CDummyGeometry.hpp
+++ b/Common/include/geometry/CDummyGeometry.hpp
@@ -2,7 +2,7 @@
* \file CDummyGeometry.hpp
* \brief Headers of the dummy geometry class used in "dry run" mode.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/CGeometry.hpp b/Common/include/geometry/CGeometry.hpp
index a01e376deed..a8549d18d43 100644
--- a/Common/include/geometry/CGeometry.hpp
+++ b/Common/include/geometry/CGeometry.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for creating the geometrical structure.
* The subroutines and functions are in the CGeometry.cpp file.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/CMultiGridGeometry.hpp b/Common/include/geometry/CMultiGridGeometry.hpp
index e0883b6d5ae..516460cccc5 100644
--- a/Common/include/geometry/CMultiGridGeometry.hpp
+++ b/Common/include/geometry/CMultiGridGeometry.hpp
@@ -2,7 +2,7 @@
* \file CMultiGridGeometry.hpp
* \brief Headers of the multigrid geometry class.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/CMultiGridQueue.hpp b/Common/include/geometry/CMultiGridQueue.hpp
index d521e7f853a..ca16e62a924 100644
--- a/Common/include/geometry/CMultiGridQueue.hpp
+++ b/Common/include/geometry/CMultiGridQueue.hpp
@@ -3,7 +3,7 @@
* \brief Header of the multigrid queue class for the FVM solver.
* The subroutines and functions are in the CMultiGridQueue.cpp file.
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/CPhysicalGeometry.hpp b/Common/include/geometry/CPhysicalGeometry.hpp
index 55cbd871302..b231ef8579e 100644
--- a/Common/include/geometry/CPhysicalGeometry.hpp
+++ b/Common/include/geometry/CPhysicalGeometry.hpp
@@ -2,7 +2,7 @@
* \file CPhysicalGeometry.hpp
* \brief Headers of the physical geometry class used to read meshes from file.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/dual_grid/CDualGrid.hpp b/Common/include/geometry/dual_grid/CDualGrid.hpp
index 7f51ee3f57b..052449b277f 100644
--- a/Common/include/geometry/dual_grid/CDualGrid.hpp
+++ b/Common/include/geometry/dual_grid/CDualGrid.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for doing the complete dual grid structure.
* The subroutines and functions are in the CDualGrid.cpp file.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/dual_grid/CEdge.hpp b/Common/include/geometry/dual_grid/CEdge.hpp
index 9a9808db407..f09878a7c4d 100644
--- a/Common/include/geometry/dual_grid/CEdge.hpp
+++ b/Common/include/geometry/dual_grid/CEdge.hpp
@@ -2,7 +2,7 @@
* \file CEdge.hpp
* \brief Declaration of the edge class CEdge.cpp file.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/dual_grid/CPoint.hpp b/Common/include/geometry/dual_grid/CPoint.hpp
index 2fe1a51a34a..a7227d4fe7a 100644
--- a/Common/include/geometry/dual_grid/CPoint.hpp
+++ b/Common/include/geometry/dual_grid/CPoint.hpp
@@ -3,7 +3,7 @@
* \brief Declaration of the point class that stores geometric and adjacency
* information for dual control volumes.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/dual_grid/CTurboVertex.hpp b/Common/include/geometry/dual_grid/CTurboVertex.hpp
index 166ece7e998..436c7888ace 100644
--- a/Common/include/geometry/dual_grid/CTurboVertex.hpp
+++ b/Common/include/geometry/dual_grid/CTurboVertex.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for doing the complete dual grid structure.
* The subroutines and functions are in the CTurboVertex.cpp file.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/dual_grid/CVertex.hpp b/Common/include/geometry/dual_grid/CVertex.hpp
index b27ecfc24ae..c7d2e2f0a61 100644
--- a/Common/include/geometry/dual_grid/CVertex.hpp
+++ b/Common/include/geometry/dual_grid/CVertex.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for doing the complete dual grid structure.
* The subroutines and functions are in the CVertex.cpp file.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/elements/CElement.hpp b/Common/include/geometry/elements/CElement.hpp
index fd585c985e8..dec7fa99c8f 100644
--- a/Common/include/geometry/elements/CElement.hpp
+++ b/Common/include/geometry/elements/CElement.hpp
@@ -3,7 +3,7 @@
* \brief Main header of the Finite Element structure declaring the abstract
* interface and the available finite element types.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -749,7 +749,7 @@ class CPYRAM5 final : public CElementWithKnownSizes<5,5,3> {
* \class CPRISM6
* \brief Prism element with 6 Gauss Points
* \author R. Sanchez, F. Palacios, A. Bueno, T. Economon, S. Padron.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CPRISM6 final : public CElementWithKnownSizes<6,6,3> {
private:
diff --git a/Common/include/geometry/elements/CElementProperty.hpp b/Common/include/geometry/elements/CElementProperty.hpp
index 071681f4360..7f067e0f6af 100644
--- a/Common/include/geometry/elements/CElementProperty.hpp
+++ b/Common/include/geometry/elements/CElementProperty.hpp
@@ -2,7 +2,7 @@
* \file CElementProperty.hpp
* \brief Light classes to define finite element properties.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -31,7 +31,7 @@
* \class CProperty
* \brief Base class for defining element properties.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CProperty {
protected:
@@ -106,7 +106,7 @@ class CProperty {
* \class CElementProperty
* \brief Class for defining element properties for the structural solver.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CElementProperty final : public CProperty {
private:
diff --git a/Common/include/geometry/elements/CGaussVariable.hpp b/Common/include/geometry/elements/CGaussVariable.hpp
index e80782ad2e7..b54f9716ef0 100644
--- a/Common/include/geometry/elements/CGaussVariable.hpp
+++ b/Common/include/geometry/elements/CGaussVariable.hpp
@@ -2,7 +2,7 @@
* \file CGaussVariable.hpp
* \brief Light-weight class to store Gaussian point information.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -32,7 +32,7 @@
/*!
* \class CGaussVariable
* \brief Main class for defining the gaussian points.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CGaussVariable {
protected:
diff --git a/Common/include/geometry/meshreader/CBoxMeshReaderFVM.hpp b/Common/include/geometry/meshreader/CBoxMeshReaderFVM.hpp
index 3c73b930764..462c99b9d90 100644
--- a/Common/include/geometry/meshreader/CBoxMeshReaderFVM.hpp
+++ b/Common/include/geometry/meshreader/CBoxMeshReaderFVM.hpp
@@ -3,7 +3,7 @@
* \brief Header file for the class CBoxMeshReaderFVM.
* The implementations are in the CBoxMeshReaderFVM.cpp file.
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/meshreader/CCGNSMeshReaderFVM.hpp b/Common/include/geometry/meshreader/CCGNSMeshReaderFVM.hpp
index 1c8da185d69..3e334b69b30 100644
--- a/Common/include/geometry/meshreader/CCGNSMeshReaderFVM.hpp
+++ b/Common/include/geometry/meshreader/CCGNSMeshReaderFVM.hpp
@@ -3,7 +3,7 @@
* \brief Header file for the class CCGNSMeshReaderFVM.
* The implementations are in the CCGNSMeshReaderFVM.cpp file.
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/meshreader/CMeshReaderFVM.hpp b/Common/include/geometry/meshreader/CMeshReaderFVM.hpp
index bde5bf2d6e3..75f609e449c 100644
--- a/Common/include/geometry/meshreader/CMeshReaderFVM.hpp
+++ b/Common/include/geometry/meshreader/CMeshReaderFVM.hpp
@@ -4,7 +4,7 @@
* \brief Header file for the class CMeshReaderFVM.
* The implementations are in the CMeshReaderFVM.cpp file.
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/meshreader/CRectangularMeshReaderFVM.hpp b/Common/include/geometry/meshreader/CRectangularMeshReaderFVM.hpp
index 8c56b1407ca..80cd4007cd3 100644
--- a/Common/include/geometry/meshreader/CRectangularMeshReaderFVM.hpp
+++ b/Common/include/geometry/meshreader/CRectangularMeshReaderFVM.hpp
@@ -3,7 +3,7 @@
* \brief Header file for the class CRectangularMeshReaderFVM.
* The implementations are in the CRectangularMeshReaderFVM.cpp file.
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/meshreader/CSU2ASCIIMeshReaderFVM.hpp b/Common/include/geometry/meshreader/CSU2ASCIIMeshReaderFVM.hpp
index cdd895ed340..55547d97625 100644
--- a/Common/include/geometry/meshreader/CSU2ASCIIMeshReaderFVM.hpp
+++ b/Common/include/geometry/meshreader/CSU2ASCIIMeshReaderFVM.hpp
@@ -3,7 +3,7 @@
* \brief Header file for the class CSU2ASCIIMeshReaderFVM.
* The implementations are in the CSU2ASCIIMeshReaderFVM.cpp file.
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/primal_grid/CHexahedron.hpp b/Common/include/geometry/primal_grid/CHexahedron.hpp
index 6311fde8538..8c0f4ecbe82 100644
--- a/Common/include/geometry/primal_grid/CHexahedron.hpp
+++ b/Common/include/geometry/primal_grid/CHexahedron.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for storing the primal grid structure.
* The subroutines and functions are in the CHexahedron.cpp file.
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/primal_grid/CLine.hpp b/Common/include/geometry/primal_grid/CLine.hpp
index 7254535436a..01abde6ca4b 100644
--- a/Common/include/geometry/primal_grid/CLine.hpp
+++ b/Common/include/geometry/primal_grid/CLine.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for storing the primal grid structure.
* The subroutines and functions are in the CLine.cpp file.
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/primal_grid/CPrimalGrid.hpp b/Common/include/geometry/primal_grid/CPrimalGrid.hpp
index f99d7ffde47..41fe4b07d38 100644
--- a/Common/include/geometry/primal_grid/CPrimalGrid.hpp
+++ b/Common/include/geometry/primal_grid/CPrimalGrid.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for storing the primal grid structure.
* The subroutines and functions are in the primal_grid_structure.cpp file.
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/primal_grid/CPrimalGridBoundFEM.hpp b/Common/include/geometry/primal_grid/CPrimalGridBoundFEM.hpp
index b784607f3f6..e24acc3ae9a 100644
--- a/Common/include/geometry/primal_grid/CPrimalGridBoundFEM.hpp
+++ b/Common/include/geometry/primal_grid/CPrimalGridBoundFEM.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for storing the primal grid structure.
* The subroutines and functions are in the CPrimalGridBoundFEM.cpp file.
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -33,7 +33,7 @@
/*!
* \class CPrimalGridBoundFEM
* \brief Class to define primal grid boundary element for the FEM solver.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CPrimalGridBoundFEM final: public CPrimalGrid {
private:
diff --git a/Common/include/geometry/primal_grid/CPrimalGridFEM.hpp b/Common/include/geometry/primal_grid/CPrimalGridFEM.hpp
index 06e0f73ad0a..f271f55b398 100644
--- a/Common/include/geometry/primal_grid/CPrimalGridFEM.hpp
+++ b/Common/include/geometry/primal_grid/CPrimalGridFEM.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for storing the primal grid structure.
* The subroutines and functions are in the CPrimalGridFEM.cpp file.
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -33,7 +33,7 @@
/*!
* \class CPrimalGridFEM
* \brief Class to define primal grid element for the FEM solver.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CPrimalGridFEM final: public CPrimalGrid {
private:
diff --git a/Common/include/geometry/primal_grid/CPrism.hpp b/Common/include/geometry/primal_grid/CPrism.hpp
index 3968c87c8fd..bfc59dd0719 100644
--- a/Common/include/geometry/primal_grid/CPrism.hpp
+++ b/Common/include/geometry/primal_grid/CPrism.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for storing the primal grid structure.
* The subroutines and functions are in the CPrism.cpp file.
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/primal_grid/CPyramid.hpp b/Common/include/geometry/primal_grid/CPyramid.hpp
index b34a8cd7fd3..180266557f9 100644
--- a/Common/include/geometry/primal_grid/CPyramid.hpp
+++ b/Common/include/geometry/primal_grid/CPyramid.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for storing the primal grid structure.
* The subroutines and functions are in the CPyramid.cpp file.
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/primal_grid/CQuadrilateral.hpp b/Common/include/geometry/primal_grid/CQuadrilateral.hpp
index 3e828977060..23c2d301a66 100644
--- a/Common/include/geometry/primal_grid/CQuadrilateral.hpp
+++ b/Common/include/geometry/primal_grid/CQuadrilateral.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for storing the primal grid structure.
* The subroutines and functions are in the CQuadrilateral.cpp file.
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/primal_grid/CTetrahedron.hpp b/Common/include/geometry/primal_grid/CTetrahedron.hpp
index 95a11b9394a..508d937236f 100644
--- a/Common/include/geometry/primal_grid/CTetrahedron.hpp
+++ b/Common/include/geometry/primal_grid/CTetrahedron.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for storing the primal grid structure.
* The subroutines and functions are in the CTetrahedron.cpp file.
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/primal_grid/CTriangle.hpp b/Common/include/geometry/primal_grid/CTriangle.hpp
index ab333e162db..a2a0e7b9be4 100644
--- a/Common/include/geometry/primal_grid/CTriangle.hpp
+++ b/Common/include/geometry/primal_grid/CTriangle.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for storing the primal grid structure.
* The subroutines and functions are in the CTriangle.cpp file.
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/geometry/primal_grid/CVertexMPI.hpp b/Common/include/geometry/primal_grid/CVertexMPI.hpp
index fa1b9b779b9..e6c5c04355a 100644
--- a/Common/include/geometry/primal_grid/CVertexMPI.hpp
+++ b/Common/include/geometry/primal_grid/CVertexMPI.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for storing the primal grid structure.
* The subroutines and functions are in the primal_grid_structure.cpp file.
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/graph_coloring_structure.hpp b/Common/include/graph_coloring_structure.hpp
index f6179507738..aeea3385eb9 100644
--- a/Common/include/graph_coloring_structure.hpp
+++ b/Common/include/graph_coloring_structure.hpp
@@ -4,7 +4,7 @@
* coloring of a given graph. The functions are in the
* graph_coloring_structure.cpp file.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -40,7 +40,7 @@ using namespace std;
* \class CGraphColoringStructure
* \brief Class, which provides graph coloring algorithms.
* \author: E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CGraphColoringStructure {
public:
diff --git a/Common/include/grid_movement/CBSplineBlending.hpp b/Common/include/grid_movement/CBSplineBlending.hpp
index bc829b3be09..a67b0367ba0 100644
--- a/Common/include/grid_movement/CBSplineBlending.hpp
+++ b/Common/include/grid_movement/CBSplineBlending.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the CBSplineBlending class.
* Defines blending using uniform BSplines
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/grid_movement/CBezierBlending.hpp b/Common/include/grid_movement/CBezierBlending.hpp
index 137e2b9247b..b2ee0712b48 100644
--- a/Common/include/grid_movement/CBezierBlending.hpp
+++ b/Common/include/grid_movement/CBezierBlending.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the CBezierBlending class.
* Defines blending using Bernsteinpolynomials (Bezier Curves)
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/grid_movement/CFreeFormBlending.hpp b/Common/include/grid_movement/CFreeFormBlending.hpp
index a54366b834b..3e46b548599 100644
--- a/Common/include/grid_movement/CFreeFormBlending.hpp
+++ b/Common/include/grid_movement/CFreeFormBlending.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the CFreeFormBlending class.
* It is the parent class for the FFD blending function
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/grid_movement/CFreeFormDefBox.hpp b/Common/include/grid_movement/CFreeFormDefBox.hpp
index aa914da3408..fabbe85dab6 100644
--- a/Common/include/grid_movement/CFreeFormDefBox.hpp
+++ b/Common/include/grid_movement/CFreeFormDefBox.hpp
@@ -2,7 +2,7 @@
* \file CFreeFormDefBox.hpp
* \brief Headers of the CFreeFormDefBox class.
* \author F. Palacios & A. Galdran.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/grid_movement/CGridMovement.hpp b/Common/include/grid_movement/CGridMovement.hpp
index b3ad2d7a1ff..b88b151c997 100644
--- a/Common/include/grid_movement/CGridMovement.hpp
+++ b/Common/include/grid_movement/CGridMovement.hpp
@@ -2,7 +2,7 @@
* \file CGridMovement.hpp
* \brief Headers of the CGridMovement class
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/grid_movement/CSurfaceMovement.hpp b/Common/include/grid_movement/CSurfaceMovement.hpp
index 09cf4d6514b..c1ecf20c78f 100644
--- a/Common/include/grid_movement/CSurfaceMovement.hpp
+++ b/Common/include/grid_movement/CSurfaceMovement.hpp
@@ -2,7 +2,7 @@
* \file CSurfaceMovement.hpp
* \brief Headers of the CSurfaceMovement class.
* \author F. Palacios, T. Economon.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/grid_movement/CVolumetricMovement.hpp b/Common/include/grid_movement/CVolumetricMovement.hpp
index 8de7f01c30f..78137e3362f 100644
--- a/Common/include/grid_movement/CVolumetricMovement.hpp
+++ b/Common/include/grid_movement/CVolumetricMovement.hpp
@@ -2,7 +2,7 @@
* \file CVolumetricMovement.hpp
* \brief Headers of the CVolumetricMovement class.
* \author F. Palacios, A. Bueno, T. Economon, S. Padron.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/interface_interpolation/CInterpolator.hpp b/Common/include/interface_interpolation/CInterpolator.hpp
index 3404f32688b..9065a18e951 100644
--- a/Common/include/interface_interpolation/CInterpolator.hpp
+++ b/Common/include/interface_interpolation/CInterpolator.hpp
@@ -2,7 +2,7 @@
* \file CInterpolator.hpp
* \brief Base class for multiphysics interpolation.
* \author H. Kline
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/interface_interpolation/CInterpolatorFactory.hpp b/Common/include/interface_interpolation/CInterpolatorFactory.hpp
index c1a77bfc502..cf7498b2aff 100644
--- a/Common/include/interface_interpolation/CInterpolatorFactory.hpp
+++ b/Common/include/interface_interpolation/CInterpolatorFactory.hpp
@@ -1,7 +1,7 @@
/*!
* \file CInterpolatorFactory.hpp
* \brief Factory to generate interpolator objects.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/interface_interpolation/CIsoparametric.hpp b/Common/include/interface_interpolation/CIsoparametric.hpp
index d1205c744b7..b3517b078c9 100644
--- a/Common/include/interface_interpolation/CIsoparametric.hpp
+++ b/Common/include/interface_interpolation/CIsoparametric.hpp
@@ -2,7 +2,7 @@
* \file CIsoparametric.hpp
* \brief Isoparametric interpolation using FE shape functions.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/interface_interpolation/CMirror.hpp b/Common/include/interface_interpolation/CMirror.hpp
index 36e8c78664c..9908a45f6ca 100644
--- a/Common/include/interface_interpolation/CMirror.hpp
+++ b/Common/include/interface_interpolation/CMirror.hpp
@@ -2,7 +2,7 @@
* \file CMirror.hpp
* \brief Mirror interpolation for the conservative (work-wise) approach in FSI problems.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/interface_interpolation/CNearestNeighbor.hpp b/Common/include/interface_interpolation/CNearestNeighbor.hpp
index c9b17e5585d..33e74a7dc88 100644
--- a/Common/include/interface_interpolation/CNearestNeighbor.hpp
+++ b/Common/include/interface_interpolation/CNearestNeighbor.hpp
@@ -2,7 +2,7 @@
* \file CNearestNeighbor.hpp
* \brief Nearest Neighbor interpolation class.
* \author H. Kline
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/interface_interpolation/CRadialBasisFunction.hpp b/Common/include/interface_interpolation/CRadialBasisFunction.hpp
index 6a3d96d252c..bc50ad1c23e 100644
--- a/Common/include/interface_interpolation/CRadialBasisFunction.hpp
+++ b/Common/include/interface_interpolation/CRadialBasisFunction.hpp
@@ -2,7 +2,7 @@
* \file CRadialBasisFunction.hpp
* \brief Radial basis function interpolation.
* \author Joel Ho, P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/interface_interpolation/CSlidingMesh.hpp b/Common/include/interface_interpolation/CSlidingMesh.hpp
index b9bc8ef2557..8adcc4a79e9 100644
--- a/Common/include/interface_interpolation/CSlidingMesh.hpp
+++ b/Common/include/interface_interpolation/CSlidingMesh.hpp
@@ -2,7 +2,7 @@
* \file CSlidingMesh.hpp
* \brief Sliding mesh interpolation.
* \author H. Kline
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/linear_algebra/CMatrixVectorProduct.hpp b/Common/include/linear_algebra/CMatrixVectorProduct.hpp
index e3e9e9f60d7..53cf338570f 100644
--- a/Common/include/linear_algebra/CMatrixVectorProduct.hpp
+++ b/Common/include/linear_algebra/CMatrixVectorProduct.hpp
@@ -3,7 +3,7 @@
* \brief Headers for the classes related to sparse matrix-vector product wrappers.
* The actual operations are currently implemented mostly by CSysMatrix.
* \author F. Palacios, J. Hicken, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/linear_algebra/CPastixWrapper.hpp b/Common/include/linear_algebra/CPastixWrapper.hpp
index bb42f4a4f0b..e494053c845 100644
--- a/Common/include/linear_algebra/CPastixWrapper.hpp
+++ b/Common/include/linear_algebra/CPastixWrapper.hpp
@@ -3,7 +3,7 @@
* \brief An interface to the INRIA solver PaStiX
* (http://pastix.gforge.inria.fr/files/README-txt.html)
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/linear_algebra/CPreconditioner.hpp b/Common/include/linear_algebra/CPreconditioner.hpp
index b79dcc916ee..d2ca29cb45b 100644
--- a/Common/include/linear_algebra/CPreconditioner.hpp
+++ b/Common/include/linear_algebra/CPreconditioner.hpp
@@ -3,7 +3,7 @@
* \brief Classes related to linear preconditioner wrappers.
* The actual operations are currently implemented mostly by CSysMatrix.
* \author F. Palacios, J. Hicken, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/linear_algebra/CSysMatrix.hpp b/Common/include/linear_algebra/CSysMatrix.hpp
index 0abbc3e663a..cf26885d2fa 100644
--- a/Common/include/linear_algebra/CSysMatrix.hpp
+++ b/Common/include/linear_algebra/CSysMatrix.hpp
@@ -3,7 +3,7 @@
* \brief Declaration of the block-sparse matrix class.
* The implemtation is in CSysMatrix.cpp.
* \author F. Palacios, A. Bueno, T. Economon, P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/linear_algebra/CSysMatrix.inl b/Common/include/linear_algebra/CSysMatrix.inl
index 04d84b724cb..e0738cc9daa 100644
--- a/Common/include/linear_algebra/CSysMatrix.inl
+++ b/Common/include/linear_algebra/CSysMatrix.inl
@@ -5,7 +5,7 @@
* of the .cpp file and so they are hidden to avoid triggering
* recompilation of other units when changes are made here.
* \author F. Palacios, A. Bueno, T. Economon, P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/linear_algebra/CSysSolve.hpp b/Common/include/linear_algebra/CSysSolve.hpp
index bf13a200abe..ecfb4a3a789 100644
--- a/Common/include/linear_algebra/CSysSolve.hpp
+++ b/Common/include/linear_algebra/CSysSolve.hpp
@@ -3,7 +3,7 @@
* \brief Headers for the classes related to linear solvers (CG, FGMRES, etc)
* The subroutines and functions are in the CSysSolve.cpp file.
* \author J. Hicken, F. Palacios, T. Economon, P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/linear_algebra/CSysSolve_b.hpp b/Common/include/linear_algebra/CSysSolve_b.hpp
index 87455c5d565..f37e110845c 100644
--- a/Common/include/linear_algebra/CSysSolve_b.hpp
+++ b/Common/include/linear_algebra/CSysSolve_b.hpp
@@ -2,7 +2,7 @@
* \file CSysSolve_b.hpp
* \brief Routines for the linear solver used in the reverse sweep of AD.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/linear_algebra/CSysVector.hpp b/Common/include/linear_algebra/CSysVector.hpp
index 7540cfb9494..6a54b84efa1 100644
--- a/Common/include/linear_algebra/CSysVector.hpp
+++ b/Common/include/linear_algebra/CSysVector.hpp
@@ -3,7 +3,7 @@
* \brief Declararion and inlines of the vector class used in the
* solution of large, distributed, sparse linear systems.
* \author P. Gomes, F. Palacios, J. Hicken, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/linear_algebra/blas_structure.hpp b/Common/include/linear_algebra/blas_structure.hpp
index 49e131bc54d..0aea97ce64c 100644
--- a/Common/include/linear_algebra/blas_structure.hpp
+++ b/Common/include/linear_algebra/blas_structure.hpp
@@ -4,7 +4,7 @@
operations, which are typically found in the BLAS libraries.
The functions are in the blass_structure.cpp file.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -40,7 +40,7 @@ class CConfig;
* \class CBlasStructure
* \brief Class, which serves as an interface to the BLAS functionalities needed.
* \author: E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CBlasStructure {
public:
diff --git a/Common/include/linear_algebra/vector_expressions.hpp b/Common/include/linear_algebra/vector_expressions.hpp
index 3f1b6ed80a6..0df23094f62 100644
--- a/Common/include/linear_algebra/vector_expressions.hpp
+++ b/Common/include/linear_algebra/vector_expressions.hpp
@@ -2,7 +2,7 @@
* \file vector_expressions.hpp
* \brief Expression templates for vector types with coefficient-wise operations.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/option_structure.hpp b/Common/include/option_structure.hpp
index 52aa9e2a007..49c75bbfad2 100644
--- a/Common/include/option_structure.hpp
+++ b/Common/include/option_structure.hpp
@@ -2,7 +2,7 @@
* \file option_structure.hpp
* \brief Defines classes for referencing options for easy input in CConfig
* \author J. Hicken, B. Tracey
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/option_structure.inl b/Common/include/option_structure.inl
index b78035d6f45..669419b1f5e 100644
--- a/Common/include/option_structure.inl
+++ b/Common/include/option_structure.inl
@@ -3,7 +3,7 @@
* \brief Template derived classes from COption, defined here as we
* only include them where needed to reduce compilation time.
* \author J. Hicken, B. Tracey
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/parallelization/mpi_structure.cpp b/Common/include/parallelization/mpi_structure.cpp
index 3c7aa9c5747..72a06917cbd 100644
--- a/Common/include/parallelization/mpi_structure.cpp
+++ b/Common/include/parallelization/mpi_structure.cpp
@@ -2,7 +2,7 @@
* \file mpi_structure.cpp
* \brief Main subroutines for the mpi structures.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/parallelization/mpi_structure.hpp b/Common/include/parallelization/mpi_structure.hpp
index 09d8a10fd56..1ee14c7d2fb 100644
--- a/Common/include/parallelization/mpi_structure.hpp
+++ b/Common/include/parallelization/mpi_structure.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the mpi interface for generalized datatypes.
* The subroutines and functions are in the mpi_structure.cpp file.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/parallelization/omp_structure.hpp b/Common/include/parallelization/omp_structure.hpp
index d12f450219b..09721e414b4 100644
--- a/Common/include/parallelization/omp_structure.hpp
+++ b/Common/include/parallelization/omp_structure.hpp
@@ -13,7 +13,7 @@
* defined here with suitable fallback versions to limit the spread of
* compiler tricks in other areas of the code.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/parallelization/special_vectorization.hpp b/Common/include/parallelization/special_vectorization.hpp
index 1f49bfa0f18..b435632abc4 100644
--- a/Common/include/parallelization/special_vectorization.hpp
+++ b/Common/include/parallelization/special_vectorization.hpp
@@ -2,7 +2,7 @@
* \file special_vectorization.hpp
* \brief Code generator header to create specializations of simd::Array.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/parallelization/vectorization.hpp b/Common/include/parallelization/vectorization.hpp
index 1a232844ee6..aaa601a25af 100644
--- a/Common/include/parallelization/vectorization.hpp
+++ b/Common/include/parallelization/vectorization.hpp
@@ -2,7 +2,7 @@
* \file vectorization.hpp
* \brief Implementation of a portable SIMD type.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/C1DInterpolation.hpp b/Common/include/toolboxes/C1DInterpolation.hpp
index f7a577c83a5..13f7dbf68cf 100644
--- a/Common/include/toolboxes/C1DInterpolation.hpp
+++ b/Common/include/toolboxes/C1DInterpolation.hpp
@@ -2,7 +2,7 @@
* \file C1DInterpolation.hpp
* \brief Inlet_interpolation_functions
* \author Aman Baig
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/CLinearPartitioner.hpp b/Common/include/toolboxes/CLinearPartitioner.hpp
index 8c937932d9b..783c0e79267 100644
--- a/Common/include/toolboxes/CLinearPartitioner.hpp
+++ b/Common/include/toolboxes/CLinearPartitioner.hpp
@@ -3,7 +3,7 @@
* \brief Header file for the class CLinearPartitioner.
* The implementations are in the CLinearPartitioner.cpp file.
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/CQuasiNewtonInvLeastSquares.hpp b/Common/include/toolboxes/CQuasiNewtonInvLeastSquares.hpp
index 645616b6274..49a8fce74fe 100644
--- a/Common/include/toolboxes/CQuasiNewtonInvLeastSquares.hpp
+++ b/Common/include/toolboxes/CQuasiNewtonInvLeastSquares.hpp
@@ -7,7 +7,7 @@
* \note Based on the IQN-ILS method, see DOI 10.1007/s11831-013-9085-5 and
* references therein.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/CSquareMatrixCM.hpp b/Common/include/toolboxes/CSquareMatrixCM.hpp
index adb4094199c..0e17144a54f 100644
--- a/Common/include/toolboxes/CSquareMatrixCM.hpp
+++ b/Common/include/toolboxes/CSquareMatrixCM.hpp
@@ -3,7 +3,7 @@
* \brief Dense general square matrix, used for example in DG standard elements
* in Column Major order storage.
* \author Edwin van der Weide, Pedro Gomes.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/CSymmetricMatrix.hpp b/Common/include/toolboxes/CSymmetricMatrix.hpp
index 9d7f158c048..fac98cb8dda 100644
--- a/Common/include/toolboxes/CSymmetricMatrix.hpp
+++ b/Common/include/toolboxes/CSymmetricMatrix.hpp
@@ -2,7 +2,7 @@
* \file CSymmetricMatrix.hpp
* \brief Dense symmetric matrix, used for example in RBF interpolation.
* \author Joel Ho, P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/MMS/CIncTGVSolution.hpp b/Common/include/toolboxes/MMS/CIncTGVSolution.hpp
index c9dc9c24ef7..de7c108ab27 100644
--- a/Common/include/toolboxes/MMS/CIncTGVSolution.hpp
+++ b/Common/include/toolboxes/MMS/CIncTGVSolution.hpp
@@ -3,7 +3,7 @@
* \brief Header file for the class CIncTGVSolution.
* The implementations are in the CIncTGVSolution.cpp file.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/MMS/CInviscidVortexSolution.hpp b/Common/include/toolboxes/MMS/CInviscidVortexSolution.hpp
index 7521402cbd1..c32da19c91a 100644
--- a/Common/include/toolboxes/MMS/CInviscidVortexSolution.hpp
+++ b/Common/include/toolboxes/MMS/CInviscidVortexSolution.hpp
@@ -3,7 +3,7 @@
* \brief Header file for the class CInviscidVortexSolution.
* The implementations are in the CInviscidVortexSolution.cpp file.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/MMS/CMMSIncEulerSolution.hpp b/Common/include/toolboxes/MMS/CMMSIncEulerSolution.hpp
index 39b73aeb975..8b290bedde6 100644
--- a/Common/include/toolboxes/MMS/CMMSIncEulerSolution.hpp
+++ b/Common/include/toolboxes/MMS/CMMSIncEulerSolution.hpp
@@ -3,7 +3,7 @@
* \brief Header file for the class CMMSIncEulerSolution.
* The implementations are in the CMMSIncEulerSolution.cpp file.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/MMS/CMMSIncNSSolution.hpp b/Common/include/toolboxes/MMS/CMMSIncNSSolution.hpp
index 3664007e538..b5b8063739a 100644
--- a/Common/include/toolboxes/MMS/CMMSIncNSSolution.hpp
+++ b/Common/include/toolboxes/MMS/CMMSIncNSSolution.hpp
@@ -3,7 +3,7 @@
* \brief Header file for the class CMMSIncNSSolution.
* The implementations are in the CMMSIncNSSolution.cpp file.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/MMS/CMMSNSTwoHalfCirclesSolution.hpp b/Common/include/toolboxes/MMS/CMMSNSTwoHalfCirclesSolution.hpp
index 74048c8a0eb..1e9e090bf7d 100644
--- a/Common/include/toolboxes/MMS/CMMSNSTwoHalfCirclesSolution.hpp
+++ b/Common/include/toolboxes/MMS/CMMSNSTwoHalfCirclesSolution.hpp
@@ -3,7 +3,7 @@
* \brief Header file for the class CMMSNSTwoHalfCirclesSolution.
* The implementations are in the CMMSNSTwoHalfCirclesSolution.cpp file.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/MMS/CMMSNSTwoHalfSpheresSolution.hpp b/Common/include/toolboxes/MMS/CMMSNSTwoHalfSpheresSolution.hpp
index 3b37fff112c..747b15957c5 100644
--- a/Common/include/toolboxes/MMS/CMMSNSTwoHalfSpheresSolution.hpp
+++ b/Common/include/toolboxes/MMS/CMMSNSTwoHalfSpheresSolution.hpp
@@ -3,7 +3,7 @@
* \brief Header file for the class CMMSNSTwoHalfSpheresSolution.
* The implementations are in the CMMSNSTwoHalfSpheresSolution.cpp file.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/MMS/CMMSNSUnitQuadSolution.hpp b/Common/include/toolboxes/MMS/CMMSNSUnitQuadSolution.hpp
index 4108157fb2f..a9647ffe9d9 100644
--- a/Common/include/toolboxes/MMS/CMMSNSUnitQuadSolution.hpp
+++ b/Common/include/toolboxes/MMS/CMMSNSUnitQuadSolution.hpp
@@ -3,7 +3,7 @@
* \brief Header file for the class CMMSNSUnitQuadSolution.
* The implementations are in the CMMSNSUnitQuadSolution.cpp file.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/MMS/CMMSNSUnitQuadSolutionWallBC.hpp b/Common/include/toolboxes/MMS/CMMSNSUnitQuadSolutionWallBC.hpp
index e0fca4c310d..31ba4471d12 100644
--- a/Common/include/toolboxes/MMS/CMMSNSUnitQuadSolutionWallBC.hpp
+++ b/Common/include/toolboxes/MMS/CMMSNSUnitQuadSolutionWallBC.hpp
@@ -3,7 +3,7 @@
* \brief Header file for the class CMMSNSUnitQuadSolutionWallBC.
* The implementations are in the CMMSNSUnitQuadSolutionWallBC.cpp file.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/MMS/CNSUnitQuadSolution.hpp b/Common/include/toolboxes/MMS/CNSUnitQuadSolution.hpp
index 9029824f4e0..cd4a8708b5b 100644
--- a/Common/include/toolboxes/MMS/CNSUnitQuadSolution.hpp
+++ b/Common/include/toolboxes/MMS/CNSUnitQuadSolution.hpp
@@ -3,7 +3,7 @@
* \brief Header file for the class CNSUnitQuadSolution.hpp.
* The implementations are in the CNSUnitQuadSolution.cpp file.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/MMS/CRinglebSolution.hpp b/Common/include/toolboxes/MMS/CRinglebSolution.hpp
index a0edf62cf95..1262cc4b22b 100644
--- a/Common/include/toolboxes/MMS/CRinglebSolution.hpp
+++ b/Common/include/toolboxes/MMS/CRinglebSolution.hpp
@@ -3,7 +3,7 @@
* \brief Header file for the class CRinglebSolution.hpp.
* The implementations are in the CRinglebSolution.cpp file.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/MMS/CTGVSolution.hpp b/Common/include/toolboxes/MMS/CTGVSolution.hpp
index 9a41a30dc03..10fb86405d7 100644
--- a/Common/include/toolboxes/MMS/CTGVSolution.hpp
+++ b/Common/include/toolboxes/MMS/CTGVSolution.hpp
@@ -3,7 +3,7 @@
* \brief Header file for the class CTGVSolution.
* The implementations are in the CTGVSolution.cpp file.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/MMS/CUserDefinedSolution.hpp b/Common/include/toolboxes/MMS/CUserDefinedSolution.hpp
index 4c9b52f2e01..d17e143919a 100644
--- a/Common/include/toolboxes/MMS/CUserDefinedSolution.hpp
+++ b/Common/include/toolboxes/MMS/CUserDefinedSolution.hpp
@@ -3,7 +3,7 @@
* \brief Header file for the class CUserDefinedSolution.
* The implementations are in the CUserDefinedSolution.cpp file.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/MMS/CVerificationSolution.hpp b/Common/include/toolboxes/MMS/CVerificationSolution.hpp
index ce7cabd37ef..1ce3d0d0e2c 100644
--- a/Common/include/toolboxes/MMS/CVerificationSolution.hpp
+++ b/Common/include/toolboxes/MMS/CVerificationSolution.hpp
@@ -3,7 +3,7 @@
* \brief Header file for the base class CVerificationSolution.
* The implementations are in the CVerificationSolution.cpp file.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/allocation_toolbox.hpp b/Common/include/toolboxes/allocation_toolbox.hpp
index 9754217d3a7..fa2a18bdeaa 100644
--- a/Common/include/toolboxes/allocation_toolbox.hpp
+++ b/Common/include/toolboxes/allocation_toolbox.hpp
@@ -5,7 +5,7 @@
* \note These are "kernel" functions, only to be used with good reason,
* always try to use higher level container classes.
* \author P. Gomes, D. Kavolis
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/geometry_toolbox.hpp b/Common/include/toolboxes/geometry_toolbox.hpp
index 594e79fd9b3..05111951510 100644
--- a/Common/include/toolboxes/geometry_toolbox.hpp
+++ b/Common/include/toolboxes/geometry_toolbox.hpp
@@ -1,7 +1,7 @@
/*!
* \file geometry_toolbox.hpp
* \brief Collection of common lightweight geometry-oriented methods.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/graph_toolbox.hpp b/Common/include/toolboxes/graph_toolbox.hpp
index 3ad0721ab10..a33e7d43117 100644
--- a/Common/include/toolboxes/graph_toolbox.hpp
+++ b/Common/include/toolboxes/graph_toolbox.hpp
@@ -2,7 +2,7 @@
* \file graph_toolbox.hpp
* \brief Functions and classes to build/represent sparse graphs or sparse patterns.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/toolboxes/printing_toolbox.hpp b/Common/include/toolboxes/printing_toolbox.hpp
index 4b243b77d65..fe9d75b9e5d 100644
--- a/Common/include/toolboxes/printing_toolbox.hpp
+++ b/Common/include/toolboxes/printing_toolbox.hpp
@@ -2,7 +2,7 @@
* \file printing_toolbox.hpp
* \brief Header file for the printing toolbox.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/include/wall_model.hpp b/Common/include/wall_model.hpp
index 72b1fce03ef..8571cfe9079 100644
--- a/Common/include/wall_model.hpp
+++ b/Common/include/wall_model.hpp
@@ -2,7 +2,7 @@
* \file wall_model.hpp
* \brief Headers for the wall model functions for large eddy simulations.
* \author E. van der Weide, T. Economon, P. Urbanczyk
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -42,7 +42,7 @@ class CFluidModel;
* \class CWallModel
* \brief Base class for defining the LES wall model.
* \author: E. van der Weide, T. Economon, P. Urbanczyk
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CWallModel {
diff --git a/Common/lib/Makefile.am b/Common/lib/Makefile.am
index 3b88976007f..2e698b72336 100644
--- a/Common/lib/Makefile.am
+++ b/Common/lib/Makefile.am
@@ -3,7 +3,7 @@
# \file Makefile.am
# \brief Makefile for the SU2 common library
# \author M. Colonno, T. Economon, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/Common/src/CConfig.cpp b/Common/src/CConfig.cpp
index 5ae576f72d0..c693a48338d 100644
--- a/Common/src/CConfig.cpp
+++ b/Common/src/CConfig.cpp
@@ -2,7 +2,7 @@
* \file CConfig.cpp
* \brief Main file for managing the config file
* \author F. Palacios, T. Economon, B. Tracey, H. Kline
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -3046,7 +3046,7 @@ void CConfig::SetHeader(unsigned short val_software) const{
if ((iZone == 0) && (rank == MASTER_NODE)){
cout << endl << "-------------------------------------------------------------------------" << endl;
cout << "| ___ _ _ ___ |" << endl;
- cout << "| / __| | | |_ ) Release 7.1.0 \"Blackbird\" |" << endl;
+ cout << "| / __| | | |_ ) Release 7.1.1 \"Blackbird\" |" << endl;
cout << "| \\__ \\ |_| |/ / |" << endl;
switch (val_software) {
case SU2_CFD: cout << "| |___/\\___//___| Suite (Computational Fluid Dynamics Code) |" << endl; break;
diff --git a/Common/src/adt/CADTBaseClass.cpp b/Common/src/adt/CADTBaseClass.cpp
index d42d86d0ea0..6439e73aee5 100644
--- a/Common/src/adt/CADTBaseClass.cpp
+++ b/Common/src/adt/CADTBaseClass.cpp
@@ -2,7 +2,7 @@
* \file CADTBaseClass.cpp
* \brief Base class for storing an ADT in an arbitrary number of dimensions.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/adt/CADTElemClass.cpp b/Common/src/adt/CADTElemClass.cpp
index 7e6ff76af00..270863ed008 100644
--- a/Common/src/adt/CADTElemClass.cpp
+++ b/Common/src/adt/CADTElemClass.cpp
@@ -2,7 +2,7 @@
* \file CADTElemClass.cpp
* \brief Class for storing an ADT of (linear) elements in an arbitrary number of dimensions.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/adt/CADTPointsOnlyClass.cpp b/Common/src/adt/CADTPointsOnlyClass.cpp
index 0a2555e21fa..d8c5448059b 100644
--- a/Common/src/adt/CADTPointsOnlyClass.cpp
+++ b/Common/src/adt/CADTPointsOnlyClass.cpp
@@ -2,7 +2,7 @@
* \file CADTPointsOnlyClass.cpp
* \brief Class for storing an ADT of only points in an arbitrary number of dimensions.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/basic_types/ad_structure.cpp b/Common/src/basic_types/ad_structure.cpp
index 6d3a99c4375..cd4381c6761 100644
--- a/Common/src/basic_types/ad_structure.cpp
+++ b/Common/src/basic_types/ad_structure.cpp
@@ -2,7 +2,7 @@
* \file ad_structure.cpp
* \brief Main subroutines for the algorithmic differentiation (AD) structure.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/fem/fem_cgns_elements.cpp b/Common/src/fem/fem_cgns_elements.cpp
index 22c6a554921..50956b5629d 100644
--- a/Common/src/fem/fem_cgns_elements.cpp
+++ b/Common/src/fem/fem_cgns_elements.cpp
@@ -2,7 +2,7 @@
* \file fem_cgns_elements.cpp
* \brief CGNS element definitions and conversions to the SU2 standard.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/fem/fem_gauss_jacobi_quadrature.cpp b/Common/src/fem/fem_gauss_jacobi_quadrature.cpp
index 7ba621f3640..c6ee5266b2b 100644
--- a/Common/src/fem/fem_gauss_jacobi_quadrature.cpp
+++ b/Common/src/fem/fem_gauss_jacobi_quadrature.cpp
@@ -4,7 +4,7 @@
quadrature rules. All the functions in this file are based on the
program JACOBI_RULE of John Burkardt.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/fem/fem_geometry_structure.cpp b/Common/src/fem/fem_geometry_structure.cpp
index e0119ac2ada..45e5f6e02bb 100644
--- a/Common/src/fem/fem_geometry_structure.cpp
+++ b/Common/src/fem/fem_geometry_structure.cpp
@@ -2,7 +2,7 @@
* \file fem_geometry_structure.cpp
* \brief Functions for creating the primal grid for the FEM solver.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/fem/fem_integration_rules.cpp b/Common/src/fem/fem_integration_rules.cpp
index fd56a486390..f455c6698b8 100644
--- a/Common/src/fem/fem_integration_rules.cpp
+++ b/Common/src/fem/fem_integration_rules.cpp
@@ -2,7 +2,7 @@
* \file fem_integration_rules.cpp
* \brief FEM integration rules for the standard elements.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/fem/fem_standard_element.cpp b/Common/src/fem/fem_standard_element.cpp
index 143ee58e946..f4698bc4950 100644
--- a/Common/src/fem/fem_standard_element.cpp
+++ b/Common/src/fem/fem_standard_element.cpp
@@ -2,7 +2,7 @@
* \file fem_standard_element.cpp
* \brief Functions for the FEM standard elements.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/fem/fem_wall_distance.cpp b/Common/src/fem/fem_wall_distance.cpp
index 8ff30688ae6..8cb687a2ab9 100644
--- a/Common/src/fem/fem_wall_distance.cpp
+++ b/Common/src/fem/fem_wall_distance.cpp
@@ -2,7 +2,7 @@
* \file fem_wall_distance.cpp
* \brief Main subroutines for computing the wall distance for the FEM solver.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/fem/fem_work_estimate_metis.cpp b/Common/src/fem/fem_work_estimate_metis.cpp
index 54ab466069d..af4b1d031b9 100644
--- a/Common/src/fem/fem_work_estimate_metis.cpp
+++ b/Common/src/fem/fem_work_estimate_metis.cpp
@@ -3,7 +3,7 @@
* \brief This file contains the implementation of the member functions WorkEstimateMetis
for the FEM standard elements.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/fem/geometry_structure_fem_part.cpp b/Common/src/fem/geometry_structure_fem_part.cpp
index caf47fbe223..0c82404e186 100644
--- a/Common/src/fem/geometry_structure_fem_part.cpp
+++ b/Common/src/fem/geometry_structure_fem_part.cpp
@@ -2,7 +2,7 @@
* \file geometry_structure_fem_part.cpp
* \brief Main subroutines for distributin the grid for the Fluid FEM solver.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/CDummyGeometry.cpp b/Common/src/geometry/CDummyGeometry.cpp
index a4ff312d54a..9419bda7386 100644
--- a/Common/src/geometry/CDummyGeometry.cpp
+++ b/Common/src/geometry/CDummyGeometry.cpp
@@ -2,7 +2,7 @@
* \file CDummyGeometry.hpp
* \brief Implementation of the dummy geometry class used in "dry run" mode.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/CGeometry.cpp b/Common/src/geometry/CGeometry.cpp
index 735477a7bd5..69f337368de 100644
--- a/Common/src/geometry/CGeometry.cpp
+++ b/Common/src/geometry/CGeometry.cpp
@@ -2,7 +2,7 @@
* \file CGeometry.cpp
* \brief Implementation of the base geometry class.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/CMultiGridGeometry.cpp b/Common/src/geometry/CMultiGridGeometry.cpp
index 6e09d81b9cf..f6ba9222211 100644
--- a/Common/src/geometry/CMultiGridGeometry.cpp
+++ b/Common/src/geometry/CMultiGridGeometry.cpp
@@ -2,7 +2,7 @@
* \file CMultiGridGeometry.cpp
* \brief Implementation of the multigrid geometry class.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/CMultiGridQueue.cpp b/Common/src/geometry/CMultiGridQueue.cpp
index 10bf0e29c03..114550207de 100644
--- a/Common/src/geometry/CMultiGridQueue.cpp
+++ b/Common/src/geometry/CMultiGridQueue.cpp
@@ -2,7 +2,7 @@
* \file CMultiGridQueue.cpp
* \brief Implementation of the multigrid queue class for the FVM solver.
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/CPhysicalGeometry.cpp b/Common/src/geometry/CPhysicalGeometry.cpp
index c1021d38a14..6ede288f986 100644
--- a/Common/src/geometry/CPhysicalGeometry.cpp
+++ b/Common/src/geometry/CPhysicalGeometry.cpp
@@ -2,7 +2,7 @@
* \file CPhysicalGeometry.cpp
* \brief Implementation of the physical geometry class.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/dual_grid/CDualGrid.cpp b/Common/src/geometry/dual_grid/CDualGrid.cpp
index 9e92d133b04..b09df0e3211 100644
--- a/Common/src/geometry/dual_grid/CDualGrid.cpp
+++ b/Common/src/geometry/dual_grid/CDualGrid.cpp
@@ -2,7 +2,7 @@
* \file CDualGrid.cpp
* \brief Main classes for defining the dual grid
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/dual_grid/CEdge.cpp b/Common/src/geometry/dual_grid/CEdge.cpp
index 18d38e9cab5..f0aecede3fa 100644
--- a/Common/src/geometry/dual_grid/CEdge.cpp
+++ b/Common/src/geometry/dual_grid/CEdge.cpp
@@ -2,7 +2,7 @@
* \file CEdge.cpp
* \brief Implementation of the edge class.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/dual_grid/CPoint.cpp b/Common/src/geometry/dual_grid/CPoint.cpp
index 08ad55cf1fc..e4fb9944e81 100644
--- a/Common/src/geometry/dual_grid/CPoint.cpp
+++ b/Common/src/geometry/dual_grid/CPoint.cpp
@@ -2,7 +2,7 @@
* \file CPoint.cpp
* \brief Main classes for defining the points of the dual grid
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/dual_grid/CTurboVertex.cpp b/Common/src/geometry/dual_grid/CTurboVertex.cpp
index 1f485d8da1a..429dfc17b45 100644
--- a/Common/src/geometry/dual_grid/CTurboVertex.cpp
+++ b/Common/src/geometry/dual_grid/CTurboVertex.cpp
@@ -2,7 +2,7 @@
* \file CTurboVertex.cpp
* \brief Main classes for defining the turbo vertices of the dual grid
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/dual_grid/CVertex.cpp b/Common/src/geometry/dual_grid/CVertex.cpp
index a60dc9bb122..76e9a518b4a 100644
--- a/Common/src/geometry/dual_grid/CVertex.cpp
+++ b/Common/src/geometry/dual_grid/CVertex.cpp
@@ -2,7 +2,7 @@
* \file CVertex.cpp
* \brief Main classes for defining the vertices of the dual grid
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/elements/CElement.cpp b/Common/src/geometry/elements/CElement.cpp
index adc36c439cc..d49f13e0839 100644
--- a/Common/src/geometry/elements/CElement.cpp
+++ b/Common/src/geometry/elements/CElement.cpp
@@ -2,7 +2,7 @@
* \file CElement.cpp
* \brief Definition of the Finite Element structure (elements)
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/elements/CHEXA8.cpp b/Common/src/geometry/elements/CHEXA8.cpp
index bf354132841..815d9628c79 100644
--- a/Common/src/geometry/elements/CHEXA8.cpp
+++ b/Common/src/geometry/elements/CHEXA8.cpp
@@ -2,7 +2,7 @@
* \file CHEXA8.cpp
* \brief Definition of 8-node hexa element with 8 Gauss points.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/elements/CPRISM6.cpp b/Common/src/geometry/elements/CPRISM6.cpp
index cc38c7c9e25..799c43c8e86 100644
--- a/Common/src/geometry/elements/CPRISM6.cpp
+++ b/Common/src/geometry/elements/CPRISM6.cpp
@@ -2,7 +2,7 @@
* \file CPRISM6.cpp
* \brief Definition of the 6-node triangular prism element with 6 Gauss points.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/elements/CPYRAM5.cpp b/Common/src/geometry/elements/CPYRAM5.cpp
index 8f82241d68f..d31aed69012 100644
--- a/Common/src/geometry/elements/CPYRAM5.cpp
+++ b/Common/src/geometry/elements/CPYRAM5.cpp
@@ -2,7 +2,7 @@
* \file CPYRAM5.cpp
* \brief Definition of 5-node pyramid element with 5 Gauss points.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/elements/CQUAD4.cpp b/Common/src/geometry/elements/CQUAD4.cpp
index 433c9027908..8d6c9822116 100644
--- a/Common/src/geometry/elements/CQUAD4.cpp
+++ b/Common/src/geometry/elements/CQUAD4.cpp
@@ -2,7 +2,7 @@
* \file CQUAD4.cpp
* \brief Definition of the 4-node quadrilateral element with 4 Gauss points.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/elements/CTETRA1.cpp b/Common/src/geometry/elements/CTETRA1.cpp
index 4fd754222d1..9cb9454c51f 100644
--- a/Common/src/geometry/elements/CTETRA1.cpp
+++ b/Common/src/geometry/elements/CTETRA1.cpp
@@ -2,7 +2,7 @@
* \file CTETRA1.cpp
* \brief Definition of 4-node tetra element with 1 Gauss point.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/elements/CTRIA1.cpp b/Common/src/geometry/elements/CTRIA1.cpp
index 2b33b385762..5f383fcf364 100644
--- a/Common/src/geometry/elements/CTRIA1.cpp
+++ b/Common/src/geometry/elements/CTRIA1.cpp
@@ -2,7 +2,7 @@
* \file CTRIA1.cpp
* \brief Definition of the 3-node triangular element with one Gauss point.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/meshreader/CBoxMeshReaderFVM.cpp b/Common/src/geometry/meshreader/CBoxMeshReaderFVM.cpp
index 90ede660f4d..54076dbd8d2 100644
--- a/Common/src/geometry/meshreader/CBoxMeshReaderFVM.cpp
+++ b/Common/src/geometry/meshreader/CBoxMeshReaderFVM.cpp
@@ -3,7 +3,7 @@
* \brief Reads a 3D box grid into linear partitions for the
* finite volume solver (FVM).
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/meshreader/CCGNSMeshReaderFVM.cpp b/Common/src/geometry/meshreader/CCGNSMeshReaderFVM.cpp
index c81244c54cd..b23616979a4 100644
--- a/Common/src/geometry/meshreader/CCGNSMeshReaderFVM.cpp
+++ b/Common/src/geometry/meshreader/CCGNSMeshReaderFVM.cpp
@@ -3,7 +3,7 @@
* \brief Class that reads a single zone of a CGNS mesh file from disk into
* linear partitions across all ranks.
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/meshreader/CMeshReaderFVM.cpp b/Common/src/geometry/meshreader/CMeshReaderFVM.cpp
index 3274e8203a9..ce5b53f5dd6 100644
--- a/Common/src/geometry/meshreader/CMeshReaderFVM.cpp
+++ b/Common/src/geometry/meshreader/CMeshReaderFVM.cpp
@@ -3,7 +3,7 @@
* \brief Helper class that provides the counts for each rank in a linear
* partitioning given the global count as input.
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/meshreader/CRectangularMeshReaderFVM.cpp b/Common/src/geometry/meshreader/CRectangularMeshReaderFVM.cpp
index ec59f1730d8..2d89f9f9244 100644
--- a/Common/src/geometry/meshreader/CRectangularMeshReaderFVM.cpp
+++ b/Common/src/geometry/meshreader/CRectangularMeshReaderFVM.cpp
@@ -3,7 +3,7 @@
* \brief Reads a 2D rectangular grid into linear partitions for the
* finite volume solver (FVM).
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/meshreader/CSU2ASCIIMeshReaderFVM.cpp b/Common/src/geometry/meshreader/CSU2ASCIIMeshReaderFVM.cpp
index ed9855fa543..480450a87e6 100644
--- a/Common/src/geometry/meshreader/CSU2ASCIIMeshReaderFVM.cpp
+++ b/Common/src/geometry/meshreader/CSU2ASCIIMeshReaderFVM.cpp
@@ -3,7 +3,7 @@
* \brief Reads a native SU2 ASCII grid into linear partitions for the
* finite volume solver (FVM).
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/primal_grid/CHexahedron.cpp b/Common/src/geometry/primal_grid/CHexahedron.cpp
index b24caa18f2d..e71536990f2 100644
--- a/Common/src/geometry/primal_grid/CHexahedron.cpp
+++ b/Common/src/geometry/primal_grid/CHexahedron.cpp
@@ -2,7 +2,7 @@
* \file CHexahedron.cpp
* \brief Main classes for defining the primal grid elements
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/primal_grid/CLine.cpp b/Common/src/geometry/primal_grid/CLine.cpp
index 3cdddbe178e..7eb589cbd2b 100644
--- a/Common/src/geometry/primal_grid/CLine.cpp
+++ b/Common/src/geometry/primal_grid/CLine.cpp
@@ -2,7 +2,7 @@
* \file CLine.cpp
* \brief Main classes for defining the primal grid elements
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/primal_grid/CPrimalGrid.cpp b/Common/src/geometry/primal_grid/CPrimalGrid.cpp
index 077923502db..7593048a17d 100644
--- a/Common/src/geometry/primal_grid/CPrimalGrid.cpp
+++ b/Common/src/geometry/primal_grid/CPrimalGrid.cpp
@@ -2,7 +2,7 @@
* \file CPrimalGrid.cpp
* \brief Main classes for defining the primal grid elements
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/primal_grid/CPrimalGridBoundFEM.cpp b/Common/src/geometry/primal_grid/CPrimalGridBoundFEM.cpp
index ed26eabbcc3..9e07c168c9d 100644
--- a/Common/src/geometry/primal_grid/CPrimalGridBoundFEM.cpp
+++ b/Common/src/geometry/primal_grid/CPrimalGridBoundFEM.cpp
@@ -2,7 +2,7 @@
* \file CPrimalGridBoundFEM.cpp
* \brief Main classes for defining the primal grid elements
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/primal_grid/CPrimalGridFEM.cpp b/Common/src/geometry/primal_grid/CPrimalGridFEM.cpp
index 4d5a15f9f7f..665b14dbafd 100644
--- a/Common/src/geometry/primal_grid/CPrimalGridFEM.cpp
+++ b/Common/src/geometry/primal_grid/CPrimalGridFEM.cpp
@@ -2,7 +2,7 @@
* \file CPrimalGridFEM.cpp
* \brief Main classes for defining the primal grid elements
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/primal_grid/CPrism.cpp b/Common/src/geometry/primal_grid/CPrism.cpp
index d2a6bbfb1f5..62230e783f6 100644
--- a/Common/src/geometry/primal_grid/CPrism.cpp
+++ b/Common/src/geometry/primal_grid/CPrism.cpp
@@ -2,7 +2,7 @@
* \file CPrism.cpp
* \brief Main classes for defining the primal grid elements
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/primal_grid/CPyramid.cpp b/Common/src/geometry/primal_grid/CPyramid.cpp
index c8048e67e22..bf1d69087db 100644
--- a/Common/src/geometry/primal_grid/CPyramid.cpp
+++ b/Common/src/geometry/primal_grid/CPyramid.cpp
@@ -2,7 +2,7 @@
* \file CPyramid.cpp
* \brief Main classes for defining the primal grid elements
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/primal_grid/CQuadrilateral.cpp b/Common/src/geometry/primal_grid/CQuadrilateral.cpp
index 6691474092c..3e332c9aad0 100644
--- a/Common/src/geometry/primal_grid/CQuadrilateral.cpp
+++ b/Common/src/geometry/primal_grid/CQuadrilateral.cpp
@@ -2,7 +2,7 @@
* \file CQuadrilateral.cpp
* \brief Main classes for defining the primal grid elements
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/primal_grid/CTetrahedron.cpp b/Common/src/geometry/primal_grid/CTetrahedron.cpp
index ef8e8311bba..612ed31bc27 100644
--- a/Common/src/geometry/primal_grid/CTetrahedron.cpp
+++ b/Common/src/geometry/primal_grid/CTetrahedron.cpp
@@ -2,7 +2,7 @@
* \file CTetrahedron.cpp
* \brief Main classes for defining the primal grid elements
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/primal_grid/CTriangle.cpp b/Common/src/geometry/primal_grid/CTriangle.cpp
index 464de22f418..421e4739a46 100644
--- a/Common/src/geometry/primal_grid/CTriangle.cpp
+++ b/Common/src/geometry/primal_grid/CTriangle.cpp
@@ -2,7 +2,7 @@
* \file CTriangle.cpp
* \brief Main classes for defining the primal grid elements
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/geometry/primal_grid/CVertexMPI.cpp b/Common/src/geometry/primal_grid/CVertexMPI.cpp
index a615d91adfb..2dcf2446faa 100644
--- a/Common/src/geometry/primal_grid/CVertexMPI.cpp
+++ b/Common/src/geometry/primal_grid/CVertexMPI.cpp
@@ -2,7 +2,7 @@
* \file CVertexMPI.cpp
* \brief Main classes for defining the primal grid elements
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/graph_coloring_structure.cpp b/Common/src/graph_coloring_structure.cpp
index e26f462659a..d6e85a739f7 100644
--- a/Common/src/graph_coloring_structure.cpp
+++ b/Common/src/graph_coloring_structure.cpp
@@ -2,7 +2,7 @@
* \file graph_coloring_structure.cpp
* \brief Functions used to carry out the coloring of a given graph.
* \author E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/grid_movement/CBSplineBlending.cpp b/Common/src/grid_movement/CBSplineBlending.cpp
index 06494cec4c1..9792d7c178a 100644
--- a/Common/src/grid_movement/CBSplineBlending.cpp
+++ b/Common/src/grid_movement/CBSplineBlending.cpp
@@ -2,7 +2,7 @@
* \file CBSplineBlending.cpp
* \brief Subroutines for B-Spline blening for FFDs
* \author F. Palacios, T. Economon, S. Padron
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/grid_movement/CBezierBlending.cpp b/Common/src/grid_movement/CBezierBlending.cpp
index 79fcac17b62..04248de06fe 100644
--- a/Common/src/grid_movement/CBezierBlending.cpp
+++ b/Common/src/grid_movement/CBezierBlending.cpp
@@ -2,7 +2,7 @@
* \file CBezierBlending.cpp
* \brief Subroutines for Bezier blending for FFDs
* \author F. Palacios, T. Economon, S. Padron
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/grid_movement/CFreeFormBlending.cpp b/Common/src/grid_movement/CFreeFormBlending.cpp
index a2bf378af84..c1312de02a7 100644
--- a/Common/src/grid_movement/CFreeFormBlending.cpp
+++ b/Common/src/grid_movement/CFreeFormBlending.cpp
@@ -2,7 +2,7 @@
* \file CFreeFormBlending.cpp
* \brief Parent class for FFD Blending functions
* \author F. Palacios, T. Economon, S. Padron
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/grid_movement/CFreeFormDefBox.cpp b/Common/src/grid_movement/CFreeFormDefBox.cpp
index 850c1533a24..0e54fbfec76 100644
--- a/Common/src/grid_movement/CFreeFormDefBox.cpp
+++ b/Common/src/grid_movement/CFreeFormDefBox.cpp
@@ -2,7 +2,7 @@
* \file CFreeFormDefBox.cpp
* \brief Subroutines for handling Free-Form Deformation Boxes
* \author F. Palacios, T. Economon, S. Padron
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/grid_movement/CGridMovement.cpp b/Common/src/grid_movement/CGridMovement.cpp
index acf668b0d79..fdbc3c194af 100644
--- a/Common/src/grid_movement/CGridMovement.cpp
+++ b/Common/src/grid_movement/CGridMovement.cpp
@@ -2,7 +2,7 @@
* \file CGridMovement.cpp
* \brief Parent class for grid movement classes
* \author F. Palacios, T. Economon, S. Padron
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/grid_movement/CSurfaceMovement.cpp b/Common/src/grid_movement/CSurfaceMovement.cpp
index 9f71401e3e2..7041dbebf4c 100644
--- a/Common/src/grid_movement/CSurfaceMovement.cpp
+++ b/Common/src/grid_movement/CSurfaceMovement.cpp
@@ -2,7 +2,7 @@
* \file CSurfaceMovement.cpp
* \brief Subroutines for moving mesh surface elements
* \author F. Palacios, T. Economon, S. Padron
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/grid_movement/CVolumetricMovement.cpp b/Common/src/grid_movement/CVolumetricMovement.cpp
index b0dd11cf8ec..bf448631c6a 100644
--- a/Common/src/grid_movement/CVolumetricMovement.cpp
+++ b/Common/src/grid_movement/CVolumetricMovement.cpp
@@ -2,7 +2,7 @@
* \file CVolumetricMovement.cpp
* \brief Subroutines for moving mesh volume elements
* \author F. Palacios, T. Economon, S. Padron
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/interface_interpolation/CInterpolator.cpp b/Common/src/interface_interpolation/CInterpolator.cpp
index afb3c2fff17..95b5eb2c79e 100644
--- a/Common/src/interface_interpolation/CInterpolator.cpp
+++ b/Common/src/interface_interpolation/CInterpolator.cpp
@@ -2,7 +2,7 @@
* \file CInterpolator.cpp
* \brief Definition of the base class for interface interpolation.
* \author H. Kline
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/interface_interpolation/CInterpolatorFactory.cpp b/Common/src/interface_interpolation/CInterpolatorFactory.cpp
index 625294274be..8bf2ea30cf6 100644
--- a/Common/src/interface_interpolation/CInterpolatorFactory.cpp
+++ b/Common/src/interface_interpolation/CInterpolatorFactory.cpp
@@ -1,7 +1,7 @@
/*!
* \file CInterpolatorFactory.cpp
* \brief Factory to generate interpolator objects.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/interface_interpolation/CIsoparametric.cpp b/Common/src/interface_interpolation/CIsoparametric.cpp
index 92e5aef651f..c0589a2a88e 100644
--- a/Common/src/interface_interpolation/CIsoparametric.cpp
+++ b/Common/src/interface_interpolation/CIsoparametric.cpp
@@ -2,7 +2,7 @@
* \file CIsoparametric.cpp
* \brief Implementation isoparametric interpolation (using FE shape functions).
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/interface_interpolation/CMirror.cpp b/Common/src/interface_interpolation/CMirror.cpp
index ed42afb51ff..0ef8a55d751 100644
--- a/Common/src/interface_interpolation/CMirror.cpp
+++ b/Common/src/interface_interpolation/CMirror.cpp
@@ -2,7 +2,7 @@
* \file CMirror.cpp
* \brief Implementation of mirror interpolation (conservative approach in FSI problems).
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/interface_interpolation/CNearestNeighbor.cpp b/Common/src/interface_interpolation/CNearestNeighbor.cpp
index c4cdd783087..e29d893c1fe 100644
--- a/Common/src/interface_interpolation/CNearestNeighbor.cpp
+++ b/Common/src/interface_interpolation/CNearestNeighbor.cpp
@@ -2,7 +2,7 @@
* \file CNearestNeighbor.cpp
* \brief Implementation of nearest neighbor interpolation.
* \author H. Kline
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/interface_interpolation/CRadialBasisFunction.cpp b/Common/src/interface_interpolation/CRadialBasisFunction.cpp
index 82bd1ebef0d..2b88464dea7 100644
--- a/Common/src/interface_interpolation/CRadialBasisFunction.cpp
+++ b/Common/src/interface_interpolation/CRadialBasisFunction.cpp
@@ -2,7 +2,7 @@
* \file CRadialBasisFunction.cpp
* \brief Implementation of RBF interpolation.
* \author Joel Ho, P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/interface_interpolation/CSlidingMesh.cpp b/Common/src/interface_interpolation/CSlidingMesh.cpp
index fb856382b7a..0df50ec2fd4 100644
--- a/Common/src/interface_interpolation/CSlidingMesh.cpp
+++ b/Common/src/interface_interpolation/CSlidingMesh.cpp
@@ -2,7 +2,7 @@
* \file CSlidingMesh.cpp
* \brief Implementation of sliding mesh interpolation.
* \author H. Kline
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/linear_algebra/CPastixWrapper.cpp b/Common/src/linear_algebra/CPastixWrapper.cpp
index 9797e750ad0..af199bd8eff 100644
--- a/Common/src/linear_algebra/CPastixWrapper.cpp
+++ b/Common/src/linear_algebra/CPastixWrapper.cpp
@@ -3,7 +3,7 @@
* \brief An interface to the INRIA solver PaStiX
* (http://pastix.gforge.inria.fr/files/README-txt.html)
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/linear_algebra/CSysMatrix.cpp b/Common/src/linear_algebra/CSysMatrix.cpp
index e71afd5144b..5acf31fac08 100644
--- a/Common/src/linear_algebra/CSysMatrix.cpp
+++ b/Common/src/linear_algebra/CSysMatrix.cpp
@@ -2,7 +2,7 @@
* \file CSysMatrix.cpp
* \brief Implementation of the sparse matrix class.
* \author F. Palacios, A. Bueno, T. Economon, P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/linear_algebra/CSysSolve.cpp b/Common/src/linear_algebra/CSysSolve.cpp
index 2f4907f00cd..43b1fffe92d 100644
--- a/Common/src/linear_algebra/CSysSolve.cpp
+++ b/Common/src/linear_algebra/CSysSolve.cpp
@@ -2,7 +2,7 @@
* \file CSysSolve.cpp
* \brief Main classes required for solving linear systems of equations
* \author J. Hicken, F. Palacios, T. Economon, P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/linear_algebra/CSysSolve_b.cpp b/Common/src/linear_algebra/CSysSolve_b.cpp
index 062708f9dc7..977c1ab0d0a 100644
--- a/Common/src/linear_algebra/CSysSolve_b.cpp
+++ b/Common/src/linear_algebra/CSysSolve_b.cpp
@@ -2,7 +2,7 @@
* \file CSysSolve_b.cpp
* \brief Routines for the linear solver used in the reverse sweep of AD.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/linear_algebra/CSysVector.cpp b/Common/src/linear_algebra/CSysVector.cpp
index 0c941c5c800..42aec4517e6 100644
--- a/Common/src/linear_algebra/CSysVector.cpp
+++ b/Common/src/linear_algebra/CSysVector.cpp
@@ -2,7 +2,7 @@
* \file CSysVector.cpp
* \brief Implementation and explicit instantiations of CSysVector.
* \author P. Gomes, F. Palacios, J. Hicken, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/toolboxes/C1DInterpolation.cpp b/Common/src/toolboxes/C1DInterpolation.cpp
index d9175951714..00c0ae5f288 100644
--- a/Common/src/toolboxes/C1DInterpolation.cpp
+++ b/Common/src/toolboxes/C1DInterpolation.cpp
@@ -2,7 +2,7 @@
* \file C1DInterpolation.cpp
* \brief Inlet_interpolation_functions
* \author Aman Baig
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/toolboxes/CLinearPartitioner.cpp b/Common/src/toolboxes/CLinearPartitioner.cpp
index 4fde525bd84..5c48abc15ee 100644
--- a/Common/src/toolboxes/CLinearPartitioner.cpp
+++ b/Common/src/toolboxes/CLinearPartitioner.cpp
@@ -3,7 +3,7 @@
* \brief Helper class that provides the counts for each rank in a linear
* partitioning given the global count as input.
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/toolboxes/CSquareMatrixCM.cpp b/Common/src/toolboxes/CSquareMatrixCM.cpp
index a5da8779b19..a4a538bfdcd 100644
--- a/Common/src/toolboxes/CSquareMatrixCM.cpp
+++ b/Common/src/toolboxes/CSquareMatrixCM.cpp
@@ -2,7 +2,7 @@
* \file CSquareMatrixCM.cpp
* \brief Implementation of dense matrix helper class in Column Major order (see hpp).
* \author Edwin van der Weide, Pedro Gomes.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/toolboxes/CSymmetricMatrix.cpp b/Common/src/toolboxes/CSymmetricMatrix.cpp
index 9aa9a682cf3..fa4b7abee6a 100644
--- a/Common/src/toolboxes/CSymmetricMatrix.cpp
+++ b/Common/src/toolboxes/CSymmetricMatrix.cpp
@@ -2,7 +2,7 @@
* \file CSymmetricMatrix.cpp
* \brief Implementation of dense symmetric matrix helper class (see hpp).
* \author Joel Ho, P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/toolboxes/MMS/CIncTGVSolution.cpp b/Common/src/toolboxes/MMS/CIncTGVSolution.cpp
index 6dcfb0c3a57..5f7c9a786d2 100644
--- a/Common/src/toolboxes/MMS/CIncTGVSolution.cpp
+++ b/Common/src/toolboxes/MMS/CIncTGVSolution.cpp
@@ -2,7 +2,7 @@
* \file CIncTGVSolution.cpp
* \brief Implementations of the member functions of CIncTGVSolution.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/toolboxes/MMS/CInviscidVortexSolution.cpp b/Common/src/toolboxes/MMS/CInviscidVortexSolution.cpp
index 73fb08f638f..c437bf4a542 100644
--- a/Common/src/toolboxes/MMS/CInviscidVortexSolution.cpp
+++ b/Common/src/toolboxes/MMS/CInviscidVortexSolution.cpp
@@ -2,7 +2,7 @@
* \file CInviscidVortexSolution.cpp
* \brief Implementations of the member functions of CInviscidVortexSolution.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/toolboxes/MMS/CMMSIncEulerSolution.cpp b/Common/src/toolboxes/MMS/CMMSIncEulerSolution.cpp
index c3b04d5adaf..847ef0bbcd2 100644
--- a/Common/src/toolboxes/MMS/CMMSIncEulerSolution.cpp
+++ b/Common/src/toolboxes/MMS/CMMSIncEulerSolution.cpp
@@ -2,7 +2,7 @@
* \file CMMSIncEulerSolution.cpp
* \brief Implementations of the member functions of CMMSIncEulerSolution.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/toolboxes/MMS/CMMSIncNSSolution.cpp b/Common/src/toolboxes/MMS/CMMSIncNSSolution.cpp
index 6b49e227538..7f411dbe6a0 100644
--- a/Common/src/toolboxes/MMS/CMMSIncNSSolution.cpp
+++ b/Common/src/toolboxes/MMS/CMMSIncNSSolution.cpp
@@ -2,7 +2,7 @@
* \file CMMSIncNSSolution.cpp
* \brief Implementations of the member functions of CMMSIncNSSolution.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/toolboxes/MMS/CMMSNSTwoHalfCirclesSolution.cpp b/Common/src/toolboxes/MMS/CMMSNSTwoHalfCirclesSolution.cpp
index c5a6fcb6771..cc8f546d1d2 100644
--- a/Common/src/toolboxes/MMS/CMMSNSTwoHalfCirclesSolution.cpp
+++ b/Common/src/toolboxes/MMS/CMMSNSTwoHalfCirclesSolution.cpp
@@ -2,7 +2,7 @@
* \file CMMSNSTwoHalfCirclesSolution.cpp
* \brief Implementations of the member functions of CMMSNSTwoHalfCirclesSolution.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/toolboxes/MMS/CMMSNSTwoHalfSpheresSolution.cpp b/Common/src/toolboxes/MMS/CMMSNSTwoHalfSpheresSolution.cpp
index 2350d0014af..ac2e2cf7164 100644
--- a/Common/src/toolboxes/MMS/CMMSNSTwoHalfSpheresSolution.cpp
+++ b/Common/src/toolboxes/MMS/CMMSNSTwoHalfSpheresSolution.cpp
@@ -2,7 +2,7 @@
* \file CMMSNSTwoHalfSpheresSolution.cpp
* \brief Implementations of the member functions of CMMSNSTwoHalfSpheresSolution.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/toolboxes/MMS/CMMSNSUnitQuadSolution.cpp b/Common/src/toolboxes/MMS/CMMSNSUnitQuadSolution.cpp
index 5004b8584fb..a49a7782d55 100644
--- a/Common/src/toolboxes/MMS/CMMSNSUnitQuadSolution.cpp
+++ b/Common/src/toolboxes/MMS/CMMSNSUnitQuadSolution.cpp
@@ -2,7 +2,7 @@
* \file CMMSNSUnitQuadSolution.cpp
* \brief Implementations of the member functions of CMMSNSUnitQuadSolution.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/toolboxes/MMS/CMMSNSUnitQuadSolutionWallBC.cpp b/Common/src/toolboxes/MMS/CMMSNSUnitQuadSolutionWallBC.cpp
index e6bf87a6679..66ebdbb8322 100644
--- a/Common/src/toolboxes/MMS/CMMSNSUnitQuadSolutionWallBC.cpp
+++ b/Common/src/toolboxes/MMS/CMMSNSUnitQuadSolutionWallBC.cpp
@@ -2,7 +2,7 @@
* \file CMMSNSUnitQuadSolutionWallBC.cpp
* \brief Implementations of the member functions of CMMSNSUnitQuadSolutionWallBC.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/toolboxes/MMS/CNSUnitQuadSolution.cpp b/Common/src/toolboxes/MMS/CNSUnitQuadSolution.cpp
index 250282bf9cc..9ea6741b9e4 100644
--- a/Common/src/toolboxes/MMS/CNSUnitQuadSolution.cpp
+++ b/Common/src/toolboxes/MMS/CNSUnitQuadSolution.cpp
@@ -2,7 +2,7 @@
* \file CNSUnitQuadSolution.cpp
* \brief Implementations of the member functions of CNSUnitQuadSolution.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/toolboxes/MMS/CRinglebSolution.cpp b/Common/src/toolboxes/MMS/CRinglebSolution.cpp
index 0b0e4d4d45b..c7710624bea 100644
--- a/Common/src/toolboxes/MMS/CRinglebSolution.cpp
+++ b/Common/src/toolboxes/MMS/CRinglebSolution.cpp
@@ -2,7 +2,7 @@
* \file CRinglebSolution.cpp
* \brief Implementations of the member functions of CRinglebSolution.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/toolboxes/MMS/CTGVSolution.cpp b/Common/src/toolboxes/MMS/CTGVSolution.cpp
index 86cd097873c..b9e399d4e12 100644
--- a/Common/src/toolboxes/MMS/CTGVSolution.cpp
+++ b/Common/src/toolboxes/MMS/CTGVSolution.cpp
@@ -2,7 +2,7 @@
* \file CTGVSolution.cpp
* \brief Implementations of the member functions of CTGVSolution.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/toolboxes/MMS/CUserDefinedSolution.cpp b/Common/src/toolboxes/MMS/CUserDefinedSolution.cpp
index 85a81a43b57..4ab8cbfcb6b 100644
--- a/Common/src/toolboxes/MMS/CUserDefinedSolution.cpp
+++ b/Common/src/toolboxes/MMS/CUserDefinedSolution.cpp
@@ -2,7 +2,7 @@
* \file CUserDefinedSolution.cpp
* \brief Implementations of the member functions of CUserDefinedSolution.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/toolboxes/MMS/CVerificationSolution.cpp b/Common/src/toolboxes/MMS/CVerificationSolution.cpp
index 5fb39ef9ae3..6d56a733766 100644
--- a/Common/src/toolboxes/MMS/CVerificationSolution.cpp
+++ b/Common/src/toolboxes/MMS/CVerificationSolution.cpp
@@ -2,7 +2,7 @@
* \file CVerificationSolution.cpp
* \brief Implementations of the member functions of CVerificationSolution.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/toolboxes/MMS/CreateMMSSourceTerms/CMMSIncEulerSolution.py b/Common/src/toolboxes/MMS/CreateMMSSourceTerms/CMMSIncEulerSolution.py
index 95b1afd698a..cbf999f412e 100755
--- a/Common/src/toolboxes/MMS/CreateMMSSourceTerms/CMMSIncEulerSolution.py
+++ b/Common/src/toolboxes/MMS/CreateMMSSourceTerms/CMMSIncEulerSolution.py
@@ -4,7 +4,7 @@
# \brief Python script that generates the source terms for a
# manufactured solution for the incompressible Euler eqns.
# \author T. Economon
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# The current SU2 release has been coordinated by the
# SU2 International Developers Society
diff --git a/Common/src/toolboxes/MMS/CreateMMSSourceTerms/CMMSIncNSSolution.py b/Common/src/toolboxes/MMS/CreateMMSSourceTerms/CMMSIncNSSolution.py
index ac585bddf05..614c458c103 100755
--- a/Common/src/toolboxes/MMS/CreateMMSSourceTerms/CMMSIncNSSolution.py
+++ b/Common/src/toolboxes/MMS/CreateMMSSourceTerms/CMMSIncNSSolution.py
@@ -4,7 +4,7 @@
# \brief Python script that generates the source terms for a
# manufactured solution for the incompressible Navier-Stokes eqns.
# \author T. Economon
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# The current SU2 release has been coordinated by the
# SU2 International Developers Society
diff --git a/Common/src/toolboxes/printing_toolbox.cpp b/Common/src/toolboxes/printing_toolbox.cpp
index ae1db824d51..306395f0690 100644
--- a/Common/src/toolboxes/printing_toolbox.cpp
+++ b/Common/src/toolboxes/printing_toolbox.cpp
@@ -2,7 +2,7 @@
* \file printing_toolbox.cpp
* \brief Printing tools
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Common/src/wall_model.cpp b/Common/src/wall_model.cpp
index efb291835bd..c90aaa9ccc4 100644
--- a/Common/src/wall_model.cpp
+++ b/Common/src/wall_model.cpp
@@ -3,7 +3,7 @@
* \brief File, which contains the implementation for the wall model functions
* for large eddy simulations.
* \author E. van der Weide, T. Economon, P. Urbanczyk
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/Makefile.am b/Makefile.am
index 33ff29ba5c7..dbdc2b34bee 100644
--- a/Makefile.am
+++ b/Makefile.am
@@ -3,7 +3,7 @@
# \file Makefile.am
# \brief Global makefile for the SU2 project
# \author M. Colonno, T. Economon, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# The current SU2 release has been coordinated by the
# SU2 International Developers Society
diff --git a/QuickStart/inv_NACA0012.cfg b/QuickStart/inv_NACA0012.cfg
index 2f9d6db35ed..10bcc036c34 100644
--- a/QuickStart/inv_NACA0012.cfg
+++ b/QuickStart/inv_NACA0012.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2014.06.11 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/README.md b/README.md
index 05f5d0bddb0..e6280ae7b20 100644
--- a/README.md
+++ b/README.md
@@ -3,7 +3,7 @@
-# SU2 (ver. 7.1.0 "Blackbird"): The Open-Source CFD Code
+# SU2 (ver. 7.1.1 "Blackbird"): The Open-Source CFD Code
Computational analysis tools have revolutionized the way we design engineering systems, but most established codes are proprietary, unavailable, or prohibitively expensive for many users. The SU2 team is changing this, making multiphysics analysis and design optimization freely available as open-source software and involving everyone in its creation and development.
diff --git a/SU2_CFD/include/CMarkerProfileReaderFVM.hpp b/SU2_CFD/include/CMarkerProfileReaderFVM.hpp
index c80e7c2d30a..7fe5a46dd47 100644
--- a/SU2_CFD/include/CMarkerProfileReaderFVM.hpp
+++ b/SU2_CFD/include/CMarkerProfileReaderFVM.hpp
@@ -3,7 +3,7 @@
* \brief Header file for the class CMarkerProfileReaderFVM.
* The implementations are in the CMarkerProfileReaderFVM.cpp file.
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* The current SU2 release has been coordinated by the
* SU2 International Developers Society
diff --git a/SU2_CFD/include/SU2_CFD.hpp b/SU2_CFD/include/SU2_CFD.hpp
index 8261344a4b5..0df25eb4af5 100644
--- a/SU2_CFD/include/SU2_CFD.hpp
+++ b/SU2_CFD/include/SU2_CFD.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines of the code SU2_CFD.
* The subroutines and functions are in the SU2_CFD.cpp file.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/definition_structure.hpp b/SU2_CFD/include/definition_structure.hpp
index c64c601919d..325b35182ba 100644
--- a/SU2_CFD/include/definition_structure.hpp
+++ b/SU2_CFD/include/definition_structure.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines used by SU2_CFD.
* The subroutines and functions are in the definition_structure.cpp file.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/drivers/CDiscAdjMultizoneDriver.hpp b/SU2_CFD/include/drivers/CDiscAdjMultizoneDriver.hpp
index b5856f49e82..6a0d0034f1c 100644
--- a/SU2_CFD/include/drivers/CDiscAdjMultizoneDriver.hpp
+++ b/SU2_CFD/include/drivers/CDiscAdjMultizoneDriver.hpp
@@ -2,7 +2,7 @@
* \class CDiscAdjMultizoneDriver.hpp
* \brief Class for driving adjoint multi-zone problems.
* \author O. Burghardt, P. Gomes, T. Albring, R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/drivers/CDiscAdjSinglezoneDriver.hpp b/SU2_CFD/include/drivers/CDiscAdjSinglezoneDriver.hpp
index b8ac1335c8b..93954bde7be 100644
--- a/SU2_CFD/include/drivers/CDiscAdjSinglezoneDriver.hpp
+++ b/SU2_CFD/include/drivers/CDiscAdjSinglezoneDriver.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for driving single or multi-zone problems.
* The subroutines and functions are in the driver_structure.cpp file.
* \author T. Economon, H. Kline, R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -33,7 +33,7 @@
* \class CDiscAdjSinglezoneDriver
* \brief Class for driving single-zone adjoint solvers.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CDiscAdjSinglezoneDriver : public CSinglezoneDriver {
protected:
diff --git a/SU2_CFD/include/drivers/CDriver.hpp b/SU2_CFD/include/drivers/CDriver.hpp
index 954f943036f..30c37ec9e27 100644
--- a/SU2_CFD/include/drivers/CDriver.hpp
+++ b/SU2_CFD/include/drivers/CDriver.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for driving single or multi-zone problems.
* The subroutines and functions are in the driver_structure.cpp file.
* \author T. Economon, H. Kline, R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/drivers/CDummyDriver.hpp b/SU2_CFD/include/drivers/CDummyDriver.hpp
index d2903622487..4a0f168cadf 100644
--- a/SU2_CFD/include/drivers/CDummyDriver.hpp
+++ b/SU2_CFD/include/drivers/CDummyDriver.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for driving single or multi-zone problems.
* The subroutines and functions are in the driver_structure.cpp file.
* \author T. Economon, H. Kline, R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/drivers/CMultizoneDriver.hpp b/SU2_CFD/include/drivers/CMultizoneDriver.hpp
index 079d91ea7f1..a938c1a50ec 100644
--- a/SU2_CFD/include/drivers/CMultizoneDriver.hpp
+++ b/SU2_CFD/include/drivers/CMultizoneDriver.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for driving single or multi-zone problems.
* The subroutines and functions are in the driver_structure.cpp file.
* \author T. Economon, H. Kline, R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -34,7 +34,7 @@
* \class CMultizoneDriver
* \brief Class for driving zone-specific iterations.
* \author R. Sanchez, O. Burghardt
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CMultizoneDriver : public CDriver {
protected:
diff --git a/SU2_CFD/include/drivers/CSinglezoneDriver.hpp b/SU2_CFD/include/drivers/CSinglezoneDriver.hpp
index 82360bd0cc0..a46e799370f 100644
--- a/SU2_CFD/include/drivers/CSinglezoneDriver.hpp
+++ b/SU2_CFD/include/drivers/CSinglezoneDriver.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for driving single or multi-zone problems.
* The subroutines and functions are in the driver_structure.cpp file.
* \author T. Economon, H. Kline, R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -33,7 +33,7 @@
* \class CSinglezoneDriver
* \brief Class for driving single-zone solvers.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CSinglezoneDriver : public CDriver {
protected:
diff --git a/SU2_CFD/include/fluid/CConductivityModel.hpp b/SU2_CFD/include/fluid/CConductivityModel.hpp
index 676d7a5047d..ecf1157130d 100644
--- a/SU2_CFD/include/fluid/CConductivityModel.hpp
+++ b/SU2_CFD/include/fluid/CConductivityModel.hpp
@@ -2,7 +2,7 @@
* \file CConductivityModel.hpp
* \brief Defines an interface class for thermal conductivity models.
* \author S. Vitale, M. Pini, G. Gori, A. Guardone, P. Colonna, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/fluid/CConstantConductivity.hpp b/SU2_CFD/include/fluid/CConstantConductivity.hpp
index a4b2dbb4d55..7f957887b18 100644
--- a/SU2_CFD/include/fluid/CConstantConductivity.hpp
+++ b/SU2_CFD/include/fluid/CConstantConductivity.hpp
@@ -2,7 +2,7 @@
* \file CConstantConductivity.hpp
* \brief Defines a constant laminar thermal conductivity model.
* \author S. Vitale, M. Pini, G. Gori, A. Guardone, P. Colonna, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/fluid/CConstantConductivityRANS.hpp b/SU2_CFD/include/fluid/CConstantConductivityRANS.hpp
index aede30be625..d67035e67b9 100644
--- a/SU2_CFD/include/fluid/CConstantConductivityRANS.hpp
+++ b/SU2_CFD/include/fluid/CConstantConductivityRANS.hpp
@@ -2,7 +2,7 @@
* \file CConstantConductivityRANS.hpp
* \brief Defines a constant conductivity model for RANS problems.
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/fluid/CConstantDensity.hpp b/SU2_CFD/include/fluid/CConstantDensity.hpp
index 0bb57d88908..eca3b95c0a2 100644
--- a/SU2_CFD/include/fluid/CConstantDensity.hpp
+++ b/SU2_CFD/include/fluid/CConstantDensity.hpp
@@ -2,7 +2,7 @@
* \file CConstantDensity.hpp
* \brief Defines the incompressible constant density model.
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/fluid/CConstantPrandtl.hpp b/SU2_CFD/include/fluid/CConstantPrandtl.hpp
index 46ce24d3292..bb4bc5fd422 100644
--- a/SU2_CFD/include/fluid/CConstantPrandtl.hpp
+++ b/SU2_CFD/include/fluid/CConstantPrandtl.hpp
@@ -2,7 +2,7 @@
* \file CConstantPrandtl.hpp
* \brief Defines a non-constant laminar Prandtl number thermal conductivity model.
* \author S. Vitale, M. Pini, G. Gori, A. Guardone, P. Colonna, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/fluid/CConstantPrandtlRANS.hpp b/SU2_CFD/include/fluid/CConstantPrandtlRANS.hpp
index 172a58e5bcc..7cb7439b676 100644
--- a/SU2_CFD/include/fluid/CConstantPrandtlRANS.hpp
+++ b/SU2_CFD/include/fluid/CConstantPrandtlRANS.hpp
@@ -2,7 +2,7 @@
* \file CConstantPrandtlRANS.hpp
* \brief Defines a non-constant effective thermal conductivity for RANS problems using Prandtl numbers.
* \author S. Vitale, M. Pini, G. Gori, A. Guardone, P. Colonna, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/fluid/CConstantViscosity.hpp b/SU2_CFD/include/fluid/CConstantViscosity.hpp
index be47ab89fc2..548a2baa7bc 100644
--- a/SU2_CFD/include/fluid/CConstantViscosity.hpp
+++ b/SU2_CFD/include/fluid/CConstantViscosity.hpp
@@ -2,7 +2,7 @@
* \file CConstantViscosity.hpp
* \brief Defines a constant laminar viscosity model.
* \author S. Vitale, M. Pini, G. Gori, A. Guardone, P. Colonna, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/fluid/CFluidModel.hpp b/SU2_CFD/include/fluid/CFluidModel.hpp
index aafe78197d9..a521a3cac83 100644
--- a/SU2_CFD/include/fluid/CFluidModel.hpp
+++ b/SU2_CFD/include/fluid/CFluidModel.hpp
@@ -2,7 +2,7 @@
* \file CFluidModel.hpp
* \brief Defines the main fluid model class for thermophysical properties.
* \author S. Vitale, G. Gori, M. Pini, A. Guardone, P. Colonna, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/fluid/CIdealGas.hpp b/SU2_CFD/include/fluid/CIdealGas.hpp
index 487c2197807..1282552203a 100644
--- a/SU2_CFD/include/fluid/CIdealGas.hpp
+++ b/SU2_CFD/include/fluid/CIdealGas.hpp
@@ -2,7 +2,7 @@
* \file CIdealGas.hpp
* \brief Defines the ideal gas model.
* \author S. Vitale, G. Gori, M. Pini, A. Guardone, P. Colonna
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/fluid/CIncIdealGas.hpp b/SU2_CFD/include/fluid/CIncIdealGas.hpp
index d9d8193de17..548d0269dd6 100644
--- a/SU2_CFD/include/fluid/CIncIdealGas.hpp
+++ b/SU2_CFD/include/fluid/CIncIdealGas.hpp
@@ -2,7 +2,7 @@
* \file CIncIdealGas.hpp
* \brief Defines the incompressible Ideal Gas model.
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/fluid/CIncIdealGasPolynomial.hpp b/SU2_CFD/include/fluid/CIncIdealGasPolynomial.hpp
index 1407a0e4bc0..b789d9b2f92 100644
--- a/SU2_CFD/include/fluid/CIncIdealGasPolynomial.hpp
+++ b/SU2_CFD/include/fluid/CIncIdealGasPolynomial.hpp
@@ -2,7 +2,7 @@
* \file CIncIdealGasPolynomial.hpp
* \brief Defines the incompressible Ideal Gas model with polynomial Cp.
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/fluid/CMutationTCLib.hpp b/SU2_CFD/include/fluid/CMutationTCLib.hpp
index 863d05ff670..9820eeb164f 100644
--- a/SU2_CFD/include/fluid/CMutationTCLib.hpp
+++ b/SU2_CFD/include/fluid/CMutationTCLib.hpp
@@ -2,7 +2,7 @@
* \file CMutationTCLib.hpp
* \brief Defines the class for the link to Mutation++ ThermoChemistry library.
* \author C. Garbacz
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/fluid/CNEMOGas.hpp b/SU2_CFD/include/fluid/CNEMOGas.hpp
index 0cc9b06c97a..734ac565c3c 100644
--- a/SU2_CFD/include/fluid/CNEMOGas.hpp
+++ b/SU2_CFD/include/fluid/CNEMOGas.hpp
@@ -2,7 +2,7 @@
* \file CNEMOGas.hpp
* \brief Defines the nonequilibrium gas model.
* \author C. Garbacz, W. Maier, S. R. Copeland
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/fluid/CPengRobinson.hpp b/SU2_CFD/include/fluid/CPengRobinson.hpp
index 59d12573598..66061aaf378 100644
--- a/SU2_CFD/include/fluid/CPengRobinson.hpp
+++ b/SU2_CFD/include/fluid/CPengRobinson.hpp
@@ -2,7 +2,7 @@
* \file CPengRobinson.hpp
* \brief Defines the Peng-Robinson model.
* \author S. Vitale, G. Gori, M. Pini, A. Guardone, P. Colonna
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/fluid/CPolynomialConductivity.hpp b/SU2_CFD/include/fluid/CPolynomialConductivity.hpp
index d0d4f56aef8..5626cfc7147 100644
--- a/SU2_CFD/include/fluid/CPolynomialConductivity.hpp
+++ b/SU2_CFD/include/fluid/CPolynomialConductivity.hpp
@@ -2,7 +2,7 @@
* \file CPolynomialConductivity.hpp
* \brief Defines a non-constant laminar thermal conductivity using a polynomial function of temperature.
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/fluid/CPolynomialConductivityRANS.hpp b/SU2_CFD/include/fluid/CPolynomialConductivityRANS.hpp
index 3ef74132834..02fdd35fae3 100644
--- a/SU2_CFD/include/fluid/CPolynomialConductivityRANS.hpp
+++ b/SU2_CFD/include/fluid/CPolynomialConductivityRANS.hpp
@@ -3,7 +3,7 @@
* \brief Defines a non-constant thermal conductivity using a polynomial function of temperature
* for RANS problems with the addition of a turbulent component based on a turbulent Prandtl number.
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/fluid/CPolynomialViscosity.hpp b/SU2_CFD/include/fluid/CPolynomialViscosity.hpp
index f69c021fe71..31ae3130421 100644
--- a/SU2_CFD/include/fluid/CPolynomialViscosity.hpp
+++ b/SU2_CFD/include/fluid/CPolynomialViscosity.hpp
@@ -2,7 +2,7 @@
* \file CPolynomialViscosity.hpp
* \brief Defines a laminar viscosity model as a polynomial function of temperature.
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/fluid/CSU2TCLib.hpp b/SU2_CFD/include/fluid/CSU2TCLib.hpp
index b08a03acdb1..0a42773582a 100644
--- a/SU2_CFD/include/fluid/CSU2TCLib.hpp
+++ b/SU2_CFD/include/fluid/CSU2TCLib.hpp
@@ -2,7 +2,7 @@
* \file CSU2TCLib.hpp
* \brief Defines the classes for different user defined ThermoChemistry libraries.
* \author C. Garbacz, W. Maier, S. R. Copeland
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/fluid/CSutherland.hpp b/SU2_CFD/include/fluid/CSutherland.hpp
index a47ab501c55..204c230efa3 100644
--- a/SU2_CFD/include/fluid/CSutherland.hpp
+++ b/SU2_CFD/include/fluid/CSutherland.hpp
@@ -2,7 +2,7 @@
* \file CSutherland.hpp
* \brief Defines Sutherland's Law for laminar viscosity.
* \author S. Vitale, M. Pini, G. Gori, A. Guardone, P. Colonna, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/fluid/CVanDerWaalsGas.hpp b/SU2_CFD/include/fluid/CVanDerWaalsGas.hpp
index 9167076a90a..5a9448cc981 100644
--- a/SU2_CFD/include/fluid/CVanDerWaalsGas.hpp
+++ b/SU2_CFD/include/fluid/CVanDerWaalsGas.hpp
@@ -2,7 +2,7 @@
* \file CVanDerWaalsGas.hpp
* \brief Declaration of the Polytropic Van der Waals model.
* \author S. Vitale, G. Gori, M. Pini, A. Guardone, P. Colonna
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/fluid/CViscosityModel.hpp b/SU2_CFD/include/fluid/CViscosityModel.hpp
index 04aa7adefb9..7a5b75c102c 100644
--- a/SU2_CFD/include/fluid/CViscosityModel.hpp
+++ b/SU2_CFD/include/fluid/CViscosityModel.hpp
@@ -2,7 +2,7 @@
* \file CViscosityModel.hpp
* \brief Interface class for defining laminar viscosity models.
* \author S. Vitale, M. Pini, G. Gori, A. Guardone, P. Colonna, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/gradients/computeGradientsGreenGauss.hpp b/SU2_CFD/include/gradients/computeGradientsGreenGauss.hpp
index 89bd45f8c3a..0233daa886c 100644
--- a/SU2_CFD/include/gradients/computeGradientsGreenGauss.hpp
+++ b/SU2_CFD/include/gradients/computeGradientsGreenGauss.hpp
@@ -4,7 +4,7 @@
* \note This allows the same implementation to be used for conservative
* and primitive variables of any solver.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/gradients/computeGradientsLeastSquares.hpp b/SU2_CFD/include/gradients/computeGradientsLeastSquares.hpp
index c706a2b6f3b..6cf2e739a7b 100644
--- a/SU2_CFD/include/gradients/computeGradientsLeastSquares.hpp
+++ b/SU2_CFD/include/gradients/computeGradientsLeastSquares.hpp
@@ -3,7 +3,7 @@
* \brief Generic implementation of Least-Squares gradient computation.
* \note This allows the same implementation to be used for conservative
* and primitive variables of any solver.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/integration/CFEM_DG_Integration.hpp b/SU2_CFD/include/integration/CFEM_DG_Integration.hpp
index 8d3fff4a2af..13e1c32473c 100644
--- a/SU2_CFD/include/integration/CFEM_DG_Integration.hpp
+++ b/SU2_CFD/include/integration/CFEM_DG_Integration.hpp
@@ -2,7 +2,7 @@
* \file CFEM_DG_Integration.hpp
* \brief Declaration of class for integration with the FEM DG solver.
* \author E. van der Weide, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -31,7 +31,7 @@
* \class CFEM_DG_Integration
* \brief Class for integration with the FEM DG solver.
* \author E. van der Weide, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CFEM_DG_Integration final : public CIntegration {
public:
diff --git a/SU2_CFD/include/integration/CIntegration.hpp b/SU2_CFD/include/integration/CIntegration.hpp
index 72bf34b512d..34d31f00fb3 100644
--- a/SU2_CFD/include/integration/CIntegration.hpp
+++ b/SU2_CFD/include/integration/CIntegration.hpp
@@ -2,7 +2,7 @@
* \file CIntegration.hpp
* \brief Declaration of the main routines to orchestrate space and time integration.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/integration/CMultiGridIntegration.hpp b/SU2_CFD/include/integration/CMultiGridIntegration.hpp
index f268190c1e9..b69342f55ce 100644
--- a/SU2_CFD/include/integration/CMultiGridIntegration.hpp
+++ b/SU2_CFD/include/integration/CMultiGridIntegration.hpp
@@ -2,7 +2,7 @@
* \file CMultiGridIntegration.hpp
* \brief Declaration of class for time integration using a multigrid method.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/integration/CNewtonIntegration.hpp b/SU2_CFD/include/integration/CNewtonIntegration.hpp
index c25e47e701d..86626b7629e 100644
--- a/SU2_CFD/include/integration/CNewtonIntegration.hpp
+++ b/SU2_CFD/include/integration/CNewtonIntegration.hpp
@@ -2,7 +2,7 @@
* \file CNewtonIntegration.hpp
* \brief Newton-Krylov integration.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/integration/CSingleGridIntegration.hpp b/SU2_CFD/include/integration/CSingleGridIntegration.hpp
index 02c364b8eef..53bd4f5966e 100644
--- a/SU2_CFD/include/integration/CSingleGridIntegration.hpp
+++ b/SU2_CFD/include/integration/CSingleGridIntegration.hpp
@@ -2,7 +2,7 @@
* \file CSingleGridIntegration.hpp
* \brief Declaration of class for numerical integration of fine grid-only problems.
* \author A. Bueno.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/integration/CStructuralIntegration.hpp b/SU2_CFD/include/integration/CStructuralIntegration.hpp
index bcd44693580..0977f6fe64c 100644
--- a/SU2_CFD/include/integration/CStructuralIntegration.hpp
+++ b/SU2_CFD/include/integration/CStructuralIntegration.hpp
@@ -2,7 +2,7 @@
* \file CStructuralIntegration.hpp
* \brief Declaration of class for numerical integration of structural problems.
* \author R. Sanchez.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/interfaces/CInterface.hpp b/SU2_CFD/include/interfaces/CInterface.hpp
index d8911e39333..6c9c66edf24 100644
--- a/SU2_CFD/include/interfaces/CInterface.hpp
+++ b/SU2_CFD/include/interfaces/CInterface.hpp
@@ -3,7 +3,7 @@
* \brief Declarations and inlines of the transfer structure.
* The subroutines and functions are in the physics folders.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -50,7 +50,7 @@ using namespace std;
* \class CInterface
* \brief Main class for defining the physical transfer of information.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CInterface {
diff --git a/SU2_CFD/include/interfaces/cfd/CConservativeVarsInterface.hpp b/SU2_CFD/include/interfaces/cfd/CConservativeVarsInterface.hpp
index 8388c30dcc0..8d53bce2586 100644
--- a/SU2_CFD/include/interfaces/cfd/CConservativeVarsInterface.hpp
+++ b/SU2_CFD/include/interfaces/cfd/CConservativeVarsInterface.hpp
@@ -3,7 +3,7 @@
* \brief Declaration and inlines of the class to transfer conservative variables
* from a generic zone into another one.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/interfaces/cfd/CMixingPlaneInterface.hpp b/SU2_CFD/include/interfaces/cfd/CMixingPlaneInterface.hpp
index 7d427134d80..e758813762d 100644
--- a/SU2_CFD/include/interfaces/cfd/CMixingPlaneInterface.hpp
+++ b/SU2_CFD/include/interfaces/cfd/CMixingPlaneInterface.hpp
@@ -3,7 +3,7 @@
* \brief Declaration and inlines of the class to transfer average variables
* needed for MixingPlane computation from a generic zone into another one.
* \author S. Vitale
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/interfaces/cfd/CSlidingInterface.hpp b/SU2_CFD/include/interfaces/cfd/CSlidingInterface.hpp
index 3c675b87d6b..9e4b8fdf8c6 100644
--- a/SU2_CFD/include/interfaces/cfd/CSlidingInterface.hpp
+++ b/SU2_CFD/include/interfaces/cfd/CSlidingInterface.hpp
@@ -3,7 +3,7 @@
* \brief Declaration and inlines of the class to transfer conservative variables
* from a generic zone into another
* \author G. Gori Politecnico di Milano
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/interfaces/cht/CConjugateHeatInterface.hpp b/SU2_CFD/include/interfaces/cht/CConjugateHeatInterface.hpp
index 0db18d0d6ca..0aceee45403 100644
--- a/SU2_CFD/include/interfaces/cht/CConjugateHeatInterface.hpp
+++ b/SU2_CFD/include/interfaces/cht/CConjugateHeatInterface.hpp
@@ -3,7 +3,7 @@
* \brief Declaration and inlines of the class to transfer temperature and heatflux
* density for conjugate heat interfaces between structure and fluid zones.
* \author O. Burghardt
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/interfaces/fsi/CDiscAdjFlowTractionInterface.hpp b/SU2_CFD/include/interfaces/fsi/CDiscAdjFlowTractionInterface.hpp
index b0d419c2264..7f527ebdb63 100644
--- a/SU2_CFD/include/interfaces/fsi/CDiscAdjFlowTractionInterface.hpp
+++ b/SU2_CFD/include/interfaces/fsi/CDiscAdjFlowTractionInterface.hpp
@@ -3,7 +3,7 @@
* \brief Declaration and inlines of the class to transfer flow tractions
* from a fluid zone into a structural zone in a discrete adjoint simulation.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/interfaces/fsi/CDisplacementsInterface.hpp b/SU2_CFD/include/interfaces/fsi/CDisplacementsInterface.hpp
index 4c16621b94e..f0594f470d2 100644
--- a/SU2_CFD/include/interfaces/fsi/CDisplacementsInterface.hpp
+++ b/SU2_CFD/include/interfaces/fsi/CDisplacementsInterface.hpp
@@ -3,7 +3,7 @@
* \brief Declaration and inlines of the class to transfer boundary displacements
* from a structural zone into a fluid zone.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/interfaces/fsi/CFlowTractionInterface.hpp b/SU2_CFD/include/interfaces/fsi/CFlowTractionInterface.hpp
index b0fcce25def..d7025943bd5 100644
--- a/SU2_CFD/include/interfaces/fsi/CFlowTractionInterface.hpp
+++ b/SU2_CFD/include/interfaces/fsi/CFlowTractionInterface.hpp
@@ -3,7 +3,7 @@
* \brief Declaration and inlines of the class to transfer flow tractions
* from a fluid zone into a structural zone.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/iteration/CAdjFluidIteration.hpp b/SU2_CFD/include/iteration/CAdjFluidIteration.hpp
index 620dda7bd5b..88672922358 100644
--- a/SU2_CFD/include/iteration/CAdjFluidIteration.hpp
+++ b/SU2_CFD/include/iteration/CAdjFluidIteration.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the iteration classes used by SU2_CFD.
* Each CIteration class represents an available physics package.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/iteration/CDiscAdjFEAIteration.hpp b/SU2_CFD/include/iteration/CDiscAdjFEAIteration.hpp
index fdd23c0040e..3f1697c9ebe 100644
--- a/SU2_CFD/include/iteration/CDiscAdjFEAIteration.hpp
+++ b/SU2_CFD/include/iteration/CDiscAdjFEAIteration.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the iteration classes used by SU2_CFD.
* Each CIteration class represents an available physics package.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/iteration/CDiscAdjFluidIteration.hpp b/SU2_CFD/include/iteration/CDiscAdjFluidIteration.hpp
index b1fa772908b..c7da838c79a 100644
--- a/SU2_CFD/include/iteration/CDiscAdjFluidIteration.hpp
+++ b/SU2_CFD/include/iteration/CDiscAdjFluidIteration.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the iteration classes used by SU2_CFD.
* Each CIteration class represents an available physics package.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/iteration/CDiscAdjHeatIteration.hpp b/SU2_CFD/include/iteration/CDiscAdjHeatIteration.hpp
index 0736fe0a1fc..933ad64ca65 100644
--- a/SU2_CFD/include/iteration/CDiscAdjHeatIteration.hpp
+++ b/SU2_CFD/include/iteration/CDiscAdjHeatIteration.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the iteration classes used by SU2_CFD.
* Each CIteration class represents an available physics package.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/iteration/CFEAIteration.hpp b/SU2_CFD/include/iteration/CFEAIteration.hpp
index aadc86fd22b..1998b19cfa0 100644
--- a/SU2_CFD/include/iteration/CFEAIteration.hpp
+++ b/SU2_CFD/include/iteration/CFEAIteration.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the iteration classes used by SU2_CFD.
* Each CIteration class represents an available physics package.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -34,7 +34,7 @@
* \class CFEAIteration
* \brief Class for driving an iteration of structural analysis.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CFEAIteration : public CIteration {
public:
diff --git a/SU2_CFD/include/iteration/CFEMFluidIteration.hpp b/SU2_CFD/include/iteration/CFEMFluidIteration.hpp
index f89896550cf..aa147b1b171 100644
--- a/SU2_CFD/include/iteration/CFEMFluidIteration.hpp
+++ b/SU2_CFD/include/iteration/CFEMFluidIteration.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the iteration classes used by SU2_CFD.
* Each CIteration class represents an available physics package.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -34,7 +34,7 @@
* \class CFEMFluidIteration
* \brief Class for driving an iteration of the finite element flow system.
* \author T. Economon, E. van der Weide
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CFEMFluidIteration : public CFluidIteration {
public:
diff --git a/SU2_CFD/include/iteration/CFluidIteration.hpp b/SU2_CFD/include/iteration/CFluidIteration.hpp
index 9271ef475a1..2e5029d0dd7 100644
--- a/SU2_CFD/include/iteration/CFluidIteration.hpp
+++ b/SU2_CFD/include/iteration/CFluidIteration.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the iteration classes used by SU2_CFD.
* Each CIteration class represents an available physics package.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/iteration/CHeatIteration.hpp b/SU2_CFD/include/iteration/CHeatIteration.hpp
index 54b81aae79a..6490c30c466 100644
--- a/SU2_CFD/include/iteration/CHeatIteration.hpp
+++ b/SU2_CFD/include/iteration/CHeatIteration.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the iteration classes used by SU2_CFD.
* Each CIteration class represents an available physics package.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/iteration/CIteration.hpp b/SU2_CFD/include/iteration/CIteration.hpp
index f4691250b97..7a75eadf213 100644
--- a/SU2_CFD/include/iteration/CIteration.hpp
+++ b/SU2_CFD/include/iteration/CIteration.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the iteration classes used by SU2_CFD.
* Each CIteration class represents an available physics package.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/iteration/CIterationFactory.hpp b/SU2_CFD/include/iteration/CIterationFactory.hpp
index e731134fffb..af39692f5e6 100644
--- a/SU2_CFD/include/iteration/CIterationFactory.hpp
+++ b/SU2_CFD/include/iteration/CIterationFactory.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the iteration classes used by SU2_CFD.
* Each CIteration class represents an available physics package.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/iteration/CTurboIteration.hpp b/SU2_CFD/include/iteration/CTurboIteration.hpp
index e93ff07325b..aab0cd598bf 100644
--- a/SU2_CFD/include/iteration/CTurboIteration.hpp
+++ b/SU2_CFD/include/iteration/CTurboIteration.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the iteration classes used by SU2_CFD.
* Each CIteration class represents an available physics package.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/limiters/CLimiterDetails.hpp b/SU2_CFD/include/limiters/CLimiterDetails.hpp
index 7c9dbb1fe62..2b82e80351c 100644
--- a/SU2_CFD/include/limiters/CLimiterDetails.hpp
+++ b/SU2_CFD/include/limiters/CLimiterDetails.hpp
@@ -3,7 +3,7 @@
* \brief A class template that allows defining limiters via
* specialization of particular details.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/limiters/computeLimiters.hpp b/SU2_CFD/include/limiters/computeLimiters.hpp
index 5b0b2bbfc2e..a54832af6b9 100644
--- a/SU2_CFD/include/limiters/computeLimiters.hpp
+++ b/SU2_CFD/include/limiters/computeLimiters.hpp
@@ -2,7 +2,7 @@
* \file computeLimiters.hpp
* \brief Compute limiters wrapper function.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/limiters/computeLimiters_impl.hpp b/SU2_CFD/include/limiters/computeLimiters_impl.hpp
index f15ebe68109..ae43d10e07a 100644
--- a/SU2_CFD/include/limiters/computeLimiters_impl.hpp
+++ b/SU2_CFD/include/limiters/computeLimiters_impl.hpp
@@ -4,7 +4,7 @@
* \note Common methods are derived by defining small details
* via specialization of CLimiterDetails.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/CNumerics.hpp b/SU2_CFD/include/numerics/CNumerics.hpp
index ef0172750f5..b3e20801e84 100644
--- a/SU2_CFD/include/numerics/CNumerics.hpp
+++ b/SU2_CFD/include/numerics/CNumerics.hpp
@@ -3,7 +3,7 @@
* \brief Delaration of the base numerics class, the
* implementation is in the CNumerics.cpp file.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/NEMO/CNEMONumerics.hpp b/SU2_CFD/include/numerics/NEMO/CNEMONumerics.hpp
index 0590231b4e3..510e755d083 100644
--- a/SU2_CFD/include/numerics/NEMO/CNEMONumerics.hpp
+++ b/SU2_CFD/include/numerics/NEMO/CNEMONumerics.hpp
@@ -2,7 +2,7 @@
* \file CNEMONumerics.hpp
* \brief Base class template NEMO numerics.
* \author C. Garbacz, W. Maier, S. R. Copeland
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/NEMO/NEMO_diffusion.hpp b/SU2_CFD/include/numerics/NEMO/NEMO_diffusion.hpp
index f8fc6c01cb8..a44dbe598b6 100644
--- a/SU2_CFD/include/numerics/NEMO/NEMO_diffusion.hpp
+++ b/SU2_CFD/include/numerics/NEMO/NEMO_diffusion.hpp
@@ -2,7 +2,7 @@
* \file NEMO_diffusion.hpp
* \brief Declarations of numerics classes for viscous flux computation.
* \author S.R. Copeland, W. Maier, C. Garbacz.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -34,7 +34,7 @@
* \brief Class for computing viscous term using the average of gradients.
* \ingroup ViscDiscr
* \author S.R. Copeland, W. Maier, C. Garbacz
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CAvgGrad_NEMO : public CNEMONumerics {
private:
@@ -89,7 +89,7 @@ class CAvgGrad_NEMO : public CNEMONumerics {
* \brief Class for computing viscous term using the average of gradients.
* \ingroup ViscDiscr
* \author C. Garbacz, W. Maier, S.R. Copeland.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CAvgGradCorrected_NEMO : public CNEMONumerics {
private:
diff --git a/SU2_CFD/include/numerics/NEMO/NEMO_sources.hpp b/SU2_CFD/include/numerics/NEMO/NEMO_sources.hpp
index 7db036298bd..c94cc1620c7 100644
--- a/SU2_CFD/include/numerics/NEMO/NEMO_sources.hpp
+++ b/SU2_CFD/include/numerics/NEMO/NEMO_sources.hpp
@@ -2,7 +2,7 @@
* \file NEMO_sources.hpp
* \brief Delarations of numerics classes for source-term integration.
* \author C. Garbacz, W. Maier, S. Copeland.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -34,7 +34,7 @@
* \brief Class for two-temperature model source terms.
* \ingroup SourceDiscr
* \author C. Garbacz, W. Maier, S. Copeland.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CSource_NEMO : public CNEMONumerics {
private:
diff --git a/SU2_CFD/include/numerics/NEMO/convection/ausm.hpp b/SU2_CFD/include/numerics/NEMO/convection/ausm.hpp
index 4f1e2e1a3fe..3a6c15c2211 100644
--- a/SU2_CFD/include/numerics/NEMO/convection/ausm.hpp
+++ b/SU2_CFD/include/numerics/NEMO/convection/ausm.hpp
@@ -2,7 +2,7 @@
* \file ausm.hpp
* \brief Declaration of numerics classes for the AUSM family of schemes in NEMO.
* \author F. Palacios, S.R. Copeland, W. Maier, C. Garbacz
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/NEMO/convection/ausmplusup2.hpp b/SU2_CFD/include/numerics/NEMO/convection/ausmplusup2.hpp
index e2efa3c4746..4ae5a51c504 100644
--- a/SU2_CFD/include/numerics/NEMO/convection/ausmplusup2.hpp
+++ b/SU2_CFD/include/numerics/NEMO/convection/ausmplusup2.hpp
@@ -2,7 +2,7 @@
* \file ausmplusup2.hpp
* \brief Declaration of numerics classes for the AUSM family of schemes in NEMO - AUSM+UP2.
* \author W. Maier, A. Sachedeva, C. Garbacz.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/NEMO/convection/ausmpwplus.hpp b/SU2_CFD/include/numerics/NEMO/convection/ausmpwplus.hpp
index 8796f07ae10..e906b912ea3 100644
--- a/SU2_CFD/include/numerics/NEMO/convection/ausmpwplus.hpp
+++ b/SU2_CFD/include/numerics/NEMO/convection/ausmpwplus.hpp
@@ -2,7 +2,7 @@
* \file ausmpwplus.hpp
* \brief Declaration of numerics classes for the AUSM family of schemes in NEMO - AUSMPWPLUS.
* \author F. Palacios, W.Maier, C. Garbacz
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/NEMO/convection/lax.hpp b/SU2_CFD/include/numerics/NEMO/convection/lax.hpp
index 7c89fb579b9..8356749a0a3 100644
--- a/SU2_CFD/include/numerics/NEMO/convection/lax.hpp
+++ b/SU2_CFD/include/numerics/NEMO/convection/lax.hpp
@@ -2,7 +2,7 @@
* \file lax.hpp
* \brief Declaration of numerics classes for Lax centered scheme.
* \author F. Palacios, S.R. Copeland, W. Maier, C. Garbacz
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/NEMO/convection/msw.hpp b/SU2_CFD/include/numerics/NEMO/convection/msw.hpp
index a5c587c1f58..de280e98038 100644
--- a/SU2_CFD/include/numerics/NEMO/convection/msw.hpp
+++ b/SU2_CFD/include/numerics/NEMO/convection/msw.hpp
@@ -2,7 +2,7 @@
* \file msw.hpp
* \brief Declaration of numerics classes for modified Steger-Warming scheme.
* \author ADL Stanford, S.R. Copeland, W. Maier, C. Garbacz
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -34,7 +34,7 @@
* \brief Class for solving a flux-vector splitting method by Steger & Warming, modified version.
* \ingroup ConvDiscr
* \author ADL Stanford, S.R. Copeland, W. Maier, C. Garbacz
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CUpwMSW_NEMO : public CNEMONumerics {
private:
diff --git a/SU2_CFD/include/numerics/NEMO/convection/roe.hpp b/SU2_CFD/include/numerics/NEMO/convection/roe.hpp
index 89393c25e3f..306901c570e 100644
--- a/SU2_CFD/include/numerics/NEMO/convection/roe.hpp
+++ b/SU2_CFD/include/numerics/NEMO/convection/roe.hpp
@@ -2,7 +2,7 @@
* \file roe.hpp
* \brief Delarations of numerics classes for Roe-type schemes in NEMO.
* \author S.R. Copeland, W. Maier, C. Garbacz
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -34,7 +34,7 @@
* \brief Class for evaluating the Riemann problem using Roe's scheme for a two-temperature model.
* \ingroup ConvDiscr
* \author S. R. Copeland, W. Maier, C. Garbacz
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CUpwRoe_NEMO : public CNEMONumerics {
private:
diff --git a/SU2_CFD/include/numerics/continuous_adjoint/adj_convection.hpp b/SU2_CFD/include/numerics/continuous_adjoint/adj_convection.hpp
index 43ec863a17f..0cad6e0a41b 100644
--- a/SU2_CFD/include/numerics/continuous_adjoint/adj_convection.hpp
+++ b/SU2_CFD/include/numerics/continuous_adjoint/adj_convection.hpp
@@ -3,7 +3,7 @@
* \brief Delarations of numerics classes for continuous adjoint
* convective discretization. Implemented in adj_convection.cpp.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/continuous_adjoint/adj_diffusion.hpp b/SU2_CFD/include/numerics/continuous_adjoint/adj_diffusion.hpp
index 07b566bd69d..9e3bb461983 100644
--- a/SU2_CFD/include/numerics/continuous_adjoint/adj_diffusion.hpp
+++ b/SU2_CFD/include/numerics/continuous_adjoint/adj_diffusion.hpp
@@ -3,7 +3,7 @@
* \brief Delarations of numerics classes for continuous adjoint
* diffusion discretization. Implemented in adj_diffusion.cpp.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/continuous_adjoint/adj_sources.hpp b/SU2_CFD/include/numerics/continuous_adjoint/adj_sources.hpp
index 4cca49fc667..c8e7be9b98b 100644
--- a/SU2_CFD/include/numerics/continuous_adjoint/adj_sources.hpp
+++ b/SU2_CFD/include/numerics/continuous_adjoint/adj_sources.hpp
@@ -3,7 +3,7 @@
* \brief Delarations of numerics classes for continuous adjoint
* source term integration. Implemented in adj_sources.cpp.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/elasticity/CFEAElasticity.hpp b/SU2_CFD/include/numerics/elasticity/CFEAElasticity.hpp
index bf3c352dedd..dd777faea78 100644
--- a/SU2_CFD/include/numerics/elasticity/CFEAElasticity.hpp
+++ b/SU2_CFD/include/numerics/elasticity/CFEAElasticity.hpp
@@ -2,7 +2,7 @@
* \file CFEAElasticity.hpp
* \brief Declaration and inlines of the base class for elasticity problems.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -38,7 +38,7 @@
* document the public interface of this class hierarchy.
* \ingroup FEM_Discr
* \author R.Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CFEAElasticity : public CNumerics {
diff --git a/SU2_CFD/include/numerics/elasticity/CFEALinearElasticity.hpp b/SU2_CFD/include/numerics/elasticity/CFEALinearElasticity.hpp
index c4c07580c8d..e896c04258a 100644
--- a/SU2_CFD/include/numerics/elasticity/CFEALinearElasticity.hpp
+++ b/SU2_CFD/include/numerics/elasticity/CFEALinearElasticity.hpp
@@ -2,7 +2,7 @@
* \file CFEALinearElasticity.hpp
* \brief Declaration and inlines of the linear elasticity FE numerics class.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -35,7 +35,7 @@
* \brief Class for computing the stiffness matrix of a linear, elastic problem.
* \ingroup FEM_Discr
* \author R.Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CFEALinearElasticity : public CFEAElasticity {
protected:
@@ -90,7 +90,7 @@ class CFEALinearElasticity : public CFEAElasticity {
* \brief Particular case of linear elasticity used for mesh deformation.
* \ingroup FEM_Discr
* \author R.Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CFEAMeshElasticity final : public CFEALinearElasticity {
diff --git a/SU2_CFD/include/numerics/elasticity/CFEANonlinearElasticity.hpp b/SU2_CFD/include/numerics/elasticity/CFEANonlinearElasticity.hpp
index 6457b104d9e..afffa5351b3 100644
--- a/SU2_CFD/include/numerics/elasticity/CFEANonlinearElasticity.hpp
+++ b/SU2_CFD/include/numerics/elasticity/CFEANonlinearElasticity.hpp
@@ -2,7 +2,7 @@
* \file CFEANonlinearElasticity.hpp
* \brief Declaration and inlines of the nonlinear elasticity FE numerics class.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -37,7 +37,7 @@
* Compute_Plane_Stress_Term and Compute_Stress_Tensor.
* \ingroup FEM_Discr
* \author R.Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CFEANonlinearElasticity : public CFEAElasticity {
diff --git a/SU2_CFD/include/numerics/elasticity/nonlinear_models.hpp b/SU2_CFD/include/numerics/elasticity/nonlinear_models.hpp
index e3fa2b0de10..db14e4c9fa1 100644
--- a/SU2_CFD/include/numerics/elasticity/nonlinear_models.hpp
+++ b/SU2_CFD/include/numerics/elasticity/nonlinear_models.hpp
@@ -2,7 +2,7 @@
* \file nonlinear_models.hpp
* \brief Declarations of nonlinear constitutive models.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -35,7 +35,7 @@
* \brief Class for computing the constitutive and stress tensors for a neo-Hookean material model, compressible.
* \ingroup FEM_Discr
* \author R.Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CFEM_NeoHookean_Comp final : public CFEANonlinearElasticity {
@@ -83,7 +83,7 @@ class CFEM_NeoHookean_Comp final : public CFEANonlinearElasticity {
* \brief Constitutive and stress tensors for a Knowles stored-energy function, nearly incompressible.
* \ingroup FEM_Discr
* \author R.Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CFEM_Knowles_NearInc final : public CFEANonlinearElasticity {
@@ -134,7 +134,7 @@ class CFEM_Knowles_NearInc final : public CFEANonlinearElasticity {
* \brief Class for computing the constitutive and stress tensors for a dielectric elastomer.
* \ingroup FEM_Discr
* \author R.Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CFEM_DielectricElastomer final : public CFEANonlinearElasticity {
@@ -182,7 +182,7 @@ class CFEM_DielectricElastomer final : public CFEANonlinearElasticity {
* \brief Class for computing the constitutive and stress tensors for a nearly-incompressible ideal DE.
* \ingroup FEM_Discr
* \author R.Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CFEM_IdealDE final : public CFEANonlinearElasticity {
diff --git a/SU2_CFD/include/numerics/flow/convection/ausm_slau.hpp b/SU2_CFD/include/numerics/flow/convection/ausm_slau.hpp
index 5728634b36d..e1b6a59f6f7 100644
--- a/SU2_CFD/include/numerics/flow/convection/ausm_slau.hpp
+++ b/SU2_CFD/include/numerics/flow/convection/ausm_slau.hpp
@@ -3,7 +3,7 @@
* \brief Declaration of numerics classes for the AUSM family of schemes,
* including SLAU. The implementation is in ausm.cpp.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/flow/convection/centered.hpp b/SU2_CFD/include/numerics/flow/convection/centered.hpp
index 3f808c4aa88..2b140b168a5 100644
--- a/SU2_CFD/include/numerics/flow/convection/centered.hpp
+++ b/SU2_CFD/include/numerics/flow/convection/centered.hpp
@@ -3,7 +3,7 @@
* \brief Delaration of numerics classes for centered schemes,
* the implementation is in centered.cpp.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/flow/convection/cusp.hpp b/SU2_CFD/include/numerics/flow/convection/cusp.hpp
index 25cc6058876..eed2403cc7f 100644
--- a/SU2_CFD/include/numerics/flow/convection/cusp.hpp
+++ b/SU2_CFD/include/numerics/flow/convection/cusp.hpp
@@ -2,7 +2,7 @@
* \file cusp.hpp
* \brief Declaration of the CUSP numerics class.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/flow/convection/fds.hpp b/SU2_CFD/include/numerics/flow/convection/fds.hpp
index 0ac74986d4c..1cfeed942e1 100644
--- a/SU2_CFD/include/numerics/flow/convection/fds.hpp
+++ b/SU2_CFD/include/numerics/flow/convection/fds.hpp
@@ -3,7 +3,7 @@
* \brief Declarations of classes for Flux-Difference-Spliting schemes,
* the implementations are in fds.cpp
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/flow/convection/fvs.hpp b/SU2_CFD/include/numerics/flow/convection/fvs.hpp
index c8f98d6d5f2..da8d27da152 100644
--- a/SU2_CFD/include/numerics/flow/convection/fvs.hpp
+++ b/SU2_CFD/include/numerics/flow/convection/fvs.hpp
@@ -3,7 +3,7 @@
* \brief Delarations of classes for Flux-Vector-Spliting schemes,
* the implementations are in fvs.cpp.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/flow/convection/hllc.hpp b/SU2_CFD/include/numerics/flow/convection/hllc.hpp
index 6507ef06df4..9f391485191 100644
--- a/SU2_CFD/include/numerics/flow/convection/hllc.hpp
+++ b/SU2_CFD/include/numerics/flow/convection/hllc.hpp
@@ -2,7 +2,7 @@
* \file hllc.hpp
* \brief Declaration of HLLC numerics classes, implemented in hllc.cpp.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -34,7 +34,7 @@
* \brief Class for solving an approximate Riemann HLLC.
* \ingroup ConvDiscr
* \author G. Gori, Politecnico di Milano
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CUpwHLLC_Flow final : public CNumerics {
private:
@@ -86,7 +86,7 @@ class CUpwHLLC_Flow final : public CNumerics {
* \brief Class for solving an approximate Riemann HLLC.
* \ingroup ConvDiscr
* \author G. Gori, Politecnico di Milano
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CUpwGeneralHLLC_Flow final : public CNumerics {
private:
diff --git a/SU2_CFD/include/numerics/flow/convection/roe.hpp b/SU2_CFD/include/numerics/flow/convection/roe.hpp
index af53bc18c93..7de952680d3 100644
--- a/SU2_CFD/include/numerics/flow/convection/roe.hpp
+++ b/SU2_CFD/include/numerics/flow/convection/roe.hpp
@@ -3,7 +3,7 @@
* \brief Delarations of numerics classes for Roe-type schemes,
* implemented in roe.cpp.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -119,7 +119,7 @@ class CUpwRoe_Flow final : public CUpwRoeBase_Flow {
* \brief Class for solving an approximate Riemann solver of L2Roe for the flow equations.
* \ingroup ConvDiscr
* \author E. Molina, A. Bueno, F. Palacios, P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CUpwL2Roe_Flow final : public CUpwRoeBase_Flow {
private:
@@ -149,7 +149,7 @@ class CUpwL2Roe_Flow final : public CUpwRoeBase_Flow {
* \brief Class for solving an approximate Riemann solver of LMRoe for the flow equations.
* \ingroup ConvDiscr
* \author E. Molina, A. Bueno, F. Palacios, P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CUpwLMRoe_Flow final : public CUpwRoeBase_Flow {
private:
diff --git a/SU2_CFD/include/numerics/flow/flow_diffusion.hpp b/SU2_CFD/include/numerics/flow/flow_diffusion.hpp
index f72677c78e9..b58a91c7d67 100644
--- a/SU2_CFD/include/numerics/flow/flow_diffusion.hpp
+++ b/SU2_CFD/include/numerics/flow/flow_diffusion.hpp
@@ -2,7 +2,7 @@
* \file flow_diffusion.hpp
* \brief Delarations of numerics classes for viscous flux computation.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/flow/flow_sources.hpp b/SU2_CFD/include/numerics/flow/flow_sources.hpp
index 2f5d7275fac..8930af68505 100644
--- a/SU2_CFD/include/numerics/flow/flow_sources.hpp
+++ b/SU2_CFD/include/numerics/flow/flow_sources.hpp
@@ -2,7 +2,7 @@
* \file flow_sources.hpp
* \brief Delarations of numerics classes for source-term integration.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -177,7 +177,7 @@ class CSourceBodyForce final : public CSourceBase_Flow {
* \brief Class for the source term integration of a body force in the incompressible solver.
* \ingroup SourceDiscr
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CSourceIncBodyForce final : public CSourceBase_Flow {
su2double Body_Force_Vector[3];
@@ -204,7 +204,7 @@ class CSourceIncBodyForce final : public CSourceBase_Flow {
* \brief Class for the source term integration of the Boussinesq approximation for incompressible flow.
* \ingroup SourceDiscr
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CSourceBoussinesq final : public CSourceBase_Flow {
su2double Gravity_Vector[3];
diff --git a/SU2_CFD/include/numerics/heat.hpp b/SU2_CFD/include/numerics/heat.hpp
index 4a869c73f0e..58c91a7fd3d 100644
--- a/SU2_CFD/include/numerics/heat.hpp
+++ b/SU2_CFD/include/numerics/heat.hpp
@@ -2,7 +2,7 @@
* \file heat.hpp
* \brief Delarations of numerics classes for heat transfer problems.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -34,7 +34,7 @@
* \brief Class for scalar centered scheme.
* \ingroup ConvDiscr
* \author O. Burghardt
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CCentSca_Heat : public CNumerics {
@@ -81,7 +81,7 @@ class CCentSca_Heat : public CNumerics {
* \brief Class for doing a scalar upwind solver for the heat convection equation.
* \ingroup ConvDiscr
* \author O. Burghardt.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CUpwSca_Heat : public CNumerics {
private:
@@ -119,7 +119,7 @@ class CUpwSca_Heat : public CNumerics {
* \brief Class for computing viscous term using average of gradients without correction (heat equation).
* \ingroup ViscDiscr
* \author O. Burghardt.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CAvgGrad_Heat : public CNumerics {
private:
@@ -160,7 +160,7 @@ class CAvgGrad_Heat : public CNumerics {
* \brief Class for computing viscous term using average of gradients with correction (heat equation).
* \ingroup ViscDiscr
* \author O. Burghardt.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CAvgGradCorrected_Heat : public CNumerics {
private:
diff --git a/SU2_CFD/include/numerics/radiation.hpp b/SU2_CFD/include/numerics/radiation.hpp
index 768ec3a83eb..dba0db87841 100644
--- a/SU2_CFD/include/numerics/radiation.hpp
+++ b/SU2_CFD/include/numerics/radiation.hpp
@@ -3,7 +3,7 @@
* \brief Declaration and inlines of the classes used to compute
* residual terms in radiation problems.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/template.hpp b/SU2_CFD/include/numerics/template.hpp
index b305ce98f00..4dae8622eda 100644
--- a/SU2_CFD/include/numerics/template.hpp
+++ b/SU2_CFD/include/numerics/template.hpp
@@ -5,7 +5,7 @@
* new schemes in SU2, in practice you should look for a similar
* scheme and try to re-use functionality (not by copy-paste).
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/transition.hpp b/SU2_CFD/include/numerics/transition.hpp
index 4be38768ee3..ded785a2ad3 100644
--- a/SU2_CFD/include/numerics/transition.hpp
+++ b/SU2_CFD/include/numerics/transition.hpp
@@ -2,7 +2,7 @@
* \file transition.hpp
* \brief Delarations of numerics classes for transition problems.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/turbulent/turb_convection.hpp b/SU2_CFD/include/numerics/turbulent/turb_convection.hpp
index f50fbaa9764..9abad4d6ad3 100644
--- a/SU2_CFD/include/numerics/turbulent/turb_convection.hpp
+++ b/SU2_CFD/include/numerics/turbulent/turb_convection.hpp
@@ -3,7 +3,7 @@
* \brief Delarations of numerics classes for discretization of
* convective fluxes in turbulence problems.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/turbulent/turb_diffusion.hpp b/SU2_CFD/include/numerics/turbulent/turb_diffusion.hpp
index de77c97a6be..4fdcd62c5e7 100644
--- a/SU2_CFD/include/numerics/turbulent/turb_diffusion.hpp
+++ b/SU2_CFD/include/numerics/turbulent/turb_diffusion.hpp
@@ -3,7 +3,7 @@
* \brief Declarations of numerics classes for discretization of
* viscous fluxes in turbulence problems.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics/turbulent/turb_sources.hpp b/SU2_CFD/include/numerics/turbulent/turb_sources.hpp
index 55f5ba65842..92960ca41e4 100644
--- a/SU2_CFD/include/numerics/turbulent/turb_sources.hpp
+++ b/SU2_CFD/include/numerics/turbulent/turb_sources.hpp
@@ -3,7 +3,7 @@
* \brief Delarations of numerics classes for integration of source
* terms in turbulence problems.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -158,7 +158,7 @@ class CSourcePieceWise_TurbSA final : public CSourceBase_TurbSA {
* \brief Class for integrating the source terms of the Spalart-Allmaras CC modification turbulence model equation.
* \ingroup SourceDiscr
* \author E.Molina, A. Bueno.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CSourcePieceWise_TurbSA_COMP final : public CSourceBase_TurbSA {
private:
@@ -193,7 +193,7 @@ class CSourcePieceWise_TurbSA_COMP final : public CSourceBase_TurbSA {
* \brief Class for integrating the source terms of the Spalart-Allmaras Edwards modification turbulence model equation.
* \ingroup SourceDiscr
* \author E.Molina, A. Bueno.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CSourcePieceWise_TurbSA_E final : public CSourceBase_TurbSA {
private:
@@ -226,7 +226,7 @@ class CSourcePieceWise_TurbSA_E final : public CSourceBase_TurbSA {
* \brief Class for integrating the source terms of the Spalart-Allmaras Edwards modification with CC turbulence model equation.
* \ingroup SourceDiscr
* \author E.Molina, A. Bueno.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CSourcePieceWise_TurbSA_E_COMP : public CSourceBase_TurbSA {
private:
diff --git a/SU2_CFD/include/numerics_simd/CNumericsSIMD.cpp b/SU2_CFD/include/numerics_simd/CNumericsSIMD.cpp
index c7222226109..ccc91a7e577 100644
--- a/SU2_CFD/include/numerics_simd/CNumericsSIMD.cpp
+++ b/SU2_CFD/include/numerics_simd/CNumericsSIMD.cpp
@@ -4,7 +4,7 @@
* \note This should be the only cpp for this family of classes
* (which are all templates). All compilation takes place here.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics_simd/CNumericsSIMD.hpp b/SU2_CFD/include/numerics_simd/CNumericsSIMD.hpp
index 893b648f750..7dbbdb9efa1 100644
--- a/SU2_CFD/include/numerics_simd/CNumericsSIMD.hpp
+++ b/SU2_CFD/include/numerics_simd/CNumericsSIMD.hpp
@@ -2,7 +2,7 @@
* \file CNumericsSIMD.hpp
* \brief Vectorized (SIMD) numerics classes.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics_simd/flow/convection/centered.hpp b/SU2_CFD/include/numerics_simd/flow/convection/centered.hpp
index ca0a708256c..d1180b04466 100644
--- a/SU2_CFD/include/numerics_simd/flow/convection/centered.hpp
+++ b/SU2_CFD/include/numerics_simd/flow/convection/centered.hpp
@@ -2,7 +2,7 @@
* \file centered.hpp
* \brief Centered convective schemes.
* \author P. Gomes, F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics_simd/flow/convection/common.hpp b/SU2_CFD/include/numerics_simd/flow/convection/common.hpp
index a1160191d9c..d05549085bd 100644
--- a/SU2_CFD/include/numerics_simd/flow/convection/common.hpp
+++ b/SU2_CFD/include/numerics_simd/flow/convection/common.hpp
@@ -2,7 +2,7 @@
* \file common.hpp
* \brief Common convection-related methods.
* \author P. Gomes, F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics_simd/flow/convection/roe.hpp b/SU2_CFD/include/numerics_simd/flow/convection/roe.hpp
index bd875f618ea..3477ea0f764 100644
--- a/SU2_CFD/include/numerics_simd/flow/convection/roe.hpp
+++ b/SU2_CFD/include/numerics_simd/flow/convection/roe.hpp
@@ -2,7 +2,7 @@
* \file roe.hpp
* \brief Roe-family of convective schemes.
* \author P. Gomes, A. Bueno, F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics_simd/flow/diffusion/common.hpp b/SU2_CFD/include/numerics_simd/flow/diffusion/common.hpp
index a519cf28f94..c6a212c4c6e 100644
--- a/SU2_CFD/include/numerics_simd/flow/diffusion/common.hpp
+++ b/SU2_CFD/include/numerics_simd/flow/diffusion/common.hpp
@@ -2,7 +2,7 @@
* \file common.hpp
* \brief Helper functions for viscous methods.
* \author P. Gomes, C. Pederson, A. Bueno, F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics_simd/flow/diffusion/viscous_fluxes.hpp b/SU2_CFD/include/numerics_simd/flow/diffusion/viscous_fluxes.hpp
index 69801eaae38..020ce7e05ed 100644
--- a/SU2_CFD/include/numerics_simd/flow/diffusion/viscous_fluxes.hpp
+++ b/SU2_CFD/include/numerics_simd/flow/diffusion/viscous_fluxes.hpp
@@ -2,7 +2,7 @@
* \file viscous_fluxes.hpp
* \brief Decorator classes for computation of viscous fluxes.
* \author P. Gomes, C. Pederson, A. Bueno, F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics_simd/flow/variables.hpp b/SU2_CFD/include/numerics_simd/flow/variables.hpp
index ab270a51c2a..27dd6b7b3ec 100644
--- a/SU2_CFD/include/numerics_simd/flow/variables.hpp
+++ b/SU2_CFD/include/numerics_simd/flow/variables.hpp
@@ -2,7 +2,7 @@
* \file variables.hpp
* \brief Collection of types to store physical variables.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/numerics_simd/util.hpp b/SU2_CFD/include/numerics_simd/util.hpp
index 3bc993b5929..785bf894d51 100644
--- a/SU2_CFD/include/numerics_simd/util.hpp
+++ b/SU2_CFD/include/numerics_simd/util.hpp
@@ -2,7 +2,7 @@
* \file util.hpp
* \brief Generic auxiliary functions.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/CAdjElasticityOutput.hpp b/SU2_CFD/include/output/CAdjElasticityOutput.hpp
index 4da75e2a0af..382da9ee266 100644
--- a/SU2_CFD/include/output/CAdjElasticityOutput.hpp
+++ b/SU2_CFD/include/output/CAdjElasticityOutput.hpp
@@ -2,7 +2,7 @@
* \file CAdjElasticityOutput.hpp
* \brief Headers of the adjoint elasticity output class.
* \author T. Albring, R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/CAdjFlowIncOutput.hpp b/SU2_CFD/include/output/CAdjFlowIncOutput.hpp
index 9f523c0e981..78fb48a1fdf 100644
--- a/SU2_CFD/include/output/CAdjFlowIncOutput.hpp
+++ b/SU2_CFD/include/output/CAdjFlowIncOutput.hpp
@@ -2,7 +2,7 @@
* \file CAdjFlowIncOutput.hpp
* \brief Headers of the adjoint incompressible flow output.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/CAdjFlowOutput.hpp b/SU2_CFD/include/output/CAdjFlowOutput.hpp
index 56c054ecb1d..6d3e6ccb85a 100644
--- a/SU2_CFD/include/output/CAdjFlowOutput.hpp
+++ b/SU2_CFD/include/output/CAdjFlowOutput.hpp
@@ -2,7 +2,7 @@
* \file CAdjFlowCompOutput.hpp
* \brief Headers of the adjoint compressible flow output.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/CAdjHeatOutput.hpp b/SU2_CFD/include/output/CAdjHeatOutput.hpp
index 4da091712c9..1398fd96e55 100644
--- a/SU2_CFD/include/output/CAdjHeatOutput.hpp
+++ b/SU2_CFD/include/output/CAdjHeatOutput.hpp
@@ -2,7 +2,7 @@
* \file output_fea_discadj.hpp
* \brief Headers of the adjoint heat output.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/CBaselineOutput.hpp b/SU2_CFD/include/output/CBaselineOutput.hpp
index fd0f17b92d4..c2e22dadc0f 100644
--- a/SU2_CFD/include/output/CBaselineOutput.hpp
+++ b/SU2_CFD/include/output/CBaselineOutput.hpp
@@ -2,7 +2,7 @@
* \file CBaselineOutput.hpp
* \brief Headers of the baseline output.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/CElasticityOutput.hpp b/SU2_CFD/include/output/CElasticityOutput.hpp
index a8c5ea9a046..60049187133 100644
--- a/SU2_CFD/include/output/CElasticityOutput.hpp
+++ b/SU2_CFD/include/output/CElasticityOutput.hpp
@@ -2,7 +2,7 @@
* \file CElasticityOutput.hpp
* \brief Headers of the elasticity output.
* \author F. Palacios, T. Economon, M. Colonno
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/CFlowCompFEMOutput.hpp b/SU2_CFD/include/output/CFlowCompFEMOutput.hpp
index ec5c5fbd67e..d097f9190e1 100644
--- a/SU2_CFD/include/output/CFlowCompFEMOutput.hpp
+++ b/SU2_CFD/include/output/CFlowCompFEMOutput.hpp
@@ -2,7 +2,7 @@
* \file CFlowCompFEMOutput.hpp
* \brief Headers of the compressible FEM flow output.
* \author R. Sanchez, T. Albring.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/CFlowCompOutput.hpp b/SU2_CFD/include/output/CFlowCompOutput.hpp
index 9ce0535959d..d7370cde962 100644
--- a/SU2_CFD/include/output/CFlowCompOutput.hpp
+++ b/SU2_CFD/include/output/CFlowCompOutput.hpp
@@ -2,7 +2,7 @@
* \file CFlowCompOutput.hpp
* \brief Headers of the compressible flow output.
* \author R. Sanchez, T. Albring.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/CFlowIncOutput.hpp b/SU2_CFD/include/output/CFlowIncOutput.hpp
index 59896cb0eea..7627b1ee7bc 100644
--- a/SU2_CFD/include/output/CFlowIncOutput.hpp
+++ b/SU2_CFD/include/output/CFlowIncOutput.hpp
@@ -2,7 +2,7 @@
* \file CFlowIncCompOutput.hpp
* \brief Headers of the incompressible flow output.
* \author T. Albring, R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/CFlowOutput.hpp b/SU2_CFD/include/output/CFlowOutput.hpp
index 01ba58bd2ae..3571d3e8032 100644
--- a/SU2_CFD/include/output/CFlowOutput.hpp
+++ b/SU2_CFD/include/output/CFlowOutput.hpp
@@ -2,7 +2,7 @@
* \file CFlowOutput.hpp
* \brief Headers of the flow output.
* \author F. Palacios, T. Economon, M. Colonno
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/CHeatOutput.hpp b/SU2_CFD/include/output/CHeatOutput.hpp
index 69ac423ccc7..616562e736e 100644
--- a/SU2_CFD/include/output/CHeatOutput.hpp
+++ b/SU2_CFD/include/output/CHeatOutput.hpp
@@ -2,7 +2,7 @@
* \file CHeatOutput.hpp
* \brief Headers of the heat output.
* \author R. Sanchez, T. Albring.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/CMeshOutput.hpp b/SU2_CFD/include/output/CMeshOutput.hpp
index 68e0b37ffaa..39d071c41d4 100644
--- a/SU2_CFD/include/output/CMeshOutput.hpp
+++ b/SU2_CFD/include/output/CMeshOutput.hpp
@@ -2,7 +2,7 @@
* \file CMeshOutput.hpp
* \brief Headers of the mesh output.
* \author R. Sanchez, T. Albring.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/CMultizoneOutput.hpp b/SU2_CFD/include/output/CMultizoneOutput.hpp
index 38066008186..65c088e576a 100644
--- a/SU2_CFD/include/output/CMultizoneOutput.hpp
+++ b/SU2_CFD/include/output/CMultizoneOutput.hpp
@@ -2,7 +2,7 @@
* \file CDriverOutput.hpp
* \brief Headers of the main subroutines for screen and history output in multizone problems.
* \author R. Sanchez, T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/CNEMOCompOutput.hpp b/SU2_CFD/include/output/CNEMOCompOutput.hpp
index 47a43ea9c4c..1458757833a 100644
--- a/SU2_CFD/include/output/CNEMOCompOutput.hpp
+++ b/SU2_CFD/include/output/CNEMOCompOutput.hpp
@@ -2,7 +2,7 @@
* \file CNEMOCompOutput.hpp
* \brief Headers of the compressible flow output.
* \author R. Sanchez, W. Maier.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/COutput.hpp b/SU2_CFD/include/output/COutput.hpp
index 7f9f3161a80..88358c8726e 100644
--- a/SU2_CFD/include/output/COutput.hpp
+++ b/SU2_CFD/include/output/COutput.hpp
@@ -2,7 +2,7 @@
* \file COutput.hpp
* \brief Headers of the output class.
* \author T.Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/COutputFactory.hpp b/SU2_CFD/include/output/COutputFactory.hpp
index 75a435b7f5b..ece08e8d8df 100644
--- a/SU2_CFD/include/output/COutputFactory.hpp
+++ b/SU2_CFD/include/output/COutputFactory.hpp
@@ -2,7 +2,7 @@
* \file COutput.hpp
* \brief Headers of the output class.
* \author T.Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/COutputLegacy.hpp b/SU2_CFD/include/output/COutputLegacy.hpp
index 17935f935ef..48d1a7367d4 100644
--- a/SU2_CFD/include/output/COutputLegacy.hpp
+++ b/SU2_CFD/include/output/COutputLegacy.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines for generating the file outputs.
* The subroutines and functions are in the output_structure.cpp file.
* \author F. Palacios, T. Economon, M. Colonno
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/filewriter/CCSVFileWriter.hpp b/SU2_CFD/include/output/filewriter/CCSVFileWriter.hpp
index 7e3955a9aed..64eda923292 100644
--- a/SU2_CFD/include/output/filewriter/CCSVFileWriter.hpp
+++ b/SU2_CFD/include/output/filewriter/CCSVFileWriter.hpp
@@ -2,7 +2,7 @@
* \file CCSVFileWriter.hpp
* \brief Headers fo the CSV file writer class.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/filewriter/CFEMDataSorter.hpp b/SU2_CFD/include/output/filewriter/CFEMDataSorter.hpp
index 78450d3b5ef..8a241f5c6f3 100644
--- a/SU2_CFD/include/output/filewriter/CFEMDataSorter.hpp
+++ b/SU2_CFD/include/output/filewriter/CFEMDataSorter.hpp
@@ -2,7 +2,7 @@
* \file CFEMDataSorter.hpp
* \brief Headers fo the FEM data sorter class.
* \author T. Albring, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/filewriter/CFVMDataSorter.hpp b/SU2_CFD/include/output/filewriter/CFVMDataSorter.hpp
index f0facc90130..791701a8210 100644
--- a/SU2_CFD/include/output/filewriter/CFVMDataSorter.hpp
+++ b/SU2_CFD/include/output/filewriter/CFVMDataSorter.hpp
@@ -2,7 +2,7 @@
* \file CFVMDataSorter.hpp
* \brief Headers fo the FVM data sorter class.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/filewriter/CFileWriter.hpp b/SU2_CFD/include/output/filewriter/CFileWriter.hpp
index 542a0b2b285..5734841ffec 100644
--- a/SU2_CFD/include/output/filewriter/CFileWriter.hpp
+++ b/SU2_CFD/include/output/filewriter/CFileWriter.hpp
@@ -2,7 +2,7 @@
* \file CFileWriter.hpp
* \brief Headers fo the file writer class.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/filewriter/CParallelDataSorter.hpp b/SU2_CFD/include/output/filewriter/CParallelDataSorter.hpp
index 1cfc9f7a83e..5b35820c5c7 100644
--- a/SU2_CFD/include/output/filewriter/CParallelDataSorter.hpp
+++ b/SU2_CFD/include/output/filewriter/CParallelDataSorter.hpp
@@ -2,7 +2,7 @@
* \file CParallelDataSorter.hpp
* \brief Headers fo the data sorter class.
* \author T. Albring, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/filewriter/CParaviewBinaryFileWriter.hpp b/SU2_CFD/include/output/filewriter/CParaviewBinaryFileWriter.hpp
index fe46ac6eab7..d25f8641481 100644
--- a/SU2_CFD/include/output/filewriter/CParaviewBinaryFileWriter.hpp
+++ b/SU2_CFD/include/output/filewriter/CParaviewBinaryFileWriter.hpp
@@ -2,7 +2,7 @@
* \file CParaviewBinaryFileWriter.hpp
* \brief Headers fo paraview binary file writer class.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/filewriter/CParaviewFileWriter.hpp b/SU2_CFD/include/output/filewriter/CParaviewFileWriter.hpp
index 3bdf3db11b5..bfe1bd69a97 100644
--- a/SU2_CFD/include/output/filewriter/CParaviewFileWriter.hpp
+++ b/SU2_CFD/include/output/filewriter/CParaviewFileWriter.hpp
@@ -2,7 +2,7 @@
* \file CParaviewFileWriter.hpp
* \brief Headers fo the paraview file writer class.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/filewriter/CParaviewVTMFileWriter.hpp b/SU2_CFD/include/output/filewriter/CParaviewVTMFileWriter.hpp
index 9a1408fa88b..c37cc7558b6 100644
--- a/SU2_CFD/include/output/filewriter/CParaviewVTMFileWriter.hpp
+++ b/SU2_CFD/include/output/filewriter/CParaviewVTMFileWriter.hpp
@@ -2,7 +2,7 @@
* \file CParaviewVTMFileWriter.hpp
* \brief Headers fo paraview binary file writer class.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/filewriter/CParaviewXMLFileWriter.hpp b/SU2_CFD/include/output/filewriter/CParaviewXMLFileWriter.hpp
index bc91a53bf19..25890ed1095 100644
--- a/SU2_CFD/include/output/filewriter/CParaviewXMLFileWriter.hpp
+++ b/SU2_CFD/include/output/filewriter/CParaviewXMLFileWriter.hpp
@@ -2,7 +2,7 @@
* \file CParaviewXMLFileWriter.hpp
* \brief Headers fo paraview binary file writer class.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/filewriter/CSTLFileWriter.hpp b/SU2_CFD/include/output/filewriter/CSTLFileWriter.hpp
index 868e3d3bec7..94438058cb8 100644
--- a/SU2_CFD/include/output/filewriter/CSTLFileWriter.hpp
+++ b/SU2_CFD/include/output/filewriter/CSTLFileWriter.hpp
@@ -2,7 +2,7 @@
* \file CSTLFileWriter.hpp
* \brief Headers fo the STL file writer class.
* \author T. Kattmann, T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -33,7 +33,7 @@
* \class CSTLFileWriter
* \brief Class for writing STL output files.
* \author T. Kattmann, T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CSTLFileWriter final : public CFileWriter{
private:
diff --git a/SU2_CFD/include/output/filewriter/CSU2BinaryFileWriter.hpp b/SU2_CFD/include/output/filewriter/CSU2BinaryFileWriter.hpp
index 2b2d3cd1cb1..ec9bed7a15d 100644
--- a/SU2_CFD/include/output/filewriter/CSU2BinaryFileWriter.hpp
+++ b/SU2_CFD/include/output/filewriter/CSU2BinaryFileWriter.hpp
@@ -2,7 +2,7 @@
* \file CSU2BinaryFileWriter.hpp
* \brief Headers fo the SU2 binary file writer class.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/filewriter/CSU2FileWriter.hpp b/SU2_CFD/include/output/filewriter/CSU2FileWriter.hpp
index c33f3a71961..0b5252b6035 100644
--- a/SU2_CFD/include/output/filewriter/CSU2FileWriter.hpp
+++ b/SU2_CFD/include/output/filewriter/CSU2FileWriter.hpp
@@ -2,7 +2,7 @@
* \file CSU2FileWriter.hpp
* \brief Headers fo the CSV file writer class.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/filewriter/CSU2MeshFileWriter.hpp b/SU2_CFD/include/output/filewriter/CSU2MeshFileWriter.hpp
index 05e35420a6e..5f35f422605 100644
--- a/SU2_CFD/include/output/filewriter/CSU2MeshFileWriter.hpp
+++ b/SU2_CFD/include/output/filewriter/CSU2MeshFileWriter.hpp
@@ -2,7 +2,7 @@
* \file CSU2MeshFileWriter.hpp
* \brief Headers fo the CSV file writer class.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/filewriter/CSurfaceFEMDataSorter.hpp b/SU2_CFD/include/output/filewriter/CSurfaceFEMDataSorter.hpp
index be26c515728..4c0f4bf722e 100644
--- a/SU2_CFD/include/output/filewriter/CSurfaceFEMDataSorter.hpp
+++ b/SU2_CFD/include/output/filewriter/CSurfaceFEMDataSorter.hpp
@@ -2,7 +2,7 @@
* \file CSurfaceFEMDataSorter.hpp
* \brief Headers fo the surface FEM data sorter class.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/filewriter/CSurfaceFVMDataSorter.hpp b/SU2_CFD/include/output/filewriter/CSurfaceFVMDataSorter.hpp
index 79e59827bfa..3eafd7a2cc0 100644
--- a/SU2_CFD/include/output/filewriter/CSurfaceFVMDataSorter.hpp
+++ b/SU2_CFD/include/output/filewriter/CSurfaceFVMDataSorter.hpp
@@ -2,7 +2,7 @@
* \file CSurfaceFVMDataSorter.hpp
* \brief Headers for the surface FVM data sorter class.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/filewriter/CTecplotBinaryFileWriter.hpp b/SU2_CFD/include/output/filewriter/CTecplotBinaryFileWriter.hpp
index 1cf0690e6f4..5b6b1d0ada3 100644
--- a/SU2_CFD/include/output/filewriter/CTecplotBinaryFileWriter.hpp
+++ b/SU2_CFD/include/output/filewriter/CTecplotBinaryFileWriter.hpp
@@ -2,7 +2,7 @@
* \file CTecplotBinaryFileWriter.hpp
* \brief Headers fo the tecplot binary writer class.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/filewriter/CTecplotFileWriter.hpp b/SU2_CFD/include/output/filewriter/CTecplotFileWriter.hpp
index c69d1a748dd..20d48810f59 100644
--- a/SU2_CFD/include/output/filewriter/CTecplotFileWriter.hpp
+++ b/SU2_CFD/include/output/filewriter/CTecplotFileWriter.hpp
@@ -2,7 +2,7 @@
* \file CTecplotFileWriter.hpp
* \brief Headers fo the tecplot ASCII writer class.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/output/tools/CWindowingTools.hpp b/SU2_CFD/include/output/tools/CWindowingTools.hpp
index 6a86139cee5..f5d0649b031 100644
--- a/SU2_CFD/include/output/tools/CWindowingTools.hpp
+++ b/SU2_CFD/include/output/tools/CWindowingTools.hpp
@@ -2,7 +2,7 @@
* \file signal_processing_toolbox.hpp
* \brief Header file for the signal processing toolbox.
* \author S. Schotthöfer
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/sgs_model.hpp b/SU2_CFD/include/sgs_model.hpp
index 6f6be007616..28088842801 100644
--- a/SU2_CFD/include/sgs_model.hpp
+++ b/SU2_CFD/include/sgs_model.hpp
@@ -2,7 +2,7 @@
* \file sgs_model.hpp
* \brief Headers of the LES subgrid scale models of the SU2 solvers.
* \author E. van der Weide, T. Economon, P. Urbanczyk
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -38,7 +38,7 @@ using namespace std;
* \class CSGSModel
* \brief Base class for defining the LES subgrid scale model.
* \author: E. van der Weide, T. Economon, P. Urbanczyk
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CSGSModel {
@@ -224,7 +224,7 @@ class CSGSModel {
* \class CSmagorinskyModel
* \brief Derived class for defining the Smagorinsky SGS model.
* \author: E. van der Weide, T. Economon, P. Urbanczyk
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CSmagorinskyModel : public CSGSModel {
@@ -413,7 +413,7 @@ class CSmagorinskyModel : public CSGSModel {
* \class CWALEModel
* \brief Derived class for defining the WALE SGS model.
* \author: E. van der Weide, T. Economon, P. Urbanczyk
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CWALEModel : public CSGSModel {
@@ -601,7 +601,7 @@ class CWALEModel : public CSGSModel {
* \class CVremanModel
* \brief Derived class for defining the WALE SGS model.
* \author: E. van der Weide, T. Economon, P. Urbanczyk, E. Molina
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CVremanModel : public CSGSModel {
diff --git a/SU2_CFD/include/sgs_model.inl b/SU2_CFD/include/sgs_model.inl
index fbd2a27ced8..74023039c06 100644
--- a/SU2_CFD/include/sgs_model.inl
+++ b/SU2_CFD/include/sgs_model.inl
@@ -2,7 +2,7 @@
* \file sgs_model.inl
* \brief In-Line subroutines of the sgs_model.hpp file.
* \author E. van der Weide, T. Economon, P. Urbanczyk
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CAdjEulerSolver.hpp b/SU2_CFD/include/solvers/CAdjEulerSolver.hpp
index 71ec9e79e0e..c87b3af1771 100644
--- a/SU2_CFD/include/solvers/CAdjEulerSolver.hpp
+++ b/SU2_CFD/include/solvers/CAdjEulerSolver.hpp
@@ -2,7 +2,7 @@
* \file CAdjEulerSolver.hpp
* \brief Headers of the CAdjEulerSolver class
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CAdjNSSolver.hpp b/SU2_CFD/include/solvers/CAdjNSSolver.hpp
index 259886e6ade..98adceed677 100644
--- a/SU2_CFD/include/solvers/CAdjNSSolver.hpp
+++ b/SU2_CFD/include/solvers/CAdjNSSolver.hpp
@@ -2,7 +2,7 @@
* \file CAdjNSSolver.hpp
* \brief Headers of the CAdjNSSolver class
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CAdjTurbSolver.hpp b/SU2_CFD/include/solvers/CAdjTurbSolver.hpp
index 021f2ae3606..459d5039e1a 100644
--- a/SU2_CFD/include/solvers/CAdjTurbSolver.hpp
+++ b/SU2_CFD/include/solvers/CAdjTurbSolver.hpp
@@ -2,7 +2,7 @@
* \file CAdjTurbSolver.hpp
* \brief Headers of the CAdjTurbSolver class
* \author F. Palacios, A. Bueno.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CBaselineSolver.hpp b/SU2_CFD/include/solvers/CBaselineSolver.hpp
index 69aeb6665fc..29fdec3c5b5 100644
--- a/SU2_CFD/include/solvers/CBaselineSolver.hpp
+++ b/SU2_CFD/include/solvers/CBaselineSolver.hpp
@@ -2,7 +2,7 @@
* \file CBaslineSolver.hpp
* \brief Headers of the CBaselineSolver class
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CBaselineSolver_FEM.hpp b/SU2_CFD/include/solvers/CBaselineSolver_FEM.hpp
index 12c2f848ddb..38ef3b20bdb 100644
--- a/SU2_CFD/include/solvers/CBaselineSolver_FEM.hpp
+++ b/SU2_CFD/include/solvers/CBaselineSolver_FEM.hpp
@@ -2,7 +2,7 @@
* \file CBaslineSolver_FEM.hpp
* \brief Headers of the CBaselineSolver class
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -31,7 +31,7 @@
* \class CBaselineSolver_FEM
* \brief Main class for defining a baseline solution from a restart file for the DG-FEM solver output.
* \author T. Economon.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CBaselineSolver_FEM final : public CSolver {
protected:
diff --git a/SU2_CFD/include/solvers/CDiscAdjFEASolver.hpp b/SU2_CFD/include/solvers/CDiscAdjFEASolver.hpp
index 6824d0bc604..8777a720b1f 100644
--- a/SU2_CFD/include/solvers/CDiscAdjFEASolver.hpp
+++ b/SU2_CFD/include/solvers/CDiscAdjFEASolver.hpp
@@ -2,7 +2,7 @@
* \file CDiscAdjFEASolver.hpp
* \brief Headers of the CDiscAdjFEASolver class
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CDiscAdjMeshSolver.hpp b/SU2_CFD/include/solvers/CDiscAdjMeshSolver.hpp
index d5e5882cf50..cc557b4af93 100644
--- a/SU2_CFD/include/solvers/CDiscAdjMeshSolver.hpp
+++ b/SU2_CFD/include/solvers/CDiscAdjMeshSolver.hpp
@@ -3,7 +3,7 @@
* \brief Declaration and inlines of the class to compute the
* the discrete adjoint of the linear-elastic mesh solver.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CDiscAdjSolver.hpp b/SU2_CFD/include/solvers/CDiscAdjSolver.hpp
index f561cbae26a..c5b5dcd4138 100644
--- a/SU2_CFD/include/solvers/CDiscAdjSolver.hpp
+++ b/SU2_CFD/include/solvers/CDiscAdjSolver.hpp
@@ -2,7 +2,7 @@
* \file CDiscAdjSolver.hpp
* \brief Headers of the CDiscAdjSolver class
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CEulerSolver.hpp b/SU2_CFD/include/solvers/CEulerSolver.hpp
index 890bec177e0..8780d54b52c 100644
--- a/SU2_CFD/include/solvers/CEulerSolver.hpp
+++ b/SU2_CFD/include/solvers/CEulerSolver.hpp
@@ -2,7 +2,7 @@
* \file CEulerSolver.hpp
* \brief Headers of the CEulerSolver class
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CFEASolver.hpp b/SU2_CFD/include/solvers/CFEASolver.hpp
index 2e3cee9e5e0..927be283cbd 100644
--- a/SU2_CFD/include/solvers/CFEASolver.hpp
+++ b/SU2_CFD/include/solvers/CFEASolver.hpp
@@ -2,7 +2,7 @@
* \file CFEASolver.hpp
* \brief Finite element solver for elasticity problems.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CFEM_DG_EulerSolver.hpp b/SU2_CFD/include/solvers/CFEM_DG_EulerSolver.hpp
index 0ce24a053d0..74f22ab7950 100644
--- a/SU2_CFD/include/solvers/CFEM_DG_EulerSolver.hpp
+++ b/SU2_CFD/include/solvers/CFEM_DG_EulerSolver.hpp
@@ -2,7 +2,7 @@
* \file CFEM_DG_EulerSolver.hpp
* \brief Headers of the CFEM_DG_EulerSolver class
* \author E. van der Weide, T. Economon, J. Alonso
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -35,7 +35,7 @@
* \brief Main class for defining the Euler Discontinuous Galerkin finite element flow solver.
* \ingroup Euler_Equations
* \author E. van der Weide, T. Economon, J. Alonso
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CFEM_DG_EulerSolver : public CSolver {
protected:
diff --git a/SU2_CFD/include/solvers/CFEM_DG_NSSolver.hpp b/SU2_CFD/include/solvers/CFEM_DG_NSSolver.hpp
index 65d8f336a01..31e44bf29c5 100644
--- a/SU2_CFD/include/solvers/CFEM_DG_NSSolver.hpp
+++ b/SU2_CFD/include/solvers/CFEM_DG_NSSolver.hpp
@@ -2,7 +2,7 @@
* \file CFEM_DG_NSSolver.hpp
* \brief Headers of the CFEM_DG_NSSolver class
* \author E. van der Weide, T. Economon, J. Alonso
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -35,7 +35,7 @@
* \brief Main class for defining the Navier-Stokes Discontinuous Galerkin finite element flow solver.
* \ingroup Navier_Stokes_Equations
* \author E. van der Weide, T. Economon, J. Alonso
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CFEM_DG_NSSolver final : public CFEM_DG_EulerSolver {
private:
diff --git a/SU2_CFD/include/solvers/CFVMFlowSolverBase.hpp b/SU2_CFD/include/solvers/CFVMFlowSolverBase.hpp
index e1673fb1fed..acb1135c426 100644
--- a/SU2_CFD/include/solvers/CFVMFlowSolverBase.hpp
+++ b/SU2_CFD/include/solvers/CFVMFlowSolverBase.hpp
@@ -1,7 +1,7 @@
/*!
* \file CFVMFlowSolverBase.hpp
* \brief Base class template for all FVM flow solvers.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CFVMFlowSolverBase.inl b/SU2_CFD/include/solvers/CFVMFlowSolverBase.inl
index 598d38ff636..5cc95853861 100644
--- a/SU2_CFD/include/solvers/CFVMFlowSolverBase.inl
+++ b/SU2_CFD/include/solvers/CFVMFlowSolverBase.inl
@@ -1,7 +1,7 @@
/*!
* \file CFVMFlowSolverBase.inl
* \brief Base class template for all FVM flow solvers.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CHeatSolver.hpp b/SU2_CFD/include/solvers/CHeatSolver.hpp
index d09d1c3eaef..95b3a063b23 100644
--- a/SU2_CFD/include/solvers/CHeatSolver.hpp
+++ b/SU2_CFD/include/solvers/CHeatSolver.hpp
@@ -2,7 +2,7 @@
* \file CHeatSolver.hpp
* \brief Headers of the CHeatSolver class
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -34,7 +34,7 @@
* \class CHeatSolver
* \brief Main class for defining the finite-volume heat solver.
* \author O. Burghardt
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CHeatSolver final : public CSolver {
protected:
diff --git a/SU2_CFD/include/solvers/CIncEulerSolver.hpp b/SU2_CFD/include/solvers/CIncEulerSolver.hpp
index 796d409d438..b7e650d6087 100644
--- a/SU2_CFD/include/solvers/CIncEulerSolver.hpp
+++ b/SU2_CFD/include/solvers/CIncEulerSolver.hpp
@@ -2,7 +2,7 @@
* \file CIncEulerSolver.hpp
* \brief Headers of the CIncEulerSolver class
* \author F. Palacios, T. Economon, T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CIncNSSolver.hpp b/SU2_CFD/include/solvers/CIncNSSolver.hpp
index 04f8d4286e1..5b2ce7a5ceb 100644
--- a/SU2_CFD/include/solvers/CIncNSSolver.hpp
+++ b/SU2_CFD/include/solvers/CIncNSSolver.hpp
@@ -2,7 +2,7 @@
* \file CIncNSSolver.hpp
* \brief Headers of the CIncNSSolver class
* \author F. Palacios, T. Economon, T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CMeshSolver.hpp b/SU2_CFD/include/solvers/CMeshSolver.hpp
index 55c14d7aa6f..aed8b77f91d 100644
--- a/SU2_CFD/include/solvers/CMeshSolver.hpp
+++ b/SU2_CFD/include/solvers/CMeshSolver.hpp
@@ -3,7 +3,7 @@
* \brief Declaration and inlines of the class to compute the deformation of
* the volumetric numerical grid using the linear elasticity solver.
* \author Ruben Sanchez, based on CVolumetricMovement developments (F. Palacios, A. Bueno, T. Economon, S. Padron)
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CNEMOEulerSolver.hpp b/SU2_CFD/include/solvers/CNEMOEulerSolver.hpp
index 195a218631f..09bb9216b92 100644
--- a/SU2_CFD/include/solvers/CNEMOEulerSolver.hpp
+++ b/SU2_CFD/include/solvers/CNEMOEulerSolver.hpp
@@ -2,7 +2,7 @@
* \file CNEMOEulerSolver.hpp
* \brief Headers of the CNEMOEulerSolver class
* \author S. R. Copeland, F. Palacios, W. Maier.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -36,7 +36,7 @@
* \brief Main class for defining the NEMO Euler's flow solver.
* \ingroup Euler_Equations
* \author S. R. Copeland, F. Palacios, W. Maier.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CNEMOEulerSolver : public CFVMFlowSolverBase {
protected:
diff --git a/SU2_CFD/include/solvers/CNEMONSSolver.hpp b/SU2_CFD/include/solvers/CNEMONSSolver.hpp
index 7e9acf02f54..0c3ea0c1155 100644
--- a/SU2_CFD/include/solvers/CNEMONSSolver.hpp
+++ b/SU2_CFD/include/solvers/CNEMONSSolver.hpp
@@ -2,7 +2,7 @@
* \file CNEMONSSolver.hpp
* \brief Headers of the CNEMONSSolver class
* \author S. R. Copeland, F. Palacios, W. Maier.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CNSSolver.hpp b/SU2_CFD/include/solvers/CNSSolver.hpp
index 99260e34f2c..519c82db16e 100644
--- a/SU2_CFD/include/solvers/CNSSolver.hpp
+++ b/SU2_CFD/include/solvers/CNSSolver.hpp
@@ -2,7 +2,7 @@
* \file CNSSolver.hpp
* \brief Headers of the CNSSolver class
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CRadP1Solver.hpp b/SU2_CFD/include/solvers/CRadP1Solver.hpp
index 88b34da2c5f..1c2e144a6ea 100644
--- a/SU2_CFD/include/solvers/CRadP1Solver.hpp
+++ b/SU2_CFD/include/solvers/CRadP1Solver.hpp
@@ -2,7 +2,7 @@
* \file CRadP1Solver.hpp
* \brief Declaration and inlines of the class to compute a P1 radiation problem.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CRadSolver.hpp b/SU2_CFD/include/solvers/CRadSolver.hpp
index 70f148da5d9..b3ab378c529 100644
--- a/SU2_CFD/include/solvers/CRadSolver.hpp
+++ b/SU2_CFD/include/solvers/CRadSolver.hpp
@@ -2,7 +2,7 @@
* \file CRadSolver.hpp
* \brief Declaration and inlines of the class to compute a generic radiation solver.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CSolver.hpp b/SU2_CFD/include/solvers/CSolver.hpp
index 42af3d4ad5c..48e929d665c 100644
--- a/SU2_CFD/include/solvers/CSolver.hpp
+++ b/SU2_CFD/include/solvers/CSolver.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the CSolver class which is inherited by all of the other
* solvers
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CTemplateSolver.hpp b/SU2_CFD/include/solvers/CTemplateSolver.hpp
index db6c7601f7e..395564f5201 100644
--- a/SU2_CFD/include/solvers/CTemplateSolver.hpp
+++ b/SU2_CFD/include/solvers/CTemplateSolver.hpp
@@ -2,7 +2,7 @@
* \file CTemplateSolver.hpp
* \brief Headers of the CTemplateSolver class
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CTransLMSolver.hpp b/SU2_CFD/include/solvers/CTransLMSolver.hpp
index f60250a0b56..d6120fc028d 100644
--- a/SU2_CFD/include/solvers/CTransLMSolver.hpp
+++ b/SU2_CFD/include/solvers/CTransLMSolver.hpp
@@ -2,7 +2,7 @@
* \file CTransLMSolver.hpp
* \brief Headers of the CTransLMSolver class
* \author A. Aranake
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CTurbSASolver.hpp b/SU2_CFD/include/solvers/CTurbSASolver.hpp
index ef75485c7cc..320cc555715 100644
--- a/SU2_CFD/include/solvers/CTurbSASolver.hpp
+++ b/SU2_CFD/include/solvers/CTurbSASolver.hpp
@@ -2,7 +2,7 @@
* \file CTurbSASolver.hpp
* \brief Headers of the CTurbSASolver class
* \author A. Bueno.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CTurbSSTSolver.hpp b/SU2_CFD/include/solvers/CTurbSSTSolver.hpp
index 6a5813be462..7d38a8050aa 100644
--- a/SU2_CFD/include/solvers/CTurbSSTSolver.hpp
+++ b/SU2_CFD/include/solvers/CTurbSSTSolver.hpp
@@ -2,7 +2,7 @@
* \file CTurbSSTSolver.hpp
* \brief Headers of the CTurbSSTSolver class
* \author A. Campos, F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/solvers/CTurbSolver.hpp b/SU2_CFD/include/solvers/CTurbSolver.hpp
index 8abd303ceb5..31882562bcd 100644
--- a/SU2_CFD/include/solvers/CTurbSolver.hpp
+++ b/SU2_CFD/include/solvers/CTurbSolver.hpp
@@ -2,7 +2,7 @@
* \file CTurbSolver.hpp
* \brief Headers of the CTurbSolver class
* \author A. Bueno.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/task_definition.hpp b/SU2_CFD/include/task_definition.hpp
index ef6318e051b..fa6aef1f99d 100644
--- a/SU2_CFD/include/task_definition.hpp
+++ b/SU2_CFD/include/task_definition.hpp
@@ -2,7 +2,7 @@
* \file task_definition.hpp
* \brief Header of the task definition class for the SU2 solvers.
* \author E. van der Weide, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -37,7 +37,7 @@ using namespace std;
* \class CTaskDefinition
* \brief Class for defining a task to be carried out
* \author: E. van der Weide, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CTaskDefinition {
diff --git a/SU2_CFD/include/task_definition.inl b/SU2_CFD/include/task_definition.inl
index 2d95de81dc1..8482ab72a0b 100644
--- a/SU2_CFD/include/task_definition.inl
+++ b/SU2_CFD/include/task_definition.inl
@@ -2,7 +2,7 @@
* \file task_definition.inl
* \brief In-Line subroutines of the task_definition.hpp file.
* \author E. van der Weide, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/variables/CAdjEulerVariable.hpp b/SU2_CFD/include/variables/CAdjEulerVariable.hpp
index 60b47dba610..448f9763e02 100644
--- a/SU2_CFD/include/variables/CAdjEulerVariable.hpp
+++ b/SU2_CFD/include/variables/CAdjEulerVariable.hpp
@@ -2,7 +2,7 @@
* \file CAdjEulerVariable.hpp
* \brief Main class for defining the variables of the adjoint Euler solver.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/variables/CAdjNSVariable.hpp b/SU2_CFD/include/variables/CAdjNSVariable.hpp
index 83f2c9807f7..cb16c06e516 100644
--- a/SU2_CFD/include/variables/CAdjNSVariable.hpp
+++ b/SU2_CFD/include/variables/CAdjNSVariable.hpp
@@ -2,7 +2,7 @@
* \file CAdjNSVariable.hpp
* \brief Main class for defining the variables of the adjoint Navier-Stokes solver.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/variables/CAdjTurbVariable.hpp b/SU2_CFD/include/variables/CAdjTurbVariable.hpp
index 19a5cc6a689..0c0cf142add 100644
--- a/SU2_CFD/include/variables/CAdjTurbVariable.hpp
+++ b/SU2_CFD/include/variables/CAdjTurbVariable.hpp
@@ -2,7 +2,7 @@
* \file CAdjTurbVariable.hpp
* \brief Main class for defining the variables of the adjoint turbulence model.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/variables/CBaselineVariable.hpp b/SU2_CFD/include/variables/CBaselineVariable.hpp
index be8a1be6348..5cd095e7635 100644
--- a/SU2_CFD/include/variables/CBaselineVariable.hpp
+++ b/SU2_CFD/include/variables/CBaselineVariable.hpp
@@ -2,7 +2,7 @@
* \file CBaselineVariable.hpp
* \brief Main class for defining the variables of a baseline solution from a restart file (for output).
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/variables/CDiscAdjFEABoundVariable.hpp b/SU2_CFD/include/variables/CDiscAdjFEABoundVariable.hpp
index 64226c00dac..b8d4973cd51 100644
--- a/SU2_CFD/include/variables/CDiscAdjFEABoundVariable.hpp
+++ b/SU2_CFD/include/variables/CDiscAdjFEABoundVariable.hpp
@@ -2,7 +2,7 @@
* \file CDiscAdjFEABoundVariable.hpp
* \brief Main class for defining the variables of the adjoint FEA solver at the boundary.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -35,7 +35,7 @@
* \brief Main class for defining the variables on the FEA boundaries for adjoint applications.
* \ingroup Discrete_Adjoint
* \author R. Sanchez.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CDiscAdjFEABoundVariable final : public CDiscAdjFEAVariable {
private:
diff --git a/SU2_CFD/include/variables/CDiscAdjFEAVariable.hpp b/SU2_CFD/include/variables/CDiscAdjFEAVariable.hpp
index 0d3d0ef806a..94dd8162c8d 100644
--- a/SU2_CFD/include/variables/CDiscAdjFEAVariable.hpp
+++ b/SU2_CFD/include/variables/CDiscAdjFEAVariable.hpp
@@ -2,7 +2,7 @@
* \file CDiscAdjFEAVariable.hpp
* \brief Main class for defining the variables of the adjoint FEA solver.
* \author T. Albring, R. Sanchez.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -34,7 +34,7 @@
* \brief Main class for defining the variables of the adjoint solver.
* \ingroup Discrete_Adjoint
* \author T. Albring, R. Sanchez.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CDiscAdjFEAVariable : public CVariable {
protected:
diff --git a/SU2_CFD/include/variables/CDiscAdjMeshBoundVariable.hpp b/SU2_CFD/include/variables/CDiscAdjMeshBoundVariable.hpp
index d6cc480306f..f994925578e 100644
--- a/SU2_CFD/include/variables/CDiscAdjMeshBoundVariable.hpp
+++ b/SU2_CFD/include/variables/CDiscAdjMeshBoundVariable.hpp
@@ -3,7 +3,7 @@
* \brief Declaration and inlines of the class
* to define the adjoint variables of the mesh movement.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/variables/CDiscAdjVariable.hpp b/SU2_CFD/include/variables/CDiscAdjVariable.hpp
index b4f5b332316..ed043787fcc 100644
--- a/SU2_CFD/include/variables/CDiscAdjVariable.hpp
+++ b/SU2_CFD/include/variables/CDiscAdjVariable.hpp
@@ -2,7 +2,7 @@
* \file CDiscAdjVariable.hpp
* \brief Main class for defining the variables of the adjoint solver.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/variables/CEulerVariable.hpp b/SU2_CFD/include/variables/CEulerVariable.hpp
index 24e5a0d2410..3f7a02735d4 100644
--- a/SU2_CFD/include/variables/CEulerVariable.hpp
+++ b/SU2_CFD/include/variables/CEulerVariable.hpp
@@ -2,7 +2,7 @@
* \file CEulerVariable.hpp
* \brief Class for defining the variables of the compressible Euler solver.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/variables/CFEABoundVariable.hpp b/SU2_CFD/include/variables/CFEABoundVariable.hpp
index 37109f9867d..ee229b32e66 100644
--- a/SU2_CFD/include/variables/CFEABoundVariable.hpp
+++ b/SU2_CFD/include/variables/CFEABoundVariable.hpp
@@ -2,7 +2,7 @@
* \file CFEABoundVariable.hpp
* \brief Class for defining the variables on the FEA boundaries for FSI applications.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -37,7 +37,7 @@
* A map is constructed so that variables can be referenced by iPoint instead of iVertex.
* \ingroup Structural Finite Element Analysis Variables
* \author R. Sanchez.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CFEABoundVariable final : public CFEAVariable {
protected:
diff --git a/SU2_CFD/include/variables/CFEAVariable.hpp b/SU2_CFD/include/variables/CFEAVariable.hpp
index 9c2153432ce..dbaa82b3054 100644
--- a/SU2_CFD/include/variables/CFEAVariable.hpp
+++ b/SU2_CFD/include/variables/CFEAVariable.hpp
@@ -2,7 +2,7 @@
* \file CFEAVariable.hpp
* \brief Class for defining the variables of the FEM structural problem.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -34,7 +34,7 @@
* \brief Class for defining the variables of the FEM structural problem.
* \ingroup Structural Finite Element Analysis Variables
* \author F. Palacios, R. Sanchez.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CFEAVariable : public CVariable {
protected:
diff --git a/SU2_CFD/include/variables/CHeatVariable.hpp b/SU2_CFD/include/variables/CHeatVariable.hpp
index a69a05c57ba..92474870a6b 100644
--- a/SU2_CFD/include/variables/CHeatVariable.hpp
+++ b/SU2_CFD/include/variables/CHeatVariable.hpp
@@ -2,7 +2,7 @@
* \file CHeatVariable.hpp
* \brief Class for defining the variables of the finite-volume heat equation solver.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -33,7 +33,7 @@
* \class CHeatVariable
* \brief Class for defining the variables of the finite-volume heat equation solver.
* \author O. Burghardt
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*/
class CHeatVariable final : public CVariable {
protected:
diff --git a/SU2_CFD/include/variables/CIncEulerVariable.hpp b/SU2_CFD/include/variables/CIncEulerVariable.hpp
index abb9d43e312..c736555483d 100644
--- a/SU2_CFD/include/variables/CIncEulerVariable.hpp
+++ b/SU2_CFD/include/variables/CIncEulerVariable.hpp
@@ -2,7 +2,7 @@
* \file CIncEulerVariable.hpp
* \brief Class for defining the variables of the incompressible Euler solver.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/variables/CIncNSVariable.hpp b/SU2_CFD/include/variables/CIncNSVariable.hpp
index e4e3c735e85..37d376babdf 100644
--- a/SU2_CFD/include/variables/CIncNSVariable.hpp
+++ b/SU2_CFD/include/variables/CIncNSVariable.hpp
@@ -3,7 +3,7 @@
* \brief Class for defining the variables of the incompressible
Navier-Stokes solver.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/variables/CMeshBoundVariable.hpp b/SU2_CFD/include/variables/CMeshBoundVariable.hpp
index 43ef5eba4b4..2300bf4c1f9 100644
--- a/SU2_CFD/include/variables/CMeshBoundVariable.hpp
+++ b/SU2_CFD/include/variables/CMeshBoundVariable.hpp
@@ -3,7 +3,7 @@
* \brief Declaration and inlines of the class
* to define the variables of the mesh movement at the moving boundaries.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/variables/CMeshElement.hpp b/SU2_CFD/include/variables/CMeshElement.hpp
index 790c26a2c9c..4ed2e4906f5 100644
--- a/SU2_CFD/include/variables/CMeshElement.hpp
+++ b/SU2_CFD/include/variables/CMeshElement.hpp
@@ -3,7 +3,7 @@
* \brief Declaration and inlines of the class
* to define the variables of the mesh movement.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/variables/CMeshVariable.hpp b/SU2_CFD/include/variables/CMeshVariable.hpp
index 71f68f6e6ff..d242ba161dc 100644
--- a/SU2_CFD/include/variables/CMeshVariable.hpp
+++ b/SU2_CFD/include/variables/CMeshVariable.hpp
@@ -3,7 +3,7 @@
* \brief Declaration and inlines of the class
* to define the variables of the mesh movement.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/variables/CNEMOEulerVariable.hpp b/SU2_CFD/include/variables/CNEMOEulerVariable.hpp
index b68e9498400..2d8596f94f3 100644
--- a/SU2_CFD/include/variables/CNEMOEulerVariable.hpp
+++ b/SU2_CFD/include/variables/CNEMOEulerVariable.hpp
@@ -1,589 +1,589 @@
-/*!
- * \file CNEMOEulerVariable.hpp
- * \brief Class for defining the variables of the compressible NEMO Euler solver.
- * \author C. Garbacz, W. Maier, S.R. Copeland
- * \version 7.1.0 "Blackbird"
- *
- * SU2 Project Website: https://su2code.github.io
- *
- * The SU2 Project is maintained by the SU2 Foundation
- * (http://su2foundation.org)
- *
- * Copyright 2012-2020, SU2 Contributors (cf. AUTHORS.md)
- *
- * SU2 is free software; you can redistribute it and/or
- * modify it under the terms of the GNU Lesser General Public
- * License as published by the Free Software Foundation; either
- * version 2.1 of the License, or (at your option) any later version.
- *
- * SU2 is distributed in the hope that it will be useful,
- * but WITHOUT ANY WARRANTY; without even the implied warranty of
- * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
- * Lesser General Public License for more details.
- *
- * You should have received a copy of the GNU Lesser General Public
- * License along with SU2. If not, see .
- */
-
-#pragma once
-
-#include "CVariable.hpp"
-#include "../fluid/CNEMOGas.hpp"
-
-/*!
- * \class CNEMOEulerVariable
- * \brief Main class for defining the variables of the NEMO Euler's solver.
- * \ingroup Euler_Equations
- * \author S. R. Copeland, F. Palacios, W. Maier, C. Garbacz
- * \version 7.0.8
- */
-class CNEMOEulerVariable : public CVariable {
-public:
- static constexpr size_t MAXNVAR = 25;
-
-protected:
-
- bool ionization; /*!< \brief Presence of charged species in gas mixture. */
- bool monoatomic = false; /*!< \brief Presence of single species gas. */
-
- VectorType Velocity2; /*!< \brief Square of the velocity vector. */
- MatrixType Precond_Beta; /*!< \brief Low Mach number preconditioner value, Beta. */
-
- CVectorOfMatrix& Gradient_Reconstruction; /*!< \brief Reference to the gradient of the conservative variables for MUSCL reconstruction for the convective term */
- CVectorOfMatrix Gradient_Aux; /*!< \brief Auxiliary structure to store a second gradient for reconstruction, if required. */
-
- /*--- Primitive variable definition ---*/
- MatrixType Primitive; /*!< \brief Primitive variables (rhos_s, T, Tve, ...) in compressible flows. */
- MatrixType Primitive_Aux; /*!< \brief Primitive auxiliary variables (Y_s, T, Tve, ...) in compressible flows. */
- CVectorOfMatrix Gradient_Primitive; /*!< \brief Gradient of the primitive variables (rhos_s, T, Tve, ...). */
- MatrixType Limiter_Primitive; /*!< \brief Limiter of the primitive variables (rhos_s, T, Tve, ...). */
-
- /*--- Secondary variable definition ---*/
- MatrixType Secondary; /*!< \brief Primitive variables (T, vx, vy, vz, P, rho, h, c) in compressible flows. */
- CVectorOfMatrix Gradient_Secondary; /*!< \brief Gradient of the primitive variables (T, vx, vy, vz, P, rho). */
-
- /*--- New solution container for Classical RK4 ---*/
- MatrixType Solution_New; /*!< \brief New solution container for Classical RK4. */
-
- /*--- Other Necessary Variable Definition ---*/
- MatrixType dPdU; /*!< \brief Partial derivative of pressure w.r.t. conserved variables. */
- MatrixType dTdU; /*!< \brief Partial derivative of temperature w.r.t. conserved variables. */
- MatrixType dTvedU; /*!< \brief Partial derivative of vib.-el. temperature w.r.t. conserved variables. */
- MatrixType eves; /*!< \brief energy of vib-el mode w.r.t. species. */
- MatrixType Cvves; /*!< \brief Specific heat of vib-el mode w.r.t. species. */
- VectorType Gamma; /*!< \brief Ratio of specific heats. */
-
- CNEMOGas *fluidmodel;
-
- /*!< \brief Index definition for NEMO pritimive variables. */
- unsigned long RHOS_INDEX, T_INDEX, TVE_INDEX, VEL_INDEX, P_INDEX,
- RHO_INDEX, H_INDEX, A_INDEX, RHOCVTR_INDEX, RHOCVVE_INDEX,
- LAM_VISC_INDEX, EDDY_VISC_INDEX, nSpecies;
-
- su2double Tve_Freestream; /*!< \brief Freestream vib-el temperature. */
-
-public:
-
- /*!
- * \brief Constructor of the class.
- * \param[in] val_pressure - Value of the flow pressure (initialization value).
- * \param[in] val_massfrac - Value of the mass fraction (initialization value).
- * \param[in] val_mach - Value of the Mach number (initialization value).
- * \param[in] val_temperature - Value of the flow temperature (initialization value).
- * \param[in] val_temperature_ve - Value of the flow temperature_ve (initialization value).
- * \param[in] npoint - Number of points/nodes/vertices in the domain.
- * \param[in] val_nDim - Number of dimensions of the problem.
- * \param[in] val_nVar - Number of conserved variables.
- * \param[in] val_nVarPrim - Number of primitive variables.
- * \param[in] val_nVarPrimGrad - Number of primitive gradient variables.
- * \param[in] config - Definition of the particular problem.
- */
- CNEMOEulerVariable(su2double val_pressure, const su2double *val_massfrac,
- su2double *val_mach, su2double val_temperature,
- su2double val_temperature_ve, unsigned long npoint,
- unsigned long ndim,
- unsigned long nvar, unsigned long nvalprim,
- unsigned long nvarprimgrad, CConfig *config, CNEMOGas *fluidmodel);
-
- /*!
- * \brief Destructor of the class.
- */
- ~CNEMOEulerVariable() override = default;
-
- /*---------------------------------------*/
- /*--- U,V,S Routines ---*/
- /*---------------------------------------*/
-
- /*!
- * \brief Get the new solution of the problem (Classical RK4).
- * \param[in] iVar - Index of the variable.
- * \return Pointer to the old solution vector.
- */
- inline su2double GetSolution_New(unsigned long iPoint, unsigned long iVar) const final { return Solution_New(iPoint,iVar); }
-
- /*!
- * \brief Set the new solution container for Classical RK4.
- */
- void SetSolution_New() final;
-
- /*!
- * \brief Add a value to the new solution container for Classical RK4.
- * \param[in] iVar - Number of the variable.
- * \param[in] val_solution - Value that we want to add to the solution.
- */
- inline void AddSolution_New(unsigned long iPoint, unsigned long iVar, su2double val_solution) final {
- Solution_New(iPoint,iVar) += val_solution;
- }
-
- /*!
- * \brief Set the value of the primitive variables.
- * \param[in] iVar - Index of the variable.
- * \param[in] iVar - Index of the variable.
- * \return Set the value of the primitive variable for the index iVar.
- */
- inline void SetPrimitive(unsigned long iPoint, unsigned long iVar, su2double val_prim) final { Primitive(iPoint,iVar) = val_prim; }
-
- /*!
- * \brief Set the value of the primitive variables.
- * \param[in] val_prim - Primitive variables.
- * \return Set the value of the primitive variable for the index iVar.
- */
- inline void SetPrimitive(unsigned long iPoint, const su2double *val_prim) final {
- for (unsigned long iVar = 0; iVar < nPrimVar; iVar++)
- Primitive(iPoint,iVar) = val_prim[iVar];
- }
-
- /*!
- * \brief Get the primitive variables limiter.
- * \return Primitive variables limiter for the entire domain.
- */
- inline MatrixType& GetLimiter_Primitive(void) {return Limiter_Primitive; }
-
- /*!
- * \brief Set the gradient of the primitive variables.
- * \param[in] iVar - Index of the variable.
- * \param[in] iDim - Index of the dimension.
- * \param[in] value - Value of the gradient.
- */
- inline su2double GetLimiter_Primitive(unsigned long iPoint, unsigned long iVar) const final {return Limiter_Primitive(iPoint,iVar); }
-
- /*!
- * \brief Get the value of the primitive variables gradient.
- * \return Value of the primitive variables gradient.
- */
- inline su2double *GetLimiter_Primitive(unsigned long iPoint) final { return Limiter_Primitive[iPoint]; }
-
- /*!
- * \brief Set the gradient of the primitive variables.
- * \param[in] iVar - Index of the variable.
- * \param[in] value - Value of the gradient.
- */
- inline void SetLimiter_Primitive(unsigned long iPoint, unsigned long iVar, su2double value) final {
- Limiter_Primitive(iPoint,iVar) = value;
- }
-
- /*!
- * \brief Set the value of the primitive variables.
- * \param[in] iVar - Index of the variable.
- * \param[in] iVar - Index of the variable.
- * \return Set the value of the primitive variable for the index iVar.
- */
- inline void SetSecondary(unsigned long iPoint, unsigned long iVar, su2double val_secondary) final {Secondary(iPoint,iVar) = val_secondary; }
-
- /*!
- * \brief Set the value of the primitive variables.
- * \param[in] val_prim - Primitive variables.
- * \return Set the value of the primitive variable for the index iVar.
- */
- inline void SetSecondary(unsigned long iPoint, const su2double *val_secondary) final {
- for (unsigned long iVar = 0; iVar < nSecondaryVar; iVar++)
- Secondary(iPoint,iVar) = val_secondary[iVar];
- }
-
- /*!
- * \brief Set the value of the primitive auxiliary variables - with mass fractions.
- * \param[in] iVar - Index of the variable.
- * \param[in] iVar - Index of the variable.
- * \return Set the value of the primitive variable for the index iVar.
- */
- inline void SetPrimitive_Aux(unsigned long iPoint, unsigned long iVar, su2double val_prim) { Primitive_Aux(iPoint,iVar) = val_prim; }
-
-
- /*!
- * \brief Get the primitive variables.
- * \param[in] iVar - Index of the variable.
- * \return Value of the primitive variable for the index iVar.
- */
- inline su2double GetPrimitive(unsigned long iPoint, unsigned long iVar) const final { return Primitive(iPoint,iVar); }
-
- /*!
- * \brief Get the primitive variables of the problem.
- * \return Pointer to the primitive variable vector.
- */
- inline su2double *GetPrimitive(unsigned long iPoint) final {return Primitive[iPoint]; }
-
- /*!
- * \brief Get the primitive variables for all points.
- * \return Reference to primitives.
- */
- inline const MatrixType& GetPrimitive(void) const { return Primitive; }
-
- /*!
- * \brief Get the primitive variables for all points.
- * \return Reference to primitives.
- */
- inline const MatrixType& GetPrimitive_Aux(void) const { return Primitive_Aux; }
-
-
- /*!
- * \brief Get the primitive variables.
- * \param[in] iVar - Index of the variable.
- * \return Value of the primitive variable for the index iVar.
- */
- inline su2double GetSecondary(unsigned long iPoint, unsigned long iVar) const final {return Secondary(iPoint,iVar); }
-
- /*!
- * \brief Get the primitive variables of the problem.
- * \return Pointer to the primitive variable vector.
- */
- inline su2double *GetSecondary(unsigned long iPoint) final { return Secondary[iPoint]; }
-
- /*---------------------------------------*/
- /*--- Gradient Routines ---*/
- /*---------------------------------------*/
-
- /*!
- * \brief Get the reconstruction gradient for primitive variable at all points.
- * \return Reference to variable reconstruction gradient.
- */
- inline CVectorOfMatrix& GetGradient_Reconstruction(void) final { return Gradient_Reconstruction; }
-
- /*!
- * \brief Get the value of the reconstruction variables gradient at a node.
- * \param[in] iPoint - Index of the current node.
- * \param[in] iVar - Index of the variable.
- * \param[in] iDim - Index of the dimension.
- * \return Value of the reconstruction variables gradient at a node.
- */
- inline su2double GetGradient_Reconstruction(unsigned long iPoint, unsigned long iVar, unsigned long iDim) const final {
- return Gradient_Reconstruction(iPoint,iVar,iDim);
- }
-
- /*!
- * \brief Get the array of the reconstruction variables gradient at a node.
- * \param[in] iPoint - Index of the current node.
- * \return Array of the reconstruction variables gradient at a node.
- */
- inline su2double **GetGradient_Reconstruction(unsigned long iPoint) final { return Gradient_Reconstruction[iPoint]; }
-
- /*!
- * \brief Get the value of the reconstruction variables gradient at a node.
- * \param[in] iPoint - Index of the current node.
- * \param[in] iVar - Index of the variable.
- * \param[in] iDim - Index of the dimension.
- * \param[in] value - Value of the reconstruction gradient component.
- */
- inline void SetGradient_Reconstruction(unsigned long iPoint, unsigned long iVar, unsigned long iDim, su2double value) final {
- Gradient_Reconstruction(iPoint,iVar,iDim) = value;
- }
-
- /*!
- * \brief Set to zero the gradient of the primitive variables.
- */
- void SetGradient_PrimitiveZero();
-
- /*!
- * \brief Add value to the gradient of the primitive variables.
- * \param[in] iVar - Index of the variable.
- * \param[in] iDim - Index of the dimension.
- * \param[in] value - Value to add to the gradient of the primitive variables.
- */
- inline void AddGradient_Primitive(unsigned long iPoint, unsigned long iVar, unsigned long iDim, su2double value) final {
- Gradient_Primitive(iPoint,iVar,iDim) += value;
- }
-
- /*!
- * \brief Subtract value to the gradient of the primitive variables.
- * \param[in] iVar - Index of the variable.
- * \param[in] iDim - Index of the dimension.
- * \param[in] value - Value to subtract to the gradient of the primitive variables.
- */
- inline void SubtractGradient_Primitive(unsigned long iPoint, unsigned long iVar, unsigned long iDim, su2double value) {
- Gradient_Primitive(iPoint,iVar,iDim) -= value;
- }
-
- /*!
- * \brief Get the value of the primitive variables gradient.
- * \param[in] iVar - Index of the variable.
- * \param[in] iDim - Index of the dimension.
- * \return Value of the primitive variables gradient.
- */
- inline su2double GetGradient_Primitive(unsigned long iPoint, unsigned long iVar, unsigned long iDim) const final {
- return Gradient_Primitive(iPoint,iVar,iDim);
- }
-
- /*!
- * \brief Set the gradient of the primitive variables.
- * \param[in] iVar - Index of the variable.
- * \param[in] iDim - Index of the dimension.
- * \param[in] value - Value of the gradient.
- */
- inline void SetGradient_Primitive(unsigned long iPoint, unsigned long iVar, unsigned long iDim, su2double value) final {
- Gradient_Primitive(iPoint,iVar,iDim) = value;
- }
-
- /*!
- * \brief Get the value of the primitive variables gradient.
- * \return Value of the primitive variables gradient.
- */
- inline su2double **GetGradient_Primitive(unsigned long iPoint) final { return Gradient_Primitive[iPoint]; }
-
- /*!
- * \brief Get the primitive variable gradients for all points.
- * \return Reference to primitive variable gradient.
- */
- inline CVectorOfMatrix& GetGradient_Primitive(void) { return Gradient_Primitive; }
-
- /*!
- * \brief Set all the primitive variables for compressible flows.
- */
- bool SetPrimVar(unsigned long iPoint, CFluidModel *FluidModel) override;
-
- /*!
- * \brief Set all the primitive and secondary variables from the conserved vector.
- */
- bool Cons2PrimVar(su2double *U, su2double *V, su2double *dPdU,
- su2double *dTdU, su2double *dTvedU, su2double *val_eves,
- su2double *val_Cvves);
-
- /*---------------------------------------*/
- /*--- Specific variable routines ---*/
- /*---------------------------------------*/
-
- /*!
- * \brief Set the norm 2 of the velocity.
- * \return Norm 2 of the velocity vector.
- */
- void SetVelocity2(unsigned long iPoint) final;
-
- /*!
- * \brief Get the norm 2 of the velocity.
- * \return Norm 2 of the velocity vector.
- */
- inline su2double GetVelocity2(unsigned long iPoint) const final { return Velocity2(iPoint); }
-
- /*!
- * \brief Get the flow pressure.
- * \return Value of the flow pressure.
- */
- inline su2double GetPressure(unsigned long iPoint) const final { return Primitive(iPoint,P_INDEX); }
-
- /*!
- * \brief Get the speed of the sound.
- * \return Value of speed of the sound.
- */
- inline su2double GetSoundSpeed(unsigned long iPoint) const final { return Primitive(iPoint,A_INDEX); }
-
- /*!
- * \brief Get the enthalpy of the flow.
- * \return Value of the enthalpy of the flow.
- */
- inline su2double GetEnthalpy(unsigned long iPoint) const final { return Primitive(iPoint,H_INDEX); }
-
- /*!
- * \brief Get the density of the flow.
- * \return Value of the density of the flow.
- */
- inline su2double GetDensity(unsigned long iPoint) const final { return Primitive(iPoint,RHO_INDEX); }
-
- /*!
- * \brief Get the specie density of the flow.
- * \return Value of the specie density of the flow.
- */
- inline su2double GetDensity(unsigned long iPoint, unsigned long val_Species) const final { return Primitive(iPoint,RHOS_INDEX+val_Species); }
-
- /*!
- * \brief Get the energy of the flow.
- * \return Value of the energy of the flow.
- */
- inline su2double GetEnergy(unsigned long iPoint) const final { return Solution(iPoint,nSpecies+nDim)/Primitive(iPoint,RHO_INDEX); }
-
- /*!
- * \brief Get the temperature of the flow.
- * \return Value of the temperature of the flow.
- */
- inline su2double GetTemperature(unsigned long iPoint) const final { return Primitive(iPoint,T_INDEX); }
-
- /*!
- * \brief Get the velocity of the flow.
- * \param[in] iDim - Index of the dimension.
- * \return Value of the velocity for the dimension iDim.
- */
- inline su2double GetVelocity(unsigned long iPoint, unsigned long iDim) const final { return Primitive(iPoint,VEL_INDEX+iDim); }
-
- /*!
- * \brief Get the projected velocity in a unitary vector direction (compressible solver).
- * \param[in] val_vector - Direction of projection.
- * \return Value of the projected velocity.
- */
- inline su2double GetProjVel(unsigned long iPoint, const su2double *val_vector) const final {
- su2double ProjVel = 0.0;
- for (unsigned long iDim = 0; iDim < nDim; iDim++)
- ProjVel += Primitive(iPoint,VEL_INDEX+iDim)*val_vector[iDim];
- return ProjVel;
- }
-
- /*!
- * \brief Set the velocity vector from the solution.
- * \param[in] val_velocity - Pointer to the velocity.
- */
- inline void SetVelocity(unsigned long iPoint) final {
- Velocity2(iPoint) = 0.0;
- for (unsigned long iDim = 0; iDim < nDim; iDim++) {
- Primitive(iPoint,VEL_INDEX+iDim) = Solution(iPoint,nSpecies+iDim) / Primitive(iPoint,RHO_INDEX);
- Velocity2(iPoint) += pow(Primitive(iPoint,VEL_INDEX+iDim),2);
- }
- }
-
- /*!
- * \brief Set the velocity vector from the old solution.
- * \param[in] val_velocity - Pointer to the velocity.
- */
- inline void SetVelocity_Old(unsigned long iPoint, const su2double *val_velocity) final {
- for (unsigned long iDim = 0; iDim < nDim; iDim++){
- Solution_Old(iPoint,nSpecies+iDim) = val_velocity[iDim]*Primitive(iPoint,RHO_INDEX);
- }
- }
-
- /*!
- * \brief A virtual member.
- * \return Value of the vibrational-electronic temperature.
- */
- inline su2double GetTemperature_ve(unsigned long iPoint) const final
- { return Primitive(iPoint,TVE_INDEX); }
-
- /*!
- * \brief Sets the vibrational electronic temperature of the flow.
- * \return Value of the temperature of the flow.
- */
- inline bool SetTemperature_ve(unsigned long iPoint, su2double val_Tve) final
- { Primitive(iPoint,TVE_INDEX) = val_Tve; return false; }
-
- /*!
- * \brief Get the mixture specific heat at constant volume (trans.-rot.).
- * \return \f$\rho C^{t-r}_{v} \f$
- */
- inline su2double GetRhoCv_tr(unsigned long iPoint) const final
- { return Primitive(iPoint,RHOCVTR_INDEX); }
-
- /*!
- * \brief Get the mixture specific heat at constant volume (vib.-el.).
- * \return \f$\rho C^{v-e}_{v} \f$
- */
- inline su2double GetRhoCv_ve(unsigned long iPoint) const final
- { return Primitive(iPoint,RHOCVVE_INDEX); }
-
- /*!
- * \brief Returns the stored value of Eve at the specified node
- */
- inline su2double *GetEve(unsigned long iPoint) { return eves[iPoint]; }
-
- /*!
- * \brief Returns the value of Cvve at the specified node
- */
- su2double *GetCvve(unsigned long iPoint) { return Cvves[iPoint]; }
-
- /*!
- * \brief Set partial derivative of pressure w.r.t. density \f$\frac{\partial P}{\partial \rho_s}\f$
- */
- inline su2double *GetdPdU(unsigned long iPoint) final { return dPdU[iPoint]; }
-
- /*!
- * \brief Set partial derivative of temperature w.r.t. density \f$\frac{\partial T}{\partial \rho_s}\f$
- */
- inline su2double *GetdTdU(unsigned long iPoint) final { return dTdU[iPoint]; }
-
- /*!
- * \brief Set partial derivative of vib.-el. temperature w.r.t. density \f$\frac{\partial T^{V-E}}{\partial \rho_s}\f$
- */
- inline su2double *GetdTvedU(unsigned long iPoint) final { return dTvedU[iPoint]; }
-
- /*!
- * \brief Get the mass fraction \f$\rho_s / \rho \f$ of species s.
- * \param[in] val_Species - Index of species s.
- * \return Value of the mass fraction of species s.
- */
- inline su2double GetMassFraction(unsigned long iPoint, unsigned long val_Species) const final {
- return Primitive(iPoint,RHOS_INDEX+val_Species) / Primitive(iPoint,RHO_INDEX);
- }
-
- /*!
- * \brief Returns the stored value of Gamma at the specified node
- */
- inline su2double GetGamma(unsigned long iPoint) { return Gamma(iPoint); }
-
- /*---------------------------------------*/
- /*--- NEMO indices ---*/
- /*---------------------------------------*/
-
- /*!
- * \brief Retrieves the value of the species density in the primitive variable vector.
- */
- inline unsigned short GetRhosIndex(void) { return RHOS_INDEX; }
-
- /*!
- * \brief Retrieves the value of the total density in the primitive variable vector.
- */
- inline unsigned short GetRhoIndex(void) { return RHO_INDEX; }
-
- /*!
- * \brief Retrieves the value of the pressure in the primitive variable vector.
- */
- inline unsigned short GetPIndex(void) { return P_INDEX; }
-
- /*!
- * \brief Retrieves the value of the in temperature the primitive variable vector.
- */
- inline unsigned short GetTIndex(void) { return T_INDEX; }
-
- /*!
- * \brief Retrieves the value of the vibe-elec temperature in the primitive variable vector.
- */
- inline unsigned short GetTveIndex(void) { return TVE_INDEX; }
-
- /*!
- * \brief Retrieves the value of the velocity in the primitive variable vector.
- */
- inline unsigned short GetVelIndex(void) { return VEL_INDEX; }
-
- /*!
- * \brief Retrieves the value of the enthalpy in the primitive variable vector.
- */
- inline unsigned short GetHIndex(void) { return H_INDEX; }
-
- /*!
- * \brief Retrieves the value of the soundspeed in the primitive variable vector.
- */
- inline unsigned short GetAIndex(void) { return A_INDEX; }
-
- /*!
- * \brief Retrieves the value of the RhoCvtr in the primitive variable vector.
- */
- inline unsigned short GetRhoCvtrIndex(void) { return RHOCVTR_INDEX; }
-
- /*!
- * \brief Retrieves the value of the RhoCvve in the primitive variable vector.
- */
- inline unsigned short GetRhoCvveIndex(void) { return RHOCVVE_INDEX; }
-
- /*!
- * \brief Specify a vector to set the velocity components of the solution. Multiplied by density for compressible cases.
- * \param[in] iPoint - Point index.
- * \param[in] val_vector - Pointer to the vector.
- */
- inline void SetVelSolutionVector(unsigned long iPoint, const su2double *val_vector) final {
+/*!
+ * \file CNEMOEulerVariable.hpp
+ * \brief Class for defining the variables of the compressible NEMO Euler solver.
+ * \author C. Garbacz, W. Maier, S.R. Copeland
+ * \version 7.1.1 "Blackbird"
+ *
+ * SU2 Project Website: https://su2code.github.io
+ *
+ * The SU2 Project is maintained by the SU2 Foundation
+ * (http://su2foundation.org)
+ *
+ * Copyright 2012-2020, SU2 Contributors (cf. AUTHORS.md)
+ *
+ * SU2 is free software; you can redistribute it and/or
+ * modify it under the terms of the GNU Lesser General Public
+ * License as published by the Free Software Foundation; either
+ * version 2.1 of the License, or (at your option) any later version.
+ *
+ * SU2 is distributed in the hope that it will be useful,
+ * but WITHOUT ANY WARRANTY; without even the implied warranty of
+ * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
+ * Lesser General Public License for more details.
+ *
+ * You should have received a copy of the GNU Lesser General Public
+ * License along with SU2. If not, see .
+ */
+
+#pragma once
+
+#include "CVariable.hpp"
+#include "../fluid/CNEMOGas.hpp"
+
+/*!
+ * \class CNEMOEulerVariable
+ * \brief Main class for defining the variables of the NEMO Euler's solver.
+ * \ingroup Euler_Equations
+ * \author S. R. Copeland, F. Palacios, W. Maier, C. Garbacz
+ * \version 7.0.8
+ */
+class CNEMOEulerVariable : public CVariable {
+public:
+ static constexpr size_t MAXNVAR = 25;
+
+protected:
+
+ bool ionization; /*!< \brief Presence of charged species in gas mixture. */
+ bool monoatomic = false; /*!< \brief Presence of single species gas. */
+
+ VectorType Velocity2; /*!< \brief Square of the velocity vector. */
+ MatrixType Precond_Beta; /*!< \brief Low Mach number preconditioner value, Beta. */
+
+ CVectorOfMatrix& Gradient_Reconstruction; /*!< \brief Reference to the gradient of the conservative variables for MUSCL reconstruction for the convective term */
+ CVectorOfMatrix Gradient_Aux; /*!< \brief Auxiliary structure to store a second gradient for reconstruction, if required. */
+
+ /*--- Primitive variable definition ---*/
+ MatrixType Primitive; /*!< \brief Primitive variables (rhos_s, T, Tve, ...) in compressible flows. */
+ MatrixType Primitive_Aux; /*!< \brief Primitive auxiliary variables (Y_s, T, Tve, ...) in compressible flows. */
+ CVectorOfMatrix Gradient_Primitive; /*!< \brief Gradient of the primitive variables (rhos_s, T, Tve, ...). */
+ MatrixType Limiter_Primitive; /*!< \brief Limiter of the primitive variables (rhos_s, T, Tve, ...). */
+
+ /*--- Secondary variable definition ---*/
+ MatrixType Secondary; /*!< \brief Primitive variables (T, vx, vy, vz, P, rho, h, c) in compressible flows. */
+ CVectorOfMatrix Gradient_Secondary; /*!< \brief Gradient of the primitive variables (T, vx, vy, vz, P, rho). */
+
+ /*--- New solution container for Classical RK4 ---*/
+ MatrixType Solution_New; /*!< \brief New solution container for Classical RK4. */
+
+ /*--- Other Necessary Variable Definition ---*/
+ MatrixType dPdU; /*!< \brief Partial derivative of pressure w.r.t. conserved variables. */
+ MatrixType dTdU; /*!< \brief Partial derivative of temperature w.r.t. conserved variables. */
+ MatrixType dTvedU; /*!< \brief Partial derivative of vib.-el. temperature w.r.t. conserved variables. */
+ MatrixType eves; /*!< \brief energy of vib-el mode w.r.t. species. */
+ MatrixType Cvves; /*!< \brief Specific heat of vib-el mode w.r.t. species. */
+ VectorType Gamma; /*!< \brief Ratio of specific heats. */
+
+ CNEMOGas *fluidmodel;
+
+ /*!< \brief Index definition for NEMO pritimive variables. */
+ unsigned long RHOS_INDEX, T_INDEX, TVE_INDEX, VEL_INDEX, P_INDEX,
+ RHO_INDEX, H_INDEX, A_INDEX, RHOCVTR_INDEX, RHOCVVE_INDEX,
+ LAM_VISC_INDEX, EDDY_VISC_INDEX, nSpecies;
+
+ su2double Tve_Freestream; /*!< \brief Freestream vib-el temperature. */
+
+public:
+
+ /*!
+ * \brief Constructor of the class.
+ * \param[in] val_pressure - Value of the flow pressure (initialization value).
+ * \param[in] val_massfrac - Value of the mass fraction (initialization value).
+ * \param[in] val_mach - Value of the Mach number (initialization value).
+ * \param[in] val_temperature - Value of the flow temperature (initialization value).
+ * \param[in] val_temperature_ve - Value of the flow temperature_ve (initialization value).
+ * \param[in] npoint - Number of points/nodes/vertices in the domain.
+ * \param[in] val_nDim - Number of dimensions of the problem.
+ * \param[in] val_nVar - Number of conserved variables.
+ * \param[in] val_nVarPrim - Number of primitive variables.
+ * \param[in] val_nVarPrimGrad - Number of primitive gradient variables.
+ * \param[in] config - Definition of the particular problem.
+ */
+ CNEMOEulerVariable(su2double val_pressure, const su2double *val_massfrac,
+ su2double *val_mach, su2double val_temperature,
+ su2double val_temperature_ve, unsigned long npoint,
+ unsigned long ndim,
+ unsigned long nvar, unsigned long nvalprim,
+ unsigned long nvarprimgrad, CConfig *config, CNEMOGas *fluidmodel);
+
+ /*!
+ * \brief Destructor of the class.
+ */
+ ~CNEMOEulerVariable() override = default;
+
+ /*---------------------------------------*/
+ /*--- U,V,S Routines ---*/
+ /*---------------------------------------*/
+
+ /*!
+ * \brief Get the new solution of the problem (Classical RK4).
+ * \param[in] iVar - Index of the variable.
+ * \return Pointer to the old solution vector.
+ */
+ inline su2double GetSolution_New(unsigned long iPoint, unsigned long iVar) const final { return Solution_New(iPoint,iVar); }
+
+ /*!
+ * \brief Set the new solution container for Classical RK4.
+ */
+ void SetSolution_New() final;
+
+ /*!
+ * \brief Add a value to the new solution container for Classical RK4.
+ * \param[in] iVar - Number of the variable.
+ * \param[in] val_solution - Value that we want to add to the solution.
+ */
+ inline void AddSolution_New(unsigned long iPoint, unsigned long iVar, su2double val_solution) final {
+ Solution_New(iPoint,iVar) += val_solution;
+ }
+
+ /*!
+ * \brief Set the value of the primitive variables.
+ * \param[in] iVar - Index of the variable.
+ * \param[in] iVar - Index of the variable.
+ * \return Set the value of the primitive variable for the index iVar.
+ */
+ inline void SetPrimitive(unsigned long iPoint, unsigned long iVar, su2double val_prim) final { Primitive(iPoint,iVar) = val_prim; }
+
+ /*!
+ * \brief Set the value of the primitive variables.
+ * \param[in] val_prim - Primitive variables.
+ * \return Set the value of the primitive variable for the index iVar.
+ */
+ inline void SetPrimitive(unsigned long iPoint, const su2double *val_prim) final {
+ for (unsigned long iVar = 0; iVar < nPrimVar; iVar++)
+ Primitive(iPoint,iVar) = val_prim[iVar];
+ }
+
+ /*!
+ * \brief Get the primitive variables limiter.
+ * \return Primitive variables limiter for the entire domain.
+ */
+ inline MatrixType& GetLimiter_Primitive(void) {return Limiter_Primitive; }
+
+ /*!
+ * \brief Set the gradient of the primitive variables.
+ * \param[in] iVar - Index of the variable.
+ * \param[in] iDim - Index of the dimension.
+ * \param[in] value - Value of the gradient.
+ */
+ inline su2double GetLimiter_Primitive(unsigned long iPoint, unsigned long iVar) const final {return Limiter_Primitive(iPoint,iVar); }
+
+ /*!
+ * \brief Get the value of the primitive variables gradient.
+ * \return Value of the primitive variables gradient.
+ */
+ inline su2double *GetLimiter_Primitive(unsigned long iPoint) final { return Limiter_Primitive[iPoint]; }
+
+ /*!
+ * \brief Set the gradient of the primitive variables.
+ * \param[in] iVar - Index of the variable.
+ * \param[in] value - Value of the gradient.
+ */
+ inline void SetLimiter_Primitive(unsigned long iPoint, unsigned long iVar, su2double value) final {
+ Limiter_Primitive(iPoint,iVar) = value;
+ }
+
+ /*!
+ * \brief Set the value of the primitive variables.
+ * \param[in] iVar - Index of the variable.
+ * \param[in] iVar - Index of the variable.
+ * \return Set the value of the primitive variable for the index iVar.
+ */
+ inline void SetSecondary(unsigned long iPoint, unsigned long iVar, su2double val_secondary) final {Secondary(iPoint,iVar) = val_secondary; }
+
+ /*!
+ * \brief Set the value of the primitive variables.
+ * \param[in] val_prim - Primitive variables.
+ * \return Set the value of the primitive variable for the index iVar.
+ */
+ inline void SetSecondary(unsigned long iPoint, const su2double *val_secondary) final {
+ for (unsigned long iVar = 0; iVar < nSecondaryVar; iVar++)
+ Secondary(iPoint,iVar) = val_secondary[iVar];
+ }
+
+ /*!
+ * \brief Set the value of the primitive auxiliary variables - with mass fractions.
+ * \param[in] iVar - Index of the variable.
+ * \param[in] iVar - Index of the variable.
+ * \return Set the value of the primitive variable for the index iVar.
+ */
+ inline void SetPrimitive_Aux(unsigned long iPoint, unsigned long iVar, su2double val_prim) { Primitive_Aux(iPoint,iVar) = val_prim; }
+
+
+ /*!
+ * \brief Get the primitive variables.
+ * \param[in] iVar - Index of the variable.
+ * \return Value of the primitive variable for the index iVar.
+ */
+ inline su2double GetPrimitive(unsigned long iPoint, unsigned long iVar) const final { return Primitive(iPoint,iVar); }
+
+ /*!
+ * \brief Get the primitive variables of the problem.
+ * \return Pointer to the primitive variable vector.
+ */
+ inline su2double *GetPrimitive(unsigned long iPoint) final {return Primitive[iPoint]; }
+
+ /*!
+ * \brief Get the primitive variables for all points.
+ * \return Reference to primitives.
+ */
+ inline const MatrixType& GetPrimitive(void) const { return Primitive; }
+
+ /*!
+ * \brief Get the primitive variables for all points.
+ * \return Reference to primitives.
+ */
+ inline const MatrixType& GetPrimitive_Aux(void) const { return Primitive_Aux; }
+
+
+ /*!
+ * \brief Get the primitive variables.
+ * \param[in] iVar - Index of the variable.
+ * \return Value of the primitive variable for the index iVar.
+ */
+ inline su2double GetSecondary(unsigned long iPoint, unsigned long iVar) const final {return Secondary(iPoint,iVar); }
+
+ /*!
+ * \brief Get the primitive variables of the problem.
+ * \return Pointer to the primitive variable vector.
+ */
+ inline su2double *GetSecondary(unsigned long iPoint) final { return Secondary[iPoint]; }
+
+ /*---------------------------------------*/
+ /*--- Gradient Routines ---*/
+ /*---------------------------------------*/
+
+ /*!
+ * \brief Get the reconstruction gradient for primitive variable at all points.
+ * \return Reference to variable reconstruction gradient.
+ */
+ inline CVectorOfMatrix& GetGradient_Reconstruction(void) final { return Gradient_Reconstruction; }
+
+ /*!
+ * \brief Get the value of the reconstruction variables gradient at a node.
+ * \param[in] iPoint - Index of the current node.
+ * \param[in] iVar - Index of the variable.
+ * \param[in] iDim - Index of the dimension.
+ * \return Value of the reconstruction variables gradient at a node.
+ */
+ inline su2double GetGradient_Reconstruction(unsigned long iPoint, unsigned long iVar, unsigned long iDim) const final {
+ return Gradient_Reconstruction(iPoint,iVar,iDim);
+ }
+
+ /*!
+ * \brief Get the array of the reconstruction variables gradient at a node.
+ * \param[in] iPoint - Index of the current node.
+ * \return Array of the reconstruction variables gradient at a node.
+ */
+ inline su2double **GetGradient_Reconstruction(unsigned long iPoint) final { return Gradient_Reconstruction[iPoint]; }
+
+ /*!
+ * \brief Get the value of the reconstruction variables gradient at a node.
+ * \param[in] iPoint - Index of the current node.
+ * \param[in] iVar - Index of the variable.
+ * \param[in] iDim - Index of the dimension.
+ * \param[in] value - Value of the reconstruction gradient component.
+ */
+ inline void SetGradient_Reconstruction(unsigned long iPoint, unsigned long iVar, unsigned long iDim, su2double value) final {
+ Gradient_Reconstruction(iPoint,iVar,iDim) = value;
+ }
+
+ /*!
+ * \brief Set to zero the gradient of the primitive variables.
+ */
+ void SetGradient_PrimitiveZero();
+
+ /*!
+ * \brief Add value to the gradient of the primitive variables.
+ * \param[in] iVar - Index of the variable.
+ * \param[in] iDim - Index of the dimension.
+ * \param[in] value - Value to add to the gradient of the primitive variables.
+ */
+ inline void AddGradient_Primitive(unsigned long iPoint, unsigned long iVar, unsigned long iDim, su2double value) final {
+ Gradient_Primitive(iPoint,iVar,iDim) += value;
+ }
+
+ /*!
+ * \brief Subtract value to the gradient of the primitive variables.
+ * \param[in] iVar - Index of the variable.
+ * \param[in] iDim - Index of the dimension.
+ * \param[in] value - Value to subtract to the gradient of the primitive variables.
+ */
+ inline void SubtractGradient_Primitive(unsigned long iPoint, unsigned long iVar, unsigned long iDim, su2double value) {
+ Gradient_Primitive(iPoint,iVar,iDim) -= value;
+ }
+
+ /*!
+ * \brief Get the value of the primitive variables gradient.
+ * \param[in] iVar - Index of the variable.
+ * \param[in] iDim - Index of the dimension.
+ * \return Value of the primitive variables gradient.
+ */
+ inline su2double GetGradient_Primitive(unsigned long iPoint, unsigned long iVar, unsigned long iDim) const final {
+ return Gradient_Primitive(iPoint,iVar,iDim);
+ }
+
+ /*!
+ * \brief Set the gradient of the primitive variables.
+ * \param[in] iVar - Index of the variable.
+ * \param[in] iDim - Index of the dimension.
+ * \param[in] value - Value of the gradient.
+ */
+ inline void SetGradient_Primitive(unsigned long iPoint, unsigned long iVar, unsigned long iDim, su2double value) final {
+ Gradient_Primitive(iPoint,iVar,iDim) = value;
+ }
+
+ /*!
+ * \brief Get the value of the primitive variables gradient.
+ * \return Value of the primitive variables gradient.
+ */
+ inline su2double **GetGradient_Primitive(unsigned long iPoint) final { return Gradient_Primitive[iPoint]; }
+
+ /*!
+ * \brief Get the primitive variable gradients for all points.
+ * \return Reference to primitive variable gradient.
+ */
+ inline CVectorOfMatrix& GetGradient_Primitive(void) { return Gradient_Primitive; }
+
+ /*!
+ * \brief Set all the primitive variables for compressible flows.
+ */
+ bool SetPrimVar(unsigned long iPoint, CFluidModel *FluidModel) override;
+
+ /*!
+ * \brief Set all the primitive and secondary variables from the conserved vector.
+ */
+ bool Cons2PrimVar(su2double *U, su2double *V, su2double *dPdU,
+ su2double *dTdU, su2double *dTvedU, su2double *val_eves,
+ su2double *val_Cvves);
+
+ /*---------------------------------------*/
+ /*--- Specific variable routines ---*/
+ /*---------------------------------------*/
+
+ /*!
+ * \brief Set the norm 2 of the velocity.
+ * \return Norm 2 of the velocity vector.
+ */
+ void SetVelocity2(unsigned long iPoint) final;
+
+ /*!
+ * \brief Get the norm 2 of the velocity.
+ * \return Norm 2 of the velocity vector.
+ */
+ inline su2double GetVelocity2(unsigned long iPoint) const final { return Velocity2(iPoint); }
+
+ /*!
+ * \brief Get the flow pressure.
+ * \return Value of the flow pressure.
+ */
+ inline su2double GetPressure(unsigned long iPoint) const final { return Primitive(iPoint,P_INDEX); }
+
+ /*!
+ * \brief Get the speed of the sound.
+ * \return Value of speed of the sound.
+ */
+ inline su2double GetSoundSpeed(unsigned long iPoint) const final { return Primitive(iPoint,A_INDEX); }
+
+ /*!
+ * \brief Get the enthalpy of the flow.
+ * \return Value of the enthalpy of the flow.
+ */
+ inline su2double GetEnthalpy(unsigned long iPoint) const final { return Primitive(iPoint,H_INDEX); }
+
+ /*!
+ * \brief Get the density of the flow.
+ * \return Value of the density of the flow.
+ */
+ inline su2double GetDensity(unsigned long iPoint) const final { return Primitive(iPoint,RHO_INDEX); }
+
+ /*!
+ * \brief Get the specie density of the flow.
+ * \return Value of the specie density of the flow.
+ */
+ inline su2double GetDensity(unsigned long iPoint, unsigned long val_Species) const final { return Primitive(iPoint,RHOS_INDEX+val_Species); }
+
+ /*!
+ * \brief Get the energy of the flow.
+ * \return Value of the energy of the flow.
+ */
+ inline su2double GetEnergy(unsigned long iPoint) const final { return Solution(iPoint,nSpecies+nDim)/Primitive(iPoint,RHO_INDEX); }
+
+ /*!
+ * \brief Get the temperature of the flow.
+ * \return Value of the temperature of the flow.
+ */
+ inline su2double GetTemperature(unsigned long iPoint) const final { return Primitive(iPoint,T_INDEX); }
+
+ /*!
+ * \brief Get the velocity of the flow.
+ * \param[in] iDim - Index of the dimension.
+ * \return Value of the velocity for the dimension iDim.
+ */
+ inline su2double GetVelocity(unsigned long iPoint, unsigned long iDim) const final { return Primitive(iPoint,VEL_INDEX+iDim); }
+
+ /*!
+ * \brief Get the projected velocity in a unitary vector direction (compressible solver).
+ * \param[in] val_vector - Direction of projection.
+ * \return Value of the projected velocity.
+ */
+ inline su2double GetProjVel(unsigned long iPoint, const su2double *val_vector) const final {
+ su2double ProjVel = 0.0;
for (unsigned long iDim = 0; iDim < nDim; iDim++)
- Solution(iPoint, nSpecies+iDim) = Primitive(iPoint,RHO_INDEX) * val_vector[iDim];
+ ProjVel += Primitive(iPoint,VEL_INDEX+iDim)*val_vector[iDim];
+ return ProjVel;
+ }
+
+ /*!
+ * \brief Set the velocity vector from the solution.
+ * \param[in] val_velocity - Pointer to the velocity.
+ */
+ inline void SetVelocity(unsigned long iPoint) final {
+ Velocity2(iPoint) = 0.0;
+ for (unsigned long iDim = 0; iDim < nDim; iDim++) {
+ Primitive(iPoint,VEL_INDEX+iDim) = Solution(iPoint,nSpecies+iDim) / Primitive(iPoint,RHO_INDEX);
+ Velocity2(iPoint) += pow(Primitive(iPoint,VEL_INDEX+iDim),2);
+ }
+ }
+
+ /*!
+ * \brief Set the velocity vector from the old solution.
+ * \param[in] val_velocity - Pointer to the velocity.
+ */
+ inline void SetVelocity_Old(unsigned long iPoint, const su2double *val_velocity) final {
+ for (unsigned long iDim = 0; iDim < nDim; iDim++){
+ Solution_Old(iPoint,nSpecies+iDim) = val_velocity[iDim]*Primitive(iPoint,RHO_INDEX);
+ }
+ }
+
+ /*!
+ * \brief A virtual member.
+ * \return Value of the vibrational-electronic temperature.
+ */
+ inline su2double GetTemperature_ve(unsigned long iPoint) const final
+ { return Primitive(iPoint,TVE_INDEX); }
+
+ /*!
+ * \brief Sets the vibrational electronic temperature of the flow.
+ * \return Value of the temperature of the flow.
+ */
+ inline bool SetTemperature_ve(unsigned long iPoint, su2double val_Tve) final
+ { Primitive(iPoint,TVE_INDEX) = val_Tve; return false; }
+
+ /*!
+ * \brief Get the mixture specific heat at constant volume (trans.-rot.).
+ * \return \f$\rho C^{t-r}_{v} \f$
+ */
+ inline su2double GetRhoCv_tr(unsigned long iPoint) const final
+ { return Primitive(iPoint,RHOCVTR_INDEX); }
+
+ /*!
+ * \brief Get the mixture specific heat at constant volume (vib.-el.).
+ * \return \f$\rho C^{v-e}_{v} \f$
+ */
+ inline su2double GetRhoCv_ve(unsigned long iPoint) const final
+ { return Primitive(iPoint,RHOCVVE_INDEX); }
+
+ /*!
+ * \brief Returns the stored value of Eve at the specified node
+ */
+ inline su2double *GetEve(unsigned long iPoint) { return eves[iPoint]; }
+
+ /*!
+ * \brief Returns the value of Cvve at the specified node
+ */
+ su2double *GetCvve(unsigned long iPoint) { return Cvves[iPoint]; }
+
+ /*!
+ * \brief Set partial derivative of pressure w.r.t. density \f$\frac{\partial P}{\partial \rho_s}\f$
+ */
+ inline su2double *GetdPdU(unsigned long iPoint) final { return dPdU[iPoint]; }
+
+ /*!
+ * \brief Set partial derivative of temperature w.r.t. density \f$\frac{\partial T}{\partial \rho_s}\f$
+ */
+ inline su2double *GetdTdU(unsigned long iPoint) final { return dTdU[iPoint]; }
+
+ /*!
+ * \brief Set partial derivative of vib.-el. temperature w.r.t. density \f$\frac{\partial T^{V-E}}{\partial \rho_s}\f$
+ */
+ inline su2double *GetdTvedU(unsigned long iPoint) final { return dTvedU[iPoint]; }
+
+ /*!
+ * \brief Get the mass fraction \f$\rho_s / \rho \f$ of species s.
+ * \param[in] val_Species - Index of species s.
+ * \return Value of the mass fraction of species s.
+ */
+ inline su2double GetMassFraction(unsigned long iPoint, unsigned long val_Species) const final {
+ return Primitive(iPoint,RHOS_INDEX+val_Species) / Primitive(iPoint,RHO_INDEX);
+ }
+
+ /*!
+ * \brief Returns the stored value of Gamma at the specified node
+ */
+ inline su2double GetGamma(unsigned long iPoint) { return Gamma(iPoint); }
+
+ /*---------------------------------------*/
+ /*--- NEMO indices ---*/
+ /*---------------------------------------*/
+
+ /*!
+ * \brief Retrieves the value of the species density in the primitive variable vector.
+ */
+ inline unsigned short GetRhosIndex(void) { return RHOS_INDEX; }
+
+ /*!
+ * \brief Retrieves the value of the total density in the primitive variable vector.
+ */
+ inline unsigned short GetRhoIndex(void) { return RHO_INDEX; }
+
+ /*!
+ * \brief Retrieves the value of the pressure in the primitive variable vector.
+ */
+ inline unsigned short GetPIndex(void) { return P_INDEX; }
+
+ /*!
+ * \brief Retrieves the value of the in temperature the primitive variable vector.
+ */
+ inline unsigned short GetTIndex(void) { return T_INDEX; }
+
+ /*!
+ * \brief Retrieves the value of the vibe-elec temperature in the primitive variable vector.
+ */
+ inline unsigned short GetTveIndex(void) { return TVE_INDEX; }
+
+ /*!
+ * \brief Retrieves the value of the velocity in the primitive variable vector.
+ */
+ inline unsigned short GetVelIndex(void) { return VEL_INDEX; }
+
+ /*!
+ * \brief Retrieves the value of the enthalpy in the primitive variable vector.
+ */
+ inline unsigned short GetHIndex(void) { return H_INDEX; }
+
+ /*!
+ * \brief Retrieves the value of the soundspeed in the primitive variable vector.
+ */
+ inline unsigned short GetAIndex(void) { return A_INDEX; }
+
+ /*!
+ * \brief Retrieves the value of the RhoCvtr in the primitive variable vector.
+ */
+ inline unsigned short GetRhoCvtrIndex(void) { return RHOCVTR_INDEX; }
+
+ /*!
+ * \brief Retrieves the value of the RhoCvve in the primitive variable vector.
+ */
+ inline unsigned short GetRhoCvveIndex(void) { return RHOCVVE_INDEX; }
+
+ /*!
+ * \brief Specify a vector to set the velocity components of the solution. Multiplied by density for compressible cases.
+ * \param[in] iPoint - Point index.
+ * \param[in] val_vector - Pointer to the vector.
+ */
+ inline void SetVelSolutionVector(unsigned long iPoint, const su2double *val_vector) final {
+ for (unsigned long iDim = 0; iDim < nDim; iDim++)
+ Solution(iPoint, nSpecies+iDim) = Primitive(iPoint,RHO_INDEX) * val_vector[iDim];
}
/*!
@@ -592,6 +592,6 @@ class CNEMOEulerVariable : public CVariable {
*/
inline void SetVel_ResTruncError_Zero(unsigned long iPoint) final {
for (unsigned long iDim = 0; iDim < nDim; iDim++) Res_TruncError(iPoint,nSpecies+iDim) = 0.0;
- }
-
-};
+ }
+
+};
diff --git a/SU2_CFD/include/variables/CNEMONSVariable.hpp b/SU2_CFD/include/variables/CNEMONSVariable.hpp
index 657e5aac85a..ba9a87c4a90 100644
--- a/SU2_CFD/include/variables/CNEMONSVariable.hpp
+++ b/SU2_CFD/include/variables/CNEMONSVariable.hpp
@@ -1,167 +1,167 @@
-/*!
- * \file CNEMONSVariable.hpp
- * \brief Class for defining the variables of the compressible NEMO Navier-Stokes solver.
- * \author C. Garbacz, W. Maier, S.R. Copeland.
- * \version 7.1.0 "Blackbird"
- *
- * SU2 Project Website: https://su2code.github.io
- *
- * The SU2 Project is maintained by the SU2 Foundation
- * (http://su2foundation.org)
- *
- * Copyright 2012-2020, SU2 Contributors (cf. AUTHORS.md)
- *
- * SU2 is free software; you can redistribute it and/or
- * modify it under the terms of the GNU Lesser General Public
- * License as published by the Free Software Foundation; either
- * version 2.1 of the License, or (at your option) any later version.
- *
- * SU2 is distributed in the hope that it will be useful,
- * but WITHOUT ANY WARRANTY; without even the implied warranty of
- * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
- * Lesser General Public License for more details.
- *
- * You should have received a copy of the GNU Lesser General Public
- * License along with SU2. If not, see .
- */
-
-#pragma once
-
-#include "CNEMOEulerVariable.hpp"
-
-/*!
- * \class CNEMONSVariable
- * \brief Main class for defining the variables of the NEMO Navier-Stokes' solver.
- * \ingroup Navier_Stokes_Equations
- * \author C. Garbacz, W. Maier, S.R. Copeland.
- * \version 7.0.8
- */
-class CNEMONSVariable final : public CNEMOEulerVariable {
-private:
- VectorType Prandtl_Lam; /*!< \brief Laminar Prandtl number. */
- VectorType Temperature_Ref; /*!< \brief Reference temperature of the fluid. */
- VectorType Viscosity_Ref; /*!< \brief Reference viscosity of the fluid. */
- VectorType Viscosity_Inf; /*!< \brief Viscosity of the fluid at the infinity. */
- MatrixType DiffusionCoeff; /*!< \brief Diffusion coefficient of the mixture. */
- CVectorOfMatrix Dij; /*!< \brief Binary diffusion coefficients. */
- VectorType LaminarViscosity; /*!< \brief Viscosity of the fluid. */
- VectorType ThermalCond; /*!< \brief T-R thermal conductivity of the gas mixture. */
- VectorType ThermalCond_ve; /*!< \brief V-E thermal conductivity of the gas mixture. */
- vector thermalconductivities;
- vector Ds;
-
- su2double inv_TimeScale; /*!< \brief Inverse of the reference time scale. */
-
- MatrixType Vorticity; /*!< \brief Vorticity of the fluid. */
- VectorType StrainMag; /*!< \brief Magnitude of rate of strain tensor. */
- VectorType Tau_Wall; /*!< \brief Magnitude of the wall shear stress from a wall function. */
- VectorType DES_LengthScale; /*!< \brief DES Length Scale. */
- VectorType Roe_Dissipation; /*!< \brief Roe low dissipation coefficient. */
- VectorType Vortex_Tilting; /*!< \brief Value of the vortex tilting variable for DES length scale computation. */
-
-public:
-
- /*!
- * \brief Constructor of the class.
- * \param[in] val_density - Value of the flow density (initialization value).
- * \param[in] val_massfrac - Value of the flow mass fraction (initialization value).
- * \param[in] val_velocity - Value of the flow velocity (initialization value).
- * \param[in] val_temperature - Value of the flow temperature (initialization value).
- * \param[in] val_temperature_ve - Value of the flow temperature_ve (initialization value).
- * \param[in] npoint - Number of points/nodes/vertices in the domain.
- * \param[in] val_nDim - Number of dimensions of the problem.
- * \param[in] val_nVar - Number of conserved variables.
- * \param[in] val_nPrimVar - Number of primitive variables.
- * \param[in] val_nPrimVargrad - Number of primitive gradient variables.
- * \param[in] config - Definition of the particular problem.
- */
- CNEMONSVariable(su2double val_density, const su2double *val_massfrac, su2double *val_velocity,
- su2double val_temperature, su2double val_temperature_ve, unsigned long npoint,
- unsigned long val_nDim, unsigned long val_nVar, unsigned long val_nPrimVar,
- unsigned long val_nPrimVarGrad, CConfig *config, CNEMOGas *fluidmodel);
-
- /*!
- * \brief Constructor of the class.
- * \param[in] val_solution - Pointer to the flow value (initialization value).
- * \param[in] val_nDim - Number of dimensions of the problem.
- * \param[in] val_nVar - Number of conserved variables.
- * \param[in] val_nPrimVar - Number of primitive variables.
- * \param[in] val_nPrimgVarGrad - Number of primitive gradient variables.
- * \param[in] config - Definition of the particular problem.
- */
- CNEMONSVariable(su2double *val_solution, unsigned long val_nDim, unsigned long val_nVar,
- unsigned long val_nPrimVar, unsigned long val_nPrimVarGrad, unsigned long npoint,
- CConfig *config);
-
- /*!
- * \brief Destructor of the class.
- */
- ~CNEMONSVariable() = default;
-
- /*!
- * \brief Get the primitive variables for all points.
- * \return Reference to primitives.
- */
- inline const MatrixType& GetPrimitive_Aux(void) const { return Primitive_Aux; }
-
- /*!
- * \brief Set all the primitive variables for compressible flows.
- */
- bool SetPrimVar(unsigned long iPoint, CFluidModel *FluidModel) final;
-
- /*!
- * \brief Set the vorticity value.
- */
- bool SetVorticity(void);
-
- /*!
- * \overload
- * \param[in] eddy_visc - Value of the eddy viscosity.
- */
- inline void SetEddyViscosity(unsigned long iPoint, su2double eddy_visc) override { Primitive(iPoint,EDDY_VISC_INDEX) = eddy_visc; }
-
- /*!
- * \brief Get the species diffusion coefficient.
- * \return Value of the species diffusion coefficient.
- */
- inline su2double* GetDiffusionCoeff(unsigned long iPoint) override { return DiffusionCoeff[iPoint]; }
-
- /*!
- * \brief Get the laminar viscosity of the flow.
- * \return Value of the laminar viscosity of the flow.
- */
- inline su2double GetLaminarViscosity(unsigned long iPoint) const override { return LaminarViscosity(iPoint); }
-
- /*!
- * \brief Get the eddy viscosity of the flow.
- * \return The eddy viscosity of the flow.
- */
- inline su2double GetEddyViscosity(unsigned long iPoint) const override { return Primitive(iPoint,EDDY_VISC_INDEX); }
-
- /*!
- * \brief Get the thermal conductivity of the flow.
- * \return Value of the laminar viscosity of the flow.
- */
- inline su2double GetThermalConductivity(unsigned long iPoint) const override {return ThermalCond(iPoint); }
-
- /*!
- * \brief Get the vib-el. thermal conductivity of the flow.
- * \return Value of the laminar viscosity of the flow.
- */
- inline su2double GetThermalConductivity_ve(unsigned long iPoint) const override { return ThermalCond_ve(iPoint); }
-
- /*!
- * \brief Set the temperature at the wall
- */
- inline void SetWallTemperature(unsigned long iPoint, su2double temperature_wall) override {
- Primitive(iPoint,T_INDEX) = temperature_wall;
- }
-
- /*!
- * \brief Get the value of the vorticity.
- * \return Value of the vorticity.
- */
- inline su2double *GetVorticity(unsigned long iPoint) override { return Vorticity[iPoint]; }
-
-
-};
+/*!
+ * \file CNEMONSVariable.hpp
+ * \brief Class for defining the variables of the compressible NEMO Navier-Stokes solver.
+ * \author C. Garbacz, W. Maier, S.R. Copeland.
+ * \version 7.1.1 "Blackbird"
+ *
+ * SU2 Project Website: https://su2code.github.io
+ *
+ * The SU2 Project is maintained by the SU2 Foundation
+ * (http://su2foundation.org)
+ *
+ * Copyright 2012-2020, SU2 Contributors (cf. AUTHORS.md)
+ *
+ * SU2 is free software; you can redistribute it and/or
+ * modify it under the terms of the GNU Lesser General Public
+ * License as published by the Free Software Foundation; either
+ * version 2.1 of the License, or (at your option) any later version.
+ *
+ * SU2 is distributed in the hope that it will be useful,
+ * but WITHOUT ANY WARRANTY; without even the implied warranty of
+ * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
+ * Lesser General Public License for more details.
+ *
+ * You should have received a copy of the GNU Lesser General Public
+ * License along with SU2. If not, see .
+ */
+
+#pragma once
+
+#include "CNEMOEulerVariable.hpp"
+
+/*!
+ * \class CNEMONSVariable
+ * \brief Main class for defining the variables of the NEMO Navier-Stokes' solver.
+ * \ingroup Navier_Stokes_Equations
+ * \author C. Garbacz, W. Maier, S.R. Copeland.
+ * \version 7.0.8
+ */
+class CNEMONSVariable final : public CNEMOEulerVariable {
+private:
+ VectorType Prandtl_Lam; /*!< \brief Laminar Prandtl number. */
+ VectorType Temperature_Ref; /*!< \brief Reference temperature of the fluid. */
+ VectorType Viscosity_Ref; /*!< \brief Reference viscosity of the fluid. */
+ VectorType Viscosity_Inf; /*!< \brief Viscosity of the fluid at the infinity. */
+ MatrixType DiffusionCoeff; /*!< \brief Diffusion coefficient of the mixture. */
+ CVectorOfMatrix Dij; /*!< \brief Binary diffusion coefficients. */
+ VectorType LaminarViscosity; /*!< \brief Viscosity of the fluid. */
+ VectorType ThermalCond; /*!< \brief T-R thermal conductivity of the gas mixture. */
+ VectorType ThermalCond_ve; /*!< \brief V-E thermal conductivity of the gas mixture. */
+ vector thermalconductivities;
+ vector Ds;
+
+ su2double inv_TimeScale; /*!< \brief Inverse of the reference time scale. */
+
+ MatrixType Vorticity; /*!< \brief Vorticity of the fluid. */
+ VectorType StrainMag; /*!< \brief Magnitude of rate of strain tensor. */
+ VectorType Tau_Wall; /*!< \brief Magnitude of the wall shear stress from a wall function. */
+ VectorType DES_LengthScale; /*!< \brief DES Length Scale. */
+ VectorType Roe_Dissipation; /*!< \brief Roe low dissipation coefficient. */
+ VectorType Vortex_Tilting; /*!< \brief Value of the vortex tilting variable for DES length scale computation. */
+
+public:
+
+ /*!
+ * \brief Constructor of the class.
+ * \param[in] val_density - Value of the flow density (initialization value).
+ * \param[in] val_massfrac - Value of the flow mass fraction (initialization value).
+ * \param[in] val_velocity - Value of the flow velocity (initialization value).
+ * \param[in] val_temperature - Value of the flow temperature (initialization value).
+ * \param[in] val_temperature_ve - Value of the flow temperature_ve (initialization value).
+ * \param[in] npoint - Number of points/nodes/vertices in the domain.
+ * \param[in] val_nDim - Number of dimensions of the problem.
+ * \param[in] val_nVar - Number of conserved variables.
+ * \param[in] val_nPrimVar - Number of primitive variables.
+ * \param[in] val_nPrimVargrad - Number of primitive gradient variables.
+ * \param[in] config - Definition of the particular problem.
+ */
+ CNEMONSVariable(su2double val_density, const su2double *val_massfrac, su2double *val_velocity,
+ su2double val_temperature, su2double val_temperature_ve, unsigned long npoint,
+ unsigned long val_nDim, unsigned long val_nVar, unsigned long val_nPrimVar,
+ unsigned long val_nPrimVarGrad, CConfig *config, CNEMOGas *fluidmodel);
+
+ /*!
+ * \brief Constructor of the class.
+ * \param[in] val_solution - Pointer to the flow value (initialization value).
+ * \param[in] val_nDim - Number of dimensions of the problem.
+ * \param[in] val_nVar - Number of conserved variables.
+ * \param[in] val_nPrimVar - Number of primitive variables.
+ * \param[in] val_nPrimgVarGrad - Number of primitive gradient variables.
+ * \param[in] config - Definition of the particular problem.
+ */
+ CNEMONSVariable(su2double *val_solution, unsigned long val_nDim, unsigned long val_nVar,
+ unsigned long val_nPrimVar, unsigned long val_nPrimVarGrad, unsigned long npoint,
+ CConfig *config);
+
+ /*!
+ * \brief Destructor of the class.
+ */
+ ~CNEMONSVariable() = default;
+
+ /*!
+ * \brief Get the primitive variables for all points.
+ * \return Reference to primitives.
+ */
+ inline const MatrixType& GetPrimitive_Aux(void) const { return Primitive_Aux; }
+
+ /*!
+ * \brief Set all the primitive variables for compressible flows.
+ */
+ bool SetPrimVar(unsigned long iPoint, CFluidModel *FluidModel) final;
+
+ /*!
+ * \brief Set the vorticity value.
+ */
+ bool SetVorticity(void);
+
+ /*!
+ * \overload
+ * \param[in] eddy_visc - Value of the eddy viscosity.
+ */
+ inline void SetEddyViscosity(unsigned long iPoint, su2double eddy_visc) override { Primitive(iPoint,EDDY_VISC_INDEX) = eddy_visc; }
+
+ /*!
+ * \brief Get the species diffusion coefficient.
+ * \return Value of the species diffusion coefficient.
+ */
+ inline su2double* GetDiffusionCoeff(unsigned long iPoint) override { return DiffusionCoeff[iPoint]; }
+
+ /*!
+ * \brief Get the laminar viscosity of the flow.
+ * \return Value of the laminar viscosity of the flow.
+ */
+ inline su2double GetLaminarViscosity(unsigned long iPoint) const override { return LaminarViscosity(iPoint); }
+
+ /*!
+ * \brief Get the eddy viscosity of the flow.
+ * \return The eddy viscosity of the flow.
+ */
+ inline su2double GetEddyViscosity(unsigned long iPoint) const override { return Primitive(iPoint,EDDY_VISC_INDEX); }
+
+ /*!
+ * \brief Get the thermal conductivity of the flow.
+ * \return Value of the laminar viscosity of the flow.
+ */
+ inline su2double GetThermalConductivity(unsigned long iPoint) const override {return ThermalCond(iPoint); }
+
+ /*!
+ * \brief Get the vib-el. thermal conductivity of the flow.
+ * \return Value of the laminar viscosity of the flow.
+ */
+ inline su2double GetThermalConductivity_ve(unsigned long iPoint) const override { return ThermalCond_ve(iPoint); }
+
+ /*!
+ * \brief Set the temperature at the wall
+ */
+ inline void SetWallTemperature(unsigned long iPoint, su2double temperature_wall) override {
+ Primitive(iPoint,T_INDEX) = temperature_wall;
+ }
+
+ /*!
+ * \brief Get the value of the vorticity.
+ * \return Value of the vorticity.
+ */
+ inline su2double *GetVorticity(unsigned long iPoint) override { return Vorticity[iPoint]; }
+
+
+};
diff --git a/SU2_CFD/include/variables/CNSVariable.hpp b/SU2_CFD/include/variables/CNSVariable.hpp
index c8157e8417d..0d93d7eb040 100644
--- a/SU2_CFD/include/variables/CNSVariable.hpp
+++ b/SU2_CFD/include/variables/CNSVariable.hpp
@@ -2,7 +2,7 @@
* \file CNSVariable.hpp
* \brief Class for defining the variables of the compressible Navier-Stokes solver.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/variables/CRadP1Variable.hpp b/SU2_CFD/include/variables/CRadP1Variable.hpp
index fc50698e5b3..96d466bff5a 100644
--- a/SU2_CFD/include/variables/CRadP1Variable.hpp
+++ b/SU2_CFD/include/variables/CRadP1Variable.hpp
@@ -2,7 +2,7 @@
* \file CRadP1Variable.hpp
* \brief Class for defining the variables of the P1 radiation model.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/variables/CRadVariable.hpp b/SU2_CFD/include/variables/CRadVariable.hpp
index 06fab424ab0..7fc0babcbc5 100644
--- a/SU2_CFD/include/variables/CRadVariable.hpp
+++ b/SU2_CFD/include/variables/CRadVariable.hpp
@@ -2,7 +2,7 @@
* \file CRadVariable.hpp
* \brief Class for defining the variables of the radiation solver.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/variables/CTransLMVariable.hpp b/SU2_CFD/include/variables/CTransLMVariable.hpp
index b2a315e3f31..c62d5e85ba1 100644
--- a/SU2_CFD/include/variables/CTransLMVariable.hpp
+++ b/SU2_CFD/include/variables/CTransLMVariable.hpp
@@ -2,7 +2,7 @@
* \file CTransLMVariable.hpp
* \brief Declaration of the variables of the transition model.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/variables/CTurbSAVariable.hpp b/SU2_CFD/include/variables/CTurbSAVariable.hpp
index 2c6491d8756..ee9450fc6fb 100644
--- a/SU2_CFD/include/variables/CTurbSAVariable.hpp
+++ b/SU2_CFD/include/variables/CTurbSAVariable.hpp
@@ -2,7 +2,7 @@
* \file CTurbSAVariable.hpp
* \brief Declaration of the variables of the SA turbulence model.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/variables/CTurbSSTVariable.hpp b/SU2_CFD/include/variables/CTurbSSTVariable.hpp
index c208e75b1e3..a9faec3fa45 100644
--- a/SU2_CFD/include/variables/CTurbSSTVariable.hpp
+++ b/SU2_CFD/include/variables/CTurbSSTVariable.hpp
@@ -2,7 +2,7 @@
* \file CTurbSSTVariable.hpp
* \brief Declaration of the variables of the SST turbulence model.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/variables/CTurbVariable.hpp b/SU2_CFD/include/variables/CTurbVariable.hpp
index 97d2935eb4c..0cd532ee10f 100644
--- a/SU2_CFD/include/variables/CTurbVariable.hpp
+++ b/SU2_CFD/include/variables/CTurbVariable.hpp
@@ -2,7 +2,7 @@
* \file CTurbVariable.hpp
* \brief Base class for defining the variables of the turbulence model.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/include/variables/CVariable.hpp b/SU2_CFD/include/variables/CVariable.hpp
index 54c5e8cc18e..a1064a90cc7 100644
--- a/SU2_CFD/include/variables/CVariable.hpp
+++ b/SU2_CFD/include/variables/CVariable.hpp
@@ -4,7 +4,7 @@
variables, function definitions in file CVariable.cpp.
All variables are children of at least this class.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/obj/Makefile.am b/SU2_CFD/obj/Makefile.am
index b151070ca74..30e7636a0e5 100644
--- a/SU2_CFD/obj/Makefile.am
+++ b/SU2_CFD/obj/Makefile.am
@@ -3,7 +3,7 @@
# \file Makefile.am
# \brief Makefile for SU2_CFD
# \author M. Colonno, T. Economon, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_CFD/src/CMarkerProfileReaderFVM.cpp b/SU2_CFD/src/CMarkerProfileReaderFVM.cpp
index dc12ddaf30d..c0b289ac7dc 100644
--- a/SU2_CFD/src/CMarkerProfileReaderFVM.cpp
+++ b/SU2_CFD/src/CMarkerProfileReaderFVM.cpp
@@ -2,7 +2,7 @@
* \file CMarkerProfileReaderFVM.cpp
* \brief Class that handles the reading of marker profile files.
* \author T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/SU2_CFD.cpp b/SU2_CFD/src/SU2_CFD.cpp
index a73cb5126dc..35d49885482 100644
--- a/SU2_CFD/src/SU2_CFD.cpp
+++ b/SU2_CFD/src/SU2_CFD.cpp
@@ -2,7 +2,7 @@
* \file SU2_CFD.cpp
* \brief Main file of the SU2 Computational Fluid Dynamics code
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -47,7 +47,7 @@ int main(int argc, char *argv[]) {
/*--- Command line parsing ---*/
- CLI::App app{"SU2 v7.1.0 \"Blackbird\", The Open-Source CFD Code"};
+ CLI::App app{"SU2 v7.1.1 \"Blackbird\", The Open-Source CFD Code"};
app.add_flag("-d,--dryrun", dry_run, "Enable dry run mode.\n"
"Only execute preprocessing steps using a dummy geometry.");
app.add_option("-t,--threads", num_threads, "Number of OpenMP threads per MPI rank.");
diff --git a/SU2_CFD/src/definition_structure.cpp b/SU2_CFD/src/definition_structure.cpp
index b0a4b0d2d54..7a05145b4a8 100644
--- a/SU2_CFD/src/definition_structure.cpp
+++ b/SU2_CFD/src/definition_structure.cpp
@@ -2,7 +2,7 @@
* \file definition_structure.cpp
* \brief Main subroutines used by SU2_CFD
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/drivers/CDiscAdjMultizoneDriver.cpp b/SU2_CFD/src/drivers/CDiscAdjMultizoneDriver.cpp
index 296065b8668..d8afeb89d14 100644
--- a/SU2_CFD/src/drivers/CDiscAdjMultizoneDriver.cpp
+++ b/SU2_CFD/src/drivers/CDiscAdjMultizoneDriver.cpp
@@ -2,7 +2,7 @@
* \file CDiscAdjMultizoneDriver.cpp
* \brief The main subroutines for driving adjoint multi-zone problems
* \author O. Burghardt, P. Gomes, T. Albring, R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/drivers/CDiscAdjSinglezoneDriver.cpp b/SU2_CFD/src/drivers/CDiscAdjSinglezoneDriver.cpp
index 48a9463e00d..fee8c00af65 100644
--- a/SU2_CFD/src/drivers/CDiscAdjSinglezoneDriver.cpp
+++ b/SU2_CFD/src/drivers/CDiscAdjSinglezoneDriver.cpp
@@ -2,7 +2,7 @@
* \file driver_adjoint_singlezone.cpp
* \brief The main subroutines for driving adjoint single-zone problems.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/drivers/CDriver.cpp b/SU2_CFD/src/drivers/CDriver.cpp
index 3f6856ea7bb..32b0e871c8e 100644
--- a/SU2_CFD/src/drivers/CDriver.cpp
+++ b/SU2_CFD/src/drivers/CDriver.cpp
@@ -2,7 +2,7 @@
* \file driver_structure.cpp
* \brief The main subroutines for driving single or multi-zone problems.
* \author T. Economon, H. Kline, R. Sanchez, F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/drivers/CDummyDriver.cpp b/SU2_CFD/src/drivers/CDummyDriver.cpp
index 63780909763..e6d440b662c 100644
--- a/SU2_CFD/src/drivers/CDummyDriver.cpp
+++ b/SU2_CFD/src/drivers/CDummyDriver.cpp
@@ -2,7 +2,7 @@
* \file CDummyDriver.cpp
* \brief Dummy driver class for running the preprocessing without geometry preprocessing.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/drivers/CMultizoneDriver.cpp b/SU2_CFD/src/drivers/CMultizoneDriver.cpp
index a8605ef9ae8..567ee1b14dc 100644
--- a/SU2_CFD/src/drivers/CMultizoneDriver.cpp
+++ b/SU2_CFD/src/drivers/CMultizoneDriver.cpp
@@ -2,7 +2,7 @@
* \file driver_structure.cpp
* \brief The main subroutines for driving multi-zone problems.
* \author R. Sanchez, O. Burghardt
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/drivers/CSinglezoneDriver.cpp b/SU2_CFD/src/drivers/CSinglezoneDriver.cpp
index eeee79606b9..683798053d5 100644
--- a/SU2_CFD/src/drivers/CSinglezoneDriver.cpp
+++ b/SU2_CFD/src/drivers/CSinglezoneDriver.cpp
@@ -2,7 +2,7 @@
* \file driver_direct_singlezone.cpp
* \brief The main subroutines for driving single-zone problems.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/fluid/CFluidModel.cpp b/SU2_CFD/src/fluid/CFluidModel.cpp
index 2d5f73ba2ba..1ff0728c4f5 100644
--- a/SU2_CFD/src/fluid/CFluidModel.cpp
+++ b/SU2_CFD/src/fluid/CFluidModel.cpp
@@ -2,7 +2,7 @@
* \file CFluidModel.cpp
* \brief Source of the fluid model base class containing thermo-physical subroutines.
* \author S.Vitale, M.Pini, G.Gori, A.Guardone, P.Colonna, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/fluid/CIdealGas.cpp b/SU2_CFD/src/fluid/CIdealGas.cpp
index ba1b7d9c8b7..78bf83b128c 100644
--- a/SU2_CFD/src/fluid/CIdealGas.cpp
+++ b/SU2_CFD/src/fluid/CIdealGas.cpp
@@ -2,7 +2,7 @@
* \file CIdealGas.cpp
* \brief Source of the ideal gas model.
* \author S. Vitale, G. Gori, M. Pini, A. Guardone, P. Colonna
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/fluid/CMutationTCLib.cpp b/SU2_CFD/src/fluid/CMutationTCLib.cpp
index 4eb8d3323cf..8885bda6a6c 100644
--- a/SU2_CFD/src/fluid/CMutationTCLib.cpp
+++ b/SU2_CFD/src/fluid/CMutationTCLib.cpp
@@ -2,7 +2,7 @@
* \file CMutationTCLib.cpp
* \brief Source of the Mutation++ 2T nonequilibrium gas model.
* \author C. Garbacz
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/fluid/CNEMOGas.cpp b/SU2_CFD/src/fluid/CNEMOGas.cpp
index cfc21af6387..3a36eae7220 100644
--- a/SU2_CFD/src/fluid/CNEMOGas.cpp
+++ b/SU2_CFD/src/fluid/CNEMOGas.cpp
@@ -2,7 +2,7 @@
* \file CNEMOGas.cpp
* \brief Source of the nonequilibrium gas model.
* \author C. Garbacz, W. Maier, S. R. Copeland
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/fluid/CPengRobinson.cpp b/SU2_CFD/src/fluid/CPengRobinson.cpp
index e2205975f85..bf8456af616 100644
--- a/SU2_CFD/src/fluid/CPengRobinson.cpp
+++ b/SU2_CFD/src/fluid/CPengRobinson.cpp
@@ -2,7 +2,7 @@
* \file CPengRobinson.cpp
* \brief Source of the Peng-Robinson model.
* \author S. Vitale, G. Gori, M. Pini, A. Guardone, P. Colonna
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/fluid/CSU2TCLib.cpp b/SU2_CFD/src/fluid/CSU2TCLib.cpp
index f378101efe6..4fbafd8c39d 100644
--- a/SU2_CFD/src/fluid/CSU2TCLib.cpp
+++ b/SU2_CFD/src/fluid/CSU2TCLib.cpp
@@ -2,7 +2,7 @@
* \file CSU2TCLib.cpp
* \brief Source of user defined 2T nonequilibrium gas model.
* \author C. Garbacz, W. Maier, S. R. Copeland
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/fluid/CVanDerWaalsGas.cpp b/SU2_CFD/src/fluid/CVanDerWaalsGas.cpp
index 7e0efca6c37..e16256be1e7 100644
--- a/SU2_CFD/src/fluid/CVanDerWaalsGas.cpp
+++ b/SU2_CFD/src/fluid/CVanDerWaalsGas.cpp
@@ -2,7 +2,7 @@
* \file CVanDerWaalsGas.cpp
* \brief Source of the Polytropic Van der Waals model.
* \author S. Vitale, G. Gori, M. Pini, A. Guardone, P. Colonna
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/integration/CFEM_DG_Integration.cpp b/SU2_CFD/src/integration/CFEM_DG_Integration.cpp
index 9ec00d536de..f1a339bbbc5 100644
--- a/SU2_CFD/src/integration/CFEM_DG_Integration.cpp
+++ b/SU2_CFD/src/integration/CFEM_DG_Integration.cpp
@@ -2,7 +2,7 @@
* \file CFEM_DG_Integration.cpp
* \brief Definition of time and space integration for the DG solver.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/integration/CIntegration.cpp b/SU2_CFD/src/integration/CIntegration.cpp
index c2699c9eb56..729eb41958b 100644
--- a/SU2_CFD/src/integration/CIntegration.cpp
+++ b/SU2_CFD/src/integration/CIntegration.cpp
@@ -2,7 +2,7 @@
* \file CIntegration.cpp
* \brief Implementation of the base class for space and time integration.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/integration/CIntegrationFactory.cpp b/SU2_CFD/src/integration/CIntegrationFactory.cpp
index cb4a57554cb..844b388442e 100644
--- a/SU2_CFD/src/integration/CIntegrationFactory.cpp
+++ b/SU2_CFD/src/integration/CIntegrationFactory.cpp
@@ -2,7 +2,7 @@
* \file CIntegrationFactory.cpp
* \brief Main subroutines for CIntegrationFactory .
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/integration/CMultiGridIntegration.cpp b/SU2_CFD/src/integration/CMultiGridIntegration.cpp
index 1143ce564e8..3441fe82737 100644
--- a/SU2_CFD/src/integration/CMultiGridIntegration.cpp
+++ b/SU2_CFD/src/integration/CMultiGridIntegration.cpp
@@ -2,7 +2,7 @@
* \file CMultiGridIntegration.cpp
* \brief Implementation of the multigrid integration class.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/integration/CNewtonIntegration.cpp b/SU2_CFD/src/integration/CNewtonIntegration.cpp
index 5c7abdf8908..a9f3a804c61 100644
--- a/SU2_CFD/src/integration/CNewtonIntegration.cpp
+++ b/SU2_CFD/src/integration/CNewtonIntegration.cpp
@@ -2,7 +2,7 @@
* \file CNewtonIntegration.cpp
* \brief Newton-Krylov integration.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/integration/CSingleGridIntegration.cpp b/SU2_CFD/src/integration/CSingleGridIntegration.cpp
index 69727321c9d..88da5a71ef9 100644
--- a/SU2_CFD/src/integration/CSingleGridIntegration.cpp
+++ b/SU2_CFD/src/integration/CSingleGridIntegration.cpp
@@ -2,7 +2,7 @@
* \file CSingleGridIntegration.cpp
* \brief Single (fine) grid integration class implementation.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/integration/CStructuralIntegration.cpp b/SU2_CFD/src/integration/CStructuralIntegration.cpp
index 52fb4177ceb..ee29cde6421 100644
--- a/SU2_CFD/src/integration/CStructuralIntegration.cpp
+++ b/SU2_CFD/src/integration/CStructuralIntegration.cpp
@@ -2,7 +2,7 @@
* \file CStructuralIntegration.cpp
* \brief Space and time integration for structural problems.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/interfaces/CInterface.cpp b/SU2_CFD/src/interfaces/CInterface.cpp
index 71f76e7d072..8559d1fcf84 100644
--- a/SU2_CFD/src/interfaces/CInterface.cpp
+++ b/SU2_CFD/src/interfaces/CInterface.cpp
@@ -2,7 +2,7 @@
* \file CInterface.cpp
* \brief Main subroutines for MPI transfer of information between zones
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/interfaces/cfd/CConservativeVarsInterface.cpp b/SU2_CFD/src/interfaces/cfd/CConservativeVarsInterface.cpp
index f0180f697f3..193e310c04f 100644
--- a/SU2_CFD/src/interfaces/cfd/CConservativeVarsInterface.cpp
+++ b/SU2_CFD/src/interfaces/cfd/CConservativeVarsInterface.cpp
@@ -3,7 +3,7 @@
* \brief Declaration and inlines of the class to transfer conservative variables
* from a generic zone into another one.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/interfaces/cfd/CMixingPlaneInterface.cpp b/SU2_CFD/src/interfaces/cfd/CMixingPlaneInterface.cpp
index be823780208..b422476cf7d 100644
--- a/SU2_CFD/src/interfaces/cfd/CMixingPlaneInterface.cpp
+++ b/SU2_CFD/src/interfaces/cfd/CMixingPlaneInterface.cpp
@@ -3,7 +3,7 @@
* \brief Declaration and inlines of the class to transfer average variables
* needed for MixingPlane computation from a generic zone into another one.
* \author S. Vitale
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/interfaces/cfd/CSlidingInterface.cpp b/SU2_CFD/src/interfaces/cfd/CSlidingInterface.cpp
index 709dba76b33..71dc84edf86 100644
--- a/SU2_CFD/src/interfaces/cfd/CSlidingInterface.cpp
+++ b/SU2_CFD/src/interfaces/cfd/CSlidingInterface.cpp
@@ -3,7 +3,7 @@
* \brief Declaration and inlines of the class to transfer conservative variables
* from a generic zone into another
* \author G. Gori Politecnico di Milano
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/interfaces/cht/CConjugateHeatInterface.cpp b/SU2_CFD/src/interfaces/cht/CConjugateHeatInterface.cpp
index 6ff35c0490f..51a5cc6423a 100644
--- a/SU2_CFD/src/interfaces/cht/CConjugateHeatInterface.cpp
+++ b/SU2_CFD/src/interfaces/cht/CConjugateHeatInterface.cpp
@@ -3,7 +3,7 @@
* \brief Declaration and inlines of the class to transfer temperature and heatflux
* density for conjugate heat interfaces between structure and fluid zones.
* \author O. Burghardt
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/interfaces/fsi/CDiscAdjFlowTractionInterface.cpp b/SU2_CFD/src/interfaces/fsi/CDiscAdjFlowTractionInterface.cpp
index 706189b4f81..c68ef91deff 100644
--- a/SU2_CFD/src/interfaces/fsi/CDiscAdjFlowTractionInterface.cpp
+++ b/SU2_CFD/src/interfaces/fsi/CDiscAdjFlowTractionInterface.cpp
@@ -3,7 +3,7 @@
* \brief Declaration and inlines of the class to transfer flow tractions
* from a fluid zone into a structural zone in a discrete adjoint simulation.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/interfaces/fsi/CDisplacementsInterface.cpp b/SU2_CFD/src/interfaces/fsi/CDisplacementsInterface.cpp
index 7fbe085bde7..a6d2ac03787 100644
--- a/SU2_CFD/src/interfaces/fsi/CDisplacementsInterface.cpp
+++ b/SU2_CFD/src/interfaces/fsi/CDisplacementsInterface.cpp
@@ -2,7 +2,7 @@
* \file CDisplacementsInterface.cpp
* \brief Main subroutines for transferring boundary displacements.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/interfaces/fsi/CFlowTractionInterface.cpp b/SU2_CFD/src/interfaces/fsi/CFlowTractionInterface.cpp
index cc70050817a..8dccbf19562 100644
--- a/SU2_CFD/src/interfaces/fsi/CFlowTractionInterface.cpp
+++ b/SU2_CFD/src/interfaces/fsi/CFlowTractionInterface.cpp
@@ -3,7 +3,7 @@
* \brief Declaration and inlines of the class to transfer flow tractions
* from a fluid zone into a structural zone.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/iteration/CAdjFluidIteration.cpp b/SU2_CFD/src/iteration/CAdjFluidIteration.cpp
index 870d6b00d2d..427d51851f4 100644
--- a/SU2_CFD/src/iteration/CAdjFluidIteration.cpp
+++ b/SU2_CFD/src/iteration/CAdjFluidIteration.cpp
@@ -2,7 +2,7 @@
* \file CAdjFluidIteration.cpp
* \brief Main subroutines used by SU2_CFD
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/iteration/CDiscAdjFEAIteration.cpp b/SU2_CFD/src/iteration/CDiscAdjFEAIteration.cpp
index b0887c79a41..90b4910b295 100644
--- a/SU2_CFD/src/iteration/CDiscAdjFEAIteration.cpp
+++ b/SU2_CFD/src/iteration/CDiscAdjFEAIteration.cpp
@@ -2,7 +2,7 @@
* \file CDiscAdjFEAIteration.cpp
* \brief Main subroutines used by SU2_CFD
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/iteration/CDiscAdjFluidIteration.cpp b/SU2_CFD/src/iteration/CDiscAdjFluidIteration.cpp
index 94bfab7dc34..155307886f5 100644
--- a/SU2_CFD/src/iteration/CDiscAdjFluidIteration.cpp
+++ b/SU2_CFD/src/iteration/CDiscAdjFluidIteration.cpp
@@ -2,7 +2,7 @@
* \file CDiscAdjFluidIteration.cpp
* \brief Main subroutines used by SU2_CFD
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/iteration/CDiscAdjHeatIteration.cpp b/SU2_CFD/src/iteration/CDiscAdjHeatIteration.cpp
index 64048cbce20..54c2daa78ad 100644
--- a/SU2_CFD/src/iteration/CDiscAdjHeatIteration.cpp
+++ b/SU2_CFD/src/iteration/CDiscAdjHeatIteration.cpp
@@ -2,7 +2,7 @@
* \file CDiscAdjHeatIteration.cpp
* \brief Main subroutines used by SU2_CFD
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/iteration/CFEAIteration.cpp b/SU2_CFD/src/iteration/CFEAIteration.cpp
index 1263c41b36e..2b5f0a6560c 100644
--- a/SU2_CFD/src/iteration/CFEAIteration.cpp
+++ b/SU2_CFD/src/iteration/CFEAIteration.cpp
@@ -2,7 +2,7 @@
* \file CFEAIteration.cpp
* \brief Main subroutines used by SU2_CFD
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/iteration/CFEMFluidIteration.cpp b/SU2_CFD/src/iteration/CFEMFluidIteration.cpp
index fff55845d86..beda3177410 100644
--- a/SU2_CFD/src/iteration/CFEMFluidIteration.cpp
+++ b/SU2_CFD/src/iteration/CFEMFluidIteration.cpp
@@ -2,7 +2,7 @@
* \file CFEMFluidIteration.cpp
* \brief Main subroutines used by SU2_CFD
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/iteration/CFluidIteration.cpp b/SU2_CFD/src/iteration/CFluidIteration.cpp
index 1c28976f539..aeaf77f9621 100644
--- a/SU2_CFD/src/iteration/CFluidIteration.cpp
+++ b/SU2_CFD/src/iteration/CFluidIteration.cpp
@@ -2,7 +2,7 @@
* \file CFluidIteration.cpp
* \brief Main subroutines used by SU2_CFD
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/iteration/CHeatIteration.cpp b/SU2_CFD/src/iteration/CHeatIteration.cpp
index adf02634aa1..bf125b75885 100644
--- a/SU2_CFD/src/iteration/CHeatIteration.cpp
+++ b/SU2_CFD/src/iteration/CHeatIteration.cpp
@@ -2,7 +2,7 @@
* \file CHeatIteration.cpp
* \brief Main subroutines used by SU2_CFD
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/iteration/CIteration.cpp b/SU2_CFD/src/iteration/CIteration.cpp
index d76b49ef187..7ebd79a4235 100644
--- a/SU2_CFD/src/iteration/CIteration.cpp
+++ b/SU2_CFD/src/iteration/CIteration.cpp
@@ -2,7 +2,7 @@
* \file iteration_structure.cpp
* \brief Main subroutines used by SU2_CFD
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/iteration/CIterationFactory.cpp b/SU2_CFD/src/iteration/CIterationFactory.cpp
index e330c9434e6..3af7adadfea 100644
--- a/SU2_CFD/src/iteration/CIterationFactory.cpp
+++ b/SU2_CFD/src/iteration/CIterationFactory.cpp
@@ -2,7 +2,7 @@
* \file CAdjFluidIteration.cpp
* \brief Main subroutines used by SU2_CFD
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/iteration/CTurboIteration.cpp b/SU2_CFD/src/iteration/CTurboIteration.cpp
index 7066771c1a1..30e16ca7d1a 100644
--- a/SU2_CFD/src/iteration/CTurboIteration.cpp
+++ b/SU2_CFD/src/iteration/CTurboIteration.cpp
@@ -2,7 +2,7 @@
* \file CTurboIteration.cpp
* \brief Main subroutines used by SU2_CFD
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/limiters/CLimiterDetails.cpp b/SU2_CFD/src/limiters/CLimiterDetails.cpp
index f6c5cc3292e..c575e44e15f 100644
--- a/SU2_CFD/src/limiters/CLimiterDetails.cpp
+++ b/SU2_CFD/src/limiters/CLimiterDetails.cpp
@@ -3,7 +3,7 @@
* \brief A class template that allows defining limiters via
* specialization of particular details.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/CNumerics.cpp b/SU2_CFD/src/numerics/CNumerics.cpp
index 95b96a4ee86..8d19b52c72f 100644
--- a/SU2_CFD/src/numerics/CNumerics.cpp
+++ b/SU2_CFD/src/numerics/CNumerics.cpp
@@ -4,7 +4,7 @@
* Contains methods for common tasks, e.g. compute flux
* Jacobians.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/NEMO/CNEMONumerics.cpp b/SU2_CFD/src/numerics/NEMO/CNEMONumerics.cpp
index 853a14da47f..2bbb8d471f7 100644
--- a/SU2_CFD/src/numerics/NEMO/CNEMONumerics.cpp
+++ b/SU2_CFD/src/numerics/NEMO/CNEMONumerics.cpp
@@ -4,7 +4,7 @@
* Contains methods for common tasks, e.g. compute flux
* Jacobians.
* \author S.R. Copeland, W. Maier, C. Garbacz
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/NEMO/NEMO_diffusion.cpp b/SU2_CFD/src/numerics/NEMO/NEMO_diffusion.cpp
index d0f3ac76a13..12ce854348f 100644
--- a/SU2_CFD/src/numerics/NEMO/NEMO_diffusion.cpp
+++ b/SU2_CFD/src/numerics/NEMO/NEMO_diffusion.cpp
@@ -3,7 +3,7 @@
* \brief Implementation of numerics classes for discretization
* of viscous fluxes in fluid flow NEMO problems.
* \author S.R. Copeland, W. Maier, C. Garbacz
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/NEMO/NEMO_sources.cpp b/SU2_CFD/src/numerics/NEMO/NEMO_sources.cpp
index 721672852f7..06d1b6ebd4d 100644
--- a/SU2_CFD/src/numerics/NEMO/NEMO_sources.cpp
+++ b/SU2_CFD/src/numerics/NEMO/NEMO_sources.cpp
@@ -3,7 +3,7 @@
* \brief Implementation of numerics classes for integration
* of source terms in fluid flow NEMO problems.
* \author C. Garbacz, W. Maier, S. Copeland.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/NEMO/convection/ausm.cpp b/SU2_CFD/src/numerics/NEMO/convection/ausm.cpp
index 9e14008636d..8888fb62cab 100644
--- a/SU2_CFD/src/numerics/NEMO/convection/ausm.cpp
+++ b/SU2_CFD/src/numerics/NEMO/convection/ausm.cpp
@@ -2,7 +2,7 @@
* \file ausm.cpp
* \brief Implementations of the AUSM-family of schemes in NEMO.
* \author F. Palacios, S.R. Copeland, W. Maier, C. Garbacz
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/NEMO/convection/ausmplusup2.cpp b/SU2_CFD/src/numerics/NEMO/convection/ausmplusup2.cpp
index d018b81da44..1756b1498ba 100644
--- a/SU2_CFD/src/numerics/NEMO/convection/ausmplusup2.cpp
+++ b/SU2_CFD/src/numerics/NEMO/convection/ausmplusup2.cpp
@@ -2,7 +2,7 @@
* \file ausmplusup2.cpp
* \brief Implementations of the AUSM-family of schemes - AUSM+UP2.
* \author W. Maier, A. Sachedeva, C. Garbacz
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/NEMO/convection/ausmpwplus.cpp b/SU2_CFD/src/numerics/NEMO/convection/ausmpwplus.cpp
index 62796548a34..88293d6f0be 100644
--- a/SU2_CFD/src/numerics/NEMO/convection/ausmpwplus.cpp
+++ b/SU2_CFD/src/numerics/NEMO/convection/ausmpwplus.cpp
@@ -2,7 +2,7 @@
* \file ausmpwplus.cpp
* \brief Implementations of the AUSM-family of schemes - AUSMPWPLUS.
* \author F. Palacios, W. Maier, C. Garbacz
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/NEMO/convection/lax.cpp b/SU2_CFD/src/numerics/NEMO/convection/lax.cpp
index 9f25a48fd62..8cc5714dd71 100644
--- a/SU2_CFD/src/numerics/NEMO/convection/lax.cpp
+++ b/SU2_CFD/src/numerics/NEMO/convection/lax.cpp
@@ -2,7 +2,7 @@
* \file lax.cpp
* \brief Implementations of Lax centered scheme.
* \author F. Palacios, S.R. Copeland, W. Maier, C. Garbacz
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/NEMO/convection/msw.cpp b/SU2_CFD/src/numerics/NEMO/convection/msw.cpp
index 147ad17e3e8..c2fb4ac4ddb 100644
--- a/SU2_CFD/src/numerics/NEMO/convection/msw.cpp
+++ b/SU2_CFD/src/numerics/NEMO/convection/msw.cpp
@@ -2,7 +2,7 @@
* \file msw.cpp
* \brief Implementations of the modified Steger-Warming scheme.
* \author ADL Stanford, S.R. Copeland, W. Maier, C. Garbacz
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/NEMO/convection/roe.cpp b/SU2_CFD/src/numerics/NEMO/convection/roe.cpp
index ddbf00f496d..fdd146b750f 100644
--- a/SU2_CFD/src/numerics/NEMO/convection/roe.cpp
+++ b/SU2_CFD/src/numerics/NEMO/convection/roe.cpp
@@ -2,7 +2,7 @@
* \file roe.cpp
* \brief Implementations of Roe-type schemes in NEMO.
* \author S. R. Copeland, W. Maier, C. Garbacz
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/continuous_adjoint/adj_convection.cpp b/SU2_CFD/src/numerics/continuous_adjoint/adj_convection.cpp
index e20c7c725ba..f583e264620 100644
--- a/SU2_CFD/src/numerics/continuous_adjoint/adj_convection.cpp
+++ b/SU2_CFD/src/numerics/continuous_adjoint/adj_convection.cpp
@@ -2,7 +2,7 @@
* \file adj_convection.cpp
* \brief Implementation of adjoint convection numerics classes.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/continuous_adjoint/adj_diffusion.cpp b/SU2_CFD/src/numerics/continuous_adjoint/adj_diffusion.cpp
index 6bd9b395c03..e177fa67d6f 100644
--- a/SU2_CFD/src/numerics/continuous_adjoint/adj_diffusion.cpp
+++ b/SU2_CFD/src/numerics/continuous_adjoint/adj_diffusion.cpp
@@ -2,7 +2,7 @@
* \file adj_diffusion.cpp
* \brief Implementation of adjoint diffusion numerics classes.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/continuous_adjoint/adj_sources.cpp b/SU2_CFD/src/numerics/continuous_adjoint/adj_sources.cpp
index d9ac7e84687..5a84c76ce53 100644
--- a/SU2_CFD/src/numerics/continuous_adjoint/adj_sources.cpp
+++ b/SU2_CFD/src/numerics/continuous_adjoint/adj_sources.cpp
@@ -2,7 +2,7 @@
* \file adj_sources.cpp
* \brief Implementation of adjoint source numerics classes.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/elasticity/CFEAElasticity.cpp b/SU2_CFD/src/numerics/elasticity/CFEAElasticity.cpp
index 32da0355745..4c47c6f3847 100644
--- a/SU2_CFD/src/numerics/elasticity/CFEAElasticity.cpp
+++ b/SU2_CFD/src/numerics/elasticity/CFEAElasticity.cpp
@@ -2,7 +2,7 @@
* \file CFEAElasticity.cpp
* \brief Base class for all elasticity problems.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/elasticity/CFEALinearElasticity.cpp b/SU2_CFD/src/numerics/elasticity/CFEALinearElasticity.cpp
index 199be05e382..dfe849972cc 100644
--- a/SU2_CFD/src/numerics/elasticity/CFEALinearElasticity.cpp
+++ b/SU2_CFD/src/numerics/elasticity/CFEALinearElasticity.cpp
@@ -2,7 +2,7 @@
* \file CFEALinearElasticity.cpp
* \brief Classes for linear elasticity problems.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/elasticity/CFEANonlinearElasticity.cpp b/SU2_CFD/src/numerics/elasticity/CFEANonlinearElasticity.cpp
index 45f65f568fe..10f5b54999f 100644
--- a/SU2_CFD/src/numerics/elasticity/CFEANonlinearElasticity.cpp
+++ b/SU2_CFD/src/numerics/elasticity/CFEANonlinearElasticity.cpp
@@ -3,7 +3,7 @@
* \brief This file contains the routines for setting the tangent matrix and
* residual of a FEM nonlinear elastic structural problem.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/elasticity/nonlinear_models.cpp b/SU2_CFD/src/numerics/elasticity/nonlinear_models.cpp
index 0f6c032e9df..76e70f0a5e8 100644
--- a/SU2_CFD/src/numerics/elasticity/nonlinear_models.cpp
+++ b/SU2_CFD/src/numerics/elasticity/nonlinear_models.cpp
@@ -2,7 +2,7 @@
* \file nonlinear_models.cpp
* \brief Definition of nonlinear constitutive models.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/flow/convection/ausm_slau.cpp b/SU2_CFD/src/numerics/flow/convection/ausm_slau.cpp
index 8f965336d25..86db397ce89 100644
--- a/SU2_CFD/src/numerics/flow/convection/ausm_slau.cpp
+++ b/SU2_CFD/src/numerics/flow/convection/ausm_slau.cpp
@@ -2,7 +2,7 @@
* \file ausm_slau.cpp
* \brief Implementations of the AUSM-family of schemes.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/flow/convection/centered.cpp b/SU2_CFD/src/numerics/flow/convection/centered.cpp
index 69b1b59b46e..d1a891232cb 100644
--- a/SU2_CFD/src/numerics/flow/convection/centered.cpp
+++ b/SU2_CFD/src/numerics/flow/convection/centered.cpp
@@ -2,7 +2,7 @@
* \file centered.cpp
* \brief Implementations of centered schemes.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/flow/convection/cusp.cpp b/SU2_CFD/src/numerics/flow/convection/cusp.cpp
index 063ae16d460..5840a11b693 100644
--- a/SU2_CFD/src/numerics/flow/convection/cusp.cpp
+++ b/SU2_CFD/src/numerics/flow/convection/cusp.cpp
@@ -2,7 +2,7 @@
* \file cusp.cpp
* \brief Implementation of the CUSP scheme.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/flow/convection/fds.cpp b/SU2_CFD/src/numerics/flow/convection/fds.cpp
index 270bf5dfbad..003d6da0721 100644
--- a/SU2_CFD/src/numerics/flow/convection/fds.cpp
+++ b/SU2_CFD/src/numerics/flow/convection/fds.cpp
@@ -2,7 +2,7 @@
* \file fds.cpp
* \brief Implementation of Flux-Difference-Splitting schemes.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/flow/convection/fvs.cpp b/SU2_CFD/src/numerics/flow/convection/fvs.cpp
index 59d6c81be92..bcf44c7a5bb 100644
--- a/SU2_CFD/src/numerics/flow/convection/fvs.cpp
+++ b/SU2_CFD/src/numerics/flow/convection/fvs.cpp
@@ -2,7 +2,7 @@
* \file fvs.cpp
* \brief Implementations of Flux-Vector-Splitting schemes.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/flow/convection/hllc.cpp b/SU2_CFD/src/numerics/flow/convection/hllc.cpp
index 27e1e89c281..5e194ce1f39 100644
--- a/SU2_CFD/src/numerics/flow/convection/hllc.cpp
+++ b/SU2_CFD/src/numerics/flow/convection/hllc.cpp
@@ -2,7 +2,7 @@
* \file hllc.cpp
* \brief Implementations of HLLC schemes.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/flow/convection/roe.cpp b/SU2_CFD/src/numerics/flow/convection/roe.cpp
index 07256cb790a..6d487afb94a 100644
--- a/SU2_CFD/src/numerics/flow/convection/roe.cpp
+++ b/SU2_CFD/src/numerics/flow/convection/roe.cpp
@@ -2,7 +2,7 @@
* \file roe.cpp
* \brief Implementations of Roe-type schemes.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/flow/flow_diffusion.cpp b/SU2_CFD/src/numerics/flow/flow_diffusion.cpp
index d9832b72639..1dde3aa910f 100644
--- a/SU2_CFD/src/numerics/flow/flow_diffusion.cpp
+++ b/SU2_CFD/src/numerics/flow/flow_diffusion.cpp
@@ -3,7 +3,7 @@
* \brief Implementation of numerics classes for discretization
* of viscous fluxes in fluid flow problems.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/flow/flow_sources.cpp b/SU2_CFD/src/numerics/flow/flow_sources.cpp
index b95e176eb6e..9ed3841c8f5 100644
--- a/SU2_CFD/src/numerics/flow/flow_sources.cpp
+++ b/SU2_CFD/src/numerics/flow/flow_sources.cpp
@@ -3,7 +3,7 @@
* \brief Implementation of numerics classes for integration
* of source terms in fluid flow problems.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/heat.cpp b/SU2_CFD/src/numerics/heat.cpp
index a6b1911d0f1..c6dc5cdde64 100644
--- a/SU2_CFD/src/numerics/heat.cpp
+++ b/SU2_CFD/src/numerics/heat.cpp
@@ -2,7 +2,7 @@
* \file heat.cpp
* \brief Implementation of numerics classes for heat transfer.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/radiation.cpp b/SU2_CFD/src/numerics/radiation.cpp
index 5d4268fe88b..65222ad3095 100644
--- a/SU2_CFD/src/numerics/radiation.cpp
+++ b/SU2_CFD/src/numerics/radiation.cpp
@@ -3,7 +3,7 @@
* \brief This file contains the implementation of the numerical
* methods for radiation.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/template.cpp b/SU2_CFD/src/numerics/template.cpp
index 81effb5c0d0..ba0627e47cf 100644
--- a/SU2_CFD/src/numerics/template.cpp
+++ b/SU2_CFD/src/numerics/template.cpp
@@ -2,7 +2,7 @@
* \file template.cpp
* \brief Empty implementation of numerics templates, see .hpp file.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/transition.cpp b/SU2_CFD/src/numerics/transition.cpp
index 99182037c54..4d7ceac9196 100644
--- a/SU2_CFD/src/numerics/transition.cpp
+++ b/SU2_CFD/src/numerics/transition.cpp
@@ -2,7 +2,7 @@
* \file transition.cpp
* \brief Implementation of numerics classes for transition problems.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/turbulent/turb_convection.cpp b/SU2_CFD/src/numerics/turbulent/turb_convection.cpp
index 8dfa4e3c7d2..f294b61778b 100644
--- a/SU2_CFD/src/numerics/turbulent/turb_convection.cpp
+++ b/SU2_CFD/src/numerics/turbulent/turb_convection.cpp
@@ -3,7 +3,7 @@
* \brief Implementation of numerics classes to compute convective
* fluxes in turbulence problems.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/turbulent/turb_diffusion.cpp b/SU2_CFD/src/numerics/turbulent/turb_diffusion.cpp
index 66d70730450..cd50f8ed71c 100644
--- a/SU2_CFD/src/numerics/turbulent/turb_diffusion.cpp
+++ b/SU2_CFD/src/numerics/turbulent/turb_diffusion.cpp
@@ -3,7 +3,7 @@
* \brief Implementation of numerics classes to compute viscous
* fluxes in turbulence problems.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/numerics/turbulent/turb_sources.cpp b/SU2_CFD/src/numerics/turbulent/turb_sources.cpp
index 0f6379ee926..0efc4e00dcf 100644
--- a/SU2_CFD/src/numerics/turbulent/turb_sources.cpp
+++ b/SU2_CFD/src/numerics/turbulent/turb_sources.cpp
@@ -3,7 +3,7 @@
* \brief Implementation of numerics classes for integration of
* turbulence source-terms.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/CAdjElasticityOutput.cpp b/SU2_CFD/src/output/CAdjElasticityOutput.cpp
index 1af8a45ce73..22b1e5add14 100644
--- a/SU2_CFD/src/output/CAdjElasticityOutput.cpp
+++ b/SU2_CFD/src/output/CAdjElasticityOutput.cpp
@@ -2,7 +2,7 @@
* \file CAdjElasticityOutput.cpp
* \brief Main subroutines for elasticity discrete adjoint output
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/CAdjFlowCompOutput.cpp b/SU2_CFD/src/output/CAdjFlowCompOutput.cpp
index e45ec3d6cbb..66e36e8bb8b 100644
--- a/SU2_CFD/src/output/CAdjFlowCompOutput.cpp
+++ b/SU2_CFD/src/output/CAdjFlowCompOutput.cpp
@@ -2,7 +2,7 @@
* \file output_adj_flow_comp.cpp
* \brief Main subroutines for flow discrete adjoint output
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/CAdjFlowIncOutput.cpp b/SU2_CFD/src/output/CAdjFlowIncOutput.cpp
index 0bdbb008062..b7bd9e90115 100644
--- a/SU2_CFD/src/output/CAdjFlowIncOutput.cpp
+++ b/SU2_CFD/src/output/CAdjFlowIncOutput.cpp
@@ -2,7 +2,7 @@
* \file output_adj_flow_inc.cpp
* \brief Main subroutines for flow discrete adjoint output
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/CAdjHeatOutput.cpp b/SU2_CFD/src/output/CAdjHeatOutput.cpp
index 0ea5b3a74ee..4c8f2b767a7 100644
--- a/SU2_CFD/src/output/CAdjHeatOutput.cpp
+++ b/SU2_CFD/src/output/CAdjHeatOutput.cpp
@@ -2,7 +2,7 @@
* \file output_adj_heat.cpp
* \brief Main subroutines for flow discrete adjoint output
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/CBaselineOutput.cpp b/SU2_CFD/src/output/CBaselineOutput.cpp
index 168575e6d68..6c8d3bf5499 100644
--- a/SU2_CFD/src/output/CBaselineOutput.cpp
+++ b/SU2_CFD/src/output/CBaselineOutput.cpp
@@ -2,7 +2,7 @@
* \file output_baseline.cpp
* \brief Main subroutines for flow discrete adjoint output
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/CElasticityOutput.cpp b/SU2_CFD/src/output/CElasticityOutput.cpp
index 8ff56ffc94b..07b52053e40 100644
--- a/SU2_CFD/src/output/CElasticityOutput.cpp
+++ b/SU2_CFD/src/output/CElasticityOutput.cpp
@@ -2,7 +2,7 @@
* \file output_elasticity.cpp
* \brief Main subroutines for FEA output
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/CFlowCompFEMOutput.cpp b/SU2_CFD/src/output/CFlowCompFEMOutput.cpp
index 632bdefad0c..cb1dc697aaa 100644
--- a/SU2_CFD/src/output/CFlowCompFEMOutput.cpp
+++ b/SU2_CFD/src/output/CFlowCompFEMOutput.cpp
@@ -2,7 +2,7 @@
* \file output_flow_comp_fem.cpp
* \brief Main subroutines for compressible flow output
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/CFlowCompOutput.cpp b/SU2_CFD/src/output/CFlowCompOutput.cpp
index 14240f53105..cb226265e0a 100644
--- a/SU2_CFD/src/output/CFlowCompOutput.cpp
+++ b/SU2_CFD/src/output/CFlowCompOutput.cpp
@@ -2,7 +2,7 @@
* \file output_flow_comp.cpp
* \brief Main subroutines for compressible flow output
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/CFlowIncOutput.cpp b/SU2_CFD/src/output/CFlowIncOutput.cpp
index df6ca665daf..77f8613b93c 100644
--- a/SU2_CFD/src/output/CFlowIncOutput.cpp
+++ b/SU2_CFD/src/output/CFlowIncOutput.cpp
@@ -2,7 +2,7 @@
* \file output_flow_inc.cpp
* \brief Main subroutines for incompressible flow output
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/CFlowOutput.cpp b/SU2_CFD/src/output/CFlowOutput.cpp
index 8736b6f5d55..38d62e74415 100644
--- a/SU2_CFD/src/output/CFlowOutput.cpp
+++ b/SU2_CFD/src/output/CFlowOutput.cpp
@@ -2,7 +2,7 @@
* \file output_flow.cpp
* \brief Main subroutines for compressible flow output
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
@@ -1259,7 +1259,7 @@ void CFlowOutput::WriteForcesBreakdown(CConfig *config, CGeometry *geometry, CSo
Breakdown_file << "\n" <<"-------------------------------------------------------------------------" << "\n";
Breakdown_file << "| ___ _ _ ___ |" << "\n";
- Breakdown_file << "| / __| | | |_ ) Release 7.1.0 \"Blackbird\" |" << "\n";
+ Breakdown_file << "| / __| | | |_ ) Release 7.1.1 \"Blackbird\" |" << "\n";
Breakdown_file << "| \\__ \\ |_| |/ / |" << "\n";
Breakdown_file << "| |___/\\___//___| Suite (Computational Fluid Dynamics Code) |" << "\n";
Breakdown_file << "| |" << "\n";
diff --git a/SU2_CFD/src/output/CHeatOutput.cpp b/SU2_CFD/src/output/CHeatOutput.cpp
index 857d721011a..55aa37097d1 100644
--- a/SU2_CFD/src/output/CHeatOutput.cpp
+++ b/SU2_CFD/src/output/CHeatOutput.cpp
@@ -2,7 +2,7 @@
* \file output_heat.cpp
* \brief Main subroutines for the heat solver output
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/CMeshOutput.cpp b/SU2_CFD/src/output/CMeshOutput.cpp
index 03b067b782c..0bb79e6ac3b 100644
--- a/SU2_CFD/src/output/CMeshOutput.cpp
+++ b/SU2_CFD/src/output/CMeshOutput.cpp
@@ -2,7 +2,7 @@
* \file output_mesh.cpp
* \brief Main subroutines for the heat solver output
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/CMultizoneOutput.cpp b/SU2_CFD/src/output/CMultizoneOutput.cpp
index 0c492df4659..8d182ef1dc5 100644
--- a/SU2_CFD/src/output/CMultizoneOutput.cpp
+++ b/SU2_CFD/src/output/CMultizoneOutput.cpp
@@ -2,7 +2,7 @@
* \file CMultizoneOutput.cpp
* \brief Main subroutines for multizone output
* \author R. Sanchez, T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/COutput.cpp b/SU2_CFD/src/output/COutput.cpp
index 943adc06633..d8959465121 100644
--- a/SU2_CFD/src/output/COutput.cpp
+++ b/SU2_CFD/src/output/COutput.cpp
@@ -2,7 +2,7 @@
* \file output_structure.cpp
* \brief Main subroutines for output solver information
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/COutputFactory.cpp b/SU2_CFD/src/output/COutputFactory.cpp
index a39f315ea0e..45ef89a92dc 100644
--- a/SU2_CFD/src/output/COutputFactory.cpp
+++ b/SU2_CFD/src/output/COutputFactory.cpp
@@ -2,7 +2,7 @@
* \file COutputFactory.cpp
* \brief Main subroutines for output solver information
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/filewriter/CCSVFileWriter.cpp b/SU2_CFD/src/output/filewriter/CCSVFileWriter.cpp
index 7ffd2fb9670..fbfc7846118 100644
--- a/SU2_CFD/src/output/filewriter/CCSVFileWriter.cpp
+++ b/SU2_CFD/src/output/filewriter/CCSVFileWriter.cpp
@@ -2,7 +2,7 @@
* \file CCSVFileWriter.cpp
* \brief CSV Writer output class
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/filewriter/CFEMDataSorter.cpp b/SU2_CFD/src/output/filewriter/CFEMDataSorter.cpp
index 61244dd6396..ea2b3c46504 100644
--- a/SU2_CFD/src/output/filewriter/CFEMDataSorter.cpp
+++ b/SU2_CFD/src/output/filewriter/CFEMDataSorter.cpp
@@ -2,7 +2,7 @@
* \file CFEMDataSorter.cpp
* \brief Datasorter class for FEM solvers.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/filewriter/CFVMDataSorter.cpp b/SU2_CFD/src/output/filewriter/CFVMDataSorter.cpp
index d3deb547df4..4d3b50cb744 100644
--- a/SU2_CFD/src/output/filewriter/CFVMDataSorter.cpp
+++ b/SU2_CFD/src/output/filewriter/CFVMDataSorter.cpp
@@ -2,7 +2,7 @@
* \file CFVMDataSorter.cpp
* \brief Datasorter class for FVM solvers.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/filewriter/CParallelDataSorter.cpp b/SU2_CFD/src/output/filewriter/CParallelDataSorter.cpp
index eeef9bdd0ef..c3d4f9601c5 100644
--- a/SU2_CFD/src/output/filewriter/CParallelDataSorter.cpp
+++ b/SU2_CFD/src/output/filewriter/CParallelDataSorter.cpp
@@ -2,7 +2,7 @@
* \file CParallelDataSorter.cpp
* \brief Datasorter base class.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/filewriter/CParallelFileWriter.cpp b/SU2_CFD/src/output/filewriter/CParallelFileWriter.cpp
index a882011c27b..2d9efcf1f88 100644
--- a/SU2_CFD/src/output/filewriter/CParallelFileWriter.cpp
+++ b/SU2_CFD/src/output/filewriter/CParallelFileWriter.cpp
@@ -2,7 +2,7 @@
* \file CFileWriter.cpp
* \brief Filewriter base class.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/filewriter/CParaviewBinaryFileWriter.cpp b/SU2_CFD/src/output/filewriter/CParaviewBinaryFileWriter.cpp
index 1a2d85cef37..467a1e7702f 100644
--- a/SU2_CFD/src/output/filewriter/CParaviewBinaryFileWriter.cpp
+++ b/SU2_CFD/src/output/filewriter/CParaviewBinaryFileWriter.cpp
@@ -2,7 +2,7 @@
* \file CParaviewBinaryFileWriter.cpp
* \brief Filewriter class for Paraview binary format.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/filewriter/CParaviewFileWriter.cpp b/SU2_CFD/src/output/filewriter/CParaviewFileWriter.cpp
index a4a73b9a63b..f49947e8841 100644
--- a/SU2_CFD/src/output/filewriter/CParaviewFileWriter.cpp
+++ b/SU2_CFD/src/output/filewriter/CParaviewFileWriter.cpp
@@ -2,7 +2,7 @@
* \file CParaviewFileWriter.cpp
* \brief Filewriter class for Paraview ASCII format.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/filewriter/CParaviewVTMFileWriter.cpp b/SU2_CFD/src/output/filewriter/CParaviewVTMFileWriter.cpp
index 8ca0bc41157..658e5bae03d 100644
--- a/SU2_CFD/src/output/filewriter/CParaviewVTMFileWriter.cpp
+++ b/SU2_CFD/src/output/filewriter/CParaviewVTMFileWriter.cpp
@@ -2,7 +2,7 @@
* \file CParaviewVTMFileWriter.cpp
* \brief Filewriter class for Paraview binary format.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/filewriter/CParaviewXMLFileWriter.cpp b/SU2_CFD/src/output/filewriter/CParaviewXMLFileWriter.cpp
index 4871946b7cf..2beed550964 100644
--- a/SU2_CFD/src/output/filewriter/CParaviewXMLFileWriter.cpp
+++ b/SU2_CFD/src/output/filewriter/CParaviewXMLFileWriter.cpp
@@ -2,7 +2,7 @@
* \file CParaviewXMLFileWriter.cpp
* \brief Filewriter class for Paraview binary format.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/filewriter/CSTLFileWriter.cpp b/SU2_CFD/src/output/filewriter/CSTLFileWriter.cpp
index 33281e83190..1d29acb0ad0 100644
--- a/SU2_CFD/src/output/filewriter/CSTLFileWriter.cpp
+++ b/SU2_CFD/src/output/filewriter/CSTLFileWriter.cpp
@@ -2,7 +2,7 @@
* \file CSTLFileWriter.cpp
* \brief STL Writer output class
* \author T. Kattmann, T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/filewriter/CSU2BinaryFileWriter.cpp b/SU2_CFD/src/output/filewriter/CSU2BinaryFileWriter.cpp
index 1b23f9cad0d..ccd44f34710 100644
--- a/SU2_CFD/src/output/filewriter/CSU2BinaryFileWriter.cpp
+++ b/SU2_CFD/src/output/filewriter/CSU2BinaryFileWriter.cpp
@@ -2,7 +2,7 @@
* \file CSU2BinaryFileWriter.cpp
* \brief Filewriter class SU2 native binary format.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/filewriter/CSU2FileWriter.cpp b/SU2_CFD/src/output/filewriter/CSU2FileWriter.cpp
index e7facb24ebb..1e9a7d523fc 100644
--- a/SU2_CFD/src/output/filewriter/CSU2FileWriter.cpp
+++ b/SU2_CFD/src/output/filewriter/CSU2FileWriter.cpp
@@ -2,7 +2,7 @@
* \file CSU2FileWriter.cpp
* \brief Filewriter class SU2 native ASCII (CSV) format.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/filewriter/CSU2MeshFileWriter.cpp b/SU2_CFD/src/output/filewriter/CSU2MeshFileWriter.cpp
index 0c81dcc33d8..d90a26271e9 100644
--- a/SU2_CFD/src/output/filewriter/CSU2MeshFileWriter.cpp
+++ b/SU2_CFD/src/output/filewriter/CSU2MeshFileWriter.cpp
@@ -2,7 +2,7 @@
* \file CSU2MeshFileWriter.cpp
* \brief Filewriter class SU2 native mesh format.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/filewriter/CSurfaceFEMDataSorter.cpp b/SU2_CFD/src/output/filewriter/CSurfaceFEMDataSorter.cpp
index d548dd655b4..97221c236bf 100644
--- a/SU2_CFD/src/output/filewriter/CSurfaceFEMDataSorter.cpp
+++ b/SU2_CFD/src/output/filewriter/CSurfaceFEMDataSorter.cpp
@@ -2,7 +2,7 @@
* \file CSurfaceFEMDataSorter.cpp
* \brief Datasorter for FEM surfaces.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/filewriter/CSurfaceFVMDataSorter.cpp b/SU2_CFD/src/output/filewriter/CSurfaceFVMDataSorter.cpp
index bcf6b99064e..13df7a4d8e8 100644
--- a/SU2_CFD/src/output/filewriter/CSurfaceFVMDataSorter.cpp
+++ b/SU2_CFD/src/output/filewriter/CSurfaceFVMDataSorter.cpp
@@ -2,7 +2,7 @@
* \file CSurfaceFVMDataSorter.cpp
* \brief Datasorter for FVM surfaces.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/filewriter/CTecplotBinaryFileWriter.cpp b/SU2_CFD/src/output/filewriter/CTecplotBinaryFileWriter.cpp
index 63824a1c7e2..5b609940e2d 100644
--- a/SU2_CFD/src/output/filewriter/CTecplotBinaryFileWriter.cpp
+++ b/SU2_CFD/src/output/filewriter/CTecplotBinaryFileWriter.cpp
@@ -2,7 +2,7 @@
* \file CTecplotBinaryFileWriter.cpp
* \brief Filewriter class for Tecplot binary format.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/filewriter/CTecplotFileWriter.cpp b/SU2_CFD/src/output/filewriter/CTecplotFileWriter.cpp
index c0631451dd3..c5207a27740 100644
--- a/SU2_CFD/src/output/filewriter/CTecplotFileWriter.cpp
+++ b/SU2_CFD/src/output/filewriter/CTecplotFileWriter.cpp
@@ -2,7 +2,7 @@
* \file CTecplotFileWriter.cpp
* \brief Filewriter class for Tecplot ASCII format.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/output_physics.cpp b/SU2_CFD/src/output/output_physics.cpp
index 7d68b8775b5..621937bd3c6 100644
--- a/SU2_CFD/src/output/output_physics.cpp
+++ b/SU2_CFD/src/output/output_physics.cpp
@@ -2,7 +2,7 @@
* \file output_physics.cpp
* \brief Main subroutines to compute physical output quantities such as CL, CD, entropy generation, mass flow, ecc... .
* \author S. Vitale
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/output_structure_legacy.cpp b/SU2_CFD/src/output/output_structure_legacy.cpp
index c10a2bf1d86..ebac0379aaa 100644
--- a/SU2_CFD/src/output/output_structure_legacy.cpp
+++ b/SU2_CFD/src/output/output_structure_legacy.cpp
@@ -2,7 +2,7 @@
* \file output_structure.cpp
* \brief Main subroutines for output solver information
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/output/tools/CWindowingTools.cpp b/SU2_CFD/src/output/tools/CWindowingTools.cpp
index a0bb5a26164..87fc1f250a8 100644
--- a/SU2_CFD/src/output/tools/CWindowingTools.cpp
+++ b/SU2_CFD/src/output/tools/CWindowingTools.cpp
@@ -2,7 +2,7 @@
* \file signal_processing_toolbox.cpp
* \brief Signal processing tools
* \author S. Schotthöfer
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/python_wrapper_structure.cpp b/SU2_CFD/src/python_wrapper_structure.cpp
index ebf9a926d5d..e324046844e 100644
--- a/SU2_CFD/src/python_wrapper_structure.cpp
+++ b/SU2_CFD/src/python_wrapper_structure.cpp
@@ -2,7 +2,7 @@
* \file python_wrapper_structure.cpp
* \brief Driver subroutines that are used by the Python wrapper. Those routines are usually called from an external Python environment.
* \author D. Thomas
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CAdjEulerSolver.cpp b/SU2_CFD/src/solvers/CAdjEulerSolver.cpp
index 9d213c1948e..de3ec622236 100644
--- a/SU2_CFD/src/solvers/CAdjEulerSolver.cpp
+++ b/SU2_CFD/src/solvers/CAdjEulerSolver.cpp
@@ -2,7 +2,7 @@
* \file CAdjEulerSolver.cpp
* \brief Main subroutines for solving Euler adjoint problems.
* \author F. Palacios, T. Economon, H. Kline
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CAdjNSSolver.cpp b/SU2_CFD/src/solvers/CAdjNSSolver.cpp
index 439aa053d6f..d887ab8d7de 100644
--- a/SU2_CFD/src/solvers/CAdjNSSolver.cpp
+++ b/SU2_CFD/src/solvers/CAdjNSSolver.cpp
@@ -2,7 +2,7 @@
* \file CAdjNSSolver.cpp
* \brief Main subroutines for solving Navier-Stokes adjoint problems.
* \author F. Palacios, T. Economon, H. Kline
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CAdjTurbSolver.cpp b/SU2_CFD/src/solvers/CAdjTurbSolver.cpp
index 01c8a58bf99..b71a5a5347e 100644
--- a/SU2_CFD/src/solvers/CAdjTurbSolver.cpp
+++ b/SU2_CFD/src/solvers/CAdjTurbSolver.cpp
@@ -2,7 +2,7 @@
* \file CAdjTurbVariable.cpp
* \brief Main subrotuines for solving turbulent adjoint problems.
* \author F. Palacios, A. Bueno, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CBaselineSolver.cpp b/SU2_CFD/src/solvers/CBaselineSolver.cpp
index 7900acc2a9b..195c3873265 100644
--- a/SU2_CFD/src/solvers/CBaselineSolver.cpp
+++ b/SU2_CFD/src/solvers/CBaselineSolver.cpp
@@ -2,7 +2,7 @@
* \file CBaselineSolver.cpp
* \brief Main subroutines for CBaselineSolver class.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CBaselineSolver_FEM.cpp b/SU2_CFD/src/solvers/CBaselineSolver_FEM.cpp
index faf3c855c8f..bff91f15d62 100644
--- a/SU2_CFD/src/solvers/CBaselineSolver_FEM.cpp
+++ b/SU2_CFD/src/solvers/CBaselineSolver_FEM.cpp
@@ -2,7 +2,7 @@
* \file CBaselineSolver_FEM.cpp
* \brief Main subroutines for CBaselineSolver_FEM class.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CDiscAdjFEASolver.cpp b/SU2_CFD/src/solvers/CDiscAdjFEASolver.cpp
index a0d9d81596e..74dc958baa9 100644
--- a/SU2_CFD/src/solvers/CDiscAdjFEASolver.cpp
+++ b/SU2_CFD/src/solvers/CDiscAdjFEASolver.cpp
@@ -2,7 +2,7 @@
* \file CDiscAdjFEASolver.cpp
* \brief Main subroutines for solving adjoint FEM elasticity problems.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CDiscAdjMeshSolver.cpp b/SU2_CFD/src/solvers/CDiscAdjMeshSolver.cpp
index 73997cff2f9..067f256cbdf 100644
--- a/SU2_CFD/src/solvers/CDiscAdjMeshSolver.cpp
+++ b/SU2_CFD/src/solvers/CDiscAdjMeshSolver.cpp
@@ -2,7 +2,7 @@
* \file CDiscAdjMeshSolver.cpp
* \brief Main subroutines for solving the discrete adjoint mesh problem.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CDiscAdjSolver.cpp b/SU2_CFD/src/solvers/CDiscAdjSolver.cpp
index efed6499cd0..166270e3c1b 100644
--- a/SU2_CFD/src/solvers/CDiscAdjSolver.cpp
+++ b/SU2_CFD/src/solvers/CDiscAdjSolver.cpp
@@ -2,7 +2,7 @@
* \file CDiscAdjSolver.cpp
* \brief Main subroutines for solving the discrete adjoint problem.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CEulerSolver.cpp b/SU2_CFD/src/solvers/CEulerSolver.cpp
index e7f447f2b3a..7cd1a186cb1 100644
--- a/SU2_CFD/src/solvers/CEulerSolver.cpp
+++ b/SU2_CFD/src/solvers/CEulerSolver.cpp
@@ -2,7 +2,7 @@
* \file CEulerSolver.cpp
* \brief Main subrotuines for solving Finite-Volume Euler flow problems.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CFEASolver.cpp b/SU2_CFD/src/solvers/CFEASolver.cpp
index f8b0e91096d..23a47c217f2 100644
--- a/SU2_CFD/src/solvers/CFEASolver.cpp
+++ b/SU2_CFD/src/solvers/CFEASolver.cpp
@@ -2,7 +2,7 @@
* \file CFEASolver.cpp
* \brief Main subroutines for solving direct FEM elasticity problems.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CFEM_DG_EulerSolver.cpp b/SU2_CFD/src/solvers/CFEM_DG_EulerSolver.cpp
index 245318ff48b..174a104aade 100644
--- a/SU2_CFD/src/solvers/CFEM_DG_EulerSolver.cpp
+++ b/SU2_CFD/src/solvers/CFEM_DG_EulerSolver.cpp
@@ -2,7 +2,7 @@
* \file CFEM_DG_EulerSolver.cpp
* \brief Main subroutines for solving finite element Euler flow problems
* \author J. Alonso, E. van der Weide, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CFEM_DG_NSSolver.cpp b/SU2_CFD/src/solvers/CFEM_DG_NSSolver.cpp
index 477a6b509b3..442380bdff0 100644
--- a/SU2_CFD/src/solvers/CFEM_DG_NSSolver.cpp
+++ b/SU2_CFD/src/solvers/CFEM_DG_NSSolver.cpp
@@ -2,7 +2,7 @@
* \file CFEM_DG_NSSolver.cpp
* \brief Main subroutines for solving finite element Navier-Stokes flow problems
* \author J. Alonso, E. van der Weide, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CHeatSolver.cpp b/SU2_CFD/src/solvers/CHeatSolver.cpp
index 121f0237742..7d928c01968 100644
--- a/SU2_CFD/src/solvers/CHeatSolver.cpp
+++ b/SU2_CFD/src/solvers/CHeatSolver.cpp
@@ -2,7 +2,7 @@
* \file CHeatSolver.cpp
* \brief Main subrotuines for solving the heat equation
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CIncEulerSolver.cpp b/SU2_CFD/src/solvers/CIncEulerSolver.cpp
index 90b3f0eab48..e02b8fd2504 100644
--- a/SU2_CFD/src/solvers/CIncEulerSolver.cpp
+++ b/SU2_CFD/src/solvers/CIncEulerSolver.cpp
@@ -2,7 +2,7 @@
* \file CIncEulerSolver.cpp
* \brief Main subroutines for solving incompressible flow (Euler, Navier-Stokes, etc.).
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CIncNSSolver.cpp b/SU2_CFD/src/solvers/CIncNSSolver.cpp
index 4418cef5eb5..2eb8acbd679 100644
--- a/SU2_CFD/src/solvers/CIncNSSolver.cpp
+++ b/SU2_CFD/src/solvers/CIncNSSolver.cpp
@@ -2,7 +2,7 @@
* \file CIncNSSolver.cpp
* \brief Main subroutines for solving Navier-Stokes incompressible flow.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CMeshSolver.cpp b/SU2_CFD/src/solvers/CMeshSolver.cpp
index 07748237afd..f008ad0e812 100644
--- a/SU2_CFD/src/solvers/CMeshSolver.cpp
+++ b/SU2_CFD/src/solvers/CMeshSolver.cpp
@@ -2,7 +2,7 @@
* \file CMeshSolver.cpp
* \brief Main subroutines to solve moving meshes using a pseudo-linear elastic approach.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CNEMOEulerSolver.cpp b/SU2_CFD/src/solvers/CNEMOEulerSolver.cpp
index b8e5ac6a1c9..aae061ef04d 100644
--- a/SU2_CFD/src/solvers/CNEMOEulerSolver.cpp
+++ b/SU2_CFD/src/solvers/CNEMOEulerSolver.cpp
@@ -2,7 +2,7 @@
* \file CNEMOEulerSolver.cpp
* \brief Headers of the CNEMOEulerSolver class
* \author S. R. Copeland, F. Palacios, W. Maier, C. Garbacz
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CNEMONSSolver.cpp b/SU2_CFD/src/solvers/CNEMONSSolver.cpp
index b0f73ee79ea..5fc79496d58 100644
--- a/SU2_CFD/src/solvers/CNEMONSSolver.cpp
+++ b/SU2_CFD/src/solvers/CNEMONSSolver.cpp
@@ -2,7 +2,7 @@
* \file CNEMONSSolver.cpp
* \brief Headers of the CNEMONSSolver class
* \author S. R. Copeland, F. Palacios, W. Maier.
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CNSSolver.cpp b/SU2_CFD/src/solvers/CNSSolver.cpp
index 915e296c039..87df3fb2c72 100644
--- a/SU2_CFD/src/solvers/CNSSolver.cpp
+++ b/SU2_CFD/src/solvers/CNSSolver.cpp
@@ -2,7 +2,7 @@
* \file CNSSolver.cpp
* \brief Main subrotuines for solving Finite-Volume Navier-Stokes flow problems.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CRadP1Solver.cpp b/SU2_CFD/src/solvers/CRadP1Solver.cpp
index 76bcf61681f..5bd1e64f0a3 100644
--- a/SU2_CFD/src/solvers/CRadP1Solver.cpp
+++ b/SU2_CFD/src/solvers/CRadP1Solver.cpp
@@ -2,7 +2,7 @@
* \file CRadP1Solver.cpp
* \brief Main subroutines for solving P1 radiation problems.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CRadSolver.cpp b/SU2_CFD/src/solvers/CRadSolver.cpp
index ba9228f1692..b780f23d328 100644
--- a/SU2_CFD/src/solvers/CRadSolver.cpp
+++ b/SU2_CFD/src/solvers/CRadSolver.cpp
@@ -2,7 +2,7 @@
* \file CRadP1Solver.cpp
* \brief Main subroutines for solving generic radiation problems (P1, M1, discrete ordinates...)
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CSolver.cpp b/SU2_CFD/src/solvers/CSolver.cpp
index ee2f94d4e05..312e5b39d24 100644
--- a/SU2_CFD/src/solvers/CSolver.cpp
+++ b/SU2_CFD/src/solvers/CSolver.cpp
@@ -2,7 +2,7 @@
* \file CSolver.cpp
* \brief Main subroutines for CSolver class.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CSolverFactory.cpp b/SU2_CFD/src/solvers/CSolverFactory.cpp
index affbca70ed5..5b880452064 100644
--- a/SU2_CFD/src/solvers/CSolverFactory.cpp
+++ b/SU2_CFD/src/solvers/CSolverFactory.cpp
@@ -2,7 +2,7 @@
* \file CSolverFactory.cpp
* \brief Main subroutines for CSolverFactoryclass.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CTemplateSolver.cpp b/SU2_CFD/src/solvers/CTemplateSolver.cpp
index 4019746cb65..b0795469937 100644
--- a/SU2_CFD/src/solvers/CTemplateSolver.cpp
+++ b/SU2_CFD/src/solvers/CTemplateSolver.cpp
@@ -2,7 +2,7 @@
* \file CTemplateSolver.cpp
* \brief Subroutines to be implemented for any new solvers
* \author F. Palacios
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CTransLMSolver.cpp b/SU2_CFD/src/solvers/CTransLMSolver.cpp
index 8f96d1629dd..b123c812e53 100644
--- a/SU2_CFD/src/solvers/CTransLMSolver.cpp
+++ b/SU2_CFD/src/solvers/CTransLMSolver.cpp
@@ -2,7 +2,7 @@
* \file CTransLMSolver.cpp
* \brief Main subrotuines for Transition model solver.
* \author A. Aranake
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CTurbSASolver.cpp b/SU2_CFD/src/solvers/CTurbSASolver.cpp
index 98f85d5021a..a33a4795822 100644
--- a/SU2_CFD/src/solvers/CTurbSASolver.cpp
+++ b/SU2_CFD/src/solvers/CTurbSASolver.cpp
@@ -2,7 +2,7 @@
* \file CTurbSASolver.cpp
* \brief Main subrotuines of CTurbSASolver class
* \author F. Palacios, A. Bueno
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CTurbSSTSolver.cpp b/SU2_CFD/src/solvers/CTurbSSTSolver.cpp
index 5ae1e47c69d..c03e2295c19 100644
--- a/SU2_CFD/src/solvers/CTurbSSTSolver.cpp
+++ b/SU2_CFD/src/solvers/CTurbSSTSolver.cpp
@@ -2,7 +2,7 @@
* \file CTurbSSTSolver.cpp
* \brief Main subrotuines of CTurbSSTSolver class
* \author F. Palacios, A. Bueno
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/solvers/CTurbSolver.cpp b/SU2_CFD/src/solvers/CTurbSolver.cpp
index 627e63d1846..66d9a7c8308 100644
--- a/SU2_CFD/src/solvers/CTurbSolver.cpp
+++ b/SU2_CFD/src/solvers/CTurbSolver.cpp
@@ -2,7 +2,7 @@
* \file CTurbSolver.cpp
* \brief Main subrotuines of CTurbSolver class
* \author F. Palacios, A. Bueno
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CAdjEulerVariable.cpp b/SU2_CFD/src/variables/CAdjEulerVariable.cpp
index 316e18c1054..d8a7c6476fa 100644
--- a/SU2_CFD/src/variables/CAdjEulerVariable.cpp
+++ b/SU2_CFD/src/variables/CAdjEulerVariable.cpp
@@ -2,7 +2,7 @@
* \file CAdjEulerVariable.cpp
* \brief Definition of the solution fields.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CAdjNSVariable.cpp b/SU2_CFD/src/variables/CAdjNSVariable.cpp
index 736929dff7e..a05de3455b7 100644
--- a/SU2_CFD/src/variables/CAdjNSVariable.cpp
+++ b/SU2_CFD/src/variables/CAdjNSVariable.cpp
@@ -2,7 +2,7 @@
* \file CAdjNSVariable.cpp
* \brief Definition of the solution fields.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CAdjTurbVariable.cpp b/SU2_CFD/src/variables/CAdjTurbVariable.cpp
index 4836b89d55d..bebcfde9939 100644
--- a/SU2_CFD/src/variables/CAdjTurbVariable.cpp
+++ b/SU2_CFD/src/variables/CAdjTurbVariable.cpp
@@ -2,7 +2,7 @@
* \file CAdjTurbVariable.cpp
* \brief Definition of the solution fields.
* \author F. Palacios, A. Bueno
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CBaselineVariable.cpp b/SU2_CFD/src/variables/CBaselineVariable.cpp
index 1df84c3198a..1cc0c796732 100644
--- a/SU2_CFD/src/variables/CBaselineVariable.cpp
+++ b/SU2_CFD/src/variables/CBaselineVariable.cpp
@@ -2,7 +2,7 @@
* \file CBaselineVariable.cpp
* \brief Definition of the solution fields.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CDiscAdjFEABoundVariable.cpp b/SU2_CFD/src/variables/CDiscAdjFEABoundVariable.cpp
index a71c32ecf81..0d322292024 100644
--- a/SU2_CFD/src/variables/CDiscAdjFEABoundVariable.cpp
+++ b/SU2_CFD/src/variables/CDiscAdjFEABoundVariable.cpp
@@ -2,7 +2,7 @@
* \file CDiscAdjFEAVariable.cpp
* \brief Definition of the variables for FEM adjoint elastic structural problems.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CDiscAdjFEAVariable.cpp b/SU2_CFD/src/variables/CDiscAdjFEAVariable.cpp
index 41f451a5c3a..87765f8a664 100644
--- a/SU2_CFD/src/variables/CDiscAdjFEAVariable.cpp
+++ b/SU2_CFD/src/variables/CDiscAdjFEAVariable.cpp
@@ -2,7 +2,7 @@
* \file CDiscAdjFEAVariable.cpp
* \brief Definition of the variables for FEM adjoint elastic structural problems.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CDiscAdjMeshBoundVariable.cpp b/SU2_CFD/src/variables/CDiscAdjMeshBoundVariable.cpp
index fe8781d65de..0d3b6cbfd31 100644
--- a/SU2_CFD/src/variables/CDiscAdjMeshBoundVariable.cpp
+++ b/SU2_CFD/src/variables/CDiscAdjMeshBoundVariable.cpp
@@ -2,7 +2,7 @@
* \file CDiscAdjMeshVariable.cpp
* \brief Main subroutines for the discrete adjoint mesh variable structure.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CDiscAdjVariable.cpp b/SU2_CFD/src/variables/CDiscAdjVariable.cpp
index c8ed3cb3575..178cc024d92 100644
--- a/SU2_CFD/src/variables/CDiscAdjVariable.cpp
+++ b/SU2_CFD/src/variables/CDiscAdjVariable.cpp
@@ -2,7 +2,7 @@
* \file CDiscAdjVariable.cpp
* \brief Main subroutines for the discrete adjoint variable structure.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CEulerVariable.cpp b/SU2_CFD/src/variables/CEulerVariable.cpp
index 9a48d45d8cc..cd7bcbcc4fb 100644
--- a/SU2_CFD/src/variables/CEulerVariable.cpp
+++ b/SU2_CFD/src/variables/CEulerVariable.cpp
@@ -2,7 +2,7 @@
* \file CEulerVariable.cpp
* \brief Definition of the solution fields.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CFEABoundVariable.cpp b/SU2_CFD/src/variables/CFEABoundVariable.cpp
index b493f9510eb..a60eb0803f2 100644
--- a/SU2_CFD/src/variables/CFEABoundVariable.cpp
+++ b/SU2_CFD/src/variables/CFEABoundVariable.cpp
@@ -2,7 +2,7 @@
* \file CFEABoundVariable.cpp
* \brief Definition of the variables for FEM elastic structural problems.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CFEAVariable.cpp b/SU2_CFD/src/variables/CFEAVariable.cpp
index b585a7da058..fb6d808f645 100644
--- a/SU2_CFD/src/variables/CFEAVariable.cpp
+++ b/SU2_CFD/src/variables/CFEAVariable.cpp
@@ -2,7 +2,7 @@
* \file CFEAVariable.cpp
* \brief Definition of the variables for FEM elastic structural problems.
* \author R. Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CHeatVariable.cpp b/SU2_CFD/src/variables/CHeatVariable.cpp
index 3eb6ffb8ff8..461077a15a4 100644
--- a/SU2_CFD/src/variables/CHeatVariable.cpp
+++ b/SU2_CFD/src/variables/CHeatVariable.cpp
@@ -2,7 +2,7 @@
* \file CHeatVariable.cpp
* \brief Definition of the variables for heat equation problems.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CIncEulerVariable.cpp b/SU2_CFD/src/variables/CIncEulerVariable.cpp
index df0e8da3737..e4f24b18622 100644
--- a/SU2_CFD/src/variables/CIncEulerVariable.cpp
+++ b/SU2_CFD/src/variables/CIncEulerVariable.cpp
@@ -2,7 +2,7 @@
* \file CIncEulerVariable.cpp
* \brief Definition of the variable classes for incompressible flow.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CIncNSVariable.cpp b/SU2_CFD/src/variables/CIncNSVariable.cpp
index 68fb0000ccd..1505fb42b6e 100644
--- a/SU2_CFD/src/variables/CIncNSVariable.cpp
+++ b/SU2_CFD/src/variables/CIncNSVariable.cpp
@@ -2,7 +2,7 @@
* \file CIncNSVariable.cpp
* \brief Definition of the variable classes for incompressible flow.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CMeshBoundVariable.cpp b/SU2_CFD/src/variables/CMeshBoundVariable.cpp
index 780496fc543..82cf0b2698c 100644
--- a/SU2_CFD/src/variables/CMeshBoundVariable.cpp
+++ b/SU2_CFD/src/variables/CMeshBoundVariable.cpp
@@ -2,7 +2,7 @@
* \file CMeshBoundVariable.cpp
* \brief Definition of the boundary variables for mesh motion using a pseudo-elastic approach.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CMeshElement.cpp b/SU2_CFD/src/variables/CMeshElement.cpp
index c25d38a6390..53454882f9d 100644
--- a/SU2_CFD/src/variables/CMeshElement.cpp
+++ b/SU2_CFD/src/variables/CMeshElement.cpp
@@ -2,7 +2,7 @@
* \file CMeshElement.cpp
* \brief Definition of the mesh elements for mesh deformation using a pseudo-elastic approach.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CMeshVariable.cpp b/SU2_CFD/src/variables/CMeshVariable.cpp
index f2bf92d5c81..d7b0ce383ad 100644
--- a/SU2_CFD/src/variables/CMeshVariable.cpp
+++ b/SU2_CFD/src/variables/CMeshVariable.cpp
@@ -2,7 +2,7 @@
* \file CMeshVariable.cpp
* \brief Definition of the variables for mesh motion using a pseudo-elastic approach.
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CNEMOEulerVariable.cpp b/SU2_CFD/src/variables/CNEMOEulerVariable.cpp
index 45bc0aa5fb9..4424ab95808 100644
--- a/SU2_CFD/src/variables/CNEMOEulerVariable.cpp
+++ b/SU2_CFD/src/variables/CNEMOEulerVariable.cpp
@@ -1,352 +1,352 @@
-/*!
- * \file CNEMOEulerVariable.cpp
- * \brief Definition of the solution fields.
- * \author C. Garbacz, W. Maier, S.R. Copeland
- * \version 7.1.0 "Blackbird"
- *
- * SU2 Project Website: https://su2code.github.io
- *
- * The SU2 Project is maintained by the SU2 Foundation
- * (http://su2foundation.org)
- *
- * Copyright 2012-2020, SU2 Contributors (cf. AUTHORS.md)
- *
- * SU2 is free software; you can redistribute it and/or
- * modify it under the terms of the GNU Lesser General Public
- * License as published by the Free Software Foundation; either
- * version 2.1 of the License, or (at your option) any later version.
- *
- * SU2 is distributed in the hope that it will be useful,
- * but WITHOUT ANY WARRANTY; without even the implied warranty of
- * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
- * Lesser General Public License for more details.
- *
- * You should have received a copy of the GNU Lesser General Public
- * License along with SU2. If not, see .
- */
-
-#include "../../include/variables/CNEMOEulerVariable.hpp"
-#include
-
-CNEMOEulerVariable::CNEMOEulerVariable(su2double val_pressure,
- const su2double *val_massfrac,
- su2double *val_mach,
- su2double val_temperature,
- su2double val_temperature_ve,
- unsigned long npoint,
- unsigned long ndim,
- unsigned long nvar,
- unsigned long nvarprim,
- unsigned long nvarprimgrad,
- CConfig *config,
- CNEMOGas *fluidmodel) : CVariable(npoint,
- ndim,
- nvar,
- config ),
- Gradient_Reconstruction(config->GetReconstructionGradientRequired() ? Gradient_Aux : Gradient_Primitive) {
-
- vector energies;
- unsigned short iDim, iSpecies;
- su2double soundspeed, sqvel, rho;
-
- /*--- Setting variable amounts ---*/
- nDim = ndim;
- nPrimVar = nvarprim;
- nPrimVarGrad = nvarprimgrad;
-
- nSpecies = config->GetnSpecies();
- RHOS_INDEX = 0;
- T_INDEX = nSpecies;
- TVE_INDEX = nSpecies+1;
- VEL_INDEX = nSpecies+2;
- P_INDEX = nSpecies+nDim+2;
- RHO_INDEX = nSpecies+nDim+3;
- H_INDEX = nSpecies+nDim+4;
- A_INDEX = nSpecies+nDim+5;
- RHOCVTR_INDEX = nSpecies+nDim+6;
- RHOCVVE_INDEX = nSpecies+nDim+7;
- LAM_VISC_INDEX = nSpecies+nDim+8;
- EDDY_VISC_INDEX = nSpecies+nDim+9;
-
- /*--- Set monoatomic flag ---*/
- if (config->GetMonoatomic()) {
- monoatomic = true;
- Tve_Freestream = config->GetTemperature_ve_FreeStream();
- }
-
- /*--- Allocate & initialize residual vectors ---*/
- Res_TruncError.resize(nPoint,nVar) = su2double(0.0);
-
- /*--- Size Grad_AuxVar for axiysmmetric ---*/
- if (config->GetAxisymmetric()){
- nAuxVar = 3;
- Grad_AuxVar.resize(nPoint,nAuxVar,nDim,0.0);
- AuxVar.resize(nPoint,nAuxVar) = su2double(0.0);
- }
-
- /*--- Only for residual smoothing (multigrid) ---*/
- for (unsigned long iMesh = 0; iMesh <= config->GetnMGLevels(); iMesh++) {
- if (config->GetMG_CorrecSmooth(iMesh) > 0) {
- Residual_Sum.resize(nPoint,nVar);
- Residual_Old.resize(nPoint,nVar);
- break;
- }
- }
-
- /*--- Allocate undivided laplacian (centered) and limiter (upwind)---*/
- if (config->GetKind_ConvNumScheme_Flow() == SPACE_CENTERED)
- Undivided_Laplacian.resize(nPoint,nVar);
-
- /*--- Always allocate the slope limiter,
- and the auxiliar variables (check the logic - JST with 2nd order Turb model - ) ---*/
- Limiter.resize(nPoint,nVar) = su2double(0.0);
- Limiter_Primitive.resize(nPoint,nPrimVarGrad) = su2double(0.0);
-
- Solution_Max.resize(nPoint,nPrimVarGrad) = su2double(0.0);
- Solution_Min.resize(nPoint,nPrimVarGrad) = su2double(0.0);
-
- /*--- Primitive and secondary variables ---*/
- Primitive.resize(nPoint,nPrimVar) = su2double(0.0);
- Primitive_Aux.resize(nPoint,nPrimVar) = su2double(0.0);
- Secondary.resize(nPoint,nPrimVar) = su2double(0.0);
-
- dPdU.resize(nPoint, nVar) = su2double(0.0);
- dTdU.resize(nPoint, nVar) = su2double(0.0);
- dTvedU.resize(nPoint, nVar) = su2double(0.0);
- Cvves.resize(nPoint, nSpecies) = su2double(0.0);
- eves.resize(nPoint, nSpecies) = su2double(0.0);
- Gamma.resize(nPoint) = su2double(0.0);
-
- /*--- Compressible flow, gradients primitive variables ---*/
- Gradient_Primitive.resize(nPoint,nPrimVarGrad,nDim,0.0);
- Gradient.resize(nPoint,nVar,nDim,0.0);
-
- if (config->GetReconstructionGradientRequired()) {
- Gradient_Aux.resize(nPoint,nPrimVarGrad,nDim,0.0);
- }
-
- if (config->GetKind_Gradient_Method() == WEIGHTED_LEAST_SQUARES) {
- Rmatrix.resize(nPoint,nDim,nDim,0.0);
- }
-
- Velocity2.resize(nPoint) = su2double(0.0);
- Max_Lambda_Inv.resize(nPoint) = su2double(0.0);
- Delta_Time.resize(nPoint) = su2double(0.0);
- Lambda.resize(nPoint) = su2double(0.0);
- Sensor.resize(nPoint) = su2double(0.0);
-
- /* Non-physical point (first-order) initialization. */
- Non_Physical.resize(nPoint) = false;
- Non_Physical_Counter.resize(nPoint) = 0;
-
+/*!
+ * \file CNEMOEulerVariable.cpp
+ * \brief Definition of the solution fields.
+ * \author C. Garbacz, W. Maier, S.R. Copeland
+ * \version 7.1.1 "Blackbird"
+ *
+ * SU2 Project Website: https://su2code.github.io
+ *
+ * The SU2 Project is maintained by the SU2 Foundation
+ * (http://su2foundation.org)
+ *
+ * Copyright 2012-2020, SU2 Contributors (cf. AUTHORS.md)
+ *
+ * SU2 is free software; you can redistribute it and/or
+ * modify it under the terms of the GNU Lesser General Public
+ * License as published by the Free Software Foundation; either
+ * version 2.1 of the License, or (at your option) any later version.
+ *
+ * SU2 is distributed in the hope that it will be useful,
+ * but WITHOUT ANY WARRANTY; without even the implied warranty of
+ * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
+ * Lesser General Public License for more details.
+ *
+ * You should have received a copy of the GNU Lesser General Public
+ * License along with SU2. If not, see .
+ */
+
+#include "../../include/variables/CNEMOEulerVariable.hpp"
+#include
+
+CNEMOEulerVariable::CNEMOEulerVariable(su2double val_pressure,
+ const su2double *val_massfrac,
+ su2double *val_mach,
+ su2double val_temperature,
+ su2double val_temperature_ve,
+ unsigned long npoint,
+ unsigned long ndim,
+ unsigned long nvar,
+ unsigned long nvarprim,
+ unsigned long nvarprimgrad,
+ CConfig *config,
+ CNEMOGas *fluidmodel) : CVariable(npoint,
+ ndim,
+ nvar,
+ config ),
+ Gradient_Reconstruction(config->GetReconstructionGradientRequired() ? Gradient_Aux : Gradient_Primitive) {
+
+ vector energies;
+ unsigned short iDim, iSpecies;
+ su2double soundspeed, sqvel, rho;
+
+ /*--- Setting variable amounts ---*/
+ nDim = ndim;
+ nPrimVar = nvarprim;
+ nPrimVarGrad = nvarprimgrad;
+
+ nSpecies = config->GetnSpecies();
+ RHOS_INDEX = 0;
+ T_INDEX = nSpecies;
+ TVE_INDEX = nSpecies+1;
+ VEL_INDEX = nSpecies+2;
+ P_INDEX = nSpecies+nDim+2;
+ RHO_INDEX = nSpecies+nDim+3;
+ H_INDEX = nSpecies+nDim+4;
+ A_INDEX = nSpecies+nDim+5;
+ RHOCVTR_INDEX = nSpecies+nDim+6;
+ RHOCVVE_INDEX = nSpecies+nDim+7;
+ LAM_VISC_INDEX = nSpecies+nDim+8;
+ EDDY_VISC_INDEX = nSpecies+nDim+9;
+
+ /*--- Set monoatomic flag ---*/
+ if (config->GetMonoatomic()) {
+ monoatomic = true;
+ Tve_Freestream = config->GetTemperature_ve_FreeStream();
+ }
+
+ /*--- Allocate & initialize residual vectors ---*/
+ Res_TruncError.resize(nPoint,nVar) = su2double(0.0);
+
+ /*--- Size Grad_AuxVar for axiysmmetric ---*/
+ if (config->GetAxisymmetric()){
+ nAuxVar = 3;
+ Grad_AuxVar.resize(nPoint,nAuxVar,nDim,0.0);
+ AuxVar.resize(nPoint,nAuxVar) = su2double(0.0);
+ }
+
+ /*--- Only for residual smoothing (multigrid) ---*/
+ for (unsigned long iMesh = 0; iMesh <= config->GetnMGLevels(); iMesh++) {
+ if (config->GetMG_CorrecSmooth(iMesh) > 0) {
+ Residual_Sum.resize(nPoint,nVar);
+ Residual_Old.resize(nPoint,nVar);
+ break;
+ }
+ }
+
+ /*--- Allocate undivided laplacian (centered) and limiter (upwind)---*/
+ if (config->GetKind_ConvNumScheme_Flow() == SPACE_CENTERED)
+ Undivided_Laplacian.resize(nPoint,nVar);
+
+ /*--- Always allocate the slope limiter,
+ and the auxiliar variables (check the logic - JST with 2nd order Turb model - ) ---*/
+ Limiter.resize(nPoint,nVar) = su2double(0.0);
+ Limiter_Primitive.resize(nPoint,nPrimVarGrad) = su2double(0.0);
+
+ Solution_Max.resize(nPoint,nPrimVarGrad) = su2double(0.0);
+ Solution_Min.resize(nPoint,nPrimVarGrad) = su2double(0.0);
+
+ /*--- Primitive and secondary variables ---*/
+ Primitive.resize(nPoint,nPrimVar) = su2double(0.0);
+ Primitive_Aux.resize(nPoint,nPrimVar) = su2double(0.0);
+ Secondary.resize(nPoint,nPrimVar) = su2double(0.0);
+
+ dPdU.resize(nPoint, nVar) = su2double(0.0);
+ dTdU.resize(nPoint, nVar) = su2double(0.0);
+ dTvedU.resize(nPoint, nVar) = su2double(0.0);
+ Cvves.resize(nPoint, nSpecies) = su2double(0.0);
+ eves.resize(nPoint, nSpecies) = su2double(0.0);
+ Gamma.resize(nPoint) = su2double(0.0);
+
+ /*--- Compressible flow, gradients primitive variables ---*/
+ Gradient_Primitive.resize(nPoint,nPrimVarGrad,nDim,0.0);
+ Gradient.resize(nPoint,nVar,nDim,0.0);
+
+ if (config->GetReconstructionGradientRequired()) {
+ Gradient_Aux.resize(nPoint,nPrimVarGrad,nDim,0.0);
+ }
+
+ if (config->GetKind_Gradient_Method() == WEIGHTED_LEAST_SQUARES) {
+ Rmatrix.resize(nPoint,nDim,nDim,0.0);
+ }
+
+ Velocity2.resize(nPoint) = su2double(0.0);
+ Max_Lambda_Inv.resize(nPoint) = su2double(0.0);
+ Delta_Time.resize(nPoint) = su2double(0.0);
+ Lambda.resize(nPoint) = su2double(0.0);
+ Sensor.resize(nPoint) = su2double(0.0);
+
+ /* Non-physical point (first-order) initialization. */
+ Non_Physical.resize(nPoint) = false;
+ Non_Physical_Counter.resize(nPoint) = 0;
+
/* Under-relaxation parameter. */
- UnderRelaxation.resize(nPoint) = su2double(1.0);
- LocalCFL.resize(nPoint) = su2double(0.0);
-
- /*--- Loop over all points --*/
- for(unsigned long iPoint = 0; iPoint < nPoint; ++iPoint){
-
- /*--- Reset velocity^2 [m2/s2] to zero ---*/
- sqvel = 0.0;
-
- /*--- Set mixture state ---*/
- fluidmodel->SetTDStatePTTv(val_pressure, val_massfrac, val_temperature, val_temperature_ve);
-
- /*--- Compute necessary quantities ---*/
- rho = fluidmodel->GetDensity();
- soundspeed = fluidmodel->ComputeSoundSpeed();
- for (iDim = 0; iDim < nDim; iDim++){
- sqvel += val_mach[iDim]*soundspeed * val_mach[iDim]*soundspeed;
- }
- energies = fluidmodel->ComputeMixtureEnergies();
-
- /*--- Initialize Solution & Solution_Old vectors ---*/
- for (iSpecies = 0; iSpecies < nSpecies; iSpecies++)
- Solution(iPoint,iSpecies) = rho*val_massfrac[iSpecies];
- for (iDim = 0; iDim < nDim; iDim++)
- Solution(iPoint,nSpecies+iDim) = rho*val_mach[iDim]*soundspeed;
-
- Solution(iPoint,nSpecies+nDim) = rho*(energies[0]+0.5*sqvel);
- Solution(iPoint,nSpecies+nDim+1) = rho*(energies[1]);
-
- Solution_Old = Solution;
-
- /*--- Assign primitive variables ---*/
- Primitive(iPoint,T_INDEX) = val_temperature;
- Primitive(iPoint,TVE_INDEX) = val_temperature_ve;
- Primitive(iPoint,P_INDEX) = val_pressure;
- }
-}
-
-void CNEMOEulerVariable::SetVelocity2(unsigned long iPoint) {
-
- unsigned short iDim;
-
- Velocity2(iPoint) = 0.0;
- for (iDim = 0; iDim < nDim; iDim++) {
- Primitive(iPoint,VEL_INDEX+iDim) = Solution(iPoint,nSpecies+iDim) / Primitive(iPoint,RHO_INDEX);
- Velocity2(iPoint) += Solution(iPoint,nSpecies+iDim)*Solution(iPoint,nSpecies+iDim)
- / (Primitive(iPoint,RHO_INDEX)*Primitive(iPoint,RHO_INDEX));
- }
-}
-
-bool CNEMOEulerVariable::SetPrimVar(unsigned long iPoint, CFluidModel *FluidModel) {
-
- bool nonPhys;
- unsigned short iVar;
-
- fluidmodel = static_cast(FluidModel);
-
- /*--- Convert conserved to primitive variables ---*/
- nonPhys = Cons2PrimVar(Solution[iPoint], Primitive[iPoint],
- dPdU[iPoint], dTdU[iPoint], dTvedU[iPoint], eves[iPoint], Cvves[iPoint]);
-
- /*--- Reset solution to previous one, if nonphys ---*/
- if (nonPhys) {
- for (iVar = 0; iVar < nVar; iVar++)
- Solution(iPoint,iVar) = Solution_Old(iPoint,iVar);
- }
-
- /*--- Set additional point quantaties ---*/
- Gamma(iPoint) = fluidmodel->ComputeGamma();
-
- SetVelocity2(iPoint);
-
- return nonPhys;
-}
-
-bool CNEMOEulerVariable::Cons2PrimVar(su2double *U, su2double *V,
- su2double *val_dPdU, su2double *val_dTdU,
- su2double *val_dTvedU, su2double *val_eves,
- su2double *val_Cvves) {
-
- unsigned short iDim, iSpecies;
- su2double Tmin, Tmax, Tvemin, Tvemax;
- vector rhos;
-
- rhos.resize(nSpecies,0.0);
-
- /*--- Conserved & primitive vector layout ---*/
- // U: [rho1, ..., rhoNs, rhou, rhov, rhow, rhoe, rhoeve]^T
- // V: [rho1, ..., rhoNs, T, Tve, u, v, w, P, rho, h, a, rhoCvtr, rhoCvve]^T
-
- /*--- Set booleans ---*/
- bool nonPhys = false;
-
- /*--- Set temperature clipping values ---*/
- Tmin = 50.0; Tmax = 8E4;
- Tvemin = 50.0; Tvemax = 8E4;
-
- /*--- Rename variables for convenience ---*/
- su2double rhoE = U[nSpecies+nDim]; // Density * energy [J/m3]
- su2double rhoEve = U[nSpecies+nDim+1]; // Density * energy_ve [J/m3]
-
- /*--- Assign species & mixture density ---*/
- // Note: if any species densities are < 0, these values are re-assigned
- // in the primitive AND conserved vectors to ensure positive density
- V[RHO_INDEX] = 0.0;
- for (iSpecies = 0; iSpecies < nSpecies; iSpecies++) {
- if (U[iSpecies] < 0.0) {
- U[iSpecies] = 1E-20;
- V[RHOS_INDEX+iSpecies] = 1E-20;
- rhos[iSpecies] = 1E-20;
- //nonPhys = true;
- } else {
- V[RHOS_INDEX+iSpecies] = U[iSpecies];
- rhos[iSpecies] = U[iSpecies];
- }
- V[RHO_INDEX] += U[iSpecies];
- }
-
- // Rename for convenience
- su2double rho = V[RHO_INDEX];
-
- /*--- Assign velocity^2 ---*/
- su2double sqvel = 0.0;
- for (iDim = 0; iDim < nDim; iDim++) {
- V[VEL_INDEX+iDim] = U[nSpecies+iDim]/V[RHO_INDEX];
- sqvel += V[VEL_INDEX+iDim]*V[VEL_INDEX+iDim];
- }
-
- /*--- Assign temperatures ---*/
- const auto& T = fluidmodel->ComputeTemperatures(rhos, rhoE, rhoEve, 0.5*rho*sqvel);
-
- /*--- Temperatures ---*/
- V[T_INDEX] = T[0];
- V[TVE_INDEX] = T[1];
-
- // Determine if the temperature lies within the acceptable range
- //TODO: fIX THIS
- if (V[T_INDEX] == Tmin) {
- nonPhys = true;
- } else if (V[T_INDEX] == Tmax){
- nonPhys = true;
- }
-
- /*--- Vibrational-Electronic Temperature ---*/
- vector eves_min = fluidmodel->ComputeSpeciesEve(Tvemin);
- vector eves_max = fluidmodel->ComputeSpeciesEve(Tvemax);
-
- // Check for non-physical solutions
- if (!monoatomic){
- su2double rhoEve_min = 0.0;
- su2double rhoEve_max = 0.0;
- for (iSpecies = 0; iSpecies < nSpecies; iSpecies++) {
- rhoEve_min += U[iSpecies] * eves_min[iSpecies];
- rhoEve_max += U[iSpecies] * eves_max[iSpecies];
- }
-
- if (rhoEve < rhoEve_min) {
-
- nonPhys = true;
- V[TVE_INDEX] = Tvemin;
- U[nSpecies+nDim+1] = rhoEve_min;
- } else if (rhoEve > rhoEve_max) {
- nonPhys = true;
- V[TVE_INDEX] = Tvemax;
- U[nSpecies+nDim+1] = rhoEve_max;
- }
- } else {
- //TODO: can e-modes/vibe modes be active?
- V[TVE_INDEX] = Tve_Freestream;
- }
-
- // Determine other properties of the mixture at the current state
- fluidmodel->SetTDStateRhosTTv(rhos, V[T_INDEX], V[TVE_INDEX]);
- const auto& cvves = fluidmodel->ComputeSpeciesCvVibEle();
- vector eves = fluidmodel->ComputeSpeciesEve(V[TVE_INDEX]);
-
- for (iSpecies = 0; iSpecies < nSpecies; iSpecies++) {
- val_eves[iSpecies] = eves[iSpecies];
- val_Cvves[iSpecies] = cvves[iSpecies];
- }
-
- su2double rhoCvtr = fluidmodel->ComputerhoCvtr();
- su2double rhoCvve = fluidmodel->ComputerhoCvve();
-
- V[RHOCVTR_INDEX] = rhoCvtr;
- V[RHOCVVE_INDEX] = rhoCvve;
-
- /*--- Pressure ---*/
- V[P_INDEX] = fluidmodel->ComputePressure();
-
- if (V[P_INDEX] < 0.0) {
- V[P_INDEX] = 1E-20;
- nonPhys = true;
- }
-
- /*--- Partial derivatives of pressure and temperature ---*/
- fluidmodel->ComputedPdU (V, eves, val_dPdU );
- fluidmodel->ComputedTdU (V, val_dTdU );
- fluidmodel->ComputedTvedU(V, eves, val_dTvedU);
-
- /*--- Sound speed ---*/
- V[A_INDEX] = fluidmodel->ComputeSoundSpeed();
-
- /*--- Enthalpy ---*/
- V[H_INDEX] = (U[nSpecies+nDim] + V[P_INDEX])/V[RHO_INDEX];
-
- return nonPhys;
-}
-
-void CNEMOEulerVariable::SetSolution_New() { Solution_New = Solution; }
+ UnderRelaxation.resize(nPoint) = su2double(1.0);
+ LocalCFL.resize(nPoint) = su2double(0.0);
+
+ /*--- Loop over all points --*/
+ for(unsigned long iPoint = 0; iPoint < nPoint; ++iPoint){
+
+ /*--- Reset velocity^2 [m2/s2] to zero ---*/
+ sqvel = 0.0;
+
+ /*--- Set mixture state ---*/
+ fluidmodel->SetTDStatePTTv(val_pressure, val_massfrac, val_temperature, val_temperature_ve);
+
+ /*--- Compute necessary quantities ---*/
+ rho = fluidmodel->GetDensity();
+ soundspeed = fluidmodel->ComputeSoundSpeed();
+ for (iDim = 0; iDim < nDim; iDim++){
+ sqvel += val_mach[iDim]*soundspeed * val_mach[iDim]*soundspeed;
+ }
+ energies = fluidmodel->ComputeMixtureEnergies();
+
+ /*--- Initialize Solution & Solution_Old vectors ---*/
+ for (iSpecies = 0; iSpecies < nSpecies; iSpecies++)
+ Solution(iPoint,iSpecies) = rho*val_massfrac[iSpecies];
+ for (iDim = 0; iDim < nDim; iDim++)
+ Solution(iPoint,nSpecies+iDim) = rho*val_mach[iDim]*soundspeed;
+
+ Solution(iPoint,nSpecies+nDim) = rho*(energies[0]+0.5*sqvel);
+ Solution(iPoint,nSpecies+nDim+1) = rho*(energies[1]);
+
+ Solution_Old = Solution;
+
+ /*--- Assign primitive variables ---*/
+ Primitive(iPoint,T_INDEX) = val_temperature;
+ Primitive(iPoint,TVE_INDEX) = val_temperature_ve;
+ Primitive(iPoint,P_INDEX) = val_pressure;
+ }
+}
+
+void CNEMOEulerVariable::SetVelocity2(unsigned long iPoint) {
+
+ unsigned short iDim;
+
+ Velocity2(iPoint) = 0.0;
+ for (iDim = 0; iDim < nDim; iDim++) {
+ Primitive(iPoint,VEL_INDEX+iDim) = Solution(iPoint,nSpecies+iDim) / Primitive(iPoint,RHO_INDEX);
+ Velocity2(iPoint) += Solution(iPoint,nSpecies+iDim)*Solution(iPoint,nSpecies+iDim)
+ / (Primitive(iPoint,RHO_INDEX)*Primitive(iPoint,RHO_INDEX));
+ }
+}
+
+bool CNEMOEulerVariable::SetPrimVar(unsigned long iPoint, CFluidModel *FluidModel) {
+
+ bool nonPhys;
+ unsigned short iVar;
+
+ fluidmodel = static_cast(FluidModel);
+
+ /*--- Convert conserved to primitive variables ---*/
+ nonPhys = Cons2PrimVar(Solution[iPoint], Primitive[iPoint],
+ dPdU[iPoint], dTdU[iPoint], dTvedU[iPoint], eves[iPoint], Cvves[iPoint]);
+
+ /*--- Reset solution to previous one, if nonphys ---*/
+ if (nonPhys) {
+ for (iVar = 0; iVar < nVar; iVar++)
+ Solution(iPoint,iVar) = Solution_Old(iPoint,iVar);
+ }
+
+ /*--- Set additional point quantaties ---*/
+ Gamma(iPoint) = fluidmodel->ComputeGamma();
+
+ SetVelocity2(iPoint);
+
+ return nonPhys;
+}
+
+bool CNEMOEulerVariable::Cons2PrimVar(su2double *U, su2double *V,
+ su2double *val_dPdU, su2double *val_dTdU,
+ su2double *val_dTvedU, su2double *val_eves,
+ su2double *val_Cvves) {
+
+ unsigned short iDim, iSpecies;
+ su2double Tmin, Tmax, Tvemin, Tvemax;
+ vector rhos;
+
+ rhos.resize(nSpecies,0.0);
+
+ /*--- Conserved & primitive vector layout ---*/
+ // U: [rho1, ..., rhoNs, rhou, rhov, rhow, rhoe, rhoeve]^T
+ // V: [rho1, ..., rhoNs, T, Tve, u, v, w, P, rho, h, a, rhoCvtr, rhoCvve]^T
+
+ /*--- Set booleans ---*/
+ bool nonPhys = false;
+
+ /*--- Set temperature clipping values ---*/
+ Tmin = 50.0; Tmax = 8E4;
+ Tvemin = 50.0; Tvemax = 8E4;
+
+ /*--- Rename variables for convenience ---*/
+ su2double rhoE = U[nSpecies+nDim]; // Density * energy [J/m3]
+ su2double rhoEve = U[nSpecies+nDim+1]; // Density * energy_ve [J/m3]
+
+ /*--- Assign species & mixture density ---*/
+ // Note: if any species densities are < 0, these values are re-assigned
+ // in the primitive AND conserved vectors to ensure positive density
+ V[RHO_INDEX] = 0.0;
+ for (iSpecies = 0; iSpecies < nSpecies; iSpecies++) {
+ if (U[iSpecies] < 0.0) {
+ U[iSpecies] = 1E-20;
+ V[RHOS_INDEX+iSpecies] = 1E-20;
+ rhos[iSpecies] = 1E-20;
+ //nonPhys = true;
+ } else {
+ V[RHOS_INDEX+iSpecies] = U[iSpecies];
+ rhos[iSpecies] = U[iSpecies];
+ }
+ V[RHO_INDEX] += U[iSpecies];
+ }
+
+ // Rename for convenience
+ su2double rho = V[RHO_INDEX];
+
+ /*--- Assign velocity^2 ---*/
+ su2double sqvel = 0.0;
+ for (iDim = 0; iDim < nDim; iDim++) {
+ V[VEL_INDEX+iDim] = U[nSpecies+iDim]/V[RHO_INDEX];
+ sqvel += V[VEL_INDEX+iDim]*V[VEL_INDEX+iDim];
+ }
+
+ /*--- Assign temperatures ---*/
+ const auto& T = fluidmodel->ComputeTemperatures(rhos, rhoE, rhoEve, 0.5*rho*sqvel);
+
+ /*--- Temperatures ---*/
+ V[T_INDEX] = T[0];
+ V[TVE_INDEX] = T[1];
+
+ // Determine if the temperature lies within the acceptable range
+ //TODO: fIX THIS
+ if (V[T_INDEX] == Tmin) {
+ nonPhys = true;
+ } else if (V[T_INDEX] == Tmax){
+ nonPhys = true;
+ }
+
+ /*--- Vibrational-Electronic Temperature ---*/
+ vector eves_min = fluidmodel->ComputeSpeciesEve(Tvemin);
+ vector eves_max = fluidmodel->ComputeSpeciesEve(Tvemax);
+
+ // Check for non-physical solutions
+ if (!monoatomic){
+ su2double rhoEve_min = 0.0;
+ su2double rhoEve_max = 0.0;
+ for (iSpecies = 0; iSpecies < nSpecies; iSpecies++) {
+ rhoEve_min += U[iSpecies] * eves_min[iSpecies];
+ rhoEve_max += U[iSpecies] * eves_max[iSpecies];
+ }
+
+ if (rhoEve < rhoEve_min) {
+
+ nonPhys = true;
+ V[TVE_INDEX] = Tvemin;
+ U[nSpecies+nDim+1] = rhoEve_min;
+ } else if (rhoEve > rhoEve_max) {
+ nonPhys = true;
+ V[TVE_INDEX] = Tvemax;
+ U[nSpecies+nDim+1] = rhoEve_max;
+ }
+ } else {
+ //TODO: can e-modes/vibe modes be active?
+ V[TVE_INDEX] = Tve_Freestream;
+ }
+
+ // Determine other properties of the mixture at the current state
+ fluidmodel->SetTDStateRhosTTv(rhos, V[T_INDEX], V[TVE_INDEX]);
+ const auto& cvves = fluidmodel->ComputeSpeciesCvVibEle();
+ vector eves = fluidmodel->ComputeSpeciesEve(V[TVE_INDEX]);
+
+ for (iSpecies = 0; iSpecies < nSpecies; iSpecies++) {
+ val_eves[iSpecies] = eves[iSpecies];
+ val_Cvves[iSpecies] = cvves[iSpecies];
+ }
+
+ su2double rhoCvtr = fluidmodel->ComputerhoCvtr();
+ su2double rhoCvve = fluidmodel->ComputerhoCvve();
+
+ V[RHOCVTR_INDEX] = rhoCvtr;
+ V[RHOCVVE_INDEX] = rhoCvve;
+
+ /*--- Pressure ---*/
+ V[P_INDEX] = fluidmodel->ComputePressure();
+
+ if (V[P_INDEX] < 0.0) {
+ V[P_INDEX] = 1E-20;
+ nonPhys = true;
+ }
+
+ /*--- Partial derivatives of pressure and temperature ---*/
+ fluidmodel->ComputedPdU (V, eves, val_dPdU );
+ fluidmodel->ComputedTdU (V, val_dTdU );
+ fluidmodel->ComputedTvedU(V, eves, val_dTvedU);
+
+ /*--- Sound speed ---*/
+ V[A_INDEX] = fluidmodel->ComputeSoundSpeed();
+
+ /*--- Enthalpy ---*/
+ V[H_INDEX] = (U[nSpecies+nDim] + V[P_INDEX])/V[RHO_INDEX];
+
+ return nonPhys;
+}
+
+void CNEMOEulerVariable::SetSolution_New() { Solution_New = Solution; }
diff --git a/SU2_CFD/src/variables/CNEMONSVariable.cpp b/SU2_CFD/src/variables/CNEMONSVariable.cpp
index 33dfdcae23d..d8b5066ea29 100644
--- a/SU2_CFD/src/variables/CNEMONSVariable.cpp
+++ b/SU2_CFD/src/variables/CNEMONSVariable.cpp
@@ -1,142 +1,142 @@
-/*!
- * \file CNEMONSVariable.cpp
- * \brief Definition of the solution fields.
- * \author C. Garbacz, W. Maier, S.R. Copeland
- * \version 7.1.0 "Blackbird"
- *
- * SU2 Project Website: https://su2code.github.io
- *
- * The SU2 Project is maintained by the SU2 Foundation
- * (http://su2foundation.org)
- *
- * Copyright 2012-2020, SU2 Contributors (cf. AUTHORS.md)
- *
- * SU2 is free software; you can redistribute it and/or
- * modify it under the terms of the GNU Lesser General Public
- * License as published by the Free Software Foundation; either
- * version 2.1 of the License, or (at your option) any later version.
- *
- * SU2 is distributed in the hope that it will be useful,
- * but WITHOUT ANY WARRANTY; without even the implied warranty of
- * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
- * Lesser General Public License for more details.
- *
- * You should have received a copy of the GNU Lesser General Public
- * License along with SU2. If not, see .
- */
-
-#include "../../include/variables/CNEMONSVariable.hpp"
-#include
-
-CNEMONSVariable::CNEMONSVariable(su2double val_pressure,
- const su2double *val_massfrac,
- su2double *val_mach,
- su2double val_temperature,
- su2double val_temperature_ve,
- unsigned long npoint,
- unsigned long val_ndim,
- unsigned long val_nvar,
- unsigned long val_nvarprim,
- unsigned long val_nvarprimgrad,
- CConfig *config,
- CNEMOGas *fluidmodel) : CNEMOEulerVariable(val_pressure,
- val_massfrac,
- val_mach,
- val_temperature,
- val_temperature_ve,
- npoint,
- val_ndim,
- val_nvar,
- val_nvarprim,
- val_nvarprimgrad,
- config,
- fluidmodel) {
-
-
-
- Temperature_Ref = config->GetTemperature_Ref();
- Viscosity_Ref = config->GetViscosity_Ref();
- Viscosity_Inf = config->GetViscosity_FreeStreamND();
- Prandtl_Lam = config->GetPrandtl_Lam();
-
- DiffusionCoeff.resize(nPoint, nSpecies) = su2double(0.0);
- LaminarViscosity.resize(nPoint) = su2double(0.0);
- ThermalCond.resize(nPoint) = su2double(0.0);
- ThermalCond_ve.resize(nPoint) = su2double(0.0);
-
- Max_Lambda_Visc.resize(nPoint) = su2double(0.0);
- inv_TimeScale = config->GetModVel_FreeStream() / config->GetRefLength();
-
- Vorticity.resize(nPoint,3) = su2double(0.0);
- StrainMag.resize(nPoint) = su2double(0.0);
- Tau_Wall.resize(nPoint) = su2double(-1.0);
- DES_LengthScale.resize(nPoint) = su2double(0.0);
- Roe_Dissipation.resize(nPoint) = su2double(0.0);
- Vortex_Tilting.resize(nPoint) = su2double(0.0);
- Max_Lambda_Visc.resize(nPoint) = su2double(0.0);
-}
-
-bool CNEMONSVariable::SetVorticity(void) {
-
- for (unsigned long iPoint=0; iPoint(FluidModel);
-
- /*--- Convert conserved to primitive variables ---*/
- nonPhys = Cons2PrimVar(Solution[iPoint], Primitive[iPoint], dPdU[iPoint], dTdU[iPoint], dTvedU[iPoint], eves[iPoint], Cvves[iPoint]);
-
- /*--- Reset solution to previous one, if nonphys ---*/
- if (nonPhys) {
- for (iVar = 0; iVar < nVar; iVar++)
- Solution(iPoint,iVar) = Solution_Old(iPoint,iVar);
- }
-
- /*--- Set additional point quantaties ---*/
- Gamma(iPoint) = fluidmodel->ComputeGamma();
-
- SetVelocity2(iPoint);
-
- Ds = fluidmodel->GetDiffusionCoeff();
- for (iSpecies = 0; iSpecies < nSpecies; iSpecies++)
- DiffusionCoeff(iPoint, iSpecies) = Ds[iSpecies];
-
- LaminarViscosity(iPoint) = fluidmodel->GetViscosity();
-
- thermalconductivities = fluidmodel->GetThermalConductivities();
- ThermalCond(iPoint) = thermalconductivities[0];
- ThermalCond_ve(iPoint) = thermalconductivities[1];
-
- Primitive(iPoint, LAM_VISC_INDEX) = LaminarViscosity(iPoint);
-
- return nonPhys;
-}
-
-
-
+/*!
+ * \file CNEMONSVariable.cpp
+ * \brief Definition of the solution fields.
+ * \author C. Garbacz, W. Maier, S.R. Copeland
+ * \version 7.1.1 "Blackbird"
+ *
+ * SU2 Project Website: https://su2code.github.io
+ *
+ * The SU2 Project is maintained by the SU2 Foundation
+ * (http://su2foundation.org)
+ *
+ * Copyright 2012-2020, SU2 Contributors (cf. AUTHORS.md)
+ *
+ * SU2 is free software; you can redistribute it and/or
+ * modify it under the terms of the GNU Lesser General Public
+ * License as published by the Free Software Foundation; either
+ * version 2.1 of the License, or (at your option) any later version.
+ *
+ * SU2 is distributed in the hope that it will be useful,
+ * but WITHOUT ANY WARRANTY; without even the implied warranty of
+ * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
+ * Lesser General Public License for more details.
+ *
+ * You should have received a copy of the GNU Lesser General Public
+ * License along with SU2. If not, see .
+ */
+
+#include "../../include/variables/CNEMONSVariable.hpp"
+#include
+
+CNEMONSVariable::CNEMONSVariable(su2double val_pressure,
+ const su2double *val_massfrac,
+ su2double *val_mach,
+ su2double val_temperature,
+ su2double val_temperature_ve,
+ unsigned long npoint,
+ unsigned long val_ndim,
+ unsigned long val_nvar,
+ unsigned long val_nvarprim,
+ unsigned long val_nvarprimgrad,
+ CConfig *config,
+ CNEMOGas *fluidmodel) : CNEMOEulerVariable(val_pressure,
+ val_massfrac,
+ val_mach,
+ val_temperature,
+ val_temperature_ve,
+ npoint,
+ val_ndim,
+ val_nvar,
+ val_nvarprim,
+ val_nvarprimgrad,
+ config,
+ fluidmodel) {
+
+
+
+ Temperature_Ref = config->GetTemperature_Ref();
+ Viscosity_Ref = config->GetViscosity_Ref();
+ Viscosity_Inf = config->GetViscosity_FreeStreamND();
+ Prandtl_Lam = config->GetPrandtl_Lam();
+
+ DiffusionCoeff.resize(nPoint, nSpecies) = su2double(0.0);
+ LaminarViscosity.resize(nPoint) = su2double(0.0);
+ ThermalCond.resize(nPoint) = su2double(0.0);
+ ThermalCond_ve.resize(nPoint) = su2double(0.0);
+
+ Max_Lambda_Visc.resize(nPoint) = su2double(0.0);
+ inv_TimeScale = config->GetModVel_FreeStream() / config->GetRefLength();
+
+ Vorticity.resize(nPoint,3) = su2double(0.0);
+ StrainMag.resize(nPoint) = su2double(0.0);
+ Tau_Wall.resize(nPoint) = su2double(-1.0);
+ DES_LengthScale.resize(nPoint) = su2double(0.0);
+ Roe_Dissipation.resize(nPoint) = su2double(0.0);
+ Vortex_Tilting.resize(nPoint) = su2double(0.0);
+ Max_Lambda_Visc.resize(nPoint) = su2double(0.0);
+}
+
+bool CNEMONSVariable::SetVorticity(void) {
+
+ for (unsigned long iPoint=0; iPoint(FluidModel);
+
+ /*--- Convert conserved to primitive variables ---*/
+ nonPhys = Cons2PrimVar(Solution[iPoint], Primitive[iPoint], dPdU[iPoint], dTdU[iPoint], dTvedU[iPoint], eves[iPoint], Cvves[iPoint]);
+
+ /*--- Reset solution to previous one, if nonphys ---*/
+ if (nonPhys) {
+ for (iVar = 0; iVar < nVar; iVar++)
+ Solution(iPoint,iVar) = Solution_Old(iPoint,iVar);
+ }
+
+ /*--- Set additional point quantaties ---*/
+ Gamma(iPoint) = fluidmodel->ComputeGamma();
+
+ SetVelocity2(iPoint);
+
+ Ds = fluidmodel->GetDiffusionCoeff();
+ for (iSpecies = 0; iSpecies < nSpecies; iSpecies++)
+ DiffusionCoeff(iPoint, iSpecies) = Ds[iSpecies];
+
+ LaminarViscosity(iPoint) = fluidmodel->GetViscosity();
+
+ thermalconductivities = fluidmodel->GetThermalConductivities();
+ ThermalCond(iPoint) = thermalconductivities[0];
+ ThermalCond_ve(iPoint) = thermalconductivities[1];
+
+ Primitive(iPoint, LAM_VISC_INDEX) = LaminarViscosity(iPoint);
+
+ return nonPhys;
+}
+
+
+
diff --git a/SU2_CFD/src/variables/CNSVariable.cpp b/SU2_CFD/src/variables/CNSVariable.cpp
index d85f6502dad..98ad4d18ada 100644
--- a/SU2_CFD/src/variables/CNSVariable.cpp
+++ b/SU2_CFD/src/variables/CNSVariable.cpp
@@ -2,7 +2,7 @@
* \file CNSVariable.cpp
* \brief Definition of the solution fields.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CRadP1Variable.cpp b/SU2_CFD/src/variables/CRadP1Variable.cpp
index baaf66f533d..831cbb94d7e 100644
--- a/SU2_CFD/src/variables/CRadP1Variable.cpp
+++ b/SU2_CFD/src/variables/CRadP1Variable.cpp
@@ -2,7 +2,7 @@
* \file CRadP1Variable.cpp
* \brief Definition of the P1 model variables
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CRadVariable.cpp b/SU2_CFD/src/variables/CRadVariable.cpp
index f09aa11593d..633610f1350 100644
--- a/SU2_CFD/src/variables/CRadVariable.cpp
+++ b/SU2_CFD/src/variables/CRadVariable.cpp
@@ -2,7 +2,7 @@
* \file CRadVariable.cpp
* \brief Definition of the radiation variables
* \author Ruben Sanchez
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CTransLMVariable.cpp b/SU2_CFD/src/variables/CTransLMVariable.cpp
index 061225fad4c..f4120afd35d 100644
--- a/SU2_CFD/src/variables/CTransLMVariable.cpp
+++ b/SU2_CFD/src/variables/CTransLMVariable.cpp
@@ -2,7 +2,7 @@
* \file CTransLMVariable.cpp
* \brief Definition of the solution fields.
* \author A. Aranake
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CTurbSAVariable.cpp b/SU2_CFD/src/variables/CTurbSAVariable.cpp
index cb84add72d3..9530f1d1be3 100644
--- a/SU2_CFD/src/variables/CTurbSAVariable.cpp
+++ b/SU2_CFD/src/variables/CTurbSAVariable.cpp
@@ -2,7 +2,7 @@
* \file CTurbSAVariable.cpp
* \brief Definition of the solution fields.
* \author F. Palacios, A. Bueno
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CTurbSSTVariable.cpp b/SU2_CFD/src/variables/CTurbSSTVariable.cpp
index 5b725da8e5a..b6b9fae8dc8 100644
--- a/SU2_CFD/src/variables/CTurbSSTVariable.cpp
+++ b/SU2_CFD/src/variables/CTurbSSTVariable.cpp
@@ -2,7 +2,7 @@
* \file CTurbSSTVariable.cpp
* \brief Definition of the solution fields.
* \author F. Palacios, A. Bueno
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CTurbVariable.cpp b/SU2_CFD/src/variables/CTurbVariable.cpp
index 6f41ae365ab..c2e7211c192 100644
--- a/SU2_CFD/src/variables/CTurbVariable.cpp
+++ b/SU2_CFD/src/variables/CTurbVariable.cpp
@@ -2,7 +2,7 @@
* \file CTurbVariable.cpp
* \brief Definition of the solution fields.
* \author F. Palacios, A. Bueno
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_CFD/src/variables/CVariable.cpp b/SU2_CFD/src/variables/CVariable.cpp
index d852d0e210e..5d16271961d 100644
--- a/SU2_CFD/src/variables/CVariable.cpp
+++ b/SU2_CFD/src/variables/CVariable.cpp
@@ -2,7 +2,7 @@
* \file CVariable.cpp
* \brief Definition of the solution fields.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_DEF/include/SU2_DEF.hpp b/SU2_DEF/include/SU2_DEF.hpp
index e0cd6911bd8..be5aaf23cbc 100644
--- a/SU2_DEF/include/SU2_DEF.hpp
+++ b/SU2_DEF/include/SU2_DEF.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines of the code SU2_DEF.
* The subroutines and functions are in the SU2_DEF.cpp file.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_DEF/obj/Makefile.am b/SU2_DEF/obj/Makefile.am
index 4724b670a63..90fdaf0afd3 100644
--- a/SU2_DEF/obj/Makefile.am
+++ b/SU2_DEF/obj/Makefile.am
@@ -3,7 +3,7 @@
# \file Makefile.am
# \brief Makefile for SU2_DEF
# \author M. Colonno, T. Economon, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_DEF/src/SU2_DEF.cpp b/SU2_DEF/src/SU2_DEF.cpp
index 3e1310da1da..ca4b5b2ee6e 100644
--- a/SU2_DEF/src/SU2_DEF.cpp
+++ b/SU2_DEF/src/SU2_DEF.cpp
@@ -2,7 +2,7 @@
* \file SU2_DEF.cpp
* \brief Main file of Mesh Deformation Code (SU2_DEF).
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_DOT/include/SU2_DOT.hpp b/SU2_DOT/include/SU2_DOT.hpp
index 97c0a1f3023..e986ea638ed 100644
--- a/SU2_DOT/include/SU2_DOT.hpp
+++ b/SU2_DOT/include/SU2_DOT.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines of the code SU2_DOT.
* The subroutines and functions are in the SU2_DOT.cpp file.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_DOT/obj/Makefile.am b/SU2_DOT/obj/Makefile.am
index ad99ef05100..82cfc2f2437 100644
--- a/SU2_DOT/obj/Makefile.am
+++ b/SU2_DOT/obj/Makefile.am
@@ -3,7 +3,7 @@
# \file Makefile.am
# \brief Makefile for SU2_DOT
# \author M. Colonno, T. Economon, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_DOT/src/SU2_DOT.cpp b/SU2_DOT/src/SU2_DOT.cpp
index f57ffd18df3..0273ff910fd 100644
--- a/SU2_DOT/src/SU2_DOT.cpp
+++ b/SU2_DOT/src/SU2_DOT.cpp
@@ -2,7 +2,7 @@
* \file SU2_DOT.cpp
* \brief Main file of the Gradient Projection Code (SU2_DOT).
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_GEO/include/SU2_GEO.hpp b/SU2_GEO/include/SU2_GEO.hpp
index fe4781bd65b..7824c67bd59 100644
--- a/SU2_GEO/include/SU2_GEO.hpp
+++ b/SU2_GEO/include/SU2_GEO.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines of the code SU2_GEO.
* The subroutines and functions are in the SU2_GEO.cpp file.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_GEO/obj/Makefile.am b/SU2_GEO/obj/Makefile.am
index a488af60ad0..55a1c1fe852 100644
--- a/SU2_GEO/obj/Makefile.am
+++ b/SU2_GEO/obj/Makefile.am
@@ -3,7 +3,7 @@
# \file Makefile.am
# \brief Makefile for SU2_GEO
# \author M. Colonno, T. Economon, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_GEO/src/SU2_GEO.cpp b/SU2_GEO/src/SU2_GEO.cpp
index 9bfff3e3fbf..c640b717455 100644
--- a/SU2_GEO/src/SU2_GEO.cpp
+++ b/SU2_GEO/src/SU2_GEO.cpp
@@ -2,7 +2,7 @@
* \file SU2_GEO.cpp
* \brief Main file of the Geometry Definition Code (SU2_GEO).
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_PY/FSI_tools/FSIInterface.py b/SU2_PY/FSI_tools/FSIInterface.py
index 9fe034d1e1f..5fcb809263d 100644
--- a/SU2_PY/FSI_tools/FSIInterface.py
+++ b/SU2_PY/FSI_tools/FSIInterface.py
@@ -3,7 +3,7 @@
## \file FSIInterface.py
# \brief FSI interface class that handles fluid/solid solvers synchronisation and communication.
# \authors Nicola Fonzi, Vittorio Cavalieri based on the work of David Thomas
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/FSI_tools/FSI_config.py b/SU2_PY/FSI_tools/FSI_config.py
index ec8e3c55f34..f121beaebd9 100644
--- a/SU2_PY/FSI_tools/FSI_config.py
+++ b/SU2_PY/FSI_tools/FSI_config.py
@@ -3,7 +3,7 @@
## \file FSI_config.py
# \brief Python class for handling configuration file for FSI computation.
# \authors Nicola Fonzi, Vittorio Cavalieri based on the work of David Thomas
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# The current SU2 release has been coordinated by the
# SU2 International Developers Society
diff --git a/SU2_PY/Makefile.am b/SU2_PY/Makefile.am
index 82b41fb5c9d..a14b487b862 100644
--- a/SU2_PY/Makefile.am
+++ b/SU2_PY/Makefile.am
@@ -3,7 +3,7 @@
# \file Makefile.am
# \brief Makefile for the SU2 Python framework
# \author M. Colonno, T. Economon, F. Palacios, T. Lukaczyk
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# The current SU2 release has been coordinated by the
# SU2 International Developers Society
diff --git a/SU2_PY/OptimalPropeller.py b/SU2_PY/OptimalPropeller.py
index 12f95067fe4..82112804ec1 100644
--- a/SU2_PY/OptimalPropeller.py
+++ b/SU2_PY/OptimalPropeller.py
@@ -1,7 +1,7 @@
## \file OptimalPropeller.py
# \brief Python script for generating the ActuatorDisk.dat file.
# \author E. Saetta, L. Russo, R. Tognaccini
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/eval/design.py b/SU2_PY/SU2/eval/design.py
index 606c68a28ce..96e14e0f875 100644
--- a/SU2_PY/SU2/eval/design.py
+++ b/SU2_PY/SU2/eval/design.py
@@ -3,7 +3,7 @@
## \file design.py
# \brief python package for designs
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/eval/functions.py b/SU2_PY/SU2/eval/functions.py
index b501159da88..7f30df262d9 100644
--- a/SU2_PY/SU2/eval/functions.py
+++ b/SU2_PY/SU2/eval/functions.py
@@ -3,7 +3,7 @@
## \file functions.py
# \brief python package for functions
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/eval/gradients.py b/SU2_PY/SU2/eval/gradients.py
index 0ab65f50443..6b33039e030 100644
--- a/SU2_PY/SU2/eval/gradients.py
+++ b/SU2_PY/SU2/eval/gradients.py
@@ -3,7 +3,7 @@
## \file gradients.py
# \brief python package for gradients
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/io/config.py b/SU2_PY/SU2/io/config.py
index 485ace2213a..242c0b70002 100755
--- a/SU2_PY/SU2/io/config.py
+++ b/SU2_PY/SU2/io/config.py
@@ -3,7 +3,7 @@
## \file config.py
# \brief python package for config
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/io/config_options.py b/SU2_PY/SU2/io/config_options.py
index 74fe5e0b663..e3c24d9227d 100644
--- a/SU2_PY/SU2/io/config_options.py
+++ b/SU2_PY/SU2/io/config_options.py
@@ -1,7 +1,7 @@
# \file config_options.py
# \brief python package for config
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/io/data.py b/SU2_PY/SU2/io/data.py
index 0a018be4e8f..f0fcb80d10c 100644
--- a/SU2_PY/SU2/io/data.py
+++ b/SU2_PY/SU2/io/data.py
@@ -3,7 +3,7 @@
## \file data.py
# \brief python package for data utility functions
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/io/filelock.py b/SU2_PY/SU2/io/filelock.py
index 14a9d5ed4ad..7bce2934b5e 100644
--- a/SU2_PY/SU2/io/filelock.py
+++ b/SU2_PY/SU2/io/filelock.py
@@ -3,7 +3,7 @@
## \file filelock.py
# \brief python package for filelocking
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/io/redirect.py b/SU2_PY/SU2/io/redirect.py
index b973d189a3c..a5eb3d71987 100644
--- a/SU2_PY/SU2/io/redirect.py
+++ b/SU2_PY/SU2/io/redirect.py
@@ -3,7 +3,7 @@
## \file redirect.py
# \brief python package for file redirection
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/io/state.py b/SU2_PY/SU2/io/state.py
index be4265640aa..b16e58693e7 100644
--- a/SU2_PY/SU2/io/state.py
+++ b/SU2_PY/SU2/io/state.py
@@ -3,7 +3,7 @@
## \file state.py
# \brief python package for state
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/io/tools.py b/SU2_PY/SU2/io/tools.py
index 9201256340c..d03d7bdd165 100755
--- a/SU2_PY/SU2/io/tools.py
+++ b/SU2_PY/SU2/io/tools.py
@@ -3,7 +3,7 @@
## \file tools.py
# \brief file i/o functions
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/opt/project.py b/SU2_PY/SU2/opt/project.py
index b387bfe1ca1..9b542e0e3e1 100644
--- a/SU2_PY/SU2/opt/project.py
+++ b/SU2_PY/SU2/opt/project.py
@@ -3,7 +3,7 @@
## \file project.py
# \brief package for optimization projects
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/opt/scipy_tools.py b/SU2_PY/SU2/opt/scipy_tools.py
index 8b49091fa34..6e96a0f6332 100644
--- a/SU2_PY/SU2/opt/scipy_tools.py
+++ b/SU2_PY/SU2/opt/scipy_tools.py
@@ -3,7 +3,7 @@
## \file scipy_tools.py
# \brief tools for interfacing with scipy
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/run/adjoint.py b/SU2_PY/SU2/run/adjoint.py
index 43c042056d4..66ba0ad05f6 100644
--- a/SU2_PY/SU2/run/adjoint.py
+++ b/SU2_PY/SU2/run/adjoint.py
@@ -3,7 +3,7 @@
## \file adjoint.py
# \brief python package for running adjoint problems
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/run/deform.py b/SU2_PY/SU2/run/deform.py
index dd8394f78af..94f312c0750 100644
--- a/SU2_PY/SU2/run/deform.py
+++ b/SU2_PY/SU2/run/deform.py
@@ -3,7 +3,7 @@
## \file deform.py
# \brief python package for deforming meshes
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/run/direct.py b/SU2_PY/SU2/run/direct.py
index 54c930a9595..abbeb7ca0c9 100644
--- a/SU2_PY/SU2/run/direct.py
+++ b/SU2_PY/SU2/run/direct.py
@@ -3,7 +3,7 @@
## \file direct.py
# \brief python package for running direct solutions
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/run/geometry.py b/SU2_PY/SU2/run/geometry.py
index 311029f75f7..05e9894bd9a 100644
--- a/SU2_PY/SU2/run/geometry.py
+++ b/SU2_PY/SU2/run/geometry.py
@@ -3,7 +3,7 @@
## \file geometry.py
# \brief python package for running geometry analyses
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/run/interface.py b/SU2_PY/SU2/run/interface.py
index 2d8f901c0c1..aaba83c626e 100644
--- a/SU2_PY/SU2/run/interface.py
+++ b/SU2_PY/SU2/run/interface.py
@@ -3,7 +3,7 @@
## \file interface.py
# \brief python package interfacing with the SU2 suite
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/run/merge.py b/SU2_PY/SU2/run/merge.py
index f035af4a1c3..bfcb3212e08 100644
--- a/SU2_PY/SU2/run/merge.py
+++ b/SU2_PY/SU2/run/merge.py
@@ -1,7 +1,7 @@
## \file merge.py
# \brief python package for merging meshes
# \author T. Economon, T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/run/projection.py b/SU2_PY/SU2/run/projection.py
index c9878404d4c..0c5d5256862 100644
--- a/SU2_PY/SU2/run/projection.py
+++ b/SU2_PY/SU2/run/projection.py
@@ -3,7 +3,7 @@
## \file projection.py
# \brief python package for running gradient projection
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/util/filter_adjoint.py b/SU2_PY/SU2/util/filter_adjoint.py
index 0c70cb12f09..b3971c11b18 100644
--- a/SU2_PY/SU2/util/filter_adjoint.py
+++ b/SU2_PY/SU2/util/filter_adjoint.py
@@ -3,7 +3,7 @@
## \file filter_adjoint.py
# \brief Applies various filters to the adjoint surface sensitivities of an airfoil
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/util/plot.py b/SU2_PY/SU2/util/plot.py
index 50b25bcc901..5badbb95f55 100644
--- a/SU2_PY/SU2/util/plot.py
+++ b/SU2_PY/SU2/util/plot.py
@@ -3,7 +3,7 @@
## \file plot.py
# \brief python package for plotting
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/util/polarSweepLib.py b/SU2_PY/SU2/util/polarSweepLib.py
index 6f731a475bf..a9a56bbf15e 100755
--- a/SU2_PY/SU2/util/polarSweepLib.py
+++ b/SU2_PY/SU2/util/polarSweepLib.py
@@ -2,7 +2,7 @@
# \file polarSweepLib.py
# \brief Functions library for compute_polar.py script.
# \author E Arad
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2/util/which.py b/SU2_PY/SU2/util/which.py
index e35b774f2c7..3e7b4069f1b 100644
--- a/SU2_PY/SU2/util/which.py
+++ b/SU2_PY/SU2/util/which.py
@@ -3,7 +3,7 @@
## \file which.py
# \brief looks for where a program is
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2_CFD.py b/SU2_PY/SU2_CFD.py
index dcfc15e6c57..b376cd4ae35 100755
--- a/SU2_PY/SU2_CFD.py
+++ b/SU2_PY/SU2_CFD.py
@@ -3,7 +3,7 @@
## \file SU2_CFD.py
# \brief Python script to launch SU2_CFD through the Python Wrapper.
# \author David Thomas
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/SU2_Nastran/pysu2_nastran.py b/SU2_PY/SU2_Nastran/pysu2_nastran.py
index aa83f44c5dd..00a57fca822 100644
--- a/SU2_PY/SU2_Nastran/pysu2_nastran.py
+++ b/SU2_PY/SU2_Nastran/pysu2_nastran.py
@@ -3,7 +3,7 @@
## \file pysu2_nastran.py
# \brief Structural solver using Nastran models
# \authors Nicola Fonzi, Vittorio Cavalieri, based on the work of David Thomas
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/change_version_number.py b/SU2_PY/change_version_number.py
index b5245bb1ac9..2b2699990f5 100755
--- a/SU2_PY/change_version_number.py
+++ b/SU2_PY/change_version_number.py
@@ -3,7 +3,7 @@
## \file change_version_number.py
# \brief Python script for updating the version number of the SU2 suite.
# \author A. Aranake
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
@@ -44,8 +44,8 @@
#oldvers = '2012-2018'
#newvers = '2012-2019'
-oldvers = '7.1.0 "Blackbird"'
-oldvers_q= r'7.1.0 \"Blackbird\"'
+oldvers = '7.1.1 "Blackbird"'
+oldvers_q= r'7.1.1 \"Blackbird\"'
newvers = str(options.version) + ' "' + str(options.releasename) + '"'
newvers_q= str(options.version) + ' \\"' + str(options.releasename) + '\\"'
diff --git a/SU2_PY/compute_multipoint.py b/SU2_PY/compute_multipoint.py
index f1e7e623f08..667b63a26c9 100755
--- a/SU2_PY/compute_multipoint.py
+++ b/SU2_PY/compute_multipoint.py
@@ -3,7 +3,7 @@
## \file Compute_multipoint.py
# \brief Python script for performing a multipoint design.
# \author Indiana Stokes
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/compute_polar.py b/SU2_PY/compute_polar.py
index 979e72ce4b0..779cb70d561 100755
--- a/SU2_PY/compute_polar.py
+++ b/SU2_PY/compute_polar.py
@@ -3,7 +3,7 @@
## \file Compute_polar.py
# \brief Python script for performing polar sweep.
# \author E Arad (based on T. Lukaczyk and F. Palacios script)
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/compute_stability.py b/SU2_PY/compute_stability.py
index b30338ebf38..0097036e31e 100755
--- a/SU2_PY/compute_stability.py
+++ b/SU2_PY/compute_stability.py
@@ -3,7 +3,7 @@
## \file compute_stability.py
# \brief Python script for performing the shape optimization.
# \author T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/compute_uncertainty.py b/SU2_PY/compute_uncertainty.py
index 43e8142257c..15d742b9726 100755
--- a/SU2_PY/compute_uncertainty.py
+++ b/SU2_PY/compute_uncertainty.py
@@ -3,7 +3,7 @@
## \file compute_uncertainty.py
# \brief Python script for performing model-form UQ for SST turbulence model
# \author J. Mukhopadhaya
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/config_gui.py b/SU2_PY/config_gui.py
index c971864f2c9..f679e4571d3 100755
--- a/SU2_PY/config_gui.py
+++ b/SU2_PY/config_gui.py
@@ -3,7 +3,7 @@
## \file config_gui.py
# \brief _____________.
# \author A. Aranake
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/continuous_adjoint.py b/SU2_PY/continuous_adjoint.py
index a7d5fd81096..ff5cf88589e 100755
--- a/SU2_PY/continuous_adjoint.py
+++ b/SU2_PY/continuous_adjoint.py
@@ -3,7 +3,7 @@
## \file continuous_adjoint.py
# \brief Python script for continuous adjoint computation using the SU2 suite.
# \author F. Palacios, T. Economon, T. Lukaczyk
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/direct_differentiation.py b/SU2_PY/direct_differentiation.py
index d306a45375a..be42c8669a5 100755
--- a/SU2_PY/direct_differentiation.py
+++ b/SU2_PY/direct_differentiation.py
@@ -3,7 +3,7 @@
## \file direct_differentiation.py
# \brief Python script for doing the direct differentiation computation using the SU2 suite.
# \author F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/discrete_adjoint.py b/SU2_PY/discrete_adjoint.py
index 23487ac9960..d05ded79fd0 100755
--- a/SU2_PY/discrete_adjoint.py
+++ b/SU2_PY/discrete_adjoint.py
@@ -3,7 +3,7 @@
## \file discrete_adjoint.py
# \brief Python script for doing the discrete adjoint computation using the SU2 suite.
# \author F. Palacios, T. Economon, T. Lukaczyk
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/finite_differences.py b/SU2_PY/finite_differences.py
index 41bd42448cb..d7df7843a50 100755
--- a/SU2_PY/finite_differences.py
+++ b/SU2_PY/finite_differences.py
@@ -3,7 +3,7 @@
## \file finite_differences.py
# \brief Python script for doing the finite differences computation using the SU2 suite.
# \author F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/fsi_computation.py b/SU2_PY/fsi_computation.py
index 6f246a018c6..5745571d2ee 100644
--- a/SU2_PY/fsi_computation.py
+++ b/SU2_PY/fsi_computation.py
@@ -3,7 +3,7 @@
## \file fsi_computation.py
# \brief Python wrapper code for FSI computation by coupling a third-party structural solver to SU2.
# \authors Nicola Fonzi, Vittorio Cavalieri based on the work of David Thomas
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/merge_solution.py b/SU2_PY/merge_solution.py
index 6d324795635..a197c072fe1 100755
--- a/SU2_PY/merge_solution.py
+++ b/SU2_PY/merge_solution.py
@@ -3,7 +3,7 @@
## \file merge_solution.py
# \brief Python script for merging of the solution files.
# \author F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/mesh_deformation.py b/SU2_PY/mesh_deformation.py
index 9898e0f357a..0024531fdbe 100755
--- a/SU2_PY/mesh_deformation.py
+++ b/SU2_PY/mesh_deformation.py
@@ -3,7 +3,7 @@
## \file mesh_deformation.py
# \brief Python script for doing the parallel deformation using SU2_DEF.
# \author F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/package_tests.py b/SU2_PY/package_tests.py
index 15ffcfede5f..f638f922f00 100755
--- a/SU2_PY/package_tests.py
+++ b/SU2_PY/package_tests.py
@@ -3,7 +3,7 @@
## \file package_tests.py
# \brief _____________.
# \author T. Lukaczyk
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/parallel_computation.py b/SU2_PY/parallel_computation.py
index 5e1c53fc018..e1bb5b2fd81 100755
--- a/SU2_PY/parallel_computation.py
+++ b/SU2_PY/parallel_computation.py
@@ -3,7 +3,7 @@
## \file parallel_computation.py
# \brief Python script for doing the continuous adjoint computation using the SU2 suite.
# \author T. Economon, T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/parallel_computation_fsi.py b/SU2_PY/parallel_computation_fsi.py
index 59fa50e1497..fb1a24470b6 100755
--- a/SU2_PY/parallel_computation_fsi.py
+++ b/SU2_PY/parallel_computation_fsi.py
@@ -3,7 +3,7 @@
## \file parallel_computation_fsi.py
# \brief Python script for running FSI simulations using the SU2 suite.
# \author T. Economon, T. Lukaczyk, F. Palacios, H. Kline, R. Sanchez
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/parse_config.py b/SU2_PY/parse_config.py
index 04436a4875c..951f0c53138 100755
--- a/SU2_PY/parse_config.py
+++ b/SU2_PY/parse_config.py
@@ -3,7 +3,7 @@
## \file parse_config.py
# \brief Builds a worksheet of all SU2.cpp options
# \author A. Aranake, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/profiling.py b/SU2_PY/profiling.py
index 1bb8df589a7..d09205f7679 100755
--- a/SU2_PY/profiling.py
+++ b/SU2_PY/profiling.py
@@ -3,7 +3,7 @@
## \file profiling.py
# \brief Python script for postprocessing the SU2 custom profiling (profiling.csv)
# \author T. Economon
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/pySU2/Makefile.am b/SU2_PY/pySU2/Makefile.am
index 9d0bff1651f..75fd1ff3f75 100644
--- a/SU2_PY/pySU2/Makefile.am
+++ b/SU2_PY/pySU2/Makefile.am
@@ -3,7 +3,7 @@
# \file Makefile.am
# \brief Makefile for the SU2 Python wrapper.
# \author D. Thomas
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/pySU2/pySU2.i b/SU2_PY/pySU2/pySU2.i
index ae4307d4c22..49c9bf1387f 100644
--- a/SU2_PY/pySU2/pySU2.i
+++ b/SU2_PY/pySU2/pySU2.i
@@ -4,7 +4,7 @@
# \file pySU2.i
# \brief Configuration file for the Swig compilation of the Python wrapper.
# \author D. Thomas
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/set_ffd_design_var.py b/SU2_PY/set_ffd_design_var.py
index 7714b4a6d09..42b1543b52f 100755
--- a/SU2_PY/set_ffd_design_var.py
+++ b/SU2_PY/set_ffd_design_var.py
@@ -3,7 +3,7 @@
## \file set_ffd_design_var.py
# \brief Python script for automatically generating a list of FFD variables.
# \author T. Economon, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_PY/shape_optimization.py b/SU2_PY/shape_optimization.py
index 07341aecc0b..e9a119cc395 100755
--- a/SU2_PY/shape_optimization.py
+++ b/SU2_PY/shape_optimization.py
@@ -3,7 +3,7 @@
## \file shape_optimization.py
# \brief Python script for performing the shape optimization.
# \author T. Economon, T. Lukaczyk, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
@@ -63,7 +63,7 @@ def main():
sys.stdout.write('\n-------------------------------------------------------------------------\n')
sys.stdout.write('| ___ _ _ ___ |\n')
- sys.stdout.write('| / __| | | |_ ) Release 7.1.0 \"Blackbird\" |\n')
+ sys.stdout.write('| / __| | | |_ ) Release 7.1.1 \"Blackbird\" |\n')
sys.stdout.write('| \\__ \\ |_| |/ / |\n')
sys.stdout.write('| |___/\\___//___| Aerodynamic Shape Optimization Script |\n')
sys.stdout.write('| |\n')
diff --git a/SU2_PY/topology_optimization.py b/SU2_PY/topology_optimization.py
index 2ac40841da3..e3d9f2b322f 100755
--- a/SU2_PY/topology_optimization.py
+++ b/SU2_PY/topology_optimization.py
@@ -2,7 +2,7 @@
## \file topology_optimization.py
# \brief Python script to drive SU2 in topology optimization.
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/SU2_SOL/include/SU2_SOL.hpp b/SU2_SOL/include/SU2_SOL.hpp
index dc75612d0d7..98830420341 100644
--- a/SU2_SOL/include/SU2_SOL.hpp
+++ b/SU2_SOL/include/SU2_SOL.hpp
@@ -3,7 +3,7 @@
* \brief Headers of the main subroutines of the code SU2_SOL.
* The subroutines and functions are in the SU2_SOL.cpp file.
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/SU2_SOL/obj/Makefile.am b/SU2_SOL/obj/Makefile.am
index 0d4d922e5f7..0adac873014 100644
--- a/SU2_SOL/obj/Makefile.am
+++ b/SU2_SOL/obj/Makefile.am
@@ -3,7 +3,7 @@
# \file Makefile.am
# \brief Makefile for SU2_SOL
# \author M. Colonno, T. Economon, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# The current SU2 release has been coordinated by the
# SU2 International Developers Society
diff --git a/SU2_SOL/src/SU2_SOL.cpp b/SU2_SOL/src/SU2_SOL.cpp
index 68b4da4e475..6b191747caf 100644
--- a/SU2_SOL/src/SU2_SOL.cpp
+++ b/SU2_SOL/src/SU2_SOL.cpp
@@ -2,7 +2,7 @@
* \file SU2_SOL.cpp
* \brief Main file for the solution export/conversion code (SU2_SOL).
* \author F. Palacios, T. Economon
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/TestCases/TestCase.py b/TestCases/TestCase.py
index 10907f87fb2..bfba1a8aa8a 100644
--- a/TestCases/TestCase.py
+++ b/TestCases/TestCase.py
@@ -3,7 +3,7 @@
## \file TestCase.py
# \brief Python class for automated regression testing of SU2 examples
# \author A. Aranake, A. Campos, T. Economon, T. Lukaczyk, S. Padron
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/TestCases/aeroelastic/aeroelastic_NACA64A010.cfg b/TestCases/aeroelastic/aeroelastic_NACA64A010.cfg
index e54c2d5e5a2..4b0e1af21f7 100644
--- a/TestCases/aeroelastic/aeroelastic_NACA64A010.cfg
+++ b/TestCases/aeroelastic/aeroelastic_NACA64A010.cfg
@@ -5,7 +5,7 @@
% Author: Santiago Padron %
% Institution: Stanford University %
% Date: 07-09-15 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/cont_adj_euler/naca0012/inv_NACA0012.cfg b/TestCases/cont_adj_euler/naca0012/inv_NACA0012.cfg
index fa9cadd19f2..8e900c460e8 100644
--- a/TestCases/cont_adj_euler/naca0012/inv_NACA0012.cfg
+++ b/TestCases/cont_adj_euler/naca0012/inv_NACA0012.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2011.11.02 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/cont_adj_euler/naca0012/inv_NACA0012_FD.cfg b/TestCases/cont_adj_euler/naca0012/inv_NACA0012_FD.cfg
index 81a4e80be47..336c812eef1 100644
--- a/TestCases/cont_adj_euler/naca0012/inv_NACA0012_FD.cfg
+++ b/TestCases/cont_adj_euler/naca0012/inv_NACA0012_FD.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2011.11.02 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/cont_adj_euler/naca0012/inv_NACA0012_discadj.cfg b/TestCases/cont_adj_euler/naca0012/inv_NACA0012_discadj.cfg
index 04fc13125f2..91212cb018d 100644
--- a/TestCases/cont_adj_euler/naca0012/inv_NACA0012_discadj.cfg
+++ b/TestCases/cont_adj_euler/naca0012/inv_NACA0012_discadj.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2011.11.02 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/cont_adj_euler/oneram6/inv_ONERAM6.cfg b/TestCases/cont_adj_euler/oneram6/inv_ONERAM6.cfg
index 8d43458e9a6..786d4594004 100644
--- a/TestCases/cont_adj_euler/oneram6/inv_ONERAM6.cfg
+++ b/TestCases/cont_adj_euler/oneram6/inv_ONERAM6.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2015.08.25 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/cont_adj_euler/wedge/inv_wedge_ROE.cfg b/TestCases/cont_adj_euler/wedge/inv_wedge_ROE.cfg
index 74273c989ee..8345cee9d9f 100644
--- a/TestCases/cont_adj_euler/wedge/inv_wedge_ROE.cfg
+++ b/TestCases/cont_adj_euler/wedge/inv_wedge_ROE.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2012.10.07 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/cont_adj_euler/wedge/inv_wedge_ROE_multiobj.cfg b/TestCases/cont_adj_euler/wedge/inv_wedge_ROE_multiobj.cfg
index 7b90ced501c..5857b07586d 100644
--- a/TestCases/cont_adj_euler/wedge/inv_wedge_ROE_multiobj.cfg
+++ b/TestCases/cont_adj_euler/wedge/inv_wedge_ROE_multiobj.cfg
@@ -6,7 +6,7 @@
% Author: H.L. Kline, modified from inviscid wedge by Thomas D. Economon %
% Institution: Stanford University %
% Date: 2018.01.07 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/cont_adj_navierstokes/cylinder/lam_cylinder.cfg b/TestCases/cont_adj_navierstokes/cylinder/lam_cylinder.cfg
index 7da2d683a4a..90316841376 100644
--- a/TestCases/cont_adj_navierstokes/cylinder/lam_cylinder.cfg
+++ b/TestCases/cont_adj_navierstokes/cylinder/lam_cylinder.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2013.03.01 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/cont_adj_navierstokes/naca0012_sub/lam_NACA0012.cfg b/TestCases/cont_adj_navierstokes/naca0012_sub/lam_NACA0012.cfg
index 2f37c5b145a..0ebb8b70f64 100644
--- a/TestCases/cont_adj_navierstokes/naca0012_sub/lam_NACA0012.cfg
+++ b/TestCases/cont_adj_navierstokes/naca0012_sub/lam_NACA0012.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: Jul 18th, 2014 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/cont_adj_navierstokes/naca0012_trans/lam_NACA0012.cfg b/TestCases/cont_adj_navierstokes/naca0012_trans/lam_NACA0012.cfg
index 4db33d41c08..55a1c41fd9b 100644
--- a/TestCases/cont_adj_navierstokes/naca0012_trans/lam_NACA0012.cfg
+++ b/TestCases/cont_adj_navierstokes/naca0012_trans/lam_NACA0012.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: Jul 18th, 2014 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/cont_adj_rans/naca0012/turb_nasa.cfg b/TestCases/cont_adj_rans/naca0012/turb_nasa.cfg
index d9964fc5fb2..58120e751a4 100644
--- a/TestCases/cont_adj_rans/naca0012/turb_nasa.cfg
+++ b/TestCases/cont_adj_rans/naca0012/turb_nasa.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2013.03.01 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/cont_adj_rans/naca0012/turb_nasa_binary.cfg b/TestCases/cont_adj_rans/naca0012/turb_nasa_binary.cfg
index 66be5e33e56..f4d84af47db 100644
--- a/TestCases/cont_adj_rans/naca0012/turb_nasa_binary.cfg
+++ b/TestCases/cont_adj_rans/naca0012/turb_nasa_binary.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2013.03.01 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/cont_adj_rans/oneram6/turb_ONERAM6.cfg b/TestCases/cont_adj_rans/oneram6/turb_ONERAM6.cfg
index ebfc62d342c..c99768abe2f 100644
--- a/TestCases/cont_adj_rans/oneram6/turb_ONERAM6.cfg
+++ b/TestCases/cont_adj_rans/oneram6/turb_ONERAM6.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2013.03.01 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/cont_adj_rans/rae2822/turb_SA_RAE2822.cfg b/TestCases/cont_adj_rans/rae2822/turb_SA_RAE2822.cfg
index f40989f5064..a434b460159 100644
--- a/TestCases/cont_adj_rans/rae2822/turb_SA_RAE2822.cfg
+++ b/TestCases/cont_adj_rans/rae2822/turb_SA_RAE2822.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: 5/15/2013 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/control_surface/inv_ONERAM6_moving.cfg b/TestCases/control_surface/inv_ONERAM6_moving.cfg
index a5874ceada3..9234a272406 100644
--- a/TestCases/control_surface/inv_ONERAM6_moving.cfg
+++ b/TestCases/control_surface/inv_ONERAM6_moving.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 09.07.2011 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/control_surface/inv_ONERAM6_setting.cfg b/TestCases/control_surface/inv_ONERAM6_setting.cfg
index 2f1d7ab3023..244383bc307 100644
--- a/TestCases/control_surface/inv_ONERAM6_setting.cfg
+++ b/TestCases/control_surface/inv_ONERAM6_setting.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 09.07.2011 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/ddes/flatplate/ddes_flatplate.cfg b/TestCases/ddes/flatplate/ddes_flatplate.cfg
index d0b56480136..5ebc821109d 100644
--- a/TestCases/ddes/flatplate/ddes_flatplate.cfg
+++ b/TestCases/ddes/flatplate/ddes_flatplate.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2011.11.10 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/deformation/cylindrical_ffd/def_cylindrical.cfg b/TestCases/deformation/cylindrical_ffd/def_cylindrical.cfg
index a00fcc71308..a5a2b071d5b 100644
--- a/TestCases/deformation/cylindrical_ffd/def_cylindrical.cfg
+++ b/TestCases/deformation/cylindrical_ffd/def_cylindrical.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: 5/15/2013 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/deformation/naca0012/def_NACA0012.cfg b/TestCases/deformation/naca0012/def_NACA0012.cfg
index d13acfebbfd..237649bcff9 100644
--- a/TestCases/deformation/naca0012/def_NACA0012.cfg
+++ b/TestCases/deformation/naca0012/def_NACA0012.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2014.06.11 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/deformation/naca0012/surface_file_NACA0012.cfg b/TestCases/deformation/naca0012/surface_file_NACA0012.cfg
index 6d5e142b441..38c2686b7b6 100644
--- a/TestCases/deformation/naca0012/surface_file_NACA0012.cfg
+++ b/TestCases/deformation/naca0012/surface_file_NACA0012.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2014.06.11 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/deformation/naca4412/def_NACA4412.cfg b/TestCases/deformation/naca4412/def_NACA4412.cfg
index cb98b56ecb4..21574c36151 100644
--- a/TestCases/deformation/naca4412/def_NACA4412.cfg
+++ b/TestCases/deformation/naca4412/def_NACA4412.cfg
@@ -6,7 +6,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2016.05.06 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/deformation/rae2822/def_RAE2822.cfg b/TestCases/deformation/rae2822/def_RAE2822.cfg
index 710c5d2c308..f335445d751 100644
--- a/TestCases/deformation/rae2822/def_RAE2822.cfg
+++ b/TestCases/deformation/rae2822/def_RAE2822.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: 5/15/2013 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/deformation/spherical_ffd/def_spherical.cfg b/TestCases/deformation/spherical_ffd/def_spherical.cfg
index 2717d372e1c..76f747ad6fc 100644
--- a/TestCases/deformation/spherical_ffd/def_spherical.cfg
+++ b/TestCases/deformation/spherical_ffd/def_spherical.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: 5/15/2013 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/deformation/spherical_ffd/def_spherical_bspline.cfg b/TestCases/deformation/spherical_ffd/def_spherical_bspline.cfg
index 878226806f4..af96e91c9b1 100644
--- a/TestCases/deformation/spherical_ffd/def_spherical_bspline.cfg
+++ b/TestCases/deformation/spherical_ffd/def_spherical_bspline.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: 5/15/2013 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/disc_adj_euler/cylinder3D/inv_cylinder3D.cfg b/TestCases/disc_adj_euler/cylinder3D/inv_cylinder3D.cfg
index 0ca25328f85..ce67c9b4b57 100644
--- a/TestCases/disc_adj_euler/cylinder3D/inv_cylinder3D.cfg
+++ b/TestCases/disc_adj_euler/cylinder3D/inv_cylinder3D.cfg
@@ -5,7 +5,7 @@
% Author: ___________________________________________________________________ %
% Institution: ______________________________________________________________ %
% Date: __________ %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/disc_adj_euler/oneram6/inv_ONERAM6.cfg b/TestCases/disc_adj_euler/oneram6/inv_ONERAM6.cfg
index 0ad3d1d6515..65d3a91bfe7 100644
--- a/TestCases/disc_adj_euler/oneram6/inv_ONERAM6.cfg
+++ b/TestCases/disc_adj_euler/oneram6/inv_ONERAM6.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios, Heather Kline %
% Institution: Stanford University %
% Date: 01.17.2017 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/disc_adj_fea/configAD_fem.cfg b/TestCases/disc_adj_fea/configAD_fem.cfg
index b6e96e13590..7211b34b5f7 100644
--- a/TestCases/disc_adj_fea/configAD_fem.cfg
+++ b/TestCases/disc_adj_fea/configAD_fem.cfg
@@ -4,7 +4,7 @@
% Author: R.Sanchez %
% Institution: Imperial College London %
% Date: 2017.11.29 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
SOLVER= ELASTICITY
diff --git a/TestCases/disc_adj_fsi/configFEA.cfg b/TestCases/disc_adj_fsi/configFEA.cfg
index a06a39fac28..5106c504075 100644
--- a/TestCases/disc_adj_fsi/configFEA.cfg
+++ b/TestCases/disc_adj_fsi/configFEA.cfg
@@ -4,7 +4,7 @@
% Author: R.Sanchez %
% Institution: Imperial College London %
% Date: 2017.11.29 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
SOLVER= ELASTICITY
diff --git a/TestCases/disc_adj_fsi/configFlow.cfg b/TestCases/disc_adj_fsi/configFlow.cfg
index ae108876bd3..5b1d91c1be1 100644
--- a/TestCases/disc_adj_fsi/configFlow.cfg
+++ b/TestCases/disc_adj_fsi/configFlow.cfg
@@ -4,7 +4,7 @@
% Author: R.Sanchez %
% Institution: Imperial College London %
% Date: 2017.11.29 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
SOLVER= NAVIER_STOKES
diff --git a/TestCases/disc_adj_heat/disc_adj_heat.cfg b/TestCases/disc_adj_heat/disc_adj_heat.cfg
index 9f57eda9993..f708e010951 100644
--- a/TestCases/disc_adj_heat/disc_adj_heat.cfg
+++ b/TestCases/disc_adj_heat/disc_adj_heat.cfg
@@ -6,7 +6,7 @@
% Author: Ole Burghardt %
% Institution: Chair for Scientific Computing, TU Kaiserslautern %
% Date: November 26th, 2018 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/disc_adj_incomp_euler/naca0012/incomp_NACA0012_disc.cfg b/TestCases/disc_adj_incomp_euler/naca0012/incomp_NACA0012_disc.cfg
index d7fd4a6a180..e23f83ed910 100644
--- a/TestCases/disc_adj_incomp_euler/naca0012/incomp_NACA0012_disc.cfg
+++ b/TestCases/disc_adj_incomp_euler/naca0012/incomp_NACA0012_disc.cfg
@@ -4,7 +4,7 @@
% Case description: Subsonic incompressible inviscid flow around a NACA0012 %
% Author: Thomas D. Economon %
% Date: 2018.10.30 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/disc_adj_incomp_navierstokes/cylinder/heated_cylinder.cfg b/TestCases/disc_adj_incomp_navierstokes/cylinder/heated_cylinder.cfg
index 69485bc41d9..60c8139f98c 100644
--- a/TestCases/disc_adj_incomp_navierstokes/cylinder/heated_cylinder.cfg
+++ b/TestCases/disc_adj_incomp_navierstokes/cylinder/heated_cylinder.cfg
@@ -4,7 +4,7 @@
% Case description: Steady incompressible laminar flow past a heated cylinder %
% Author: Thomas D. Economon %
% Date: 2018.06.10 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/disc_adj_incomp_rans/naca0012/turb_naca0012_sa.cfg b/TestCases/disc_adj_incomp_rans/naca0012/turb_naca0012_sa.cfg
index b6591fef723..919ce23a2e1 100755
--- a/TestCases/disc_adj_incomp_rans/naca0012/turb_naca0012_sa.cfg
+++ b/TestCases/disc_adj_incomp_rans/naca0012/turb_naca0012_sa.cfg
@@ -5,7 +5,7 @@
% http://turbmodels.larc.nasa.gov/naca0012_val_sa.html %
% Author: Thomas D. Economon & Francisco Palacios %
% Date: 2018.06.10 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/disc_adj_incomp_rans/naca0012/turb_naca0012_sst.cfg b/TestCases/disc_adj_incomp_rans/naca0012/turb_naca0012_sst.cfg
index d615f549ff2..6393a25ea83 100755
--- a/TestCases/disc_adj_incomp_rans/naca0012/turb_naca0012_sst.cfg
+++ b/TestCases/disc_adj_incomp_rans/naca0012/turb_naca0012_sst.cfg
@@ -5,7 +5,7 @@
% http://turbmodels.larc.nasa.gov/naca0012_val_sst.html %
% Author: Thomas D. Economon & Francisco Palacios %
% Date: 2018.06.10 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/disc_adj_rans/naca0012/naca0012.cfg b/TestCases/disc_adj_rans/naca0012/naca0012.cfg
index d09767d292a..4c9a1e86b7a 100644
--- a/TestCases/disc_adj_rans/naca0012/naca0012.cfg
+++ b/TestCases/disc_adj_rans/naca0012/naca0012.cfg
@@ -5,7 +5,7 @@
% Author: Steffen Schotthöfer %
% Institution: TU Kaiserslautern %
% Date: Mar 16, 2017 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/euler/CRM/inv_CRM_JST.cfg b/TestCases/euler/CRM/inv_CRM_JST.cfg
index 714e87e9619..336a3de0424 100644
--- a/TestCases/euler/CRM/inv_CRM_JST.cfg
+++ b/TestCases/euler/CRM/inv_CRM_JST.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2012.10.07 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/euler/biparabolic/BIPARABOLIC.cfg b/TestCases/euler/biparabolic/BIPARABOLIC.cfg
index d4e82c83bdb..44c033f3567 100644
--- a/TestCases/euler/biparabolic/BIPARABOLIC.cfg
+++ b/TestCases/euler/biparabolic/BIPARABOLIC.cfg
@@ -5,7 +5,7 @@
% Author: Trent W. Lukaczyk %
% Institution: Stanford University %
% Date: 2012.08.16 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/euler/channel/inv_channel.cfg b/TestCases/euler/channel/inv_channel.cfg
index fc12e26bec1..5f6d169a93b 100644
--- a/TestCases/euler/channel/inv_channel.cfg
+++ b/TestCases/euler/channel/inv_channel.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2012.09.29 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/euler/channel/inv_channel_RK.cfg b/TestCases/euler/channel/inv_channel_RK.cfg
index 25f1bab4056..f51a9465eba 100644
--- a/TestCases/euler/channel/inv_channel_RK.cfg
+++ b/TestCases/euler/channel/inv_channel_RK.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2012.10.07 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/euler/naca0012/inv_NACA0012.cfg b/TestCases/euler/naca0012/inv_NACA0012.cfg
index e1a1d45112d..e09e6d323a6 100644
--- a/TestCases/euler/naca0012/inv_NACA0012.cfg
+++ b/TestCases/euler/naca0012/inv_NACA0012.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2014.06.11 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/euler/naca0012/inv_NACA0012_Roe.cfg b/TestCases/euler/naca0012/inv_NACA0012_Roe.cfg
index 645dac16c57..c3e78b809b7 100644
--- a/TestCases/euler/naca0012/inv_NACA0012_Roe.cfg
+++ b/TestCases/euler/naca0012/inv_NACA0012_Roe.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2012.10.07 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/euler/oneram6/inv_ONERAM6.cfg b/TestCases/euler/oneram6/inv_ONERAM6.cfg
index b70c03b4f42..994d0972a4f 100644
--- a/TestCases/euler/oneram6/inv_ONERAM6.cfg
+++ b/TestCases/euler/oneram6/inv_ONERAM6.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2015.08.25 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/euler/wedge/inv_wedge_HLLC.cfg b/TestCases/euler/wedge/inv_wedge_HLLC.cfg
index 4941d153bbc..1ca52a45772 100644
--- a/TestCases/euler/wedge/inv_wedge_HLLC.cfg
+++ b/TestCases/euler/wedge/inv_wedge_HLLC.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2012.10.07 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/fea_fsi/Airfoil_RBF/configFEA.cfg b/TestCases/fea_fsi/Airfoil_RBF/configFEA.cfg
index a0254de7d6e..9d8608e5a64 100644
--- a/TestCases/fea_fsi/Airfoil_RBF/configFEA.cfg
+++ b/TestCases/fea_fsi/Airfoil_RBF/configFEA.cfg
@@ -2,7 +2,7 @@
% SU2 configuration file %
% Case description: 2D airfoil FSI with radial basis function interp. %
% Institution: Imperial College London %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
%
% Interface options ---------------------------------------------------- %
diff --git a/TestCases/fea_fsi/Airfoil_RBF/configFlow.cfg b/TestCases/fea_fsi/Airfoil_RBF/configFlow.cfg
index 3f3849f8994..97d415216b0 100644
--- a/TestCases/fea_fsi/Airfoil_RBF/configFlow.cfg
+++ b/TestCases/fea_fsi/Airfoil_RBF/configFlow.cfg
@@ -2,7 +2,7 @@
% SU2 configuration file %
% Case description: 2D airfoil FSI with radial basis function interp. %
% Institution: Imperial College London %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
%
% Interface options ---------------------------------------------------- %
diff --git a/TestCases/fea_fsi/DynBeam_2d/configBeam_2d.cfg b/TestCases/fea_fsi/DynBeam_2d/configBeam_2d.cfg
index c9444eec576..bee4b761f66 100644
--- a/TestCases/fea_fsi/DynBeam_2d/configBeam_2d.cfg
+++ b/TestCases/fea_fsi/DynBeam_2d/configBeam_2d.cfg
@@ -4,7 +4,7 @@
% Author: Ruben Sanchez Fernandez %
% Institution: Imperial College London %
% Date: 2016.02.01 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
SOLVER= ELASTICITY
diff --git a/TestCases/fea_fsi/MixElemsKnowles/config.cfg b/TestCases/fea_fsi/MixElemsKnowles/config.cfg
index c18c69d3b28..a983d3c69fa 100644
--- a/TestCases/fea_fsi/MixElemsKnowles/config.cfg
+++ b/TestCases/fea_fsi/MixElemsKnowles/config.cfg
@@ -4,7 +4,7 @@
% Case description: Tip-loaded 3D cantilever beam, mix of element types, %
% nonlinear elasticity with Knowles material model. %
% Institution: Imperial College London %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
%
diff --git a/TestCases/fea_fsi/StatBeam_3d/configBeam_3d.cfg b/TestCases/fea_fsi/StatBeam_3d/configBeam_3d.cfg
index d1ea8003c90..40aadb1cb70 100644
--- a/TestCases/fea_fsi/StatBeam_3d/configBeam_3d.cfg
+++ b/TestCases/fea_fsi/StatBeam_3d/configBeam_3d.cfg
@@ -4,7 +4,7 @@
% Author: Ruben Sanchez Fernandez %
% Institution: Imperial College London %
% Date: 2016.02.01 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
SOLVER= ELASTICITY
diff --git a/TestCases/fea_topology/config.cfg b/TestCases/fea_topology/config.cfg
index 94c1e956f3f..e541c15a184 100644
--- a/TestCases/fea_topology/config.cfg
+++ b/TestCases/fea_topology/config.cfg
@@ -2,7 +2,7 @@
% SU2 configuration file %
% Case description: 4 by 1 cantilever optim. for stiff. @ 50% material %
% Institution: Imperial College London %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
%
% Optimization
diff --git a/TestCases/gust/inv_gust_NACA0012.cfg b/TestCases/gust/inv_gust_NACA0012.cfg
index c3d44d24692..17d8ec72dbb 100644
--- a/TestCases/gust/inv_gust_NACA0012.cfg
+++ b/TestCases/gust/inv_gust_NACA0012.cfg
@@ -5,7 +5,7 @@
% Author: Santiago Padron %
% Institution: Stanford University %
% Date: 06-26-2015 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/harmonic_balance/HB.cfg b/TestCases/harmonic_balance/HB.cfg
index a944f9383b7..9dfcb122b4a 100644
--- a/TestCases/harmonic_balance/HB.cfg
+++ b/TestCases/harmonic_balance/HB.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2016.20.09 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/harmonic_balance/hb_rans_preconditioning/davis.cfg b/TestCases/harmonic_balance/hb_rans_preconditioning/davis.cfg
index 1c2e5908ae2..5ee0581dd9e 100644
--- a/TestCases/harmonic_balance/hb_rans_preconditioning/davis.cfg
+++ b/TestCases/harmonic_balance/hb_rans_preconditioning/davis.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2016.20.09 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/hom_euler/NACA0012_3D_Hybrid_4thOrder/fem_NACA0012.cfg b/TestCases/hom_euler/NACA0012_3D_Hybrid_4thOrder/fem_NACA0012.cfg
index f0c08c37757..3ae0b6beb02 100644
--- a/TestCases/hom_euler/NACA0012_3D_Hybrid_4thOrder/fem_NACA0012.cfg
+++ b/TestCases/hom_euler/NACA0012_3D_Hybrid_4thOrder/fem_NACA0012.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2014.06.11 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/hom_euler/NACA0012_5thOrder/fem_NACA0012.cfg b/TestCases/hom_euler/NACA0012_5thOrder/fem_NACA0012.cfg
index 8d021825041..18140671830 100644
--- a/TestCases/hom_euler/NACA0012_5thOrder/fem_NACA0012.cfg
+++ b/TestCases/hom_euler/NACA0012_5thOrder/fem_NACA0012.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2014.06.11 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/hom_euler/NACA0012_5thOrder/fem_NACA0012_reg.cfg b/TestCases/hom_euler/NACA0012_5thOrder/fem_NACA0012_reg.cfg
index 17297d1ed8d..c6b91e727d5 100644
--- a/TestCases/hom_euler/NACA0012_5thOrder/fem_NACA0012_reg.cfg
+++ b/TestCases/hom_euler/NACA0012_5thOrder/fem_NACA0012_reg.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2014.06.11 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/hom_euler/Sphere_4thOrder_Hexa/fem_Sphere.cfg b/TestCases/hom_euler/Sphere_4thOrder_Hexa/fem_Sphere.cfg
index 78d4ec2b022..e16acb08163 100644
--- a/TestCases/hom_euler/Sphere_4thOrder_Hexa/fem_Sphere.cfg
+++ b/TestCases/hom_euler/Sphere_4thOrder_Hexa/fem_Sphere.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2014.06.11 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/hom_euler/Sphere_4thOrder_Tet/fem_Sphere.cfg b/TestCases/hom_euler/Sphere_4thOrder_Tet/fem_Sphere.cfg
index 3aa873d3a7d..6bace675413 100644
--- a/TestCases/hom_euler/Sphere_4thOrder_Tet/fem_Sphere.cfg
+++ b/TestCases/hom_euler/Sphere_4thOrder_Tet/fem_Sphere.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2014.06.11 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/hom_euler/SubsonicChannel/nPoly1/fem_SubsonicChannel.cfg b/TestCases/hom_euler/SubsonicChannel/nPoly1/fem_SubsonicChannel.cfg
index 3bce52ca758..de36771e973 100644
--- a/TestCases/hom_euler/SubsonicChannel/nPoly1/fem_SubsonicChannel.cfg
+++ b/TestCases/hom_euler/SubsonicChannel/nPoly1/fem_SubsonicChannel.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2014.06.11 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/hom_euler/SubsonicChannel/nPoly1/fem_SubsonicChannel_Farfield.cfg b/TestCases/hom_euler/SubsonicChannel/nPoly1/fem_SubsonicChannel_Farfield.cfg
index a6031c6ef54..55ee0a156fc 100644
--- a/TestCases/hom_euler/SubsonicChannel/nPoly1/fem_SubsonicChannel_Farfield.cfg
+++ b/TestCases/hom_euler/SubsonicChannel/nPoly1/fem_SubsonicChannel_Farfield.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2014.06.11 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/hom_euler/SubsonicChannel/nPoly2/fem_SubsonicChannel.cfg b/TestCases/hom_euler/SubsonicChannel/nPoly2/fem_SubsonicChannel.cfg
index eeacdcd6a64..d92e605ee0f 100644
--- a/TestCases/hom_euler/SubsonicChannel/nPoly2/fem_SubsonicChannel.cfg
+++ b/TestCases/hom_euler/SubsonicChannel/nPoly2/fem_SubsonicChannel.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2014.06.11 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/hom_euler/SubsonicChannel/nPoly2/fem_SubsonicChannel_Farfield.cfg b/TestCases/hom_euler/SubsonicChannel/nPoly2/fem_SubsonicChannel_Farfield.cfg
index 30f2279fb85..eabc7275c6f 100644
--- a/TestCases/hom_euler/SubsonicChannel/nPoly2/fem_SubsonicChannel_Farfield.cfg
+++ b/TestCases/hom_euler/SubsonicChannel/nPoly2/fem_SubsonicChannel_Farfield.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2014.06.11 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/hom_euler/SubsonicChannel/nPoly4/fem_SubsonicChannel.cfg b/TestCases/hom_euler/SubsonicChannel/nPoly4/fem_SubsonicChannel.cfg
index 88702865987..31c47cb59ca 100644
--- a/TestCases/hom_euler/SubsonicChannel/nPoly4/fem_SubsonicChannel.cfg
+++ b/TestCases/hom_euler/SubsonicChannel/nPoly4/fem_SubsonicChannel.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2014.06.11 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/hom_euler/SubsonicChannel/nPoly4/fem_SubsonicChannel_Farfield.cfg b/TestCases/hom_euler/SubsonicChannel/nPoly4/fem_SubsonicChannel_Farfield.cfg
index c16ab4b6d79..84aad1673ee 100644
--- a/TestCases/hom_euler/SubsonicChannel/nPoly4/fem_SubsonicChannel_Farfield.cfg
+++ b/TestCases/hom_euler/SubsonicChannel/nPoly4/fem_SubsonicChannel_Farfield.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2014.06.11 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/hom_navierstokes/CylinderViscous/nPoly3/fem_Cylinder_reg.cfg b/TestCases/hom_navierstokes/CylinderViscous/nPoly3/fem_Cylinder_reg.cfg
index b952e1a2a19..002ef01668b 100644
--- a/TestCases/hom_navierstokes/CylinderViscous/nPoly3/fem_Cylinder_reg.cfg
+++ b/TestCases/hom_navierstokes/CylinderViscous/nPoly3/fem_Cylinder_reg.cfg
@@ -5,7 +5,7 @@
% Author: Edwin van der Weide %
% Institution: University of Twente %
% Date: 2016.07.15 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/hom_navierstokes/FlatPlate/nPoly4/lam_flatplate_reg.cfg b/TestCases/hom_navierstokes/FlatPlate/nPoly4/lam_flatplate_reg.cfg
index 28bb98b8065..0dd05452886 100644
--- a/TestCases/hom_navierstokes/FlatPlate/nPoly4/lam_flatplate_reg.cfg
+++ b/TestCases/hom_navierstokes/FlatPlate/nPoly4/lam_flatplate_reg.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2013.09.30 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/hom_navierstokes/SphereViscous/nPoly3_QuadDominant/fem_Sphere_reg.cfg b/TestCases/hom_navierstokes/SphereViscous/nPoly3_QuadDominant/fem_Sphere_reg.cfg
index 81902a5478a..50e605568ed 100644
--- a/TestCases/hom_navierstokes/SphereViscous/nPoly3_QuadDominant/fem_Sphere_reg.cfg
+++ b/TestCases/hom_navierstokes/SphereViscous/nPoly3_QuadDominant/fem_Sphere_reg.cfg
@@ -5,7 +5,7 @@
% Author: Edwin van der Weide %
% Institution: University of Twente %
% Date: 2016.07.15 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/hom_navierstokes/SphereViscous/nPoly3_QuadDominant/fem_Sphere_reg_ADER.cfg b/TestCases/hom_navierstokes/SphereViscous/nPoly3_QuadDominant/fem_Sphere_reg_ADER.cfg
index 3547f2855bd..71c22aa583e 100644
--- a/TestCases/hom_navierstokes/SphereViscous/nPoly3_QuadDominant/fem_Sphere_reg_ADER.cfg
+++ b/TestCases/hom_navierstokes/SphereViscous/nPoly3_QuadDominant/fem_Sphere_reg_ADER.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2014.06.11 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/hom_navierstokes/UnsteadyCylinder/nPoly4/fem_unst_cylinder.cfg b/TestCases/hom_navierstokes/UnsteadyCylinder/nPoly4/fem_unst_cylinder.cfg
index 9ed040ca933..40de22f8066 100644
--- a/TestCases/hom_navierstokes/UnsteadyCylinder/nPoly4/fem_unst_cylinder.cfg
+++ b/TestCases/hom_navierstokes/UnsteadyCylinder/nPoly4/fem_unst_cylinder.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2014.06.11 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/hom_navierstokes/UnsteadyCylinder/nPoly4/fem_unst_cylinder_ADER.cfg b/TestCases/hom_navierstokes/UnsteadyCylinder/nPoly4/fem_unst_cylinder_ADER.cfg
index 1d01d02f526..744417f1a5c 100644
--- a/TestCases/hom_navierstokes/UnsteadyCylinder/nPoly4/fem_unst_cylinder_ADER.cfg
+++ b/TestCases/hom_navierstokes/UnsteadyCylinder/nPoly4/fem_unst_cylinder_ADER.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2014.06.11 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/hybrid_regression.py b/TestCases/hybrid_regression.py
index d69473c646f..9e418b76b80 100644
--- a/TestCases/hybrid_regression.py
+++ b/TestCases/hybrid_regression.py
@@ -3,7 +3,7 @@
## \file parallel_regression.py
# \brief Python script for automated regression testing of SU2 examples
# \author A. Aranake, A. Campos, T. Economon, T. Lukaczyk, S. Padron
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/TestCases/incomp_euler/naca0012/incomp_NACA0012.cfg b/TestCases/incomp_euler/naca0012/incomp_NACA0012.cfg
index f8c1dd91eb5..cb374e90f6b 100644
--- a/TestCases/incomp_euler/naca0012/incomp_NACA0012.cfg
+++ b/TestCases/incomp_euler/naca0012/incomp_NACA0012.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: 09/18/2011 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/incomp_euler/nozzle/inv_nozzle.cfg b/TestCases/incomp_euler/nozzle/inv_nozzle.cfg
index c5b6e21df54..20b639b8d86 100644
--- a/TestCases/incomp_euler/nozzle/inv_nozzle.cfg
+++ b/TestCases/incomp_euler/nozzle/inv_nozzle.cfg
@@ -4,7 +4,7 @@
% Case description: Inv. inc. nozzle with pressure inlet and mass flow outlet %
% Author: Thomas D. Economon %
% Date: 2018.11.30 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/incomp_navierstokes/buoyancy_cavity/lam_buoyancy_cavity.cfg b/TestCases/incomp_navierstokes/buoyancy_cavity/lam_buoyancy_cavity.cfg
index 8f07b27a064..474e719298a 100644
--- a/TestCases/incomp_navierstokes/buoyancy_cavity/lam_buoyancy_cavity.cfg
+++ b/TestCases/incomp_navierstokes/buoyancy_cavity/lam_buoyancy_cavity.cfg
@@ -4,7 +4,7 @@
% Case description: Buoyancy-driven flow inside a cavity %
% Author: Thomas D. Economon %
% Date: 2018.06.10 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/incomp_navierstokes/cylinder/incomp_cylinder.cfg b/TestCases/incomp_navierstokes/cylinder/incomp_cylinder.cfg
index c50c80d42c3..2817c932700 100644
--- a/TestCases/incomp_navierstokes/cylinder/incomp_cylinder.cfg
+++ b/TestCases/incomp_navierstokes/cylinder/incomp_cylinder.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: 2012.03.14 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/incomp_navierstokes/cylinder/poly_cylinder.cfg b/TestCases/incomp_navierstokes/cylinder/poly_cylinder.cfg
index 99f14c72867..17438af462b 100644
--- a/TestCases/incomp_navierstokes/cylinder/poly_cylinder.cfg
+++ b/TestCases/incomp_navierstokes/cylinder/poly_cylinder.cfg
@@ -5,7 +5,7 @@
% custom fluid using polynomial fluid models. %
% Author: Thomas D. Economon %
% Date: 2018.12.02 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_2d/DA_configMaster.cfg b/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_2d/DA_configMaster.cfg
index 936f08747a1..ebe8ec21332 100644
--- a/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_2d/DA_configMaster.cfg
+++ b/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_2d/DA_configMaster.cfg
@@ -5,7 +5,7 @@
% Author: T. Kattmann %
% Institution: Robert Bosch GmbH %
% Date: 2020.12.15 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
%
diff --git a/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_2d/FD_configMaster.cfg b/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_2d/FD_configMaster.cfg
index 9c29fb99e4e..63ca0b64f30 100644
--- a/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_2d/FD_configMaster.cfg
+++ b/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_2d/FD_configMaster.cfg
@@ -5,7 +5,7 @@
% Author: T. Kattmann %
% Institution: Robert Bosch GmbH %
% Date: 2020.12.15 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
%
diff --git a/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_2d/configMaster.cfg b/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_2d/configMaster.cfg
index 111367a0e1a..f452de8088b 100644
--- a/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_2d/configMaster.cfg
+++ b/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_2d/configMaster.cfg
@@ -5,7 +5,7 @@
% Author: T. Kattmann %
% Institution: Robert Bosch GmbH %
% Date: 2020.12.15 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
%
diff --git a/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_2d/configSolid.cfg b/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_2d/configSolid.cfg
index fa52f63e3f9..3b49b93125e 100644
--- a/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_2d/configSolid.cfg
+++ b/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_2d/configSolid.cfg
@@ -5,7 +5,7 @@
% Author: T. Kattmann %
% Institution: Robert Bosch GmbH %
% Date: 2020.12.15 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
%
diff --git a/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_3d/configFluid.cfg b/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_3d/configFluid.cfg
index 7ef30f52a04..b7ef1fa5a75 100644
--- a/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_3d/configFluid.cfg
+++ b/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_3d/configFluid.cfg
@@ -5,7 +5,7 @@
% Author: T. Kattmann %
% Institution: Robert Bosch GmbH %
% Date: 07.06.2019 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
%
diff --git a/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_3d/configMaster.cfg b/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_3d/configMaster.cfg
index 621ec559cd6..fac9c99f4c6 100644
--- a/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_3d/configMaster.cfg
+++ b/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_3d/configMaster.cfg
@@ -5,7 +5,7 @@
% Author: T. Kattmann %
% Institution: Robert Bosch GmbH %
% Date: 2020.12.15 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
%
diff --git a/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_3d/configSolid.cfg b/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_3d/configSolid.cfg
index c4eb21b915c..a1362711f77 100644
--- a/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_3d/configSolid.cfg
+++ b/TestCases/incomp_navierstokes/streamwise_periodic/chtPinArray_3d/configSolid.cfg
@@ -5,7 +5,7 @@
% Author: T. Kattmann %
% Institution: Robert Bosch GmbH %
% Date: 07.06.2019 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
%
diff --git a/TestCases/incomp_navierstokes/streamwise_periodic/pipeSlice_3d/sp_pipeSlice_3d_dp_hf_tp.cfg b/TestCases/incomp_navierstokes/streamwise_periodic/pipeSlice_3d/sp_pipeSlice_3d_dp_hf_tp.cfg
index ffba18c797f..249beb91e71 100644
--- a/TestCases/incomp_navierstokes/streamwise_periodic/pipeSlice_3d/sp_pipeSlice_3d_dp_hf_tp.cfg
+++ b/TestCases/incomp_navierstokes/streamwise_periodic/pipeSlice_3d/sp_pipeSlice_3d_dp_hf_tp.cfg
@@ -5,7 +5,7 @@
% Author: T. Kattmann %
% Institution: Robert Bosch GmbH %
% Date: 2020.12.14 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/incomp_rans/naca0012/naca0012.cfg b/TestCases/incomp_rans/naca0012/naca0012.cfg
index b49ec5a95c7..5cd1ee3b0ad 100644
--- a/TestCases/incomp_rans/naca0012/naca0012.cfg
+++ b/TestCases/incomp_rans/naca0012/naca0012.cfg
@@ -6,7 +6,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: Feb 18th, 2013 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/incomp_rans/naca0012/naca0012_SST_SUST.cfg b/TestCases/incomp_rans/naca0012/naca0012_SST_SUST.cfg
index a4861b05b81..73392f31c69 100644
--- a/TestCases/incomp_rans/naca0012/naca0012_SST_SUST.cfg
+++ b/TestCases/incomp_rans/naca0012/naca0012_SST_SUST.cfg
@@ -6,7 +6,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: Feb 18th, 2013 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/mms/fvm_incomp_euler/inv_mms_jst.cfg b/TestCases/mms/fvm_incomp_euler/inv_mms_jst.cfg
index d8331a7080a..e52d87969f9 100755
--- a/TestCases/mms/fvm_incomp_euler/inv_mms_jst.cfg
+++ b/TestCases/mms/fvm_incomp_euler/inv_mms_jst.cfg
@@ -4,7 +4,7 @@
% Case description: Incompressible inviscid MMS test case %
% Author: Thomas D. Economon %
% Date: 2019.04.09 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/mms/fvm_incomp_navierstokes/lam_mms_fds.cfg b/TestCases/mms/fvm_incomp_navierstokes/lam_mms_fds.cfg
index 20a25bbd8aa..a361a2e7933 100755
--- a/TestCases/mms/fvm_incomp_navierstokes/lam_mms_fds.cfg
+++ b/TestCases/mms/fvm_incomp_navierstokes/lam_mms_fds.cfg
@@ -4,7 +4,7 @@
% Case description: Incompressible laminar MMS test case %
% Author: Thomas D. Economon %
% Date: 2019.04.09 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/mms/fvm_navierstokes/lam_mms_roe.cfg b/TestCases/mms/fvm_navierstokes/lam_mms_roe.cfg
index a55057a7b20..a571fe89562 100755
--- a/TestCases/mms/fvm_navierstokes/lam_mms_roe.cfg
+++ b/TestCases/mms/fvm_navierstokes/lam_mms_roe.cfg
@@ -4,7 +4,7 @@
% Case description: Compressible laminar MMS test case %
% Author: Thomas D. Economon %
% Date: 2019.04.09 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/moving_wall/cavity/lam_cavity.cfg b/TestCases/moving_wall/cavity/lam_cavity.cfg
index f6f7378821e..dd68814dc41 100644
--- a/TestCases/moving_wall/cavity/lam_cavity.cfg
+++ b/TestCases/moving_wall/cavity/lam_cavity.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2013.10.01 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/moving_wall/spinning_cylinder/spinning_cylinder.cfg b/TestCases/moving_wall/spinning_cylinder/spinning_cylinder.cfg
index 534193074e4..88af508918a 100644
--- a/TestCases/moving_wall/spinning_cylinder/spinning_cylinder.cfg
+++ b/TestCases/moving_wall/spinning_cylinder/spinning_cylinder.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2013.08.21 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/multiple_ffd/naca0012/inv_NACA0012_ffd.cfg b/TestCases/multiple_ffd/naca0012/inv_NACA0012_ffd.cfg
index 9b28228fc94..805bc713066 100644
--- a/TestCases/multiple_ffd/naca0012/inv_NACA0012_ffd.cfg
+++ b/TestCases/multiple_ffd/naca0012/inv_NACA0012_ffd.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios, Charanya Venkatesan-Crome %
% Institution: Stanford University %
% Date: 2018.07.23 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/navierstokes/cylinder/cylinder_lowmach.cfg b/TestCases/navierstokes/cylinder/cylinder_lowmach.cfg
index db91c5d4bdd..de990f8c225 100644
--- a/TestCases/navierstokes/cylinder/cylinder_lowmach.cfg
+++ b/TestCases/navierstokes/cylinder/cylinder_lowmach.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2013.09.30 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/navierstokes/cylinder/lam_cylinder.cfg b/TestCases/navierstokes/cylinder/lam_cylinder.cfg
index 9672ff6f3e0..b5e7d9cc60d 100644
--- a/TestCases/navierstokes/cylinder/lam_cylinder.cfg
+++ b/TestCases/navierstokes/cylinder/lam_cylinder.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2013.09.30 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/navierstokes/flatplate/lam_flatplate.cfg b/TestCases/navierstokes/flatplate/lam_flatplate.cfg
index 5712c970bff..7b470bd118d 100644
--- a/TestCases/navierstokes/flatplate/lam_flatplate.cfg
+++ b/TestCases/navierstokes/flatplate/lam_flatplate.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2013.09.30 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/navierstokes/naca0012/lam_NACA0012.cfg b/TestCases/navierstokes/naca0012/lam_NACA0012.cfg
index 3e144f7e237..9545f582201 100644
--- a/TestCases/navierstokes/naca0012/lam_NACA0012.cfg
+++ b/TestCases/navierstokes/naca0012/lam_NACA0012.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: Sep 28, 2012 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/navierstokes/poiseuille/lam_poiseuille.cfg b/TestCases/navierstokes/poiseuille/lam_poiseuille.cfg
index 01d165056d0..0aba572cd34 100644
--- a/TestCases/navierstokes/poiseuille/lam_poiseuille.cfg
+++ b/TestCases/navierstokes/poiseuille/lam_poiseuille.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2017.02.27 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/nicf/edge/edge_PPR.cfg b/TestCases/nicf/edge/edge_PPR.cfg
index d1429547720..c0924e6b139 100644
--- a/TestCases/nicf/edge/edge_PPR.cfg
+++ b/TestCases/nicf/edge/edge_PPR.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2012.09.29 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/nicf/edge/edge_VW.cfg b/TestCases/nicf/edge/edge_VW.cfg
index 3b068bd61bb..2a2e2bbcace 100644
--- a/TestCases/nicf/edge/edge_VW.cfg
+++ b/TestCases/nicf/edge/edge_VW.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2012.09.29 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/nonequilibrium/invwedge/invwedge.cfg b/TestCases/nonequilibrium/invwedge/invwedge.cfg
index f783a7fb799..bedfd32f6c7 100644
--- a/TestCases/nonequilibrium/invwedge/invwedge.cfg
+++ b/TestCases/nonequilibrium/invwedge/invwedge.cfg
@@ -5,7 +5,7 @@
% Author: C. Garbacz %
% Institution: Strathclyde University %
% Date: 2020.11.01 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/nonequilibrium/viscwedge/viscwedge.cfg b/TestCases/nonequilibrium/viscwedge/viscwedge.cfg
index 1a70c027391..df60ff248c2 100644
--- a/TestCases/nonequilibrium/viscwedge/viscwedge.cfg
+++ b/TestCases/nonequilibrium/viscwedge/viscwedge.cfg
@@ -5,7 +5,7 @@
% Author: C. Garbacz %
% Institution: Strathclyde University %
% Date: 2020.11.01 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/nonequilibrium/viscwedge_mpp/viscwedge_mpp.cfg b/TestCases/nonequilibrium/viscwedge_mpp/viscwedge_mpp.cfg
index d81488cc453..b230e52a280 100644
--- a/TestCases/nonequilibrium/viscwedge_mpp/viscwedge_mpp.cfg
+++ b/TestCases/nonequilibrium/viscwedge_mpp/viscwedge_mpp.cfg
@@ -5,7 +5,7 @@
% Author: C. Garbacz %
% Institution: Strathclyde University %
% Date: 2020.11.01 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/optimization_euler/multiobjective_wedge/inv_wedge_ROE_2surf_1obj.cfg b/TestCases/optimization_euler/multiobjective_wedge/inv_wedge_ROE_2surf_1obj.cfg
index 41cd1505c4e..75081c5600d 100644
--- a/TestCases/optimization_euler/multiobjective_wedge/inv_wedge_ROE_2surf_1obj.cfg
+++ b/TestCases/optimization_euler/multiobjective_wedge/inv_wedge_ROE_2surf_1obj.cfg
@@ -7,7 +7,7 @@
% Author: H.L. Kline, modified from inviscid wedge by Thomas D. Economon %
% Institution: Stanford University %
% Date: 2018.01.07 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/optimization_euler/multiobjective_wedge/inv_wedge_ROE_multiobj.cfg b/TestCases/optimization_euler/multiobjective_wedge/inv_wedge_ROE_multiobj.cfg
index 40d5597280d..94ebce1f915 100644
--- a/TestCases/optimization_euler/multiobjective_wedge/inv_wedge_ROE_multiobj.cfg
+++ b/TestCases/optimization_euler/multiobjective_wedge/inv_wedge_ROE_multiobj.cfg
@@ -8,7 +8,7 @@
% Author: H.L. Kline, modified from inviscid wedge by Thomas D. Economon %
% Institution: Stanford University %
% Date: 2018.01.07 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/optimization_euler/multiobjective_wedge/inv_wedge_ROE_multiobj_1surf.cfg b/TestCases/optimization_euler/multiobjective_wedge/inv_wedge_ROE_multiobj_1surf.cfg
index a4165b7d9dc..322bee977cc 100644
--- a/TestCases/optimization_euler/multiobjective_wedge/inv_wedge_ROE_multiobj_1surf.cfg
+++ b/TestCases/optimization_euler/multiobjective_wedge/inv_wedge_ROE_multiobj_1surf.cfg
@@ -8,7 +8,7 @@
% Author: H.L. Kline, modified from inviscid wedge by Thomas D. Economon %
% Institution: Stanford University %
% Date: 2018.01.07 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/optimization_euler/multiobjective_wedge/inv_wedge_ROE_multiobj_combo.cfg b/TestCases/optimization_euler/multiobjective_wedge/inv_wedge_ROE_multiobj_combo.cfg
index 8affe19a7db..a724e5c6d18 100644
--- a/TestCases/optimization_euler/multiobjective_wedge/inv_wedge_ROE_multiobj_combo.cfg
+++ b/TestCases/optimization_euler/multiobjective_wedge/inv_wedge_ROE_multiobj_combo.cfg
@@ -10,7 +10,7 @@
% Author: H.L. Kline, modified from inviscid wedge by Thomas D. Economon %
% Institution: Stanford University %
% Date: 2018.01.07 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/optimization_euler/multipoint_naca0012/inv_NACA0012_multipoint.cfg b/TestCases/optimization_euler/multipoint_naca0012/inv_NACA0012_multipoint.cfg
index da556c2ab1c..bcc58353134 100644
--- a/TestCases/optimization_euler/multipoint_naca0012/inv_NACA0012_multipoint.cfg
+++ b/TestCases/optimization_euler/multipoint_naca0012/inv_NACA0012_multipoint.cfg
@@ -5,7 +5,7 @@
% Author: Indiana Stokes %
% Institution: %
% Date: 2017.07.03 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/optimization_euler/pitching_naca64a010/pitching_NACA64A010.cfg b/TestCases/optimization_euler/pitching_naca64a010/pitching_NACA64A010.cfg
index f5fa022f1b4..c5eb434078d 100644
--- a/TestCases/optimization_euler/pitching_naca64a010/pitching_NACA64A010.cfg
+++ b/TestCases/optimization_euler/pitching_naca64a010/pitching_NACA64A010.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2011.11.02 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/optimization_euler/pitching_oneram6/pitching_ONERAM6.cfg b/TestCases/optimization_euler/pitching_oneram6/pitching_ONERAM6.cfg
index d9ca2a72dd7..5e148350c5b 100644
--- a/TestCases/optimization_euler/pitching_oneram6/pitching_ONERAM6.cfg
+++ b/TestCases/optimization_euler/pitching_oneram6/pitching_ONERAM6.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 09.07.2011 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/optimization_euler/rotating_naca0012/rotating_NACA0012.cfg b/TestCases/optimization_euler/rotating_naca0012/rotating_NACA0012.cfg
index 83801d29d8c..b139c62ffee 100644
--- a/TestCases/optimization_euler/rotating_naca0012/rotating_NACA0012.cfg
+++ b/TestCases/optimization_euler/rotating_naca0012/rotating_NACA0012.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2013.03.06 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/optimization_euler/steady_naca0012/inv_NACA0012_adv.cfg b/TestCases/optimization_euler/steady_naca0012/inv_NACA0012_adv.cfg
index b9778401b9e..6226b16062c 100644
--- a/TestCases/optimization_euler/steady_naca0012/inv_NACA0012_adv.cfg
+++ b/TestCases/optimization_euler/steady_naca0012/inv_NACA0012_adv.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: 2013.09.29 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/optimization_euler/steady_naca0012/inv_NACA0012_basic.cfg b/TestCases/optimization_euler/steady_naca0012/inv_NACA0012_basic.cfg
index bbc1cdd2c9b..856ce071735 100644
--- a/TestCases/optimization_euler/steady_naca0012/inv_NACA0012_basic.cfg
+++ b/TestCases/optimization_euler/steady_naca0012/inv_NACA0012_basic.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: 2013.09.29 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/optimization_euler/steady_oneram6/inv_ONERAM6_adv.cfg b/TestCases/optimization_euler/steady_oneram6/inv_ONERAM6_adv.cfg
index 3d65a14543a..b183a7738f3 100644
--- a/TestCases/optimization_euler/steady_oneram6/inv_ONERAM6_adv.cfg
+++ b/TestCases/optimization_euler/steady_oneram6/inv_ONERAM6_adv.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios, Heather Kline %
% Institution: Stanford University %
% Date: 01.17.2017 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/optimization_euler/steady_oneram6/inv_ONERAM6_basic.cfg b/TestCases/optimization_euler/steady_oneram6/inv_ONERAM6_basic.cfg
index 4a95a416992..7058184e15b 100644
--- a/TestCases/optimization_euler/steady_oneram6/inv_ONERAM6_basic.cfg
+++ b/TestCases/optimization_euler/steady_oneram6/inv_ONERAM6_basic.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios, Heather Kline %
% Institution: Stanford University %
% Date: 01.17.2017 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/optimization_rans/naca0012/naca0012.cfg b/TestCases/optimization_rans/naca0012/naca0012.cfg
index 1d1eaec533d..2d0c373a422 100644
--- a/TestCases/optimization_rans/naca0012/naca0012.cfg
+++ b/TestCases/optimization_rans/naca0012/naca0012.cfg
@@ -5,7 +5,7 @@
% Author: Steffen Schotthöfer %
% Institution: TU Kaiserslautern %
% Date: Mar 16, 2017 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/optimization_rans/pitching_naca64a010/turb_NACA64A010.cfg b/TestCases/optimization_rans/pitching_naca64a010/turb_NACA64A010.cfg
index 082307c57eb..15f61229e8b 100644
--- a/TestCases/optimization_rans/pitching_naca64a010/turb_NACA64A010.cfg
+++ b/TestCases/optimization_rans/pitching_naca64a010/turb_NACA64A010.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2011.11.02 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/optimization_rans/pitching_oneram6/turb_ONERAM6.cfg b/TestCases/optimization_rans/pitching_oneram6/turb_ONERAM6.cfg
index bcd5b3afab3..02dc5dd6480 100644
--- a/TestCases/optimization_rans/pitching_oneram6/turb_ONERAM6.cfg
+++ b/TestCases/optimization_rans/pitching_oneram6/turb_ONERAM6.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2011.11.02 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/optimization_rans/steady_oneram6/turb_ONERAM6.cfg b/TestCases/optimization_rans/steady_oneram6/turb_ONERAM6.cfg
index 8c90a847c61..a078945f5ce 100644
--- a/TestCases/optimization_rans/steady_oneram6/turb_ONERAM6.cfg
+++ b/TestCases/optimization_rans/steady_oneram6/turb_ONERAM6.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: 2011.11.02 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/optimization_rans/steady_rae2822/turb_SA_RAE2822.cfg b/TestCases/optimization_rans/steady_rae2822/turb_SA_RAE2822.cfg
index 2c377163067..99c6487b5b7 100644
--- a/TestCases/optimization_rans/steady_rae2822/turb_SA_RAE2822.cfg
+++ b/TestCases/optimization_rans/steady_rae2822/turb_SA_RAE2822.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: 5/15/2013 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/parallel_regression.py b/TestCases/parallel_regression.py
index 489db0f20d5..0ac0942e97a 100644
--- a/TestCases/parallel_regression.py
+++ b/TestCases/parallel_regression.py
@@ -3,7 +3,7 @@
## \file parallel_regression.py
# \brief Python script for automated regression testing of SU2 examples
# \author A. Aranake, A. Campos, T. Economon, T. Lukaczyk, S. Padron
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/TestCases/parallel_regression_AD.py b/TestCases/parallel_regression_AD.py
index 6cd67b598a0..26b4a8b461e 100644
--- a/TestCases/parallel_regression_AD.py
+++ b/TestCases/parallel_regression_AD.py
@@ -3,7 +3,7 @@
## \file parallel_regression.py
# \brief Python script for automated regression testing of SU2 examples
# \author A. Aranake, A. Campos, T. Economon, T. Lukaczyk, S. Padron
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/TestCases/pastix_support/config.cfg b/TestCases/pastix_support/config.cfg
index bbfab201580..e119d21b9c3 100644
--- a/TestCases/pastix_support/config.cfg
+++ b/TestCases/pastix_support/config.cfg
@@ -2,7 +2,7 @@
% SU2 configuration file %
% PaStiX options (http://pastix.gforge.inria.fr/files/README-txt.html) %
% Institution: Imperial College London %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
%
% Intro:
diff --git a/TestCases/pastix_support/readme.txt b/TestCases/pastix_support/readme.txt
index e8d264b97b6..17f832ae302 100644
--- a/TestCases/pastix_support/readme.txt
+++ b/TestCases/pastix_support/readme.txt
@@ -2,7 +2,7 @@
% SU2 configuration file %
% PaStiX support build instructions. %
% Institution: Imperial College London %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
%
% 1 - Download
diff --git a/TestCases/polar/naca0012/inv_NACA0012.cfg b/TestCases/polar/naca0012/inv_NACA0012.cfg
index 00881bf58dd..9832313a221 100644
--- a/TestCases/polar/naca0012/inv_NACA0012.cfg
+++ b/TestCases/polar/naca0012/inv_NACA0012.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2014.06.11 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/py_wrapper/disc_adj_fea/flow_load_sens/run_adjoint.py b/TestCases/py_wrapper/disc_adj_fea/flow_load_sens/run_adjoint.py
index fe244e692f6..18870e67fe9 100755
--- a/TestCases/py_wrapper/disc_adj_fea/flow_load_sens/run_adjoint.py
+++ b/TestCases/py_wrapper/disc_adj_fea/flow_load_sens/run_adjoint.py
@@ -3,7 +3,7 @@
## \file run_adjoint.py
# \brief Python script to launch SU2_CFD_AD and compute the sensitivity of the FEA problem respect to flow loads.
# \author Ruben Sanchez
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# The current SU2 release has been coordinated by the
# SU2 International Developers Society
diff --git a/TestCases/py_wrapper/disc_adj_flow/mesh_disp_sens/run_adjoint.py b/TestCases/py_wrapper/disc_adj_flow/mesh_disp_sens/run_adjoint.py
index 752458d3a96..88ce70e3112 100755
--- a/TestCases/py_wrapper/disc_adj_flow/mesh_disp_sens/run_adjoint.py
+++ b/TestCases/py_wrapper/disc_adj_flow/mesh_disp_sens/run_adjoint.py
@@ -3,7 +3,7 @@
## \file run_adjoint.py
# \brief Python script to launch SU2_CFD_AD
# \author Ruben Sanchez
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# The current SU2 release has been coordinated by the
# SU2 International Developers Society
diff --git a/TestCases/py_wrapper/flatPlate_rigidMotion/flatPlate_rigidMotion_Conf.cfg b/TestCases/py_wrapper/flatPlate_rigidMotion/flatPlate_rigidMotion_Conf.cfg
index faece71a8ed..cc1dc0b3e6e 100644
--- a/TestCases/py_wrapper/flatPlate_rigidMotion/flatPlate_rigidMotion_Conf.cfg
+++ b/TestCases/py_wrapper/flatPlate_rigidMotion/flatPlate_rigidMotion_Conf.cfg
@@ -5,7 +5,7 @@
% Author: ___________________________________________________________________ %
% Institution: ______________________________________________________________ %
% Date: __________ %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/py_wrapper/flatPlate_rigidMotion/launch_flatPlate_rigidMotion.py b/TestCases/py_wrapper/flatPlate_rigidMotion/launch_flatPlate_rigidMotion.py
index a611e6554d7..e2a1d13f326 100755
--- a/TestCases/py_wrapper/flatPlate_rigidMotion/launch_flatPlate_rigidMotion.py
+++ b/TestCases/py_wrapper/flatPlate_rigidMotion/launch_flatPlate_rigidMotion.py
@@ -3,7 +3,7 @@
## \file flatPlate_rigidMotion.py
# \brief Python script to launch SU2_CFD with customized unsteady boundary conditions using the Python wrapper.
# \author David Thomas
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# The current SU2 release has been coordinated by the
# SU2 International Developers Society
diff --git a/TestCases/py_wrapper/flatPlate_unsteady_CHT/launch_unsteady_CHT_FlatPlate.py b/TestCases/py_wrapper/flatPlate_unsteady_CHT/launch_unsteady_CHT_FlatPlate.py
index 06a3edd2b7e..d58968b0322 100755
--- a/TestCases/py_wrapper/flatPlate_unsteady_CHT/launch_unsteady_CHT_FlatPlate.py
+++ b/TestCases/py_wrapper/flatPlate_unsteady_CHT/launch_unsteady_CHT_FlatPlate.py
@@ -3,7 +3,7 @@
## \file launch_unsteady_CHT_FlatPlate.py
# \brief Python script to launch SU2_CFD with customized unsteady boundary conditions using the Python wrapper.
# \author David Thomas
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# The current SU2 release has been coordinated by the
# SU2 International Developers Society
diff --git a/TestCases/py_wrapper/flatPlate_unsteady_CHT/unsteady_CHT_FlatPlate_Conf.cfg b/TestCases/py_wrapper/flatPlate_unsteady_CHT/unsteady_CHT_FlatPlate_Conf.cfg
index e6f06d2b805..c1781b361ea 100644
--- a/TestCases/py_wrapper/flatPlate_unsteady_CHT/unsteady_CHT_FlatPlate_Conf.cfg
+++ b/TestCases/py_wrapper/flatPlate_unsteady_CHT/unsteady_CHT_FlatPlate_Conf.cfg
@@ -5,7 +5,7 @@
% Author: David THOMAS %
% Institution: University of Liège %
% Date: 12/12/2017 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/radiation/p1adjoint/configp1adjoint.cfg b/TestCases/radiation/p1adjoint/configp1adjoint.cfg
index 7dfb6926bfe..a544cb86437 100644
--- a/TestCases/radiation/p1adjoint/configp1adjoint.cfg
+++ b/TestCases/radiation/p1adjoint/configp1adjoint.cfg
@@ -4,7 +4,7 @@
% Case description: Coupled CFD-RHT adjoint problem %
% Author: Ruben Sanchez (TU Kaiserslautern) %
% Date: 2020-02-13 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/radiation/p1model/configp1.cfg b/TestCases/radiation/p1model/configp1.cfg
index b5a60a0ffcc..35cfe695db1 100644
--- a/TestCases/radiation/p1model/configp1.cfg
+++ b/TestCases/radiation/p1model/configp1.cfg
@@ -5,7 +5,7 @@
% Author: Ruben Sanchez %
% Institution: Chair for Scientific Computing, TU Kaiserslautern %
% Date: 2019-01-29 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/rans/actuatordisk_variable_load/propeller_variable_load.cfg b/TestCases/rans/actuatordisk_variable_load/propeller_variable_load.cfg
index 2c3097ba04b..7e2c33b9873 100644
--- a/TestCases/rans/actuatordisk_variable_load/propeller_variable_load.cfg
+++ b/TestCases/rans/actuatordisk_variable_load/propeller_variable_load.cfg
@@ -1,237 +1,237 @@
-%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
-% %
-% SU2 configuration file %
-% Case description: Actuator Disk with a semi-infinite spinner %
-% Author: E. Saetta, L. Russo, R. Tognaccini %
-% Institution: Theoretical and Applied Aerodynamic Research Group (TAARG) %
-% University of Naples Federico II %
-% Comments: Grid file and propeller data courtesy of Mauro Minervino, %
-% Centro Italiano Ricerche Aerospaziali (CIRA) %
-% Date: 07/08/2020 %
-% File Version 7.1.0 "Blackbird" %
-% %
-%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
-
-%----------- DIRECT, ADJOINT, AND LINEARIZED PROBLEM DEFINITION -------------------------%
-% Solver type (EULER, NAVIER_STOKES, RANS,
-% INC_EULER, INC_NAVIER_STOKES, INC_RANS
-% FEM_EULER, FEM_NAVIER_STOKES, FEM_RANS, FEM_LES,
-% HEAT_EQUATION_FVM, ELASTICITY)
-SOLVER= RANS
-%
-% Specify turbulence model (NONE, SA, SA_NEG, SST, SA_E, SA_COMP, SA_E_COMP, SST_SUST)
-KIND_TURB_MODEL= SA
-%
-% Turbulence intensity at freestream
-FREESTREAM_TURBULENCEINTENSITY=0.01
-%
-% Mathematical problem (DIRECT, CONTINUOUS_ADJOINT, DISCRETE_ADJOINT)
-MATH_PROBLEM= DIRECT
-%
-% Restart solution (NO, YES)
-RESTART_SOL= NO
-%
-% System of measurements (SI, US)
-% International system of units (SI): ( meters, kilograms, Kelvins,
-% Newtons = kg m/s^2, Pascals = N/m^2,
-% Density = kg/m^3, Speed = m/s,
-% Equiv. Area = m^2 )
-SYSTEM_MEASUREMENTS= SI
-% -------------------- COMPRESSIBLE FREE-STREAM DEFINITION --------------------%
-% Mach number (non-dimensional, based on the free-stream values)
-MACH_NUMBER= 0.55996
-%
-% Angle of attack (degrees, only for compressible flows)
-AOA= 0.0
-%
-% Side-slip angle (degrees, only for compressible flows)
-SIDESLIP_ANGLE= 0.0
-%
-% Reynolds number (non-dimensional, based on the free-stream values)
-REYNOLDS_NUMBER= 3.65E7
-%
-% Reynolds length (1 m, 1 inch by default)
-REYNOLDS_LENGTH= 5.0292
-%
-% ---------------------- REFERENCE VALUE DEFINITION ---------------------------%
-% Reference origin for moment computation (m or in)
-REF_ORIGIN_MOMENT_X = 0.0
-REF_ORIGIN_MOMENT_Y = 0.0
-REF_ORIGIN_MOMENT_Z = 0.0
-%
-% Reference length for moment non-dimensional coefficients (m or in)
-REF_LENGTH= 1.0
-%
-% Reference area for non-dimensional force coefficients (0 implies automatic
-% calculation) (m^2 or in^2)
-REF_AREA= 19.8649
-%
-% Compressible flow non-dimensionalization (DIMENSIONAL, FREESTREAM_PRESS_EQ_ONE,
-% FREESTREAM_VEL_EQ_MACH, FREESTREAM_VEL_EQ_ONE)
-REF_DIMENSIONALIZATION= DIMENSIONAL
-%
-% --------------- ENGINE AND ACTUATOR DISK SIMULATION -------------------------%
-% Highlite area to compute MFR (1 in by default)
-HIGHLITE_AREA= 19.8649
-%
-% Engine nu factor (SA model).
-ENGINE_NU_FACTOR= 0.0
-%
-% -------------------- BOUNDARY CONDITION DEFINITION --------------------------%
-ACTDISK_DOUBLE_SURFACE = YES
-%
-% Actuator disk boundary type (VARIABLE_LOAD, VARIABLES_JUMP, BC_THRUST,
-% DRAG_MINUS_THRUST)
-ACTDISK_TYPE= VARIABLE_LOAD
-%
-% Actuator disk data input file name
-ACTDISK_FILENAME= ActuatorDisk.dat
-%
-% Actuator disk boundary marker(s) with the following formats (NONE = no marker)
-% Variable Load: (inlet face marker, outlet face marker,
-% 0.0, 0.0, 0.0, 0.0, 0.0, 0.0) Markers only effectively used.
-MARKER_ACTDISK = ( DISK, DISK_BACK, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0 )
-%
-% Far-field boundary marker(s) (NONE = no marker)
-MARKER_FAR= ( FF )
-%
-% Outlet boundary marker(s) (NONE = no marker)
-% Compressible: ( outlet marker, back pressure (static thermodynamic), ... )
-MARKER_OUTLET = ( OUT , 56370.2)
-%
-% Navier-Stokes (no-slip), constant heat flux wall marker(s) (NONE = no marker)
-% Format: ( marker name, constant heat flux (J/m^2), ... )
-MARKER_HEATFLUX = (SPINNER, 0.0)
-%
-% ------------------------ SURFACES IDENTIFICATION ----------------------------%
-% Marker(s) of the surface in the surface flow solution file
-MARKER_PLOTTING = ( DISK, DISK_BACK, SPINNER )
-%
-% Marker(s) of the surface where the non-dimensional coefficients are evaluated.
-MARKER_MONITORING = ( DISK, DISK_BACK, SPINNER )
-%
-% Marker(s) of the surface that is going to be analyzed in detail (massflow, average pressure, distortion, etc)
-MARKER_ANALYZE = ( DISK, DISK_BACK )
-%
-% Method to compute the average value in MARKER_ANALYZE (AREA, MASSFLUX).
-MARKER_ANALYZE_AVERAGE = MASSFLUX
-%
-% ------------- COMMON PARAMETERS DEFINING THE NUMERICAL METHOD ---------------%
-% Numerical method for spatial gradients (GREEN_GAUSS, WEIGHTED_LEAST_SQUARES)
-NUM_METHOD_GRAD= GREEN_GAUSS
-%
-% CFL number (initial value for the adaptive CFL number)
-CFL_NUMBER= 20.0
-%
-% Adaptive CFL number (NO, YES)
-CFL_ADAPT= NO
-%
-% Objective function in gradient evaluation (DRAG, LIFT, SIDEFORCE, MOMENT_X,
-% MOMENT_Y, MOMENT_Z, EFFICIENCY, BUFFET,
-% EQUIVALENT_AREA, NEARFIELD_PRESSURE,
-% FORCE_X, FORCE_Y, FORCE_Z, THRUST,
-% TORQUE, TOTAL_HEATFLUX,
-% MAXIMUM_HEATFLUX, INVERSE_DESIGN_PRESSURE,
-% INVERSE_DESIGN_HEATFLUX, SURFACE_TOTAL_PRESSURE,
-% SURFACE_MASSFLOW, SURFACE_STATIC_PRESSURE, SURFACE_MACH)
-% For a weighted sum of objectives: separate by commas, add OBJECTIVE_WEIGHT and MARKER_MONITORING in matching order.
-OBJECTIVE_FUNCTION= DRAG
-%
-% ------------------------ LINEAR SOLVER DEFINITION ---------------------------%
-% Linear solver or smoother for implicit formulations:
-% BCGSTAB, FGMRES, RESTARTED_FGMRES, CONJUGATE_GRADIENT (self-adjoint problems only), SMOOTHER.
-LINEAR_SOLVER= FGMRES
-%
-% Preconditioner of the Krylov linear solver or type of smoother (ILU, LU_SGS, LINELET, JACOBI)
-LINEAR_SOLVER_PREC= ILU
-%
-% Minimum error of the linear solver for implicit formulations
-LINEAR_SOLVER_ERROR= 1E-12
-%
-% Max number of iterations of the linear solver for the implicit formulation
-LINEAR_SOLVER_ITER= 3
-%
-% Number of elements to apply the criteria
-CONV_CAUCHY_ELEMS= 1000
-%
-% Epsilon to control the series convergence
-CONV_CAUCHY_EPS= 1E-10
-%
-% -------------------- FLOW NUMERICAL METHOD DEFINITION -----------------------%
-% Convective numerical method (JST, LAX-FRIEDRICH, CUSP, ROE, AUSM, AUSMPLUSUP,
-% AUSMPLUSUP2, HLLC, TURKEL_PREC, MSW, FDS, SLAU, SLAU2)
-CONV_NUM_METHOD_FLOW= JST
-%
-% Time discretization (RUNGE-KUTTA_EXPLICIT, EULER_IMPLICIT, EULER_EXPLICIT)
-TIME_DISCRE_FLOW= EULER_IMPLICIT
-%
-% -------------------- TURBULENT NUMERICAL METHOD DEFINITION ------------------%
-% Convective numerical method (SCALAR_UPWIND)
-CONV_NUM_METHOD_TURB= SCALAR_UPWIND
-%
-% Monotonic Upwind Scheme for Conservation Laws (TVD) in the turbulence equations.
-% Required for 2nd order upwind schemes (NO, YES)
-MUSCL_TURB= NO
-%
-% Slope limiter (NONE, VENKATAKRISHNAN, VENKATAKRISHNAN_WANG,
-% BARTH_JESPERSEN, VAN_ALBADA_EDGE)
-SLOPE_LIMITER_TURB= VENKATAKRISHNAN
-%
-% Time discretization (EULER_IMPLICIT)
-TIME_DISCRE_TURB= EULER_IMPLICIT
-%
-% --------------------------- CONVERGENCE PARAMETERS --------------------------%
-% Maximum number of iterations
-ITER= 1500
-%
-% Convergence criteria (CAUCHY, RESIDUAL)
-CONV_CRITERIA= RESIDUAL
-%
-% Min value of the residual (log10 of the residual)
-CONV_RESIDUAL_MINVAL= -8
-%
-% Start convergence criteria at iteration number
-CONV_STARTITER= 10
-%
-% ------------------------- INPUT/OUTPUT INFORMATION --------------------------%
-% Mesh input file
-MESH_FILENAME= propeller_variable_load.su2
-%
-% Mesh input file format (SU2, CGNS)
-MESH_FORMAT= SU2
-%
-% Mesh output file
-MESH_OUT_FILENAME= mesh_out.su2
-%
-% Restart flow input file
-SOLUTION_FILENAME= restart_flow.dat
-%
-% Output tabular file format (TECPLOT, CSV)
-TABULAR_FORMAT= TECPLOT
-%
-% Output file convergence history (w/o extension)
-CONV_FILENAME= history
-%
-% Write the forces breakdown file option (NO, YES)
-WRT_FORCES_BREAKDOWN= YES
-%
-% Output file with the forces breakdown
-BREAKDOWN_FILENAME= forces_breakdown.dat
-%
-% Output file restart flow
-RESTART_FILENAME= restart_flow.dat
-%
-% Output file flow (w/o extension) variables
-VOLUME_FILENAME= flow
-%
-% Output file surface flow coefficient (w/o extension)
-SURFACE_FILENAME= surface_flow
-%
-% Writing solution file frequency
-OUTPUT_WRT_FREQ= 250
-%
-%
-%
-%
-% Screen output fields
-SCREEN_OUTPUT= (INNER_ITER, RMS_DENSITY, RMS_NU_TILDE, LIFT, DRAG)
+%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
+% %
+% SU2 configuration file %
+% Case description: Actuator Disk with a semi-infinite spinner %
+% Author: E. Saetta, L. Russo, R. Tognaccini %
+% Institution: Theoretical and Applied Aerodynamic Research Group (TAARG) %
+% University of Naples Federico II %
+% Comments: Grid file and propeller data courtesy of Mauro Minervino, %
+% Centro Italiano Ricerche Aerospaziali (CIRA) %
+% Date: 07/08/2020 %
+% File Version 7.1.1 "Blackbird" %
+% %
+%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
+
+%----------- DIRECT, ADJOINT, AND LINEARIZED PROBLEM DEFINITION -------------------------%
+% Solver type (EULER, NAVIER_STOKES, RANS,
+% INC_EULER, INC_NAVIER_STOKES, INC_RANS
+% FEM_EULER, FEM_NAVIER_STOKES, FEM_RANS, FEM_LES,
+% HEAT_EQUATION_FVM, ELASTICITY)
+SOLVER= RANS
+%
+% Specify turbulence model (NONE, SA, SA_NEG, SST, SA_E, SA_COMP, SA_E_COMP, SST_SUST)
+KIND_TURB_MODEL= SA
+%
+% Turbulence intensity at freestream
+FREESTREAM_TURBULENCEINTENSITY=0.01
+%
+% Mathematical problem (DIRECT, CONTINUOUS_ADJOINT, DISCRETE_ADJOINT)
+MATH_PROBLEM= DIRECT
+%
+% Restart solution (NO, YES)
+RESTART_SOL= NO
+%
+% System of measurements (SI, US)
+% International system of units (SI): ( meters, kilograms, Kelvins,
+% Newtons = kg m/s^2, Pascals = N/m^2,
+% Density = kg/m^3, Speed = m/s,
+% Equiv. Area = m^2 )
+SYSTEM_MEASUREMENTS= SI
+% -------------------- COMPRESSIBLE FREE-STREAM DEFINITION --------------------%
+% Mach number (non-dimensional, based on the free-stream values)
+MACH_NUMBER= 0.55996
+%
+% Angle of attack (degrees, only for compressible flows)
+AOA= 0.0
+%
+% Side-slip angle (degrees, only for compressible flows)
+SIDESLIP_ANGLE= 0.0
+%
+% Reynolds number (non-dimensional, based on the free-stream values)
+REYNOLDS_NUMBER= 3.65E7
+%
+% Reynolds length (1 m, 1 inch by default)
+REYNOLDS_LENGTH= 5.0292
+%
+% ---------------------- REFERENCE VALUE DEFINITION ---------------------------%
+% Reference origin for moment computation (m or in)
+REF_ORIGIN_MOMENT_X = 0.0
+REF_ORIGIN_MOMENT_Y = 0.0
+REF_ORIGIN_MOMENT_Z = 0.0
+%
+% Reference length for moment non-dimensional coefficients (m or in)
+REF_LENGTH= 1.0
+%
+% Reference area for non-dimensional force coefficients (0 implies automatic
+% calculation) (m^2 or in^2)
+REF_AREA= 19.8649
+%
+% Compressible flow non-dimensionalization (DIMENSIONAL, FREESTREAM_PRESS_EQ_ONE,
+% FREESTREAM_VEL_EQ_MACH, FREESTREAM_VEL_EQ_ONE)
+REF_DIMENSIONALIZATION= DIMENSIONAL
+%
+% --------------- ENGINE AND ACTUATOR DISK SIMULATION -------------------------%
+% Highlite area to compute MFR (1 in by default)
+HIGHLITE_AREA= 19.8649
+%
+% Engine nu factor (SA model).
+ENGINE_NU_FACTOR= 0.0
+%
+% -------------------- BOUNDARY CONDITION DEFINITION --------------------------%
+ACTDISK_DOUBLE_SURFACE = YES
+%
+% Actuator disk boundary type (VARIABLE_LOAD, VARIABLES_JUMP, BC_THRUST,
+% DRAG_MINUS_THRUST)
+ACTDISK_TYPE= VARIABLE_LOAD
+%
+% Actuator disk data input file name
+ACTDISK_FILENAME= ActuatorDisk.dat
+%
+% Actuator disk boundary marker(s) with the following formats (NONE = no marker)
+% Variable Load: (inlet face marker, outlet face marker,
+% 0.0, 0.0, 0.0, 0.0, 0.0, 0.0) Markers only effectively used.
+MARKER_ACTDISK = ( DISK, DISK_BACK, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0 )
+%
+% Far-field boundary marker(s) (NONE = no marker)
+MARKER_FAR= ( FF )
+%
+% Outlet boundary marker(s) (NONE = no marker)
+% Compressible: ( outlet marker, back pressure (static thermodynamic), ... )
+MARKER_OUTLET = ( OUT , 56370.2)
+%
+% Navier-Stokes (no-slip), constant heat flux wall marker(s) (NONE = no marker)
+% Format: ( marker name, constant heat flux (J/m^2), ... )
+MARKER_HEATFLUX = (SPINNER, 0.0)
+%
+% ------------------------ SURFACES IDENTIFICATION ----------------------------%
+% Marker(s) of the surface in the surface flow solution file
+MARKER_PLOTTING = ( DISK, DISK_BACK, SPINNER )
+%
+% Marker(s) of the surface where the non-dimensional coefficients are evaluated.
+MARKER_MONITORING = ( DISK, DISK_BACK, SPINNER )
+%
+% Marker(s) of the surface that is going to be analyzed in detail (massflow, average pressure, distortion, etc)
+MARKER_ANALYZE = ( DISK, DISK_BACK )
+%
+% Method to compute the average value in MARKER_ANALYZE (AREA, MASSFLUX).
+MARKER_ANALYZE_AVERAGE = MASSFLUX
+%
+% ------------- COMMON PARAMETERS DEFINING THE NUMERICAL METHOD ---------------%
+% Numerical method for spatial gradients (GREEN_GAUSS, WEIGHTED_LEAST_SQUARES)
+NUM_METHOD_GRAD= GREEN_GAUSS
+%
+% CFL number (initial value for the adaptive CFL number)
+CFL_NUMBER= 20.0
+%
+% Adaptive CFL number (NO, YES)
+CFL_ADAPT= NO
+%
+% Objective function in gradient evaluation (DRAG, LIFT, SIDEFORCE, MOMENT_X,
+% MOMENT_Y, MOMENT_Z, EFFICIENCY, BUFFET,
+% EQUIVALENT_AREA, NEARFIELD_PRESSURE,
+% FORCE_X, FORCE_Y, FORCE_Z, THRUST,
+% TORQUE, TOTAL_HEATFLUX,
+% MAXIMUM_HEATFLUX, INVERSE_DESIGN_PRESSURE,
+% INVERSE_DESIGN_HEATFLUX, SURFACE_TOTAL_PRESSURE,
+% SURFACE_MASSFLOW, SURFACE_STATIC_PRESSURE, SURFACE_MACH)
+% For a weighted sum of objectives: separate by commas, add OBJECTIVE_WEIGHT and MARKER_MONITORING in matching order.
+OBJECTIVE_FUNCTION= DRAG
+%
+% ------------------------ LINEAR SOLVER DEFINITION ---------------------------%
+% Linear solver or smoother for implicit formulations:
+% BCGSTAB, FGMRES, RESTARTED_FGMRES, CONJUGATE_GRADIENT (self-adjoint problems only), SMOOTHER.
+LINEAR_SOLVER= FGMRES
+%
+% Preconditioner of the Krylov linear solver or type of smoother (ILU, LU_SGS, LINELET, JACOBI)
+LINEAR_SOLVER_PREC= ILU
+%
+% Minimum error of the linear solver for implicit formulations
+LINEAR_SOLVER_ERROR= 1E-12
+%
+% Max number of iterations of the linear solver for the implicit formulation
+LINEAR_SOLVER_ITER= 3
+%
+% Number of elements to apply the criteria
+CONV_CAUCHY_ELEMS= 1000
+%
+% Epsilon to control the series convergence
+CONV_CAUCHY_EPS= 1E-10
+%
+% -------------------- FLOW NUMERICAL METHOD DEFINITION -----------------------%
+% Convective numerical method (JST, LAX-FRIEDRICH, CUSP, ROE, AUSM, AUSMPLUSUP,
+% AUSMPLUSUP2, HLLC, TURKEL_PREC, MSW, FDS, SLAU, SLAU2)
+CONV_NUM_METHOD_FLOW= JST
+%
+% Time discretization (RUNGE-KUTTA_EXPLICIT, EULER_IMPLICIT, EULER_EXPLICIT)
+TIME_DISCRE_FLOW= EULER_IMPLICIT
+%
+% -------------------- TURBULENT NUMERICAL METHOD DEFINITION ------------------%
+% Convective numerical method (SCALAR_UPWIND)
+CONV_NUM_METHOD_TURB= SCALAR_UPWIND
+%
+% Monotonic Upwind Scheme for Conservation Laws (TVD) in the turbulence equations.
+% Required for 2nd order upwind schemes (NO, YES)
+MUSCL_TURB= NO
+%
+% Slope limiter (NONE, VENKATAKRISHNAN, VENKATAKRISHNAN_WANG,
+% BARTH_JESPERSEN, VAN_ALBADA_EDGE)
+SLOPE_LIMITER_TURB= VENKATAKRISHNAN
+%
+% Time discretization (EULER_IMPLICIT)
+TIME_DISCRE_TURB= EULER_IMPLICIT
+%
+% --------------------------- CONVERGENCE PARAMETERS --------------------------%
+% Maximum number of iterations
+ITER= 1500
+%
+% Convergence criteria (CAUCHY, RESIDUAL)
+CONV_CRITERIA= RESIDUAL
+%
+% Min value of the residual (log10 of the residual)
+CONV_RESIDUAL_MINVAL= -8
+%
+% Start convergence criteria at iteration number
+CONV_STARTITER= 10
+%
+% ------------------------- INPUT/OUTPUT INFORMATION --------------------------%
+% Mesh input file
+MESH_FILENAME= propeller_variable_load.su2
+%
+% Mesh input file format (SU2, CGNS)
+MESH_FORMAT= SU2
+%
+% Mesh output file
+MESH_OUT_FILENAME= mesh_out.su2
+%
+% Restart flow input file
+SOLUTION_FILENAME= restart_flow.dat
+%
+% Output tabular file format (TECPLOT, CSV)
+TABULAR_FORMAT= TECPLOT
+%
+% Output file convergence history (w/o extension)
+CONV_FILENAME= history
+%
+% Write the forces breakdown file option (NO, YES)
+WRT_FORCES_BREAKDOWN= YES
+%
+% Output file with the forces breakdown
+BREAKDOWN_FILENAME= forces_breakdown.dat
+%
+% Output file restart flow
+RESTART_FILENAME= restart_flow.dat
+%
+% Output file flow (w/o extension) variables
+VOLUME_FILENAME= flow
+%
+% Output file surface flow coefficient (w/o extension)
+SURFACE_FILENAME= surface_flow
+%
+% Writing solution file frequency
+OUTPUT_WRT_FREQ= 250
+%
+%
+%
+%
+% Screen output fields
+SCREEN_OUTPUT= (INNER_ITER, RMS_DENSITY, RMS_NU_TILDE, LIFT, DRAG)
diff --git a/TestCases/rans/flatplate/turb_SA_flatplate.cfg b/TestCases/rans/flatplate/turb_SA_flatplate.cfg
index 52762ef7167..c2adda14f57 100644
--- a/TestCases/rans/flatplate/turb_SA_flatplate.cfg
+++ b/TestCases/rans/flatplate/turb_SA_flatplate.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2011.11.10 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/rans/flatplate/turb_SST_flatplate.cfg b/TestCases/rans/flatplate/turb_SST_flatplate.cfg
index 6f38e571850..77b8f8f61cc 100644
--- a/TestCases/rans/flatplate/turb_SST_flatplate.cfg
+++ b/TestCases/rans/flatplate/turb_SST_flatplate.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2011.11.10 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/rans/naca0012/turb_NACA0012_sst_multigrid_restart.cfg b/TestCases/rans/naca0012/turb_NACA0012_sst_multigrid_restart.cfg
index e11452f4059..71227c60c0e 100644
--- a/TestCases/rans/naca0012/turb_NACA0012_sst_multigrid_restart.cfg
+++ b/TestCases/rans/naca0012/turb_NACA0012_sst_multigrid_restart.cfg
@@ -6,7 +6,7 @@
% Author: David E. Manosalvas %
% Institution: Stanford University %
% Date: 02.14.2017 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/rans/oneram6/turb_ONERAM6.cfg b/TestCases/rans/oneram6/turb_ONERAM6.cfg
index 046f93463e6..e7229150f0e 100644
--- a/TestCases/rans/oneram6/turb_ONERAM6.cfg
+++ b/TestCases/rans/oneram6/turb_ONERAM6.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2014.06.14 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/rans/oneram6/turb_ONERAM6_nk.cfg b/TestCases/rans/oneram6/turb_ONERAM6_nk.cfg
index 371ebb933d5..63bea201339 100644
--- a/TestCases/rans/oneram6/turb_ONERAM6_nk.cfg
+++ b/TestCases/rans/oneram6/turb_ONERAM6_nk.cfg
@@ -2,7 +2,7 @@
% %
% SU2 configuration file %
% Case description: Turbulent flow, ONERA M6, Newton-Krylov solver %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/rans/propeller/propeller.cfg b/TestCases/rans/propeller/propeller.cfg
index 2ddb5835d79..99ee5a22d9e 100644
--- a/TestCases/rans/propeller/propeller.cfg
+++ b/TestCases/rans/propeller/propeller.cfg
@@ -5,7 +5,7 @@
% Author: %
% Institution: %
% Date: %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/rans/rae2822/turb_SA_RAE2822.cfg b/TestCases/rans/rae2822/turb_SA_RAE2822.cfg
index e7cd0b9fe8c..ce48b26de81 100644
--- a/TestCases/rans/rae2822/turb_SA_RAE2822.cfg
+++ b/TestCases/rans/rae2822/turb_SA_RAE2822.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: 5/15/2013 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/rans/rae2822/turb_SST_RAE2822.cfg b/TestCases/rans/rae2822/turb_SST_RAE2822.cfg
index 6671d416391..e0d4b5239f7 100644
--- a/TestCases/rans/rae2822/turb_SST_RAE2822.cfg
+++ b/TestCases/rans/rae2822/turb_SST_RAE2822.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: 5/15/2013 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/rans/rae2822/turb_SST_SUST_RAE2822.cfg b/TestCases/rans/rae2822/turb_SST_SUST_RAE2822.cfg
index 725d764efcc..ccb93d4e65a 100644
--- a/TestCases/rans/rae2822/turb_SST_SUST_RAE2822.cfg
+++ b/TestCases/rans/rae2822/turb_SST_SUST_RAE2822.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: 5/15/2013 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/rans/restart_directdiff_naca/naca0012.cfg b/TestCases/rans/restart_directdiff_naca/naca0012.cfg
index e5a4bf5e851..a6f7452d55c 100644
--- a/TestCases/rans/restart_directdiff_naca/naca0012.cfg
+++ b/TestCases/rans/restart_directdiff_naca/naca0012.cfg
@@ -5,7 +5,7 @@
% Author: Steffen Schotthöfer %
% Institution: TU Kaiserslautern %
% Date: Mar 16, 2017 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/rans/s809/trans_s809.cfg b/TestCases/rans/s809/trans_s809.cfg
index 09efbc7ee42..3aabee6d853 100644
--- a/TestCases/rans/s809/trans_s809.cfg
+++ b/TestCases/rans/s809/trans_s809.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: 5/15/2013 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/rans/s809/turb_S809.cfg b/TestCases/rans/s809/turb_S809.cfg
index 1f01e8f6079..6e4cbf0a0c1 100644
--- a/TestCases/rans/s809/turb_S809.cfg
+++ b/TestCases/rans/s809/turb_S809.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios %
% Institution: Stanford University %
% Date: 5/15/2013 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/rans/vki_turbine/turb_vki.cfg b/TestCases/rans/vki_turbine/turb_vki.cfg
index f800446a441..984f2abc149 100644
--- a/TestCases/rans/vki_turbine/turb_vki.cfg
+++ b/TestCases/rans/vki_turbine/turb_vki.cfg
@@ -5,7 +5,7 @@
% Author: Francisco Palacios, Thomas D. Economon %
% Institution: Stanford University %
% Date: Feb 18th, 2013 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/rotating/caradonna_tung/rot_caradonna_tung.cfg b/TestCases/rotating/caradonna_tung/rot_caradonna_tung.cfg
index 9136aefef33..310939f2d5a 100644
--- a/TestCases/rotating/caradonna_tung/rot_caradonna_tung.cfg
+++ b/TestCases/rotating/caradonna_tung/rot_caradonna_tung.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2020.05.24 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/rotating/naca0012/rot_NACA0012.cfg b/TestCases/rotating/naca0012/rot_NACA0012.cfg
index af4b128969a..63f3c151f21 100644
--- a/TestCases/rotating/naca0012/rot_NACA0012.cfg
+++ b/TestCases/rotating/naca0012/rot_NACA0012.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2020.06.06 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/serial_regression.py b/TestCases/serial_regression.py
index 6c33afd0bea..0b0a36e31b9 100644
--- a/TestCases/serial_regression.py
+++ b/TestCases/serial_regression.py
@@ -3,7 +3,7 @@
## \file serial_regression.py
# \brief Python script for automated regression testing of SU2 examples
# \author A. Aranake, A. Campos, T. Economon, T. Lukaczyk, S. Padron
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/TestCases/serial_regression_AD.py b/TestCases/serial_regression_AD.py
index 97f86d64a15..9f30bd55200 100644
--- a/TestCases/serial_regression_AD.py
+++ b/TestCases/serial_regression_AD.py
@@ -3,7 +3,7 @@
## \file serial_regression.py
# \brief Python script for automated regression testing of SU2 examples
# \author A. Aranake, A. Campos, T. Economon, T. Lukaczyk, S. Padron
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/TestCases/sliding_interface/bars_SST_2D/bars.cfg b/TestCases/sliding_interface/bars_SST_2D/bars.cfg
index 0a4e4874332..71d77128098 100644
--- a/TestCases/sliding_interface/bars_SST_2D/bars.cfg
+++ b/TestCases/sliding_interface/bars_SST_2D/bars.cfg
@@ -5,7 +5,7 @@
% Author: A. Rubino %
% Institution: Delft University of Technology %
% Date: Feb 27th, 2017 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/sliding_interface/bars_SST_2D/zone_1.cfg b/TestCases/sliding_interface/bars_SST_2D/zone_1.cfg
index 647ba376a17..1dd8d41836f 100644
--- a/TestCases/sliding_interface/bars_SST_2D/zone_1.cfg
+++ b/TestCases/sliding_interface/bars_SST_2D/zone_1.cfg
@@ -5,7 +5,7 @@
% Author: A. Rubino %
% Institution: Delft University of Technology %
% Date: Feb 27th, 2017 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
%
diff --git a/TestCases/sliding_interface/bars_SST_2D/zone_2.cfg b/TestCases/sliding_interface/bars_SST_2D/zone_2.cfg
index d98ec02e664..d922c308466 100644
--- a/TestCases/sliding_interface/bars_SST_2D/zone_2.cfg
+++ b/TestCases/sliding_interface/bars_SST_2D/zone_2.cfg
@@ -5,7 +5,7 @@
% Author: A. Rubino %
% Institution: Delft University of Technology %
% Date: Feb 27th, 2017 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/sliding_interface/bars_SST_2D/zone_3.cfg b/TestCases/sliding_interface/bars_SST_2D/zone_3.cfg
index b6e9674d74a..a3ed15dbebc 100644
--- a/TestCases/sliding_interface/bars_SST_2D/zone_3.cfg
+++ b/TestCases/sliding_interface/bars_SST_2D/zone_3.cfg
@@ -5,7 +5,7 @@
% Author: A. Rubino %
% Institution: Delft University of Technology %
% Date: Feb 27th, 2017 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
%
diff --git a/TestCases/sliding_interface/channel_2D/zone_2.cfg b/TestCases/sliding_interface/channel_2D/zone_2.cfg
index 301abf1e205..fcc887a5cdc 100644
--- a/TestCases/sliding_interface/channel_2D/zone_2.cfg
+++ b/TestCases/sliding_interface/channel_2D/zone_2.cfg
@@ -5,7 +5,7 @@
% Author: A. Rubino %
% Institution: Delft University of Technology %
% Date: Feb 27th, 2017 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/sliding_interface/channel_2D/zone_3.cfg b/TestCases/sliding_interface/channel_2D/zone_3.cfg
index b6e9674d74a..a3ed15dbebc 100644
--- a/TestCases/sliding_interface/channel_2D/zone_3.cfg
+++ b/TestCases/sliding_interface/channel_2D/zone_3.cfg
@@ -5,7 +5,7 @@
% Author: A. Rubino %
% Institution: Delft University of Technology %
% Date: Feb 27th, 2017 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
%
diff --git a/TestCases/transition/E387_Airfoil/transitional_BC_model_ConfigFile.cfg b/TestCases/transition/E387_Airfoil/transitional_BC_model_ConfigFile.cfg
index 1a445f2156b..792b3faa62a 100644
--- a/TestCases/transition/E387_Airfoil/transitional_BC_model_ConfigFile.cfg
+++ b/TestCases/transition/E387_Airfoil/transitional_BC_model_ConfigFile.cfg
@@ -6,7 +6,7 @@
% Institution: TOBB University of Economics and Technology %
% TAI-TUSAS Turkish Aerospace Industries %
% Date: Oct 10th, 2016 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/transition/Schubauer_Klebanoff/transitional_BC_model_ConfigFile.cfg b/TestCases/transition/Schubauer_Klebanoff/transitional_BC_model_ConfigFile.cfg
index c4f25979729..9d32610dae1 100644
--- a/TestCases/transition/Schubauer_Klebanoff/transitional_BC_model_ConfigFile.cfg
+++ b/TestCases/transition/Schubauer_Klebanoff/transitional_BC_model_ConfigFile.cfg
@@ -6,7 +6,7 @@
% Institution: TOBB University of Economics and Technology %
% TAI-TUSAS Turkish Aerospace Industries %
% Date: Oct 10th, 2016 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/transition/T3A_FlatPlate/transitional_BC_model_ConfigFile.cfg b/TestCases/transition/T3A_FlatPlate/transitional_BC_model_ConfigFile.cfg
index 34149021cc2..bc262ad4138 100644
--- a/TestCases/transition/T3A_FlatPlate/transitional_BC_model_ConfigFile.cfg
+++ b/TestCases/transition/T3A_FlatPlate/transitional_BC_model_ConfigFile.cfg
@@ -6,7 +6,7 @@
% Institution: TOBB University of Economics and Technology %
% TAI-TUSAS Turkish Aerospace Industries %
% Date: Oct 10th, 2016 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/tutorials.py b/TestCases/tutorials.py
index 6cd982fd6e2..5295588f255 100644
--- a/TestCases/tutorials.py
+++ b/TestCases/tutorials.py
@@ -3,7 +3,7 @@
## \file parallel_regression.py
# \brief Python script for automated regression testing of SU2 examples
# \author A. Aranake, A. Campos, T. Economon, T. Lukaczyk, S. Padron
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/TestCases/unsteady/pitching_naca64a010_euler/pitching_NACA64A010.cfg b/TestCases/unsteady/pitching_naca64a010_euler/pitching_NACA64A010.cfg
index 1bc72884c2e..0bb4beb2298 100644
--- a/TestCases/unsteady/pitching_naca64a010_euler/pitching_NACA64A010.cfg
+++ b/TestCases/unsteady/pitching_naca64a010_euler/pitching_NACA64A010.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2011.11.02 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/unsteady/pitching_naca64a010_rans/turb_NACA64A010.cfg b/TestCases/unsteady/pitching_naca64a010_rans/turb_NACA64A010.cfg
index 8fa7c6affae..7c74ee76c38 100644
--- a/TestCases/unsteady/pitching_naca64a010_rans/turb_NACA64A010.cfg
+++ b/TestCases/unsteady/pitching_naca64a010_rans/turb_NACA64A010.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2011.11.02 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/unsteady/plunging_naca0012/plunging_NACA0012.cfg b/TestCases/unsteady/plunging_naca0012/plunging_NACA0012.cfg
index 1eb4b09ae3e..8470bf0cb4c 100644
--- a/TestCases/unsteady/plunging_naca0012/plunging_NACA0012.cfg
+++ b/TestCases/unsteady/plunging_naca0012/plunging_NACA0012.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: Jun 12, 2014 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/TestCases/unsteady/square_cylinder/turb_square.cfg b/TestCases/unsteady/square_cylinder/turb_square.cfg
index ce0cd4f7fa9..ca0b55cfe7c 100644
--- a/TestCases/unsteady/square_cylinder/turb_square.cfg
+++ b/TestCases/unsteady/square_cylinder/turb_square.cfg
@@ -5,7 +5,7 @@
% Author: Thomas D. Economon %
% Institution: Stanford University %
% Date: 2013.02.25 %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/UnitTests/Common/geometry/CGeometry_test.cpp b/UnitTests/Common/geometry/CGeometry_test.cpp
index 920c50e5003..3767f56a37c 100644
--- a/UnitTests/Common/geometry/CGeometry_test.cpp
+++ b/UnitTests/Common/geometry/CGeometry_test.cpp
@@ -2,7 +2,7 @@
* \file CGeometry_tests.cpp
* \brief Unit tests for CGeometry.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/UnitTests/Common/geometry/dual_grid/CDualGrid_tests.cpp b/UnitTests/Common/geometry/dual_grid/CDualGrid_tests.cpp
index fa4003f5f82..e718b49674a 100644
--- a/UnitTests/Common/geometry/dual_grid/CDualGrid_tests.cpp
+++ b/UnitTests/Common/geometry/dual_grid/CDualGrid_tests.cpp
@@ -2,7 +2,7 @@
* \file CDualGrid_tests.cpp
* \brief Unit tests for the dual grid classes
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/UnitTests/Common/geometry/primal_grid/CPrimalGrid_tests.cpp b/UnitTests/Common/geometry/primal_grid/CPrimalGrid_tests.cpp
index f840f8ecf9d..b7ef26c36e2 100644
--- a/UnitTests/Common/geometry/primal_grid/CPrimalGrid_tests.cpp
+++ b/UnitTests/Common/geometry/primal_grid/CPrimalGrid_tests.cpp
@@ -2,7 +2,7 @@
* \file CPrimalGrid_tests.cpp
* \brief Unit tests for the primal grid classes
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/UnitTests/Common/simple_ad_test.cpp b/UnitTests/Common/simple_ad_test.cpp
index 9e253cb3af8..0282b40cfbe 100644
--- a/UnitTests/Common/simple_ad_test.cpp
+++ b/UnitTests/Common/simple_ad_test.cpp
@@ -4,7 +4,7 @@
* basic functionality, this also serves as a regression test
* to make sure that AD works within unit testing.
* \author C. Pederson
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/UnitTests/Common/simple_directdiff_test.cpp b/UnitTests/Common/simple_directdiff_test.cpp
index 91893e894e6..086616b9cbd 100644
--- a/UnitTests/Common/simple_directdiff_test.cpp
+++ b/UnitTests/Common/simple_directdiff_test.cpp
@@ -4,7 +4,7 @@
* basic functionality, this also serves as a regression test
* to make sure that DD works within unit testing.
* \author C. Pederson
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/UnitTests/Common/toolboxes/CQuasiNewtonInvLeastSquares_tests.cpp b/UnitTests/Common/toolboxes/CQuasiNewtonInvLeastSquares_tests.cpp
index d33d31a59a3..82f6d4063e0 100644
--- a/UnitTests/Common/toolboxes/CQuasiNewtonInvLeastSquares_tests.cpp
+++ b/UnitTests/Common/toolboxes/CQuasiNewtonInvLeastSquares_tests.cpp
@@ -3,7 +3,7 @@
* \brief Unit tests for the CQuasiNewtonInvLeastSquares class.
* Which should find the root of a n-d linear problem in n+1 iterations.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/UnitTests/Common/vectorization.cpp b/UnitTests/Common/vectorization.cpp
index 9c4a3551da5..44972b04397 100644
--- a/UnitTests/Common/vectorization.cpp
+++ b/UnitTests/Common/vectorization.cpp
@@ -2,7 +2,7 @@
* \file vectorization.cpp
* \brief Unit tests for the SIMD type and associated expression templates.
* \author P. Gomes
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/UnitTests/SU2_CFD/gradients.cpp b/UnitTests/SU2_CFD/gradients.cpp
index cc6b342d1fc..7757b14e1df 100644
--- a/UnitTests/SU2_CFD/gradients.cpp
+++ b/UnitTests/SU2_CFD/gradients.cpp
@@ -2,7 +2,7 @@
* \file gradients.cpp
* \brief Unit tests for gradient calculation.
* \author P. Gomes, T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/UnitTests/SU2_CFD/numerics/CNumerics_tests.cpp b/UnitTests/SU2_CFD/numerics/CNumerics_tests.cpp
index 04ca30b34f2..e92062f8ba4 100644
--- a/UnitTests/SU2_CFD/numerics/CNumerics_tests.cpp
+++ b/UnitTests/SU2_CFD/numerics/CNumerics_tests.cpp
@@ -2,7 +2,7 @@
* \file CNumerics_tests.cpp
* \brief Unit tests for the numerics classes.
* \author C. Pederson
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/UnitTests/UnitQuadTestCase.hpp b/UnitTests/UnitQuadTestCase.hpp
index 513e5ed31c1..d9e24cd5d2f 100644
--- a/UnitTests/UnitQuadTestCase.hpp
+++ b/UnitTests/UnitQuadTestCase.hpp
@@ -2,7 +2,7 @@
* \file UnitQuadTestCase.hpp
* \brief Simple unit quad test to be used in unit tests.
* \author T. Albring
- * \version 7.1.0 "Blackbird"
+ * \version 7.1.1 "Blackbird"
*
* SU2 Project Website: https://su2code.github.io
*
diff --git a/config_template.cfg b/config_template.cfg
index fd9e3d4930c..949004c7d4e 100644
--- a/config_template.cfg
+++ b/config_template.cfg
@@ -5,7 +5,7 @@
% Author: ___________________________________________________________________ %
% Institution: ______________________________________________________________ %
% Date: __________ %
-% File Version 7.1.0 "Blackbird" %
+% File Version 7.1.1 "Blackbird" %
% %
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
diff --git a/configure.ac b/configure.ac
index 3415d019da9..a0f5f1441a2 100644
--- a/configure.ac
+++ b/configure.ac
@@ -3,7 +3,7 @@
# \file configure.ac
# \brief Main file for configuring the autoconf/automake build process
# \author M. Colonno, T. Economon, F. Palacios, B. Kirk
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/externals/Makefile.am b/externals/Makefile.am
index 2adc6eb09ad..9a04f06dc25 100644
--- a/externals/Makefile.am
+++ b/externals/Makefile.am
@@ -3,7 +3,7 @@
# \file Makefile.am
# \brief Makefile for external libraries
# \author B. Kirk, T. Economon, F. Palacios
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/meson.build b/meson.build
index cb688126fbe..d15905334d9 100644
--- a/meson.build
+++ b/meson.build
@@ -1,5 +1,5 @@
project('SU2', 'c', 'cpp',
- version: '7.1.0 "Blackbird"',
+ version: '7.1.1 "Blackbird"',
license: 'LGPL2',
default_options: ['buildtype=release',
'warning_level=0',
@@ -198,7 +198,7 @@ endif
message('''-------------------------------------------------------------------------
| ___ _ _ ___ |
- | / __| | | |_ ) Release 7.1.0 "Blackbird" |
+ | / __| | | |_ ) Release 7.1.1 "Blackbird" |
| \__ \ |_| |/ / |
| |___/\___//___| Meson Configuration Summary |
| |
diff --git a/meson.py b/meson.py
index 8bab2e16064..282ab353133 100755
--- a/meson.py
+++ b/meson.py
@@ -3,7 +3,7 @@
## \file meson.py
# \brief An extended meson script for setting up the environment and running meson
# \author T. Albring
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/meson_scripts/init.py b/meson_scripts/init.py
index fe0cc063aa9..f0d47713654 100755
--- a/meson_scripts/init.py
+++ b/meson_scripts/init.py
@@ -4,7 +4,7 @@
# \brief Initializes necessary dependencies for SU2 either using git or it
# fetches zip files.
# \author T. Albring
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#
diff --git a/preconfigure.py b/preconfigure.py
index 639740a54d8..4c0094bed58 100755
--- a/preconfigure.py
+++ b/preconfigure.py
@@ -3,7 +3,7 @@
## \file configure.py
# \brief An extended configuration script.
# \author T. Albring
-# \version 7.1.0 "Blackbird"
+# \version 7.1.1 "Blackbird"
#
# SU2 Project Website: https://su2code.github.io
#