Skip to content

Commit

Permalink
FDS Source: Change HT1D to VARIABLE_THICKNESS
Browse files Browse the repository at this point in the history
  • Loading branch information
mcgratta committed Nov 8, 2023
1 parent 3d77bf0 commit c29c64a
Show file tree
Hide file tree
Showing 17 changed files with 47 additions and 43 deletions.
6 changes: 3 additions & 3 deletions Manuals/FDS_User_Guide/FDS_User_Guide.tex
Original file line number Diff line number Diff line change
Expand Up @@ -2416,14 +2416,14 @@ \subsection{1-D Heat Conduction in Solids of Varying Thickness}

Solid boundaries usually have one or more layers of a known thickness, in which case you specify the layer thicknesses and material composition on the {\ct SURF} line. However, there may be solids of more complicated geometry for which the various layers may have varying thicknesses. In such cases, you do not specify a {\ct THICKNESS} or a {\ct MATL\_ID} on the {\ct SURF} line. Instead, you specify {\ct MATL\_ID} on the obstructions ({\ct OBST}s) that make up the solid. Multiple obstructions can be used to create multiple layers, and each layer can be assigned one or more material components via {\ct MATL\_ID(:)} and {\ct MATL\_MASS\_FRACTION(:)}. Unlike the way these parameters are specified on a {\ct SURF} line, the single index represents a material component, not a layer. As an example, consider these input lines:
\begin{lstlisting}
&SURF ID='SKIN', COLOR='BLACK', HT1D=T /
&SURF ID='SKIN', COLOR='BLACK', VARIABLE_THICKNESS=T /
&OBST XB=0.2,0.8,0.2,0.8,0.2,0.8, SURF_ID='SKIN',
MATL_ID='Steel','Aluminum', MATL_MASS_FRACTION=0.8,0.2 /
&HOLE XB=0.3,0.7,0.3,0.7,0.3,0.7 /
&OBST XB=0.3,0.7,0.3,0.7,0.3,0.7, PERMIT_HOLE=F,
MATL_ID='Aluminum', MATL_MASS_FRACTION=1. /
\end{lstlisting}
The {\ct SURF} line serves only to color the surface black and to indicate, via the parameter {\ct HT1D}, that the layer thicknesses and material composition are to be conveyed via the {\ct OBST}s that make up the solid. In this case, the solid is a 0.6~m cube made up of steel and aluminum with a hollowed out core made up of pure aluminum. The material properties are conveyed via {\ct MATL} lines as described above.
The {\ct SURF} line serves only to color the surface black and to indicate, via the parameter {\ct VARIABLE\_THICKNESS}, that the layer thicknesses and material composition are to be conveyed via the {\ct OBST}s that make up the solid. In this case, the solid is a 0.6~m cube made up of steel and aluminum with a hollowed out core made up of pure aluminum. The material properties are conveyed via {\ct MATL} lines as described above.



Expand Down Expand Up @@ -12789,7 +12789,6 @@ \section{\texorpdfstring{{\tt SURF}}{SURF} (Surface Properties)}
{\ct HEAT\_TRANSFER\_MODEL} & Character & Section~\ref{info:convection} & & \\ \hline
{\ct HORIZONTAL} & Logical & Section~\ref{info:GEOMETRY} & & {\ct F} \\ \hline
{\ct HRRPUA} & Real & Section~\ref{info:gas_burner} & \si{kW/m^2} & \\ \hline
{\ct HT1D} & Logical & Section~\ref{info:ht1d} & & {\ct F} \\ \hline
{\ct HT3D} & Logical & Section~\ref{info:ht3d} & & {\ct F} \\ \hline
{\ct ID} & Character & Section~\ref{info:SURF} & & \\ \hline
{\ct IGNITION\_TEMPERATURE} & Real & Section~\ref{info:specified_burning} & $^\circ$C & 5000. \\ \hline
Expand Down Expand Up @@ -12877,6 +12876,7 @@ \section{\texorpdfstring{{\tt SURF}}{SURF} (Surface Properties)}
{\ct TMP\_GAS\_BACK} & Real & Section~\ref{info:BACKING} & $^\circ$C & \\ \hline
{\ct TMP\_INNER} & Real & Section~\ref{info:TMP_INNER} & $^\circ$C & 20. \\ \hline
{\ct TRANSPARENCY} & Real & Section~\ref{info:colors} & & 1. \\ \hline
{\ct VARIABLE\_THICKNESS} & Logical & Section~\ref{info:ht1d} & & {\ct F} \\ \hline
{\ct VEG\_LSET\_BETA} & Real & Section~\ref{info:level_set} & & 0. \\ \hline
{\ct VEG\_LSET\_CHAR\_FRACTION} & Real & Section~\ref{info:level_set} & & 0.2 \\ \hline
{\ct VEG\_LSET\_FIREBASE\_TIME} & Real & Section~\ref{info:level_set} & s & \\ \hline
Expand Down
6 changes: 3 additions & 3 deletions Source/dump.f90
Original file line number Diff line number Diff line change
Expand Up @@ -2974,7 +2974,7 @@ SUBROUTINE INITIALIZE_DIAGNOSTIC_FILE(DT)
CYCLE SURFLOOP
ENDIF

THICK: IF (SF%THERMAL_BC_INDEX==THERMALLY_THICK .AND. .NOT.SF%HT1D .AND. .NOT. SF%HT_DIM>1) THEN
THICK: IF (SF%THERMAL_BC_INDEX==THERMALLY_THICK .AND. .NOT.SF%VARIABLE_THICKNESS .AND. .NOT. SF%HT_DIM>1) THEN
WRITE(LU_OUTPUT,'(A)') ' Material List'
DO NN=1,SF%N_MATL
WRITE(LU_OUTPUT,'(8X,I3,2X,A)') NN,TRIM(SF%MATL_NAME(NN))
Expand Down Expand Up @@ -3003,7 +3003,7 @@ SUBROUTINE INITIALIZE_DIAGNOSTIC_FILE(DT)
ENDIF
IF (SF%GEOMETRY==SURF_CYLINDRICAL) WRITE(LU_OUTPUT,'(A)') ' Assumed cylindrical symmetry'
IF (SF%GEOMETRY==SURF_SPHERICAL) WRITE(LU_OUTPUT,'(A)') ' Assumed spherical symmetry'
ELSEIF (SF%THERMAL_BC_INDEX==THERMALLY_THICK .AND. (SF%HT1D .OR. SF%HT_DIM>1)) THEN
ELSEIF (SF%THERMAL_BC_INDEX==THERMALLY_THICK .AND. (SF%VARIABLE_THICKNESS .OR. SF%HT_DIM>1)) THEN
WRITE(LU_OUTPUT,'(A)') ' Internal noding and material information taken from underlying obstructions'
ENDIF THICK

Expand Down Expand Up @@ -9865,7 +9865,7 @@ SUBROUTINE DUMP_PROF(T,NM)
ENDIF

SF => SURFACE(SURF_INDEX)
IF (SF%PYROLYSIS_MODEL==PYROLYSIS_PREDICTED .OR. SF%HT_DIM>1 .OR. SF%HT1D) THEN
IF (SF%PYROLYSIS_MODEL==PYROLYSIS_PREDICTED .OR. SF%HT_DIM>1 .OR. SF%VARIABLE_THICKNESS) THEN
NWP = SUM(ONE_D%N_LAYER_CELLS)
IF (NWP==0) CYCLE PROF_LOOP
X_S_NEW(0:NWP) = ONE_D%X(0:NWP)
Expand Down
23 changes: 12 additions & 11 deletions Source/init.f90
Original file line number Diff line number Diff line change
Expand Up @@ -1569,7 +1569,7 @@ END SUBROUTINE INITIALIZE_INTERPOLATION
END SUBROUTINE INITIALIZE_MESH_VARIABLES_2


!> \brief Find WALL THIN_WALL cells with HT1D or HT3D and adjust the 1-D internal noding
!> \brief Find WALL THIN_WALL cells with VARIABLE_THICKNESS or HT3D and adjust the 1-D internal noding
!> \param NM Mesh index

SUBROUTINE ADJUST_HT3D_WALL_CELLS(NM)
Expand All @@ -1591,7 +1591,7 @@ SUBROUTINE ADJUST_HT3D_WALL_CELLS(NM)
END SUBROUTINE ADJUST_HT3D_WALL_CELLS


!> \brief For a given WALL or THIN_WALL with HT1D or HT3D, adjust the 1-D internal noding
!> \brief For a given WALL or THIN_WALL with VARIABLE_THICKNESS or HT3D, adjust the 1-D internal noding
!> \param NM Mesh index
!> \param WALL_CELL Optional WALL cell index
!> \param THIN_WALL_CELL Optional THIN_WALL cell index
Expand Down Expand Up @@ -1624,7 +1624,7 @@ SUBROUTINE REALLOCATE_ONE_D_ARRAYS(NM,WALL_CELL,THIN_WALL_CELL)
IF (PRESENT(WALL_CELL)) THEN
WC => M%WALL(WALL_CELL)
SF => SURFACE(WC%SURF_INDEX)
IF (.NOT.SF%HT1D .AND. .NOT.SF%HT_DIM>1) RETURN
IF (.NOT.SF%VARIABLE_THICKNESS .AND. .NOT.SF%HT_DIM>1) RETURN
IF (WC%BOUNDARY_TYPE/=SOLID_BOUNDARY) RETURN
IF (SF%NORMAL_DIRECTION_ONLY) RETURN
ONE_D => M%BOUNDARY_ONE_D(WC%OD_INDEX)
Expand Down Expand Up @@ -3709,7 +3709,7 @@ SUBROUTINE FIND_WALL_BACK_INDEX(NM,IW)
ITER = 0
OBST_INDEX = 0
THICKNESS = 0._EB
IF (SF%HT1D .OR. SF%HT_DIM>1) THEN
IF (SF%VARIABLE_THICKNESS .OR. SF%HT_DIM>1) THEN
N_LAYERS = 1
LAYER_THICKNESS = 0._EB
MATL_MASS_FRACTION = 0._EB
Expand All @@ -3733,7 +3733,8 @@ SUBROUTINE FIND_WALL_BACK_INDEX(NM,IW)
IF (NOM>0) THEN
IF (.NOT.PROCESS_MESH_NEIGHBORHOOD(NOM)) RETURN ! If NOM not controlled by current MPI process, abandon search
OM => MESHES(NOM)
ELSEIF (IW<=M%N_EXTERNAL_WALL_CELLS .AND. (SF%HT_DIM>1.OR.SF%HT1D)) THEN ! Do not apply HT3D or HT1D to exterior boundary
ELSEIF (IW<=M%N_EXTERNAL_WALL_CELLS .AND. (SF%HT_DIM>1.OR.SF%VARIABLE_THICKNESS)) THEN
! Do not apply HT3D to VARIABLE_THICKNESS exterior boundary
MESSAGE = 'ERROR: SURF '//TRIM(SURFACE(WC%SURF_INDEX)%ID)//' cannot be applied to an exterior boundary'
CALL SHUTDOWN(MESSAGE,PROCESS_0_ONLY=.FALSE.)
RETURN
Expand All @@ -3752,9 +3753,9 @@ SUBROUTINE FIND_WALL_BACK_INDEX(NM,IW)

IC = OM%CELL_INDEX(II,JJ,KK)

! For HT1D and HT3D cases, get material information from obstruction
! For VARIABLE_THICKNESS and HT3D cases, get material information from obstruction

IF (SF%HT1D .OR. SF%HT_DIM>1) THEN
IF (SF%VARIABLE_THICKNESS .OR. SF%HT_DIM>1) THEN

OBST_INDEX_PREVIOUS = OBST_INDEX
OBST_INDEX = OM%CELL(IC)%OBST_INDEX
Expand Down Expand Up @@ -3823,7 +3824,7 @@ SUBROUTINE FIND_WALL_BACK_INDEX(NM,IW)

! If 1-D solid and the user-specified thickness is less than the current thickness, abandon the search for back-wall cell

IF (.NOT.SF%HT1D .AND. SF%HT_DIM==1 .AND. THICKNESS>SUM(SF%LAYER_THICKNESS)) RETURN
IF (.NOT.SF%VARIABLE_THICKNESS .AND. SF%HT_DIM==1 .AND. THICKNESS>SUM(SF%LAYER_THICKNESS)) RETURN

SELECT CASE(IOR) ! New cell indices as we march deeper into the obstruction
CASE(-1) ; II=II+1
Expand All @@ -3836,7 +3837,7 @@ SUBROUTINE FIND_WALL_BACK_INDEX(NM,IW)

ENDDO FIND_BACK_WALL_CELL

! If the user has specified LINING materials (HT3D or HT1D with SURF MATLs and THICKNESS), add this information to
! If the user has specified LINING materials (HT3D or VARIABLE_THICKNESS with SURF MATLs and THICKNESS), add this information to
! existing lists of layers and materials.
! The new arrays of thickness and material information are temporarily stored in arrays with _NEW suffix.

Expand Down Expand Up @@ -3894,9 +3895,9 @@ SUBROUTINE FIND_WALL_BACK_INDEX(NM,IW)
MATL_INDEX(1:N_MATLS) = MATL_INDEX_NEW(1:N_MATLS_NEW)
ENDIF

! If HT1D or HT3D, reallocate ONE_D arrays holding layer and material info
! If VARIABLE_THICKNESS or HT3D, reallocate ONE_D arrays holding layer and material info

IF (SF%HT1D .OR. SF%HT_DIM>1) THEN
IF (SF%VARIABLE_THICKNESS .OR. SF%HT_DIM>1) THEN
ONE_D%N_LAYERS = N_LAYERS
ONE_D%N_MATL = N_MATLS
DEALLOCATE(ONE_D%MATL_COMP) ; ALLOCATE(ONE_D%MATL_COMP(ONE_D%N_MATL))
Expand Down
27 changes: 15 additions & 12 deletions Source/read.f90
Original file line number Diff line number Diff line change
Expand Up @@ -7088,7 +7088,7 @@ SUBROUTINE READ_SURF
VEG_LSET_M1,VEG_LSET_M10,VEG_LSET_M100,VEG_LSET_MLW,VEG_LSET_MLH,VEG_LSET_SURF_LOAD,VEG_LSET_FIREBASE_TIME,&
VEG_LSET_CHAR_FRACTION,VEL_PART,INIT_PER_AREA
LOGICAL :: DEFAULT,VEG_LSET_SPREAD,VEG_LSET_TAN2,TGA_ANALYSIS,COMPUTE_EMISSIVITY,&
COMPUTE_EMISSIVITY_BACK,HT1D,HT3D,THERM_THICK,NORMAL_DIRECTION_ONLY
COMPUTE_EMISSIVITY_BACK,VARIABLE_THICKNESS,HT3D,THERM_THICK,NORMAL_DIRECTION_ONLY,HT1D
! Ember generating variables
REAL(EB) :: EMBER_GENERATION_HEIGHT(2),EMBER_POWER_MEAN,EMBER_POWER_SIGMA

Expand All @@ -7098,7 +7098,7 @@ SUBROUTINE READ_SURF
DT_INSERT,E_COEFFICIENT,EMBER_GENERATION_HEIGHT,EMBER_POWER_MEAN,EMBER_POWER_SIGMA,&
EMISSIVITY,EMISSIVITY_BACK,EXTERNAL_FLUX,EXTINCTION_TEMPERATURE,&
FREE_SLIP,FYI,GEOMETRY,HEAT_OF_VAPORIZATION,HEAT_TRANSFER_COEFFICIENT,HEAT_TRANSFER_COEFFICIENT_BACK,&
HEAT_TRANSFER_MODEL,HORIZONTAL,HRRPUA,HT1D,HT3D,ID,IGNITION_TEMPERATURE,&
HEAT_TRANSFER_MODEL,HORIZONTAL,HRRPUA,VARIABLE_THICKNESS,HT3D,ID,IGNITION_TEMPERATURE,&
INIT_IDS,INIT_PER_AREA,&
INNER_RADIUS,INTERNAL_HEAT_SOURCE,LAYER_DIVIDE,&
LEAK_PATH,LEAK_PATH_ID,LENGTH,MASS_FLUX,MASS_FLUX_TOTAL,MASS_FLUX_VAR,MASS_FRACTION,&
Expand All @@ -7120,7 +7120,8 @@ SUBROUTINE READ_SURF
VEG_LSET_M1,VEG_LSET_M10,VEG_LSET_M100,VEG_LSET_MLW,VEG_LSET_MLH,VEG_LSET_QCON,&
VEG_LSET_ROS_00,VEG_LSET_ROS_BACK,VEG_LSET_ROS_FLANK,VEG_LSET_ROS_HEAD,VEG_LSET_SIGMA,&
VEG_LSET_SURF_LOAD,VEG_LSET_TAN2,VEG_LSET_WIND_EXP,&
VEL,VEL_BULK,VEL_GRAD,VEL_PART,VEL_T,VOLUME_FLOW,WIDTH,XYZ,Z0,Z_0
VEL,VEL_BULK,VEL_GRAD,VEL_PART,VEL_T,VOLUME_FLOW,WIDTH,XYZ,Z0,Z_0,&
HT1D ! Backward compatibility

! Count the SURF lines in the input file

Expand Down Expand Up @@ -7228,11 +7229,12 @@ SUBROUTINE READ_SURF
SURF_DEFAULT = TRIM(ID)
ENDIF

! Set up a dummy surface for HT1D and HT3D. The properties will be changed later.
! Set up a dummy surface for VARIABLE_THICKNESS and HT3D. The properties will be changed later.

If ((HT1D .OR. HT3D) .AND. THICKNESS(1)>TWO_EPSILON_EB .AND. MATL_ID(1,1)/='null') SF%LINING = .TRUE.
If ((HT1D .OR. HT3D) .AND. THICKNESS(1)<TWO_EPSILON_EB) THICKNESS(1) = 0.1_EB
If ((HT1D .OR. HT3D) .AND. MATL_ID(1,1)=='null') MATL_ID(1,1) = MATERIAL(1)%ID
IF (HT1D) VARIABLE_THICKNESS = .TRUE.
If ((VARIABLE_THICKNESS .OR. HT3D) .AND. THICKNESS(1)>TWO_EPSILON_EB .AND. MATL_ID(1,1)/='null') SF%LINING = .TRUE.
If ((VARIABLE_THICKNESS .OR. HT3D) .AND. THICKNESS(1)<TWO_EPSILON_EB) THICKNESS(1) = 0.1_EB
If ((VARIABLE_THICKNESS .OR. HT3D) .AND. MATL_ID(1,1)=='null') MATL_ID(1,1) = MATERIAL(1)%ID

! Load RAMP parameters into appropriate array

Expand Down Expand Up @@ -7275,7 +7277,7 @@ SUBROUTINE READ_SURF

! Convert SURFACE_VOLUME_RATIO into a THICKNESS

IF (SURFACE_VOLUME_RATIO(NL)>TWO_EPSILON_EB .AND. THICKNESS(NL)<0._EB .AND. .NOT.HT3D .AND. .NOT.HT1D) THEN
IF (SURFACE_VOLUME_RATIO(NL)>TWO_EPSILON_EB .AND. THICKNESS(NL)<0._EB .AND. .NOT.HT3D .AND. .NOT.VARIABLE_THICKNESS) THEN
SELECT CASE(GEOMETRY)
CASE('CARTESIAN') ; THICKNESS(NL) = 1._EB/SURFACE_VOLUME_RATIO(NL)
CASE('CYLINDRICAL') ; THICKNESS(NL) = 2._EB/SURFACE_VOLUME_RATIO(NL)
Expand Down Expand Up @@ -7434,14 +7436,14 @@ SUBROUTINE READ_SURF
! Check SURF parameters for potential problems

LAYER_LOOP: DO IL=1,MAX_LAYERS
IF (TMP_FRONT>-TMPM .AND. (MATL_ID(IL,1)/='null' .OR. HT1D .OR. HT3D)) DIRICHLET_FRONT = .TRUE.
IF (TMP_BACK >-TMPM .AND. (MATL_ID(IL,1)/='null' .OR. HT1D .OR. HT3D)) DIRICHLET_BACK = .TRUE.
IF (TMP_FRONT>-TMPM .AND. (MATL_ID(IL,1)/='null' .OR. VARIABLE_THICKNESS .OR. HT3D)) DIRICHLET_FRONT = .TRUE.
IF (TMP_BACK >-TMPM .AND. (MATL_ID(IL,1)/='null' .OR. VARIABLE_THICKNESS .OR. HT3D)) DIRICHLET_BACK = .TRUE.
IF ((ADIABATIC.OR.NET_HEAT_FLUX<1.E12_EB.OR.ABS(CONVECTIVE_HEAT_FLUX)>TWO_EPSILON_EB) &
.AND. MATL_ID(IL,1)/='null') THEN
WRITE(MESSAGE,'(A)') 'ERROR: SURF '//TRIM(SF%ID)//' cannot have a specified flux and a MATL_ID'
CALL SHUTDOWN(MESSAGE) ; RETURN
ENDIF
IF (THICKNESS(IL)<=0._EB .AND. .NOT.HT1D .AND. .NOT.HT3D .AND. MATL_ID(IL,1)/='null') THEN
IF (THICKNESS(IL)<=0._EB .AND. .NOT.VARIABLE_THICKNESS .AND. .NOT.HT3D .AND. MATL_ID(IL,1)/='null') THEN
WRITE(MESSAGE,'(A,I0)') 'ERROR: SURF '//TRIM(SF%ID)// ' must have a specified THICKNESS for Layer ',IL
CALL SHUTDOWN(MESSAGE) ; RETURN
ENDIF
Expand All @@ -7463,7 +7465,7 @@ SUBROUTINE READ_SURF
! Pack SURF parameters into the SURFACE derived type

SF => SURFACE(N)
SF%HT1D = HT1D
SF%VARIABLE_THICKNESS = VARIABLE_THICKNESS
SF%ADIABATIC = ADIABATIC
SF%AREA_MULTIPLIER = AREA_MULTIPLIER
SELECT CASE(BACKING)
Expand Down Expand Up @@ -8187,6 +8189,7 @@ SUBROUTINE SET_SURF_DEFAULTS
TEXTURE_HEIGHT = 1._EB
TGA_ANALYSIS = .FALSE.
THICKNESS = -1._EB
VARIABLE_THICKNESS = .FALSE.
HT1D = .FALSE.
HT3D = .FALSE.
NORMAL_DIRECTION_ONLY = .FALSE.
Expand Down
2 changes: 1 addition & 1 deletion Source/type.f90
Original file line number Diff line number Diff line change
Expand Up @@ -868,7 +868,7 @@ MODULE TYPES
SPECIFIED_NORMAL_GRADIENT=.FALSE.,CONVERT_VOLUME_TO_MASS=.FALSE.,SPECIFIED_HEAT_SOURCE=.FALSE.,&
BOUNDARY_FUEL_MODEL=.FALSE.,SET_H=.FALSE.,DIRICHLET_FRONT=.FALSE.,DIRICHLET_BACK=.FALSE.,BLOWING=.FALSE.
INTEGER :: HT_DIM=1 !< Heat Transfer Dimension
LOGICAL :: HT1D=.FALSE.
LOGICAL :: VARIABLE_THICKNESS=.FALSE. !< Allow the surface to have varying thickness
LOGICAL :: LINING=.FALSE. !< Indicator that the properties refer to a wall lining, not entire wall
LOGICAL :: NORMAL_DIRECTION_ONLY=.FALSE. !< Heat Transfer in normal direction only, even if the solid is HT3D
LOGICAL :: INCLUDE_BOUNDARY_COORD_TYPE=.TRUE. !< This surface requires basic coordinate information
Expand Down
2 changes: 1 addition & 1 deletion Source/wall.f90
Original file line number Diff line number Diff line change
Expand Up @@ -1848,7 +1848,7 @@ SUBROUTINE SOLID_HEAT_TRANSFER_1D(NM,T,DT_BC,PARTICLE_INDEX,WALL_INDEX,CFACE_IND

LAYER_DIVIDE = SF%LAYER_DIVIDE

COMPUTE_GRID: IF (SF%PYROLYSIS_MODEL==PYROLYSIS_PREDICTED .OR. SF%HT_DIM>1 .OR. SF%HT1D) THEN
COMPUTE_GRID: IF (SF%PYROLYSIS_MODEL==PYROLYSIS_PREDICTED .OR. SF%HT_DIM>1 .OR. SF%VARIABLE_THICKNESS) THEN
NWP = SUM(ONE_D%N_LAYER_CELLS(1:ONE_D%N_LAYERS))
CALL GET_WALL_NODE_WEIGHTS(NWP,ONE_D%N_LAYERS,ONE_D%N_LAYER_CELLS(1:ONE_D%N_LAYERS),ONE_D%LAYER_THICKNESS,SF%GEOMETRY, &
ONE_D%X(0:NWP),LAYER_DIVIDE,DX_S(1:NWP),RDX_S(0:NWP+1),RDXN_S(0:NWP),DX_WGT_S(0:NWP),DXF,DXB,&
Expand Down
2 changes: 1 addition & 1 deletion Verification/Fires/box_burn_away1.fds
Original file line number Diff line number Diff line change
Expand Up @@ -24,7 +24,7 @@ computed by the first DEVC.
&SURF ID = 'FOAM SLAB'
COLOR = 'TOMATO 3'
MATL_ID = 'FOAM'
HT1D = T
VARIABLE_THICKNESS = T
BURN_AWAY = T /

&OBST XB=0.30,0.70,0.30,0.70,0.30,0.70, SURF_ID='FOAM SLAB', BULK_DENSITY=20. /
Expand Down
2 changes: 1 addition & 1 deletion Verification/Fires/box_burn_away2.fds
Original file line number Diff line number Diff line change
Expand Up @@ -26,7 +26,7 @@ The gas species here is additional SPEC.
&SURF ID = 'FOAM SLAB'
COLOR = 'TOMATO 3'
MATL_ID = 'FOAM'
HT1D = T
VARIABLE_THICKNESS = T
BURN_AWAY = T /

&DUMP SMOKE3D = .FALSE.
Expand Down
2 changes: 1 addition & 1 deletion Verification/Fires/box_burn_away3.fds
Original file line number Diff line number Diff line change
Expand Up @@ -21,7 +21,7 @@ The gas species here is mixture fraction fuel, burning rate specified.
&SURF ID = 'FOAM SLAB'
COLOR = 'TOMATO 3'
MATL_ID = 'FOAM'
HT1D = T
VARIABLE_THICKNESS = T
BURN_AWAY = T
HRRPUA = 4000. /

Expand Down
2 changes: 1 addition & 1 deletion Verification/Fires/box_burn_away4.fds
Original file line number Diff line number Diff line change
Expand Up @@ -23,7 +23,7 @@ The gas species here is mixture fraction fuel, burning rate specified.
&SURF ID = 'FOAM SLAB'
COLOR = 'TOMATO 3'
MATL_ID = 'FOAM'
HT1D = T
VARIABLE_THICKNESS = T
BURN_AWAY = T
HRRPUA = 2200. /

Expand Down
2 changes: 1 addition & 1 deletion Verification/Fires/box_burn_away5.fds
Original file line number Diff line number Diff line change
Expand Up @@ -27,7 +27,7 @@ The gas species is mixture fraction fuel.
&SURF ID = 'FOAM SLAB'
COLOR = 'TOMATO 3'
MATL_ID = 'FOAM'
HT1D = T
VARIABLE_THICKNESS = T
BURN_AWAY = T /

&REAC FUEL='METHANE', AUTO_IGNITION_TEMPERATURE=15000. ,N_SIMPLE_CHEMISTRY_REACTIONS=2/
Expand Down
2 changes: 1 addition & 1 deletion Verification/Fires/box_burn_away6.fds
Original file line number Diff line number Diff line change
Expand Up @@ -27,7 +27,7 @@ The gas species is mixture fraction fuel.
&SURF ID = 'FOAM SLAB'
COLOR = 'TOMATO 3'
MATL_ID = 'FOAM'
HT1D = T
VARIABLE_THICKNESS = T
BURN_AWAY = T /

&SPEC ID='NITROGEN',BACKGROUND=.TRUE./
Expand Down
2 changes: 1 addition & 1 deletion Verification/Fires/box_burn_away8.fds
Original file line number Diff line number Diff line change
Expand Up @@ -23,7 +23,7 @@ The gas species here is mixture fraction fuel, burning rate specified.
&SURF ID = 'FOAM SLAB'
COLOR = 'TOMATO 3'
MATL_ID = 'FOAM'
HT1D = T
VARIABLE_THICKNESS = T
BURN_AWAY = T
MLRPUA = 0.0733333 /

Expand Down
2 changes: 1 addition & 1 deletion Verification/Fires/box_burn_away_2D.fds
Original file line number Diff line number Diff line change
Expand Up @@ -28,7 +28,7 @@ The gas species is mixture fraction fuel.
&SURF ID = 'FOAM SLAB'
COLOR = 'TOMATO 3'
MATL_ID = 'FOAM'
HT1D = T
VARIABLE_THICKNESS = T
BURN_AWAY = T /

&REAC FUEL='METHANE',AUTO_IGNITION_TEMPERATURE=15000. /
Expand Down
2 changes: 1 addition & 1 deletion Verification/Fires/box_burn_away_2D_residue.fds
Original file line number Diff line number Diff line change
Expand Up @@ -37,7 +37,7 @@ The gas species is mixture fraction fuel.
&SURF ID = 'FOAM SLAB'
COLOR = 'TOMATO 3'
MATL_ID = 'FOAM'
HT1D = T
VARIABLE_THICKNESS = T
STRETCH_FACTOR = 1.0
BURN_AWAY = T /

Expand Down
Loading

0 comments on commit c29c64a

Please sign in to comment.